diff --git a/CMakeLists.txt b/CMakeLists.txt index 6d2e374011722c63f467780839821c6a473c0fb6..2f50c9446922e19a97aa6c790155003d6c835ff0 100644 --- a/CMakeLists.txt +++ b/CMakeLists.txt @@ -237,6 +237,7 @@ add_subdirectory (modules/sibyll) add_subdirectory (modules/qgsjetII) add_subdirectory (modules/urqmd) add_subdirectory (modules/conex) +add_subdirectory (modules/epos) #+++++++++++++++++++++++++++++++ # unit testing diff --git a/corsika/detail/modules/epos/Interaction.inl b/corsika/detail/modules/epos/Interaction.inl new file mode 100644 index 0000000000000000000000000000000000000000..f6c1790c5710b77b39937f7d5faf96c82abf1322 --- /dev/null +++ b/corsika/detail/modules/epos/Interaction.inl @@ -0,0 +1,278 @@ +/* + * (c) Copyright 2018 CORSIKA Project, corsika-project@lists.kit.edu + * + * This software is distributed under the terms of the GNU General Public + * Licence version 3 (GPL Version 3). See file LICENSE for a full version of + * the license. + */ + +#pragma once + +#include <corsika/modules/epos/Interaction.hpp> + +#include <corsika/media/Environment.hpp> +#include <corsika/media/NuclearComposition.hpp> +#include <corsika/framework/geometry/FourVector.hpp> +//#include <corsika/modules/sibyll/ParticleConversion.hpp> +//#include <corsika/modules/sibyll/SibStack.hpp> +#include <corsika/setup/SetupStack.hpp> +#include <corsika/setup/SetupTrajectory.hpp> +#include <corsika/framework/utility/COMBoost.hpp> + +#include <epos.hpp> + +#include <tuple> + +using namespace corsika; +using SetupParticle = setup::Stack::stack_iterator_type; + +namespace corsika::epos { + + inline Interaction::Interaction() { + + // if(ilowegy.ne.1.or.MCleModel.eq.4)xsegymin=dble(0.5*egymin**2) + // if(MCModel.eq.4)xsegymax=min(xsegymax,dble(0.5*egymax**2)) + // nrnody=nrnodyxs + // do i=1,nrnody + // nody(i)= nodyxs(i) + // enddo + // #if !__CXCORSIKA__ && !__CORSIKA8__ + + // inicnt=inicnt+1 + // c isetcs=2 ! epos cross-section from tabulated calculation (h-A and AA) + ::epos::hadr6_.isetcs=3; // epos cross-section from tabulated simulations + // (h-A and A-A) + ::epos::nucl6_.infragm=2; // --> model how projectiles fragment! + ::epos::hadr6_.isigma=0; // !do not print out the + // cross section on screen ionudi=1 + + // nfnii=nxsfnii ! epos file name + // fnii=xsfnii + // nfnid=nxsfnid + // fnid=xsfnid + // nfnie=nxsfnie + // fnie=xsfnie + // nfnrj=nxsfnrj + // fnrj=xsfnrj + // nfncs=nxsfncs + // fncs=xsfncs + // nfnch=nxsfnch + // fnch=xsfnch + + // c air + /* for (int i=1; i<=3; ++i) { + ::epos::nxsair_.airanxs[i]=aira[i]; + ::epos::nxsair_.airznxs[i]=airz[i]; + ::epos::nxsair_.airwnxs[i]=airw[i]; + } + ::epos::nxsair_.airavanxs=airava; + ::epos::nxsair_.airavznxs=airavz; + */ + + ::epos::appli_.iappl = iapplxs; + ::epos::events_.nevent = neventxs; + ::epos::othe2_.iframe = iframexs; + + // if(fnch(1:nfnch).ne.'none') + // & open(ifcx,file=fnch(1:nfnch),status='unknown') + + // call iclass(idproj,iclpro) + // call iclass(idtarg,icltar) + // if(inicnt.eq.1)then + // call ranfgt(seedp) !not to change the seed ... + ::epos::hdecin_(false); + ::epos::hnbspd_(iospec); + // ktnbod=0 + ::epos::hnbpajini_(); + // if(iclegy2.gt.1)then + // egyfac=(egymax*1.0001/egylow)**(1./float(iclegy2-1)) + // else + // egyfac=1. + // endif + // endif + // maproj=mamx !to set difnuc up to the maximum mass + // call conini + // call psaini + // call ranfst(seedp) ! ... after this initialization + } + + inline Interaction::~Interaction() { + CORSIKA_LOG_DEBUG("Epos::Interaction n={} ", count_); + } + + inline corsika::CrossSectionType Interaction::getCrossSection( + const corsika::Code BeamId, const corsika::Code TargetId, + const corsika::HEPEnergyType CoMenergy) const {} + + template <> + inline corsika::GrammageType Interaction::getInteractionLength( + SetupParticle const& projectile) const { + + return std::numeric_limits<double>::infinity() * 1_g / (1_cm * 1_cm); + } + + /** + In this function SIBYLL is called to produce one event. The + event is copied (and boosted) into the shower lab frame. + */ + + template <typename TSecondaryView> + inline void Interaction::doInteraction(TSecondaryView& view) { + + auto const projectile = view.getProjectile(); + const auto corsikaBeamId = projectile.getPID(); + + if (corsika::is_nucleus(corsikaBeamId)) { + // nuclei handled by different process, this should not happen + throw std::runtime_error("Nuclear projectile are not handled by SIBYLL!"); + } + + // position and time of interaction, not used in Sibyll + Point const pOrig = projectile.getPosition(); + TimeType const tOrig = projectile.getTime(); + + // define projectile + HEPEnergyType const eProjectileLab = projectile.getEnergy(); + auto const pProjectileLab = projectile.getMomentum(); + CoordinateSystemPtr const& originalCS = pProjectileLab.getCoordinateSystem(); + + CORSIKA_LOG_DEBUG( + "ProcessEPOS: " + "DoInteraction: pid {} interaction ", + corsikaBeamId); + + // define target + // for Sibyll is always a single nucleon + // FOR NOW: target is always at rest + const auto eTargetLab = 0_GeV + constants::nucleonMass; + const auto pTargetLab = MomentumVector(originalCS, 0_GeV, 0_GeV, 0_GeV); + const FourVector PtargLab(eTargetLab, pTargetLab); + + CORSIKA_LOG_DEBUG( + "Interaction: ebeam lab: {} GeV" + "Interaction: pbeam lab: {} GeV", + eProjectileLab / 1_GeV, pProjectileLab.getComponents()); + CORSIKA_LOG_DEBUG( + "Interaction: etarget lab: {} GeV " + "Interaction: ptarget lab: {} GeV", + eTargetLab / 1_GeV, pTargetLab.getComponents() / 1_GeV); + + const FourVector PprojLab(eProjectileLab, pProjectileLab); + + // define target kinematics in lab frame + // define boost to and from CoM frame + // CoM frame definition in Sibyll projectile: +z + COMBoost const boost(PprojLab, constants::nucleonMass); + auto const& csPrime = boost.getRotatedCS(); + + // just for show: + // boost projecticle + [[maybe_unused]] auto const PprojCoM = boost.toCoM(PprojLab); + + // boost target + [[maybe_unused]] auto const PtargCoM = boost.toCoM(PtargLab); + + CORSIKA_LOG_DEBUG( + "Interaction: ebeam CoM: {} GeV " + "Interaction: pbeam CoM: {} GeV ", + PprojCoM.getTimeLikeComponent() / 1_GeV, + PprojCoM.getSpaceLikeComponents().getComponents(csPrime) / 1_GeV); + CORSIKA_LOG_DEBUG( + "Interaction: etarget CoM: {} GeV " + "Interaction: ptarget CoM: {} GeV ", + PtargCoM.getTimeLikeComponent() / 1_GeV, + PtargCoM.getSpaceLikeComponents().getComponents(csPrime) / 1_GeV); + + CORSIKA_LOG_DEBUG("Interaction: position of interaction: {} ", + pOrig.getCoordinates()); + CORSIKA_LOG_DEBUG("Interaction: time: {} ", tOrig); + + HEPEnergyType Etot = eProjectileLab + eTargetLab; + MomentumVector Ptot = projectile.getMomentum(); + // invariant mass, i.e. cm. energy + HEPEnergyType Ecm = sqrt(Etot * Etot - Ptot.getSquaredNorm()); + + // sample target mass number + auto const* currentNode = projectile.getNode(); + auto const& mediumComposition = + currentNode->getModelProperties().getNuclearComposition(); + // get cross sections for target materials + /* + Here we read the cross section from the interaction model again, + should be passed from getInteractionLength if possible + */ + //#warning reading interaction cross section again, should not be necessary + auto const& compVec = mediumComposition.getComponents(); + std::vector<CrossSectionType> cross_section_of_components(compVec.size()); + + for (size_t i = 0; i < compVec.size(); ++i) { + auto const targetId = compVec[i]; + auto const sigProd = getCrossSection(corsikaBeamId, targetId, Ecm); + cross_section_of_components[i] = sigProd; + } + + const auto targetCode = + mediumComposition.sampleTarget(cross_section_of_components, RNG_); + CORSIKA_LOG_DEBUG("Interaction: target selected: {} ", targetCode); + + // + + /* + maproj=maprojxs + laproj=laprojxs + matarg=matargxs + latarg=latargxs + idproj=idprojxs + idtarg=idtargxs + amproj=xsamproj + amtarg=xsamtarg + call idspin(idproj,ispin,jspin,istra) + isoproj=sign(1,idproj)*ispin + call idspin(idtarg,ispin,jspin,istra) + isotarg=sign(1,idtarg)*ispin + + engy=sngl(xsengy) + elab=sngl(xselab) + ecms=sngl(xsecms) + ekin=sngl(xsekin) + pnll=sngl(xspnll) + pnullx=sngl(xspnullx) + yhaha=sngl(xsyhaha) + ypjtl=sngl(xsypjtl) + detap=xsdetap + detat=xsdetat + tpro=xstpro + zpro=xszpro + ttar=xsttar + ztar=xsztar + +c xsbminim=dble(bminim) !not needed and can interfer with other MC +c xsbmaxim=dble(bmaxim) + + call iclass(idproj,iclpro) + call iclass(idtarg,icltar) + call emsini(engy,idproj,idtarg) + call paramini(1) + bkmxndif=conbmxndif() + bkmx=conbmx() + xsbkmx=dble(bkmx) + + if(maproj.gt.1.or.matarg.gt.1)then + xsbmax=xsrmproj+xsrmtarg + else + xsbmax=xsbkmx + endif + + bimevt=-1 + bmax=sngl(xsbmax) + rmproj=sngl(xsrmproj) + rmtarg=sngl(xsrmtarg) + rcproj=xsrcproj + rctarg=xsrctarg + call xsigma !set some variabkle according to xs + if(idtarg.eq.0)idtarg=1120 !air = nucleus + + */ + } + +} // namespace corsika::epos diff --git a/corsika/modules/Epos.hpp b/corsika/modules/Epos.hpp new file mode 100644 index 0000000000000000000000000000000000000000..bceb34fb5318b8d1c93c83d572eedb32cdaf382e --- /dev/null +++ b/corsika/modules/Epos.hpp @@ -0,0 +1,13 @@ +/* + * (c) Copyright 2020 CORSIKA Project, corsika-project@lists.kit.edu + * + * This software is distributed under the terms of the GNU General Public + * Licence version 3 (GPL Version 3). See file LICENSE for a full version of + * the license. + */ + +#pragma once + +//#include <corsika/modules/epos/ParticleConversion.hpp> +#include <corsika/modules/epos/Interaction.hpp> +//#include <corsika/modules/epos/Decay.hpp> diff --git a/corsika/modules/epos/Interaction.hpp b/corsika/modules/epos/Interaction.hpp new file mode 100644 index 0000000000000000000000000000000000000000..7c5e179ddb462e014b87cc4726c2af015ee4d9b1 --- /dev/null +++ b/corsika/modules/epos/Interaction.hpp @@ -0,0 +1,47 @@ +/* + * (c) Copyright 2018 CORSIKA Project, corsika-project@lists.kit.edu + * + * This software is distributed under the terms of the GNU General Public + * Licence version 3 (GPL Version 3). See file LICENSE for a full version of + * the license. + */ + +#pragma once + +#include <corsika/framework/core/ParticleProperties.hpp> +#include <corsika/framework/core/PhysicalUnits.hpp> +#include <corsika/framework/random/RNGManager.hpp> +#include <corsika/framework/process/InteractionProcess.hpp> +#include <tuple> + +namespace corsika::epos { + + class Interaction : public InteractionProcess<Interaction> { + + public: + Interaction(); + ~Interaction(); + + //! returns production and elastic cross section for hadrons in sibyll. Inputs are: + //! CorsikaId of beam particle, CorsikaId of target particle and center-of-mass + //! energy. Allowed targets are: nuclei or single nucleons (p,n,hydrogen). + CrossSectionType getCrossSection(Code const, Code const, HEPEnergyType const) const; + + template <typename TParticle> + GrammageType getInteractionLength(TParticle const&) const; + + /** + In this function SIBYLL is called to produce one event. The + event is copied (and boosted) into the shower lab frame. + */ + template <typename TSecondaries> + void doInteraction(TSecondaries&); + + private: + default_prng_type& RNG_ = RNGManager::getInstance().getRandomStream("epos"); + unsigned int count_; + }; + +} // namespace corsika::epos + +#include <corsika/detail/modules/epos/Interaction.inl> diff --git a/corsika/modules/epos/Random.hpp b/corsika/modules/epos/Random.hpp new file mode 100644 index 0000000000000000000000000000000000000000..1e7e7bc7cdc062c6a609d97161287d47310034a3 --- /dev/null +++ b/corsika/modules/epos/Random.hpp @@ -0,0 +1,31 @@ +/* + * (c) Copyright 2018 CORSIKA Project, corsika-project@lists.kit.edu + * + * This software is distributed under the terms of the GNU General Public + * Licence version 3 (GPL Version 3). See file LICENSE for a full version of + * the license. + */ + +#pragma once + +#include <corsika/framework/random/RNGManager.hpp> +#include <random> + +/** + * \file epos/Random.hpp + * + * This file is an integral part of the sibyll interface. It must be + * linked to the executable linked to sibyll exactly once + * + */ + +namespace epos { + + double rndm_interface() { + static corsika::default_prng_type& rng = + corsika::RNGManager::getInstance().getRandomStream("epos"); + std::uniform_real_distribution<double> dist; + return dist(rng); + } + +} // namespace epos diff --git a/modules/epos/CMakeLists.txt b/modules/epos/CMakeLists.txt new file mode 100644 index 0000000000000000000000000000000000000000..091ef4a26fba19884561267f0ff87f62a8baaac3 --- /dev/null +++ b/modules/epos/CMakeLists.txt @@ -0,0 +1,64 @@ +set ( + MODEL_SOURCES + epos.cpp + epos-bas-lhc.f epos-con-lhc.f eposm.f epos_j.f + epos-dky-lhc.f epos-dro-lhc.f epos-ems-lhc.f + epos-fra-lhc.f epos-ico-lhc.f epos-hnb-lhc.f + epos-ids-lhc.f epos-int-lhc.f epos-jps-lhc.f + epos-omg-lhc.f epos-par-lhc.f epos-sem-lhc.f + epos-rsh-lhc.f epos-qsh-lhc.f epos-tim-lhc.f + epos-uti-lhc.f epos-xan-lhc.f epos-xpr-lhc.f + ) + +set ( + MODEL_HEADERS + epos.hpp + ) + +enable_language (Fortran) + +add_library (EPOS SHARED ${MODEL_SOURCES}) +target_include_directories (EPOS PUBLIC + $<BUILD_INTERFACE:${CMAKE_CURRENT_SOURCE_DIR}> + $<INSTALL_INTERFACE:include/corsika_modules/epos> + ) +set_target_properties ( + EPOS + PROPERTIES + POSITION_INDEPENDENT_CODE 1 + ) + +add_library (EPOS_static STATIC ${MODEL_SOURCES}) +target_include_directories (EPOS_static PUBLIC + $<BUILD_INTERFACE:${CMAKE_CURRENT_SOURCE_DIR}> + $<INSTALL_INTERFACE:include/corsika_modules/epos> + ) +set_target_properties ( + EPOS_static + PROPERTIES + POSITION_INDEPENDENT_CODE 1 + ) + +install ( + FILES + ${MODEL_HEADERS} + DESTINATION include/corsika_modules/epos + ) + +install ( + TARGETS EPOS + EXPORT CORSIKA8PublicTargets + LIBRARY DESTINATION lib/corsika + INCLUDES DESTINATION include/corsika_modules/epos + ) + +install ( + TARGETS EPOS_static + EXPORT CORSIKA8PublicTargets + ARCHIVE DESTINATION lib/corsika + INCLUDES DESTINATION include/corsika_modules/epos + ) + +# add EPOS to CORSIKA8 build +add_dependencies (CORSIKA8 EPOS_static) +target_link_libraries (CORSIKA8 INTERFACE EPOS_static) diff --git a/modules/epos/epos-app-lhc.f b/modules/epos/epos-app-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..031ec047cfd80b65285147f2cfc93a43109baad5 --- /dev/null +++ b/modules/epos/epos-app-lhc.f @@ -0,0 +1,642 @@ +c 05.02.2008 Main program and random number generator of epos +c (Do not compile it for CONEX or Corsika) + +c----------------------------------------------------------------------- + program aamain +c----------------------------------------------------------------------- + + include 'epos.inc' + common/photrans/phoele(4),ebeam + + save nopeno + call aaset(0) + call atitle + call xiniall + +9999 continue + call aread + if(nopen.eq.-1) then !after second round aread + nopen=nopeno + iecho=1 + call xiniall + goto 9999 + endif + call utpri('aamain',ish,ishini,4) + + if(iappl.ne.0)then + if(abs(idprojin).eq.12)then !fake e-A collision with gamma(pi0)-A + noebin=-nevent + nevent=1 + if(elepti.le.1.)stop 'electron energy not defined' + if(ebeam.le.1.)stop 'proton energy not defined' + irescl=0 !no rescaling because of electron + write(ifmt,'(a,i10,a,f6.2,a,f8.2,a)')'generate',-noebin + & ,' events for electron on proton =',elepti,' ->',ebeam,' ...' + else + if(ebeam.gt.0.)stop 'ebeam need abs(idproj)=12 for DIS' + endif + do nrebin= 1,abs(noebin) + call ainit + ! if (nrebin.eq.1) call xini + if(nevent.gt.0)then + if(noebin.ge.0)then + write(ifmt,'(a,i10,a,f10.2,a)')'generate',nevent + & ,' events for engy =',engy,' ...' + endif + if(icotabr.eq.1)nevent=1 + if(icotabr.eq.1)nrevt=1 + if(nfull.gt.0)nevent=nfreeze*nfull + if(mod(nevent,nfreeze).ne.0) + & stop'nevent must be a multiple of nfreeze!!!!!!!!! ' + if(istore.gt.0) call bstora + do n=1,nevent + if(irewch.eq.1)rewind(ifch) + nfr=mod(n-1,nfreeze)*ispherio + if(nfr.ne.0)goto77 + do nin=1,iabs(ninicon) + if(icotabr.eq.0)call aepos(isign(1,-ninicon)*nin) + if(icocore.ne.0)call IniCon(nin) + enddo + 77 if(ispherio.ne.0)then + if(nfr.eq.0)write(ifmt,'(a)') + & 'spherio evolution + hadronization ...' + if(mod(nfr+1,50).eq.0) + & write(ifmt,*)'hadronization ',nfr+1,' / ',nfreeze +c call spherio2(nrevt,nfr) + if(ish.ge.2)call alist('list after spherio&',1,nptl) + call decayall(1) + if(ish.ge.2)call alist('list after decay&',1,nptl) + endif + call aafinal + if(iurqmd.eq.1)call urqmd(n) + call afinal + call xana + if(iappl.ne.3)then + if(istore.ge.1.and.istore.le.3) call bstore + if(istore.eq.4) call lhestore(n) + if(istore.eq.5) call ustore + if(istore.eq.6) call hepmcstore + if(istore.eq.-1) call estore + endif + if(nfr+1.eq.nfreeze.or.ispherio.eq.0)call aseed(1) + enddo + call astati + else + call xana + endif + enddo + call bfinal + if(noebin.lt.0)call phoGPHERAepo(2) !statistic for fake DIS + endif + if(istore.eq.3) write(ifdt,*) ' 0 0 ' + write(6,'(a)')'rewind copy-file' + rewind (ifcp) + nopeno=nopen + nopen=-1 + iecho=0 + call utprix('aamain',ish,ishini,4) + goto 9999 + + end + + +c----------------------------------------------------------------------- + function rangen() +c----------------------------------------------------------------------- +c generates a random number +c----------------------------------------------------------------------- + include 'epos.inc' + double precision dranf + 1 rangen=sngl(dranf(dble(irandm))) + if(rangen.le.0.)goto 1 + if(rangen.ge.1.)goto 1 + if(irandm.eq.1)write(ifch,*)'rangen()= ',rangen + + return + end + +c----------------------------------------------------------------------- + double precision function drangen(dummy) +c----------------------------------------------------------------------- +c generates a random number +c----------------------------------------------------------------------- + include 'epos.inc' + double precision dummy,dranf + drangen=dranf(dummy) + if(irandm.eq.1)write(ifch,*)'drangen()= ',drangen + + return + end +c----------------------------------------------------------------------- + function cxrangen(dummy) +c----------------------------------------------------------------------- +c generates a random number +c----------------------------------------------------------------------- + include 'epos.inc' + double precision dummy,dranf + cxrangen=sngl(dranf(dummy)) + if(irandm.eq.1)write(ifch,*)'cxrangen()= ',cxrangen + + return + end + + + +c Random number generator from CORSIKA ********************************* + + + + +C======================================================================= + + DOUBLE PRECISION FUNCTION DRANF(dummy) + +C----------------------------------------------------------------------- +C RAN(DOM NUMBER) GEN(ERATOR) USED IN EPOS +C If calling this function within a DO-loop +C you should use an argument which prevents (dummy) to draw this function +C outside the loop by an optimizing compiler. +C----------------------------------------------------------------------- + implicit none + common/eporansto2/irndmseq + integer irndmseq + double precision uni(1),dummy +C----------------------------------------------------------------------- + + call RMMARD( uni(1),1,irndmseq) + + DRANF = UNI(1) + UNI(1) = dummy !to avoid warning + + RETURN + END + + +c----------------------------------------------------------------------- + subroutine ranfgt(seed) +c----------------------------------------------------------------------- +c Initialize seed in EPOS : read seed (output) +c Since original output seed and EPOS seed are different, +c define output seed as : seed=ISEED(3)*1E9+ISEED(2) +c but only for printing. Important values stored in /eporansto/ +c Important : to be call before ranfst +c----------------------------------------------------------------------- + IMPLICIT NONE + INTEGER KSEQ + PARAMETER (KSEQ = 2) + COMMON /CRRANMA3/CD,CINT,CM,TWOM24,TWOM48,MODCNS + DOUBLE PRECISION CD,CINT,CM,TWOM24,TWOM48 + INTEGER MODCNS + COMMON /CRRANMA4/C,U,IJKL,I97,J97,NTOT,NTOT2,JSEQ + DOUBLE PRECISION C(KSEQ),U(97,KSEQ) + INTEGER IJKL(KSEQ),I97(KSEQ),J97(KSEQ), + * NTOT(KSEQ),NTOT2(KSEQ),JSEQ + common/eporansto/diu0(100),iiseed(3) + double precision seed,diu0 + integer iiseed,i + + iiseed(1)=IJKL(1) + iiseed(2)=NTOT(1) + iiseed(3)=NTOT2(1) + seed=dble(iiseed(3))*dble(MODCNS)+dble(iiseed(2)) + diu0(1)=C(1) + do i=2,98 + diu0(i)=U(i-1,1) + enddo + diu0(99)=dble(I97(1)) + diu0(100)=dble(J97(1)) + return + end + +c----------------------------------------------------------------------- + subroutine ranfst(seed) +c----------------------------------------------------------------------- +c Initialize seed in EPOS : restore seed (input) +c Since original output seed and EPOS seed are different, +c define output seed as : seed=ISEED(3)*1E9+ISEED(2) +c but only for printing. Important values restored from /eporansto/ +c Important : to be call after ranfgt +c----------------------------------------------------------------------- + IMPLICIT NONE + INTEGER KSEQ + PARAMETER (KSEQ = 2) + COMMON /CRRANMA3/CD,CINT,CM,TWOM24,TWOM48,MODCNS + DOUBLE PRECISION CD,CINT,CM,TWOM24,TWOM48 + INTEGER MODCNS + COMMON /CRRANMA4/C,U,IJKL,I97,J97,NTOT,NTOT2,JSEQ + DOUBLE PRECISION C(KSEQ),U(97,KSEQ) + INTEGER IJKL(KSEQ),I97(KSEQ),J97(KSEQ), + * NTOT(KSEQ),NTOT2(KSEQ),JSEQ + common/eporansto/diu0(100),iiseed(3) + double precision seedum,seed,diu0 + integer i,iiseed + + seedum=seed + IJKL(1)=iiseed(1) + NTOT(1)=iiseed(2) + NTOT2(1)=iiseed(3) + C(1)=diu0(1) + do i=2,98 + U(i-1,1)=diu0(i) + enddo + I97(1)=nint(diu0(99)) + J97(1)=nint(diu0(100)) + return + end + +c----------------------------------------------------------------------- + subroutine ranflim(seed) +c----------------------------------------------------------------------- + double precision seed + if(seed.gt.1d9)stop'seed larger than 1e9 not possible !' + end + +c----------------------------------------------------------------------- + subroutine ranfcv(seed) +c----------------------------------------------------------------------- +c Convert input seed to EPOS random number seed +c Since input seed and EPOS (from Corsika) seed are different, +c define input seed as : seed=ISEED(3)*1E9+ISEED(2) +c----------------------------------------------------------------------- + IMPLICIT NONE + COMMON /CRRANMA3/CD,CINT,CM,TWOM24,TWOM48,MODCNS + DOUBLE PRECISION CD,CINT,CM,TWOM24,TWOM48 + INTEGER MODCNS + common/eporansto/diu0(100),iiseed(3) + double precision seed,diu0 + integer iiseed + + iiseed(3)=int(seed/dble(MODCNS)) + iiseed(2)=nint(mod(seed,dble(MODCNS))) + + return + end + +c----------------------------------------------------------------------- + subroutine ranfini(seed,iseq,iqq) +c----------------------------------------------------------------------- +c Initialize random number sequence iseq with seed +c if iqq=-1, run first ini +c iqq=0 , set what sequence should be used +c iqq=1 , initialize sequence for initialization +c iqq=2 , initialize sequence for first event +c----------------------------------------------------------------------- + IMPLICIT NONE + COMMON /CRRANMA3/CD,CINT,CM,TWOM24,TWOM48,MODCNS + DOUBLE PRECISION CD,CINT,CM,TWOM24,TWOM48 + INTEGER MODCNS + common/eporansto/diu0(100),iiseed(3) + double precision seed,diu0 + integer iiseed + common/eporansto2/irndmseq + integer irndmseq + integer iseed(3),iseq,iqq,iseqdum + + if(iqq.eq.0)then + irndmseq=iseq + elseif(iqq.eq.-1)then + iseqdum=0 + call RMMAQD(iseed,iseqdum,'R') !first initialization + elseif(iqq.eq.2)then + irndmseq=iseq + if(seed.ge.dble(MODCNS))then + write(*,'(a,1p,e8.1)')'seedj larger than',dble(MODCNS) + stop 'Forbidden !' + endif + iiseed(1)=nint(mod(seed,dble(MODCNS))) +c iiseed(2) and iiseed(3) defined in aread + call RMMAQD(iiseed,iseq,'S') !initialize random number generator + elseif(iqq.eq.1)then !dummy sequence for EPOS initialization + irndmseq=iseq + if(seed.ge.dble(MODCNS))then + write(*,'(a,1p,e8.1)')'seedi larger than',dble(MODCNS) + stop 'Forbidden !' + endif + iseed(1)=nint(mod(seed,dble(MODCNS))) + iseed(2)=0 + iseed(3)=0 + call RMMAQD(iseed,iseq,'S') !initialize random number generator + endif + return + end + +C======================================================================= + + SUBROUTINE RMMARD( RVEC,LENV,ISEQ ) + +C----------------------------------------------------------------------- +C C(ONE)X +C R(ANDO)M (NUMBER GENERATOR OF) MAR(SAGLIA TYPE) D(OUBLE PRECISION) +C +C THESE ROUTINES (RMMARD,RMMAQD) ARE MODIFIED VERSIONS OF ROUTINES +C FROM THE CERN LIBRARIES. DESCRIPTION OF ALGORITHM SEE: +C http://consult.cern.ch/shortwrups/v113/top.html +C IT HAS BEEN CHECKED THAT RESULTS ARE BIT-IDENTICAL WITH CERN +C DOUBLE PRECISION RANDOM NUMBER GENERATOR RMM48, DESCRIBED IN +C http://consult.cern.ch/shortwrups/v116/top.html +C ARGUMENTS: +C RVEC = DOUBLE PREC. VECTOR FIELD TO BE FILLED WITH RANDOM NUMBERS +C LENV = LENGTH OF VECTOR (# OF RANDNUMBERS TO BE GENERATED) +C ISEQ = # OF RANDOM SEQUENCE +C +C VERSION OF D. HECK FOR DOUBLE PRECISION RANDOM NUMBERS. +C ADAPTATION : T. PIEROG IK FZK KARLSRUHE FROM D. HECK VERSION +C DATE : Feb 17, 2009 +C----------------------------------------------------------------------- + + IMPLICIT NONE + INTEGER KSEQ + PARAMETER (KSEQ = 2) + COMMON /CRRANMA3/CD,CINT,CM,TWOM24,TWOM48,MODCNS + DOUBLE PRECISION CD,CINT,CM,TWOM24,TWOM48 + INTEGER MODCNS + COMMON /CRRANMA4/C,U,IJKL,I97,J97,NTOT,NTOT2,JSEQ + DOUBLE PRECISION C(KSEQ),U(97,KSEQ),UNI + INTEGER IJKL(KSEQ),I97(KSEQ),J97(KSEQ), + * NTOT(KSEQ),NTOT2(KSEQ),JSEQ + + DOUBLE PRECISION RVEC(*) + INTEGER ISEQ,IVEC,LENV + SAVE + +C----------------------------------------------------------------------- + + IF ( ISEQ .GT. 0 .AND. ISEQ .LE. KSEQ ) JSEQ = ISEQ + + DO IVEC = 1, LENV + UNI = U(I97(JSEQ),JSEQ) - U(J97(JSEQ),JSEQ) + IF ( UNI .LT. 0.D0 ) UNI = UNI + 1.D0 + U(I97(JSEQ),JSEQ) = UNI + I97(JSEQ) = I97(JSEQ) - 1 + IF ( I97(JSEQ) .EQ. 0 ) I97(JSEQ) = 97 + J97(JSEQ) = J97(JSEQ) - 1 + IF ( J97(JSEQ) .EQ. 0 ) J97(JSEQ) = 97 + C(JSEQ) = C(JSEQ) - CD + IF ( C(JSEQ) .LT. 0.D0 ) C(JSEQ) = C(JSEQ) + CM + UNI = UNI - C(JSEQ) + IF ( UNI .LT. 0.D0 ) UNI = UNI + 1.D0 +C AN EXACT ZERO HERE IS VERY UNLIKELY, BUT LET'S BE SAFE. + IF ( UNI .EQ. 0.D0 ) UNI = TWOM48 + RVEC(IVEC) = UNI + ENDDO + + NTOT(JSEQ) = NTOT(JSEQ) + LENV + IF ( NTOT(JSEQ) .GE. MODCNS ) THEN + NTOT2(JSEQ) = NTOT2(JSEQ) + 1 + NTOT(JSEQ) = NTOT(JSEQ) - MODCNS + ENDIF + + RETURN + END + +C======================================================================= + + SUBROUTINE RMMAQD( ISEED, ISEQ, CHOPT ) + +C----------------------------------------------------------------------- +C R(ANDO)M (NUMBER GENERATOR OF) MA(RSAGLIA TYPE INITIALIZATION) DOUBLE +C +C SUBROUTINE FOR INITIALIZATION OF RMMARD +C THESE ROUTINE RMMAQD IS A MODIFIED VERSION OF ROUTINE RMMAQ FROM +C THE CERN LIBRARIES. DESCRIPTION OF ALGORITHM SEE: +C http://consult.cern.ch/shortwrups/v113/top.html +C FURTHER DETAILS SEE SUBR. RMMARD +C ARGUMENTS: +C ISEED = SEED TO INITIALIZE A SEQUENCE (3 INTEGERS) +C ISEQ = # OF RANDOM SEQUENCE +C CHOPT = CHARACTER TO STEER INITIALIZE OPTIONS +C +C CERN PROGLIB# V113 RMMAQ .VERSION KERNFOR 1.0 +C ORIG. 01/03/89 FCA + FJ +C ADAPTATION : T. PIEROG IK FZK KARLSRUHE FROM D. HECK VERSION +C DATE : Feb 17, 2009 +C----------------------------------------------------------------------- + + IMPLICIT NONE + INTEGER KSEQ + PARAMETER (KSEQ = 2) + COMMON /CRRANMA3/CD,CINT,CM,TWOM24,TWOM48,MODCNS + DOUBLE PRECISION CD,CINT,CM,TWOM24,TWOM48 + INTEGER MODCNS + COMMON /CRRANMA4/C,U,IJKL,I97,J97,NTOT,NTOT2,JSEQ + DOUBLE PRECISION C(KSEQ),U(97,KSEQ),UNI + INTEGER IJKL(KSEQ),I97(KSEQ),J97(KSEQ), + * NTOT(KSEQ),NTOT2(KSEQ),JSEQ + + DOUBLE PRECISION CC,S,T,UU(97) + INTEGER ISEED(3),I,IDUM,II,II97,IJ,IJ97,IORNDM, + * ISEQ,J,JJ,K,KL,L,LOOP2,M,NITER + CHARACTER CHOPT*(*), CCHOPT*12 + LOGICAL FIRST + SAVE + DATA FIRST / .TRUE. /, IORNDM/11/, JSEQ/1/ + + +C----------------------------------------------------------------------- + + IF ( FIRST ) THEN + TWOM24 = 2.D0**(-24) + TWOM48 = 2.D0**(-48) + CD = 7654321.D0*TWOM24 + CM = 16777213.D0*TWOM24 + CINT = 362436.D0*TWOM24 + MODCNS = 1000000000 + FIRST = .FALSE. + JSEQ = 1 + ENDIF + CCHOPT = CHOPT + IF ( CCHOPT .EQ. ' ' ) THEN + ISEED(1) = 54217137 + ISEED(2) = 0 + ISEED(3) = 0 + CCHOPT = 'S' + JSEQ = 1 + ENDIF + + IF ( INDEX(CCHOPT,'S') .NE. 0 ) THEN + IF ( ISEQ .GT. 0 .AND. ISEQ .LE. KSEQ ) JSEQ = ISEQ + IF ( INDEX(CCHOPT,'V') .NE. 0 ) THEN + READ(IORNDM,'(3Z8)') IJKL(JSEQ),NTOT(JSEQ),NTOT2(JSEQ) + READ(IORNDM,'(2Z8,Z16)') I97(JSEQ),J97(JSEQ),C(JSEQ) + READ(IORNDM,'(24(4Z16,/),Z16)') U + IJ = IJKL(JSEQ)/30082 + KL = IJKL(JSEQ) - 30082 * IJ + I = MOD(IJ/177, 177) + 2 + J = MOD(IJ, 177) + 2 + K = MOD(KL/169, 178) + 1 + L = MOD(KL, 169) + CD = 7654321.D0 * TWOM24 + CM = 16777213.D0 * TWOM24 + ELSE + IJKL(JSEQ) = ISEED(1) + NTOT(JSEQ) = ISEED(2) + NTOT2(JSEQ) = ISEED(3) + IJ = IJKL(JSEQ) / 30082 + KL = IJKL(JSEQ) - 30082*IJ + I = MOD(IJ/177, 177) + 2 + J = MOD(IJ, 177) + 2 + K = MOD(KL/169, 178) + 1 + L = MOD(KL, 169) + DO II = 1, 97 + S = 0.D0 + T = 0.5D0 + DO JJ = 1, 48 + M = MOD(MOD(I*J,179)*K, 179) + I = J + J = K + K = M + L = MOD(53*L+1, 169) + IF ( MOD(L*M,64) .GE. 32 ) S = S + T + T = 0.5D0 * T + ENDDO + UU(II) = S + ENDDO + CC = CINT + II97 = 97 + IJ97 = 33 +C COMPLETE INITIALIZATION BY SKIPPING (NTOT2*MODCNS+NTOT) RANDOMNUMBERS + NITER = MODCNS + DO LOOP2 = 1, NTOT2(JSEQ)+1 + IF ( LOOP2 .GT. NTOT2(JSEQ) ) NITER = NTOT(JSEQ) + DO IDUM = 1, NITER + UNI = UU(II97) - UU(IJ97) + IF ( UNI .LT. 0.D0 ) UNI = UNI + 1.D0 + UU(II97) = UNI + II97 = II97 - 1 + IF ( II97 .EQ. 0 ) II97 = 97 + IJ97 = IJ97 - 1 + IF ( IJ97 .EQ. 0 ) IJ97 = 97 + CC = CC - CD + IF ( CC .LT. 0.D0 ) CC = CC + CM + ENDDO + ENDDO + I97(JSEQ) = II97 + J97(JSEQ) = IJ97 + C(JSEQ) = CC + DO JJ = 1, 97 + U(JJ,JSEQ) = UU(JJ) + ENDDO + ENDIF + ELSEIF ( INDEX(CCHOPT,'R') .NE. 0 ) THEN + IF ( ISEQ .GT. 0 ) THEN + JSEQ = ISEQ + ELSE + ISEQ = JSEQ + ENDIF + IF ( INDEX(CCHOPT,'V') .NE. 0 ) THEN + WRITE(IORNDM,'(3Z8)') IJKL(JSEQ),NTOT(JSEQ),NTOT2(JSEQ) + WRITE(IORNDM,'(2Z8,Z16)') I97(JSEQ),J97(JSEQ),C(JSEQ) + WRITE(IORNDM,'(24(4Z16,/),Z16)') U + ELSE + ISEED(1) = IJKL(JSEQ) + ISEED(2) = NTOT(JSEQ) + ISEED(3) = NTOT2(JSEQ) + ENDIF + ENDIF + + RETURN + END + +c Random number generator from CERN LIB ********************************* + +c +cc----------------------------------------------------------------------- +c real function ranf(dummy) +cc----------------------------------------------------------------------- +cc uniform random number generator from cern library +cc----------------------------------------------------------------------- +c double precision dranf, g900gt, g900st +c double precision ds(2), dm(2), dseed +c double precision dx24, dx48 +c double precision dl, dc, du, dr +c logical single +c data ds / 1665 1885.d0, 286 8876.d0 / +c data dm / 1518 4245.d0, 265 1554.d0 / +c data dx24 / 1677 7216.d0 / +c data dx48 / 281 4749 7671 0656.d0 / +c double precision dummy,a +c single = .true. +c goto 10 +c entry dranf(dummy) +c a=dummy +c single = .false. +c 10 dl = ds(1) * dm(1) +c dc = dint(dl/dx24) +c dl = dl - dc*dx24 +c du = ds(1)*dm(2) + ds(2)*dm(1) + dc +c ds(2) = du - dint(du/dx24)*dx24 +c ds(1) = dl +c dr = (ds(2)*dx24 + ds(1)) / dx48 +c if(single) then +c ranf = sngl(dr) +c else +c dranf = dr +c endif +c return +c entry g900gt() +c g900gt = ds(2)*dx24 + ds(1) +c return +c entry g900st(dseed) +c ds(2) = dint(dseed/dx24) +c ds(1) = dseed - ds(2)*dx24 +c g900st = ds(1) +c return +c end +c +cc----------------------------------------------------------------------- +c subroutine ranfgt(seed) +cc----------------------------------------------------------------------- +c double precision seed, g900gt, g900st, dummy +c seed = g900gt() +c return +c entry ranfst(seed) +c dummy = g900st(seed) +c return +c end +cc----------------------------------------------------------------------- +c subroutine ranfcv(seed) +cc----------------------------------------------------------------------- +cc Convert input seed to EPOS random number seed +cc Useless with ranf +cc----------------------------------------------------------------------- +c double precision seed,dummy +c dummy=seed +c +c return +c end +c +cc----------------------------------------------------------------------- +c subroutine ranfini(seed,iseq,iqq) +cc----------------------------------------------------------------------- +cc Initialize random number sequence iseq with seed +cc if iqq=-1, run first ini : useless with ranf +cc iqq=0 , set what sequence should be used +cc iqq=1 , initialize sequence for initialization +cc iqq=2 , initialize sequence for first event +cc----------------------------------------------------------------------- +c IMPLICIT NONE +c COMMON /CRRANMA3/CD,CINT,CM,TWOM24,TWOM48,MODCNS +c DOUBLE PRECISION CD,CINT,CM,TWOM24,TWOM48 +c INTEGER MODCNS +c common/eporansto/diu0(100),iiseed(3) +c double precision seed,diu0 +c integer iiseed +c common/eporansto2/irndmseq +c integer irndmseq +c integer iseed(3),iseq,iqq,iseqdum +c +c if(iqq.eq.0)then +c call ranfst(seed) +c elseif(iqq.eq.-1)then +c iseqdum=iseq +c iseed(1)=iseq +c elseif(iqq.eq.2)then +c if(seed.gt.1d15)stop'seedj larger than 1e15 not possible !' +c call ranfst(seed) +c elseif(iqq.eq.1)then !dummy sequence for EPOS initialization +c if(seed.gt.1d15)stop'seedi larger than 1e15 not possible !' +c call ranfst(seed) +c endif +c return +c end +c diff --git a/modules/epos/epos-bas-lhc.f b/modules/epos/epos-bas-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..8099f7573244bd3331769adcdf4d812a534f2f9b --- /dev/null +++ b/modules/epos/epos-bas-lhc.f @@ -0,0 +1,6489 @@ + +c----------------------------------------------------------------------- + subroutine aaset(iop) +c----------------------------------------------------------------------- +c sets parameters and options, initializes counters ... +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + include 'epos.incsem' + common/record/maxrec(2),irecty(30,2) + common/cfacmss/facmss /cr3pomi/r3pomi,r4pomi/cifset/ifset + common /ems12/iodiba,bidiba ! defaut iodiba=0. if iodiba=1, study H-Dibaryon + character*500 fndat,fnncs,fnIIdat,fnIIncs,fnII03dat,fnII03ncs !qgs-II???????? + common/qgsfname/ fndat, fnncs, ifdat, ifncs + common/qgsIIfname/fnIIdat, fnIIncs, ifIIdat, ifIIncs !qgs-II???????? + common/qgsII03fname/fnII03dat, fnII03ncs, ifII03dat, ifII03ncs !qgs-II???????? + common/ghecsquel/anquasiel,iquasiel + common/cbincond/nozero,ibmin,ibmax + common/photrans/phoele(4),ebeam + common/producetab/ producetables !used to link CRMC + logical producetables !with EPOS and QII + !gauss weights + data (tgss(2,i),i=1,7)/ .3399810436,.8611363116 ,5*0. / + data (wgss(2,i),i=1,7)/ .6521451549,.3478548451 ,5*0. / + data (tgss(3,i),i=1,7)/ .2386192,.6612094,.9324700 ,4*0. / + data (wgss(3,i),i=1,7)/ .4679139,.3607616,.1713245 ,4*0. / + data (tgss(5,i),i=1,7)/ .1488743389,.4333953941,.6794095682 + * ,.8650633666,.9739065285 ,2*0. / + data (wgss(5,i),i=1,7)/ .2955242247,.2692667193,.2190863625 + * ,.1494513491,.0666713443 ,2*0. / + data (tgss(7,i),i=1,7)/ .9862838,.9284349,.8272013,.6872929 + * ,.5152486,.3191124,.1080549 / + data (wgss(7,i),i=1,7)/ .03511946,.08015809,.1215186,.1572032 + * ,.1855384,.2051985,.2152639 / + + if(iop.eq.1)write(ifmt,'(a)')'default settings ...' + if(iop.eq.1)goto 1001 + if(iop.eq.2)goto 1002 + +c version + + iversn=int(1.99*100) !version number + iverso=int(1.99*100) !last official version + +c application + + iappl=1 !choice for application (0,1,2,3,4,5,6,7,8,9,10) + +c model + + model=1 + iquasiel=1 !allow (1) or not (0) quasi-elastic event in model 3 + +c file names and units + + fnnx='path/epos ' !path epos name + fnch='zzz.check ' !check-file name + fnhi='zzz.histo ' !histo-file name + fndt='zzz.data ' !data-file name + fncp='zzz.copy ' !copy-file name + fnii='zzz.initl ' !initl-file name + fnid='zzz.inidi ' !inidi-file name + fndr='zzz.inidr ' !inidr-file name + fnie='zzz.iniev ' !iniev-file name + fnrj='zzz.inirj ' !inirj-file name + fncs='zzz.inics ' !inics-file name + nfnnx=index(fnnx,' ')-1 !length of path epos name + nfnch=index(fnch,' ')-1 !length of check-file name + nfnhi=index(fnhi,' ')-1 !length of histo-file name + nfndt=index(fndt,' ')-1 !length of data-file name + nfncp=index(fncp,' ')-1 !length of copy-file name + nfnii=index(fnii,' ')-1 !length of initl-file name + nfnid=index(fnid,' ')-1 !length of inidi-file name + nfndr=index(fndr,' ')-1 !length of inidr-file name + nfnie=index(fnie,' ')-1 !length of iniev-file name + nfnrj=index(fnrj,' ')-1 !length of inirj-file name + nfncs=index(fncs,' ')-1 !length of inics-file name + + ifop=5 !optns-file unit + ifmt=6 !std output unit + ifcx=31 !check-file unit (for open) + ifch=31 !check-file unit (for write) + ifhi=35 !histo-file unit + ifdt=51 !data-file unit + ifcp=52 !copy-file unit + ifin=53 !input-file unit + + hydt='---' + + producetables=.true. + +c initial seed + +c following number should be less than kseq in RMMARD (=2 in EPOS) + iseqini=2 !sequence number at start program +c seed for random number generator: at start program + seedi=0d0 !.ne.0. + iseqsim=1 !.ne.iseqini : sequence number at start program +c seed for random number generator: for first event + seedj=0d0 !.ne.0. +c place to start for random number generator: for first event + seedj2=0d0 + call ranfini(0d0,0,-1) !initialize some parameters + + + 1001 continue ! ----> entry iop=1 <----- + + call factoriel + + +c some basic things + + nevent=1 !number of events + nfull=-1 !number of full events (ico+hydro+f.o.)(if different from -1) + nfreeze=1 !number of freeze out events per epos event + ninicon=1 ! +-number of events per initial condition + ! if positive: keep same b, otherwise generate b each time + engy=-1 !energy + elab=-1 !energy lab + ecms=-1 !energy centre of mass + ekin=-1 !energy kinetic + pnll=-1 !momentum + ebeam=-1 !beam energy for proton in fake DIS (pi0-proton collision) + egymin=6. !minimum energy + egymax=2.E+06 !maximum energy + noebin=1 !number of energy bins + engmin=0 !minimum energy + engmax=0 !maximum energy + iologe=-1 !0=linear bins 1=log bins (cms engy) + iologl=-1 !0=linear bins 1=log bins (Kinetic engy) + infragm=0 !nuclear fragmentation + +c printout options + + if(iop.eq.0)iprmpt=-2 !prompt (>0) or not (<0) + ish=0 !1,2,3,4 ...: more and more detailed messages + irandm=0 !prints all random numbers (1) + irewch=0 !rewinds check file before each event (1) + if(iop.eq.0)iecho=1 !verify option for input reading + modsho=1 !message all modsho events + idensi=0 !must be 1 when subr xjden1 is used + ishevt=0 !minimum event number for certain print options + iwseed=1 !print out seed (1) or not + jwseed=1 !print out seed in see file (1) or not + +c fragmentation and decay parameters + + fkappa=0.0145 !String tension (GeV2) + fkappag=0.0145 !String tension (GeV2) for gluon string + fkainc=0.35 !factor for natural increase of string tension with energy +c energy dependence comes from fit of e+e->had mult in epos-fra +c this parameter is used to fix the increase of baryon and strangeness for Tevatron + fkamax=1.e30 !limit of effect in hadronic collision on fkappa + pud=0.433 !prob u d (from e+e- but used only in epos-dky/vedi) + pudd=0.88 !d suppression in diquark break (e+e- data) + puds=0.50 !s suppression in diquark break (important for Xi production in e+e- AND aXi in NA49) + pudc=0.33 !c suppression in diquark break (??? no data) + pmqu=0.003 !mass quark u for string fragm + pmqd=0.004 !mass quark d for string fragm + pmqs=0.077 !mass quark s for string fragm + pmqc=0.14 !mass quark c for string fragm (real mass 1.15<m<1.35) + pmqq=0.1185 !mass diquark for string fragm (fix number of baryons) + strcut=1. !cut factor for diffractive string fragmentation (1=no suppresion) + diqcut=0.5 !baryon cut factor for diffractive string fragmentation (needed for pi+p->p/ap data (pz/E > diqcut : no diquark for first node) + pdiqua= 0.1 !qq-qqbar probability in epos-dro/vedi (decazys only) + ptfra= 0.35 !string break pt + ptfraqq=0.35 !string end break pt + ptfrasr=0. !string break pt increase for strangeness (disable in epos-fra) + pbreak=-0.33 !break-parameter (~0.4 to match NA49 data and pi0 spectra for CR) +c if -1<pb<0, take pb for soft and e+e- parameterization for hard strings + pbreakg=0. !minimum pbreak at high energy in e+e- parameterization + zetacut=0. !g->ggq2 cut for special hadronization + +c fragmentation and decay options + + ndecay=0 !ndecay suppresses certain resonance decays + !0000001: all resonance decays suppressed + !0000010: k_short/long (+-20) decays suppressed + !0000100: lambda (+-2130) decays suppressed + !0001000: sigma (+-1130,+-2230) decays suppressed + !0010000: cascade (+-2330,+-1330) decays suppressed + !0100000: omega (+-3331) decays suppressed + !1000000: pi0 (110) decays suppressed + !also several "1"s may be used with obvious meaning + maxres=99999 !maximum resonance spin + aouni=0. !technical parameter for development + +c lepton-nucleon and e+e- options + + iolept=1 !q2-x ditribution calculated (1) or taken from table (<0) + ydmin=0 ! range of y + ydmax=0 + qdmin=0 ! range of q**2 + qdmax=0 + themin=0 !minimum scattering angle + themax=0 !maximum scattering angle + elomin=0 !minimum energy of outgoing lepton + elepti=0 !incoming lepton energy + elepto=0 !outgoing lepton energy + angmue=3.9645/360.*2*3.14159 !mue angle + icinpu=0 + itflav=0 ! initial flavor for e+e- + idisco=0 !deep inelastic contributions + !0=all, 1=direct-light, 2=direct-charm, 3=resolved + +c hadron-hadron options +++ + + isetcs=3 !option to obtain pomeron parameters + ! 0.....determine parameters but do not use Kfit + ! 1.....determine parameters and use Kfit + ! else..get from table + ! should be sufficiently detailed + ! say iclegy1=1,iclegy2=99 + ! table is always done, more or less detailed!!! + !and option to use cross ection tables + ! 2....tabulation of formula + ! 3....tabulation of simulations + ! else...not + iclegy1=1 !energy class lower limit ( 1 minimal 1 realistic ) + iclegy2=99 !energy class upper limit ( 1 option 99 use of table ) + isigma=0 !option for xsection printing (always calculated now) + ! 0=no, 1=yes : calculation (not good for ionudi=2) + ! 2=AA pseudo simulations + +c hadron-hadron options + + idprojin=1120 !projectile particle id + idtargin=1120 !target particle id + idproj=1120 !projectile particle id + idtarg=1120 !target particle id + iregge=0 !consider reggeons (1=yes 0=no) + isopom=1 !consider soft pomerons (1=yes 0=no) + ishpom=1 !consider semihard pomerons (1=yes 0=no) + iscreen=1 !consider screening corrections (1=yes 0=no) + isplit=1 !consider splitting corrections (1=yes 0=no) + irzptn=0 !recalculate Zptn (1=yes 0=no) ????????maybe obsolete?????????? + irmdrop=1 !consider droplet for remnants (1=yes 0=no) + nprmax=10000 !maximum number of pomerons/reggeons + iemspl=0 + intpol=3 !number of points for interpolation in psfli, psfaz + ioems=2 + iomega=1 !option for omega calculation (if 2, no diffraction in G) + !hadron excitation classes (used in psvin) + icdp=2 !projectile hadron excitation + icdt=2 !target hadron excitation + !hadron classes: 1=pions,2=nucleons,3=kaons + iclpro1=1 !projectile hadron class lower limit + iclpro2=3 !projectile hadron class upper limit + icltar1=2 !target hadron class lower limit (should not be change (see epos-sem)) + icltar2=2 !target hadron class upper limit (should not be change (see epos-sem)) + egylow=1.5 !lower limit of lowest energy bin + delh=0.25 !effective overcriticity for the hard pom (techn param) + factgam=1 !enhancement factor for gammas + +c hadron-hadron parameters +++ + + alpfomi= 0. !normalization of function fom for Phi^n (z0=alpfomi) + betfom= 5.d0 !slope of function fom for Phi^n + gamfom= 3.5d0 !Z slope of function fom for Phi^n + betpom= 0.25 !gluon structure function parameter for the so + glusea= 0.1 !sea quarks / (sea quarks + gluons) at x -> 0 + r2had(2)= 1.2 !r2 proton + r2hads(2)= 1.25 !diff corr factor proton + slopom= 0.06 !alpha prime pomeron + slopoms= 0.2 !alpha prime pomeron dif + gamhad(2)= 1. !gamma proton increase-> sig up, n up, softPom up + gamhadsi(2)=-1. !correction factor to gamma soft proton (<0 = 1 = same as gamhad) + gamtil= 0.08 !increase -> sig up, n up, hard Pom up + alppar= 0.55 !alpha particip (not 1 !) increase -> sig up, n down, width y down + alppom= 1.075 !alpha pomeron + ptsend= 1. !string end pt + ptsendi= 0.3 !string end pt for non excited state and diquark + ptsems= 0.2 !mass of string end (minimum pt) + ptsecu= 1. !cut factor for gaussian distribution + ptdiff= 0.32 !pt for diffraction + q2min= 4.0 !q**2 cutoff + q2ini= 0.25 !resolution scale + q2fin= 0.02 !q**2 cutoff timelike decrease -> high pt down + amdrmax= 30. !maximum mass leading droplet (<50 for stability) + amdrmin= 10. !minimum mass leading droplet + facdif= 0.4 !factor for diffractive profile + facmc= 1.05 !correction factor to match MC simulations (should be 1.) + reminv= 0.17 !remnant inversion probability (inversion important for forward pi(0) spectra : consequences on Xmax) + edmaxi= 1.e12 !defines edmax in epos-sem + epmaxi= 1.e12 !defines epmax in epos-sem + +c hadron-hadron parameters + + qcdlam=.04 !lambda_qcd squared + naflav=3 !number of active flavors (hard string) + nrflav=3 !number of active flavors in remnant and string fragm + !nrflav is defined later as max(nrflav,naflav) + factk=2. !k-factor value + alfe=1./137. + pt2cut=0. !p_t-cutoff for the born process + rstrau(1)=1. !pion !effective ratio of u sea over u sea basis + rstrad(1)=1. !effective ratio of d sea over u sea basis + rstras(1)=0.2 !effective ratio of s sea over u sea basis (kaons in pipp250) + rstrac(1)=1. !effective ratio of c sea over u sea basis + rstrau(2)=1. !nucl !effective ratio of u sea over u sea basis + rstrad(2)=1. !effective ratio of d sea over u sea basis + rstras(2)=0.7 !effective ratio of s sea over u sea basis + rstrac(2)=1. !effective ratio of c sea over u sea basis + rstrau(3)=1. !kaon !effective ratio of u sea over u sea basis + rstrad(3)=1. !effective ratio of d sea over u sea basis + rstras(3)=0.2 !effective ratio of s sea over u sea basis (kaons in kpp250) + rstrac(3)=1. !effective ratio of c sea over u sea basis + rstrau(4)=1. !j/psi!effective ratio of u sea over u sea basis + rstrad(4)=1. !effective ratio of d sea over u sea basis + rstras(4)=0.8 !effective ratio of s sea over u sea basis + rstrac(4)=0.2 !effective ratio of c sea over u sea basis + rstrasi=0.0 !effective ratio of strange sea over u sea increase +c wgtqqq (<1) define the probability that the diquark is a taken +c (or introduced in a meson) directly from the remnant +c it is for stopping not for baryon prod (put baryon in the center but do +c not change very large x of mesons). Value fixed with forward baryon +c in pion interactions. Active only with iremn>1 + wgtqqq(1)=0.22 !weight for val diq (as soft string ends for one pomeron) for pion + wgtqqq(2)=0.22 !weight for val diq for nucleon + wgtqqq(3)=0.22 !weight for val diq for kaon + wgtqqq(4)=0.22 !weight weight for val diq for J/Psi +c within 1-wgtqqq not to take a diquark, wgtdiq (<1) is +c the absolut probability to create a diquark as string end + wgtdiq=0.15 !weight for seadiq - antidiq as soft string end +c in the 1-wgtqqq-wgtdiq probabilty not to have a q-aq string ends, +c wgtval is the probability to take the valence quark in soft interactions +c wgtsea is the probability to take a q-aq pair from the sea, +c if no valence quarks are available, then we use sea quarks +c these values can be arbitrary choosen since wgtval/wgtsea is used + wgtval=0.15 !weight for valq - antiq as soft string ends + wgtsea=0.85 !weight for seaq - antiq as soft string ends + exmass=0.02 !excitation mass for remnant + r3pom=0.01 !triple pomeron coupling (not used) + r3pomi=r3pom !store + r4pom=0.001 !4-pomeron coupling + r4pomi=r4pom !store + wexcit=0. !excitation in fremnu (for DIS) + wproj=0. !not used + wtarg=0. !not used +c soft/hard selection like without screening to get shape of pt +c distribution in pp right and energy density in auau +c gfactor < 0 means that the hard contribution is increased % soft +c when Z increase : doesn't seem to be supported by HERA-B data + gfactor=1000. !exp(-gfactor*Z) in front of eps in om5jk (to choose soft or hard) + gwidth=0.62 !diff relative b-width +! gamhad(1) defined in psaini +! gamhad(3) defined in psaini + gamhadsi(1)=0.55 !correction factor to gamma soft pion + gamhadsi(3)=0.47 !correction factor to gamma soft kaon + gamhadsi(4)=-1. !correction factor to gamma soft charm + r2had(1)=1.5 !r2 pion + r2had(3)=0.8 !r2 kaon + r2had(4)=0. !r2 charm + r2hads(1)=1.1 !diff corr factor pion + r2hads(3)=1.1 !diff corr factor kaon + r2hads(4)=1.25 !diff corr factor kaon + chad(1)=1. !c pion + chad(2)=1. !c proton + chad(3)=1. !c kaon + chad(4)=1. !c charm + wdiff(1)=0.5 !diffractive probability + wdiff(2)=0.7 !diffractive probability + wdiff(3)=0.53 !diffractive probability + wdiff(4)=0.1 !diffractive probability + alplea(1)=0.7 !alpha leading pion + alplea(2)=1. !alpha leading proton + alplea(3)=0.7 !alpha leading kaon + alplea(4)=1. !alpha leading jpsi + rexndf=-1. !relative value of rexndi compare to rexdif if >0 +c following parameters recalculated in xsigma ... + rexdifi(1)=-0.8 !remnant excitation probability diffractive pion + rexdifi(2)=-0.725!remnant excitation probability diffractive proton + rexdifi(3)=-0.8 !remnant excitation probability diffractive kaon + rexdifi(4)=1. !remnant excitation probability diffractive charmed + rexpdif(1)=0. !remnant pion exchange probability diffractive pion + rexpdif(2)=0.26 !remnant pion exchange probability diffractive proton + rexpdif(3)=0. !remnant pion exchange probability diffractive kaon + rexpdif(4)=0. !remnant pion exchange probability diffractive charmed + rexndii(1)=0.4 !remnant excitation probability nondiffractive pion + rexndii(2)=0.55 !remnant excitation probability nondiffractive proton + rexndii(3)=0.6 !remnant excitation probability nondiffractive kaon + rexndii(4)=1. !remnant excitation probability nondiffractive charmed +c ... up to here. + xmxrem=20. !maximum momentum fraction allowed to be given for remnant mass determination (very important for multiplicity and xf distri at low energy) + xmindiff=1.35 !factor for minimum energy of pion exchange in prorem (change multiplicity and xf distribution of protons and neutrons) + xminremn=1.25 !factor for minimum energy in prorem (change multiplicity of all remnants) + rexres(1)=0.175 !pion remnant excitation probability in nucleus + rexres(2)=0.1 !nucleon remnant excitation probability in nucleus + rexres(3)=0.5 !kaon remnant excitation probability in nucleus + rexres(4)=1. !charm remnant excitation probability in nucleus + alpdif=0.45 !alpha mass diffractive for cross section and metropolis + alpdi=0.45 !alpha mass diffractive + alpndi=1.6 !alpha mass nondiffractive + alpsea=0.3 !alpha string end x for sea parton + alpval=0.3 !alpha string end x for valence parton + alpdiq=0.3 !alpha string end x for sea diquark + ammsqq=0.28 !minimum mass string quark quark + ammsqd=1.08 !minimum mass string quark diquark + ammsdd=1.88 !minimum mass string diquark diquark + delrex=0.5 !excitation mass to be added to the minimal remnant mass when remnant is not connected to string (nuclear splitting) + cumpom=ammsqq !cutoff mass for virtual pomerons (minimum= 2 pion mass) + alpdro(1)=2. !factor for minimum mass of leading droplet (not less than 1.5 for kinematic reasons) + alpdro(2)=0.3 !pt of leading droplet + alpdro(3)=1.6 !alpha mass of leading droplet (iept=3) + + iodiba=0. ! if iodiba=1, study H-Dibaryon (not used (see ProRef in epos-ems ????) + bidiba=0.030 ! epsilon of H-Dibaryon + +c screening splitting +++ + +c Note : cross section/saturation value, change inelasticity and not only cross section + epscrw=0.1 !overall factor for Z (Zsame,Zother)-> pp xsect .... w_Z + epscrp=3. !b width param for Z -> pp xsection ............ w_B + egyscr=3. !screening minimum energy -> pp xsection ........... s_M + epscrd=0.1 !screening power for diffractive part + epscrs=0.1 !screening power increase soft -> pp xsctn ........ alp_S + epscrh=2.5 !screening power increase hard -> pp xsctn ........ alp_H + epscrx=0.42 !screening power maxi -> pp xsctn + +c nuclear part of Z + znurho=1.65 !increase of Z due to nuclear effect -> pA xsctn (low E) + zbrads=0.7 !factor for saturated radius of nucleon in nuclei for shadowing (nuclear saturation -> decrease pA xs) + zbcut=0.7 !minimum diameter for shadowing (increase pA xs) + zbrmax=0. !maximum b limit for nuclear splitting pairs (fix indirectly Zmax for nuclear collision (number of pair which can be connected to the main pair) + +c Z dependent parameters + zrminc=0.75 !increase probability for remnant excitation in nuclei (without connexion) + ptvpom=0.30 !pt of virtual Pomerons (for getdropx) + zodinc=0. !# pom dependence for increase of pt + zipinc= 1.33 !inner pt modif factor increase + zopinc= 0. !soft/hard modif factor increase + zoeinc= 3. !cutoff timelike evol modif factor increase + zdfinc=15. !z factor for a diffractive pomeron + zdrinc= 0. !increase of droplet minimum mass (iremn>=2) + zmsinc= 0.15 !increase of remant minimum mass and decrease alpha (increase remnant mass with iept=3) + xzcut=3. !factor for minimum x for a Pomeron to be used for nuclear splitting + +c Reggeon parameters (not used) + + alpreg=0.734 !alpha_reggeon + sloreg=0.499 !slope_reggeon + gamreg=16.46 !gamma_reggeon + r2reg=0.613 !r^2_reggeon + +c masses + + amhadr(1)=.14 !pion mass + amhadr(2)=.939 !nucleon mass + amhadr(3)=.496 !kaon mass + amhadr(4)=1.868 !d-meson mass + amhadr(6)=1.116 !lambda mass + amhadr(5)=2.27 !lambda_c mass + amhadr(7)=.548 !eta mass + amhadr(8)=3.5 !J/psi mass +c qcmass=1.6 !c-quark mass (in idmass = 1.2 ) +c amhdibar=2.200 !h-dibaryon mass !not used any more + qmass(0)=pmqq !diquark effective bounding energy (for pt distribtions) + isospin(0)=0 + call idmass(1,qumass) + qmass(1)=qumass !u quark effective mass (for pt distribtions) + isospin(1)=1 + call idmass(2,qdmass) + qmass(2)=qdmass !d quark effective mass (for pt distribtions) + isospin(2)=-1 + call idmass(3,qsmass) + qmass(3)=qsmass !s quark effective mass (for pt distribtions) + isospin(3)=0 + call idmass(4,qcmass) + qmass(4)=qcmass !c quark effective mass (for pt distribtions) + isospin(4)=0 + call idmass(5,qbmass) + qmass(5)=qbmass !b quark effective mass (for pt distribtions) + isospin(5)=0 + call idmass(6,qtmass) + qmass(6)=qtmass !t quark effective mass (for pt distribtions) + isospin(6)=0 + +c nucleus-nucleus + + iokoll=0 !fix # of collisions (1) + laproj=0 !projectile charge number + maproj=0 !projectile mass number + latarg=0 !target charge number + matarg=0 !target mass number + core=0.34 !hard core distance(2*0.17) +c ncolmx=100000 !maximum number of collisions + fctrmx=10 !parameter determining range for density distribution + bmaxim=10000 !maximum impact parameter + bminim=0. !minimum impact parameter + phimax=2*3.1415927 !maximum phi + phimin=0 !minimum phi + iLHC=0 !LHC tune on(1)/off(0) + ionudi=3 !nuclear diffraction included (>0) or not (0) + ! = 0 for RHIC nuclear data based on glauber + ! (no event with 0 collision "a la Glauber") + ! = 1 for cosmic ray simulations (diffraction without + ! excitation counted as inelastic + ! to be consistent with sigma_ine used for CR) + ! = 2 for fixed target accelerator data cross section + ! (diffractive without projectile excitation = elastic) + ! = 3 real inelastic (no trigger effect) + ! (diffractive without excitation = elastic (but not for LHC because a Pomeron is present)) + +c rescattering parameters +++ + + iorsce=0 !color exchange turned on(1) or off(0) + iorsdf=3 !droplet formation turned on(>0) or off(0) + iorshh=0 !other hadron-hadron int. turned on(1) or off(0) + iocluin=1 !include inwards moving corona segments into clusters (1) or not (0) + ioquen=0 !jet quenching option (0=no) + iohole=0 !hole filling option (0=no) + fploss=0. !parton energy loss (effective) + fplmin=0. !minimum pl for rescaled particles after flow + fvisco=-50. !viscosity (effective) + taumin=1.0 !min tau for rescattering + taurea=1.0 !reaction time (=formation time) + nsegsu=30 !number of segments per subcluster + nsegce=4 !number of segments per cell + kigrid=1 !long grid number increase factor + fsgrid=1.0 !sgrid factor + ptclu=3 !obove this: string segments escape cluster + amimfs=1.0 !below this: elastic + amimel=0.050 !below this: nothing + delamf=1 !above this: color exch !cutoffs for kinetic energy + deuamf=1 !above this: nothing !mass - minimum mass of pair + epscri(1)=0.15!energy density for hnbaaa + epscri(3)= -1 !read in from table + +c rescattering parameters + + amsiac=.8 !interaction mass + amprif=0 !print option + delvol=1 !print option + deleps=1 !print option + deltau=0.2 !initial delta_tau for space-time evolution + factau=1.05 !factor for delta_tau for space-time evolution + numtau=80 !number of tau steps for space-time evolution + dlzeta=0.5 !delta_zeta for longitudinal droplet binning + etafac=1.0 !factor determining inner range + facnuc=0.0 !factor for nuclear size to determine inner range + hacore=0.8 !hadron compressibility factor + cepara=0.03 !parameter for excitation for color exchange + dscale=1. !scale parameter for hadron-hadron + iceopt=1 !real color exchange (1) or just excitation (0) + +c coupling with urqmd + + iurqmd=0 ! call eposurqmd (1) or not + +c initial conditions for hydro + + ispherio=0 !call spherio + cutico=3 !cutoff parameter for smoothing kernel in epos-ico + ! (as small as possible with stable results) + dssico=0.2 !s step size for string integration in epos-ico + ! (as big as possible with stable results) + icocore=0 !consider core initial condition (1 or 2) + icotabm=0 !make table for initial condition stuff + icotabr=0 !read table for initial condition stuff + +c cluster decay + + ioclude=3 !cluster decay option + amuseg=4.0 !min mass for radial boost (limit=amuseg+yrmax(E)) + yradmx= 0.5 !max radial collective boost + yradmi= 0.12 !max radial collective boost increase + yradpp=1. !max radial collective boost + yradpi=0. !max radial collective boost increase + yradpx=0. !not used + facecc=0.45 !eccentricity parameter + ylongmx=-1. !max long collective boost ( < 0 -> take from jintpo ) + rcoll=0.0 !radial collective flow param + bag4rt=0.200 !bag constant ^1/4 + taunll=1.0 !decay time (comoving frame) + vrad=0.3 + facts=0.3 !gamma-s factor + factb=1 !gamma-s factor baryons + factq=1 !gamma-qqbar + +c droplet decay initializations + + asuhax(1)=1.134 !two lowest multiplets + asuhax(2)=1.301 !two lowest multiplets + asuhax(3)=1.461 !two lowest multiplets + asuhax(4)=1.673 !two lowest multiplets + asuhax(5)=0.7700 !two lowest multiplets rho + asuhax(6)=0.8920 !two lowest multiplets K* + asuhax(7)=1.2320 !two lowest multiplets + asuhay(1)=0.940 !lowest multiplet + asuhay(2)=1.200 !lowest multiplet + asuhay(3)=1.322 !lowest multiplet + asuhay(4)=1.673 !lowest multiplet + asuhay(5)=0.1400 !lowest multiplet + asuhay(6)=0.4977 !lowest multiplet + asuhay(7)=1.2320 !lowest multiplet + +c droplet specification + + keu=0 !u flavour of droplet + ked=0 !d flavour of droplet + kes=0 !s flavour of droplet + kec=0 !c flavour of droplet + keb=0 !b flavour of droplet + ket=0 !t flavour of droplet + tecm=10 !energy of droplet + volu=70 !volume of droplet + +c metropolis and grand canonical + + iospec=10 !option for particle species + iocova=1 !covariant (1) or noncovariant (2) phase space integral + iopair=2 !single pair (1) or double pair (2) method + iozero=65 !relative weight of zeros (compared to hadrons) + ! (-1) nspecs + ! (-2) nspecs/sqrt(tecm/volu) + ioflac=1 !test multipl distr without (1) or with (2) flavour conserv + ! (2 only good for nspecs=3,7) + iostat=1 !use boltzmann (1) or quantum (0) statistics in hgc-routines + ioinco=1 !call hnbmin for initial configuration (0) + !call hgcnbi for initial configuration to generate better + !initial configuration (1) + !call hgcnbi for initial configuration to generate optimal + !initial configuration (2) + iograc=1 !call hgcaaa in case of ioinco=0 (1) + epsgc=2. !required accuracy in hgcaaa 10**(-epsgc) + iocite=0 !perform counting at metropolis iterations (1) or not (else) + ioceau=0 !perform counting for exp. autocorrel. time (1) or not (else) + iociau=0 !perform counting for int. autocorrel. time (1) or not (else) + ioinct=0 !test grand canonical metropolis sampling (1) + !to plot results call xhgccc, xhgcfl and xhgcam + ioinfl=1 !conserve flavor in initial configuration in hgcnbi (1) + !do not conserve flavor (0) + !do not conserve flavor and energy (-1) + iowidn=2 !width of total multiplicity distribution in hgcnbi + ! sigma_tot -> sigma_tot/iowidn + ! >0 unnormalized + ! <0 normalized + ionlat=2 !determine nlattc ,old method (0) + !or determine nlattc in hgcnbi as: + ! (1) max(1.3*<N>,<N>+2*sigma,6) + ! (2) max(1.5*<N>,<N>+3*sigma,6) + ! (3) max(2.0*<N>,<N>+4*sigma,6) + iomom=1 !number of momenta to be changed in hnbodz + ioobsv=0 !observable for autocorrelation time calculation + !0: total multiplicity + !else: particle id for particle species + iosngl=0 !event # for which counting at metropolis iterations is done + iorejz=0 !reject pair exchange with only zeros (1) or not (else) + iompar=4 !parameter for windowing algorithm + iozinc=0 !if iozevt>0: modifies iozero for testing (in sr hgcnbi) + iozevt=0 !if >0: modifies iozero for testing (in sr hgcnbi) + nadd=0 !number of pi0s added to minimum initial configuration + iterma=-6 !>0: maximum number of iterations + !<0: - number of iterations per corr time + iterpr=10000 !iter-increment for printout + iterpl=1 !iter-increment for plot + iternc=50 !iterations not counted for analysis + epsr=1e-4 !required accuracy in sr hnbraw + keepr=1 !keep most random numbers rnoz in hnbodz (1) + ! or update all (0) + +c strangelets + + iopenu=1 !option for minimum energy + !1: sum of hadron masses + !2: bag model curve with minimum at nonzero strangen + themas=.51225 !parameter theta in berger/jaffe mass formula + +c tests + + iotst1=0 !test + iotst2=0 !test + iotst3=0 !test + iotst4=0 !test + +c jpsi + + jpsi=0 !jpsi to be produced (1) or not (0) + jpsifi=0 !jpsi final state interaction (1) or not (0) + sigj=0.2 !jpsi nucleon cross section [fm**2] + taumx=20 !max time for jpsi evolution + nsttau=100 !time steps for jpsi evolution + ijphis=0 !fill jpsi histograms (1) or not (0) + +c analysis: intermittency, space-time, droplets, formation time + + ymximi=2 !upper limit for rapidity interval for intermittency analysis + imihis=0 !fill intermittency histograms (1) or not (0) + isphis=0 !fill space-time histograms (1) or not (0) + iologb=0 !0=linear bins 1=log bins + ispall=1 !xspace: all ptls (1) or only interacting ptls (else) + wtmini=-3 !tmin in xspace + wtstep=1 !t-step in xspace + iwcent=0 !only central point (1) or longitudinal distr (else) in xspace + iclhis=0 !fill droplet histograms (1) or not (0) + iwtime=0 !fill formation time histogram (1) or not (else) + wtimet=100 !max time in wtime + wtimei=0 !max mass in wtime + wtimea=1000 !max mass in wtime + + +c storing + maxrec(1)=7 + irecty(1,1)=1 + irecty(2,1)=2 + irecty(3,1)=3 + irecty(4,1)=4 + irecty(5,1)=5 + irecty(6,1)=6 + irecty(7,1)=7 + maxrec(2)=14 + irecty(1,2)=1 + irecty(2,2)=2 + irecty(3,2)=3 + irecty(4,2)=4 + irecty(5,2)=5 + irecty(6,2)=6 + irecty(7,2)=7 + irecty(8,2)=8 + irecty(9,2)=9 + irecty(10,2)=10 + irecty(11,2)=11 + irecty(12,2)=12 + irecty(13,2)=13 + irecty(14,2)=14 + + +c other + + gaumx=8 !range for gauss distribution + nclean=1 !clean /cptl/ if nclean > 0 + !(not for part with istptl<istmax if nclean=1 (do not change analysis) + ! for all part with ist.ne.0 if nclean > 1 (particle nb reduce at max)) + istore=0 !0: no storage to data-file + !-1: epos full info (fixed format) + !1: epos standard + !2: OSC1997A standart + !3: OSC1999A standart + !4: Les Houches Event Format (LHEF) standart + !5: calls routine ustore (modifiable by the user) + ioidch=1 !id choice for storage to data-file + iframe=0 !frame specification production run + jframe=0 !frame specification analysis + kframe=0 !frame specification analysis (2nd frame) + ! 1:total + !11:nucleon-nucleon + !12:target + !21:gamma-nucleon + !22:lab + !32:sphericity + !33:thrust + irescl=1 !momentum rescaling (1) or not (0) + ifrade=1 !suppression of fragmentation and decay (0) + idecay=1 !suppression of decay (0) + jdecay=1 !suppression of cluster decay (0), concerns only ity=60 cluster + iremn=2 !suppression of multiquark remnant (0) (string end with same flavor) -> reduce remnant excitation and suppress droplet prod. in remnant + !or full multiquark remnant (no limitations) (1) + !or multiquark remnant with valence quark conservation and inelastic remnant as low mass droplet only (2) + !or suppression of multiquark remnant with different string end flavors (3) + ntrymx=10 !try-again parameter + istmax=1 !analyse only istptl <= istmax + irdmpr=0 !random sign for projectile if 1 + ilprtg=1 !consider leading particle in projectile (1) + !or target (-1) side + +c constants + + pi=3.1415927 + pii=1./(2*pi**2) + hquer=0.197327 + prom=.94 + piom=.14 + ainfin=1e31 + +c air + + airanxs(1)=14.007 + airznxs(1)=7. + airwnxs(1)=0.781 + airanxs(2)=15.999 + airznxs(2)=8. + airwnxs(2)=.21 + airanxs(3)=39.948 + airznxs(3)=18. + airwnxs(3)=0.009 + airavanxs=airanxs(1)*airwnxs(1)+airanxs(2)*airwnxs(2) + & +airanxs(3)*airwnxs(3) + airavznxs=airznxs(1)*airwnxs(1)+airznxs(2)*airwnxs(2) + & +airznxs(3)*airwnxs(3) + +c zero initializations + + ixgeometry=0 + ixbDens=0 + ixtau=0 + iEmsB=0 + iEmsBg=0 + iEmsPm=0 + iEmsPx=0 + iEmsSe=0 + iEmsDr=0 + iEmsRx=0 + iEmsI2=0 + iEmsI1=0 + iSpaceTime=0 + nemsi=0 + facmss=1. + nstmax=0 + do 6 i=1,99 + prob(i)=0 + do 6 j=1,2 + icbac(i,j)=0 +6 icfor(i,j)=0 + imsg=0 + do j=1,mxjerr + jerr(j)=0 + enddo + ntevt=0 + nrevt=0 + naevt=0 + nrstr=0 + nrptl=0 + nptlu=0 + do itau=1,mxtau + volsum(itau)=0 + vo2sum(itau)=0 + nclsum(itau)=0 + do ivol=1,mxvol + do ieps=1,mxeps + clust(itau,ivol,ieps)=0 + enddo + enddo + enddo + iutotc=0 + iutote=0 + nopen=0 + nopenr=0 + knxopen=0 + kchopen=0 + khiopen=0 + kdtopen=0 + klgopen=0 + ifdat=0 + ifncs=0 + xpar1=0. + xpar2=0. + xpar3=0. + xpar4=0. + xpar5=0. + xpar6=0. + xpar7=0. + xpar8=0. + if(iop.eq.0)khisto=0 + nrclu=0 + nrnody=0 + do n=1,mxnody + nody(n)=0 + enddo + nrpri=0 + ctaumin=-1. + do n=1,mxpri + subpri(n)=' ' + ishpri(n)=0 + enddo + nctcor=0 + ncttim=0 + do n=1,matau + tauv(n)=0 + enddo + ncnt=0 + nrnucl(1)=0 + nrnucl(2)=0 + do i=1,mxnucl + rnucl(i,1)=0 + rnucl(i,2)=0 + rnuclo(i,1)=0 + rnuclo(i,2)=0 + bnucl(i,1)=0 + bnucl(i,2)=0 + bnucl(i,3)=0 + bnucl(i,4)=0 + enddo + xbtot(1)=0. + xbtot(2)=0. + inicnt=0 + accept=0. + reject=0. + do n=1,matau + tauv(n)=0. + enddo + anquasiel=0. + nglacc=0 + ifset=1 + + 1002 continue ! ----> entry iop=2 <---- + + +c analysis + + xvaria='numptl' + yvaria='ycmptl' + normal=11 + xminim=-100 + xmaxim=100 + nrbins=100 + hisfac=1 + do nr=1,mxbins + do l=1,5 + ar(nr,l)=0 + enddo + enddo + nozero=0 + ibmin=1 + ibmax=1e8 + + return + end + +c----------------------------------------------------------------------- + subroutine LHCparameters +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incpar' + include 'epos.incsem' + + iLHC=1 + + + infragm=2 !nuclear fragmentation + +c cross section based parameters + + epscrw=0.3 !overall factor for Z (Zsame,Zother)-> pp xsect .... w_Z + epscrp=1.25 !b width param for Z -> pp xsection ............ w_B + egyscr=3. !screening minimum energy -> pp xsection ........... s_M + epscrd=0.21 !screening power for diffractive part + epscrs=0. !screening power increase soft -> pp xsctn ........ alp_S + epscrh=2.2 !screening power increase hard -> pp xsctn ........ alp_H + epscrx=0.4 !screening power maxi -> pp xsctn + znurho=2.5 !increase of Z due to nuclear effect -> pA xsctn (low E) + zbrads=0.6 !factor for saturated radius of nucleon in nuclei for shadowing (nuclear saturation -> decrease pA xs) + zbcut=0.6 !minimum diameter for shadowing (increase pA xs) + +c slope and diffraction + + r2had(1)=1. !r2 pion + r2had(2)=0.85 !r2 proton + r2had(3)=0.7 !r2 kaon + r2had(4)=0. !r2 charm + r2hads(1)=1. !diff corr factor pion + r2hads(2)=1. !diff corr factor proton + r2hads(3)=1. !diff corr factor kaon + r2hads(4)=1. !diff corr factor charm + wdiff(1)=0.7 !diffractive probability + wdiff(2)=0.875 !diffractive probability + wdiff(3)=0.65 !diffractive probability + wdiff(4)=0.1 !diffractive probability + facdif=0.7 !factor for diffractive profile + slopom=0.18 !alpha prime pomeron + slopoms=0.26 !alpha prime pomeron dif + gwidth=1.4 !diff relative b-width + +c remnant excitation + + rexpdif(2)=0.28 !remnant pion exchange probability diffractive proton + rexdifi(2)=-0.65 !remnant excitation probability diffractive proton + rexndii(1)=0.65 !remnant excitation probability nondiffractive pion + rexndii(2)=0.65 !remnant excitation probability nondiffractive proton + rexndii(3)=0.65 !remnant excitation probability nondiffractive kaon + rexres(1)=0. !pion remnant excitation probability in nucleus + rexres(2)=0. !nucleon remnant excitation probability in nucleus + rexres(3)=0.15 !kaon remnant excitation probability in nucleus + alpdif=0.7 !alpha mass diffractive for cross section and metropolis + alpdi=1.05 !alpha mass diffractive + alpndi=2. !1.65 !alpha mass nondiffractive + alpdro(3)=2.5 !alpha mass of leading droplet (iept=3) + alpdro(2)=1.5 !alpha mass of leading droplet (iept=3) + zmsinc= 0. !increase of remant minimum mass and decrease alpha (increase remnant mass with iept=3) + zrminc= 0. !increase probability for remnant excitation in nuclei (without connexion) + +c string fragmentation + + pbreak=-0.4 !break-parameter (~0.4 to match NA49 data and pi0 spectra for CR) + pbreakg=0.15 !minimum pbreak at high energy in e+e- parameterization + zetacut=1.5 !g->ggq2 cut for special hadronization + fkappa=0.014 !String tension (GeV2) for quark string + fkappag=0.014 !String tension (GeV2) for gluon string + ptfraqq=0. !pt for rotation of string in remnant + ptsend=1. !string end pt + ptsems=0.2 + pmqq=0.107 !mass diquark for string fragm (fix number of baryons) + qmass(0)=0. !diquark effective bounding energy (for pt distribtions) + pmqs=0.074 !mass quark s for string fragm + rstras(1)=0.5 !effective ratio of s sea over u sea basis (kaons in pipp250) + rstras(2)=0.5 !effective ratio of s sea over u sea basis (lambdas in pp158) + rstras(3)=0.5 !effective ratio of s sea over u sea basis (kaons in kpp250) + wgtdiq=0.25 !weight for seadiq - antidiq as string end + wgtqqq(1)=0. !weight for val diq (as soft string ends for one pomeron) for pion + wgtqqq(2)=0. !weight for val diq for nucleon + wgtqqq(3)=0. !weight for val diq for kaon + wgtqqq(4)=0. !weight weight for val diq for J/Psi + fkainc=0. !factor for natural increase of string tension with energy +c energy dependence comes from fit of e+e->had mult in epos-fra +c this parameter is used to fix the increase of baryon and strangeness for Tevatron + fkamax=10000. !limit of effect in hadronic collision on fkappa + zopinc= 0.007 !soft/hard modif factor increase + zipinc= 1.35 !inner pt modif factor increase + zodinc= 0. !#of pom dependence + xzcut=3.35 !factor for minimum x for a Pomeron to be used for nuclear splitting + zoeinc= 0. !cutoff timelike evol modif factor increase + reminv=0.05 !remnant inversion probability (inversion important for forward pi(0) spectra : consequences on Xmax) + +c radial flow (new) + yradpx=0.55 !increase factor of low mass flow (conserv. mult.) + yradpp=4. !mass dependence of low mass flow (attenuation for heavy part) + +c radial flow (old) + yradmx= 0.04 !increase factor of high mass flow (decrease. mult.) + yradpi= 10.7 !minimum for rad flow (min=yradpi*yradmx) + +c long flow + ylongmx=-0.106 !long collective boost ( < 0 -> factor for mass dependence) + yradmi= 9.2 !minimum for long flow (min=yradmi*ylongmx) + + ptclu=1. !maximum pt of particles going into cluster (this change <pt> because the maximum flow will depend on ptclu**yradpp and multiplicity because less particles are inculded in clusters (can be compensated by fploss) + ioquen=1 !jet quenching option (0=no) + iohole=0 !hole filling option (0=no) + fploss=1.75 !parton energy loss (effective) + fvisco=1.3 !factor to correct # of segment in high density pair vs all + fplmin=-2.5 !fix the eta shape at high pt + amuseg=3. !min mass for radial boost + facecc=0.5 !max eccentricity parameter + nsegce=7 !number of segments per cell + + facts=0.35 !strangeness suppression in droplet + factb=0.35 !baryon increase in droplet + + + end + +c----------------------------------------------------------------------- + subroutine estore +c----------------------------------------------------------------------- +c writes the results of a simulation into the file with unit ifdt +c contains a description of the stored variables. +c modifiable by the user +c----------------------------------------------------------------------- + include 'epos.inc' + +c count the number of particles to be stored (--> nptevt) + + nptevt=0 + do i=1,nptl + if(istptl(i).le.istmax)nptevt=nptevt+1 + enddo + + + write(ifdt,*)nptevt,bimevt,phievt,kolevt,pmxevt,egyevt + * ,npjevt,ntgevt,qsqevt,typevt + do n=1,nptl + + if(istptl(n).le.istmax)then !store events with istptl < istmax + + write(ifdt,*)n,idptl(n),pptl(1,n),pptl(2,n),pptl(3,n),pptl(4,n) + * ,pptl(5,n),iorptl(n),jorptl(n),istptl(n),ityptl(n) + * ,xorptl(1,n),xorptl(2,n),xorptl(3,n),xorptl(4,n) + * ,ifrptl(1,n),ifrptl(2,n),dezptl(n) + + endif + + enddo + write(ifdt,'(A)') ' ' !to finish the file + + return + end + +c----------------------------------------------------------------------- + subroutine hepmcstore +c----------------------------------------------------------------------- +c writes the results of a simulation into the file with unit ifdt +c contains a description of the stored variables. +c----------------------------------------------------------------------- + include 'epos.inc' + double precision phep2,vhep2 + integer nhep2,isthep2,idhep2,jmohep2,jdahep2 + + dimension isthep2(nmxhep),idhep2(nmxhep),jmohep2(2,nmxhep) + &,jdahep2(2,nmxhep),phep2(5,nmxhep),vhep2(4,nmxhep) + integer iepo2hep(mxptl),ihep2epo(nmxhep),ihep2epo2(nmxhep) + + logical lrcore,lrcor0,lclean + +c count the number of particles to be stored + + do i=1,nptl + iepo2hep(i)=0 !initialize epos index to hep index + enddo + do j=1,nmxhep + ihep2epo(j)=0 !initialize hep index to epos index + ihep2epo2(j)=0 !initialize 2nd hep index to epos index + enddo + +c store event variables in HEP common : + + +c information available : +c nrevt.......... event number + nevhep=nrevt +c nptevt ........ number of (stored!) particles per event +c bimevt ........ absolute value of impact parameter +c phievt ........ angle of impact parameter +c kolevt ........ number of collisions +c pmxevt ........ reference momentum +c egyevt ........ pp cm energy (hadron) or string energy (lepton) +c npjevt ........ number of primary projectile participants +c ntgevt ........ number of primary target participants +c npnevt ........ number of primary projectile neutron spectators +c nppevt ........ number of primary projectile proton spectators +c ntnevt ........ number of primary target neutron spectators +c ntpevt ........ number of primary target proton spectators +c jpnevt ........ number of absolute projectile neutron spectators +c jppevt ........ number of absolute projectile proton spectators +c jtnevt ........ number of absolute target neutron spectators +c jtpevt ........ number of absolute target proton spectators + + if(istmax.gt.0.and.ioclude.ne.0)then + istmaxhep=2 + else + istmaxhep=min(istmax,1) + endif + + nhep2=0 + ipro=0 + itar=0 + do i=1,nptl + + if(istptl(i).le.istmaxhep.or.i.le.maproj+matarg)then !store events with istptl < istmax + + +c store particle variables: + +c i ............. particle number + io=iorptl(i) + lclean=.false. + if(istptl(i).le.1.and.io.eq.0.and.i.gt.maproj+matarg)then + lclean=.true. !happens only after cleaning + io=i + endif + iadd=1 + jm1io=0 + jm2io=0 + jd1io=0 + jd2io=0 + jm1hep=0 + jm2hep=0 + jd1hep=0 + jd2hep=0 + idio=0 + if(io.gt.0)then + if(istptl(io).le.1.and.i.gt.maproj+matarg.and..not.lclean)then!mother is normal particle (incl. spectators and fragments) + iadd=1 + jm1hep=iepo2hep(io) + if(jorptl(i).gt.0)jm2hep=iepo2hep(jorptl(i)) + elseif(istmaxhep.gt.0.and.(iorptl(io).gt.0.or.lclean))then +c create special father/mother to have the complete chain from beam to final particle + if(lclean)then + istptlio=99 !if cleaning defined: use all remnants + iorptlio=io + else + do while(iorptl(iorptl(io)).gt.0) + io=iorptl(io) + enddo + istptlio=istptl(io) + iorptlio=iorptl(io) + endif + if(istptlio.eq.41)then !remnant + if(istptl(i).eq.2.and.jdahep2(2,iorptl(io)).eq.0)then !beam remnant used in core + ifrptl(1,iorptl(io))=io !no to be used again as core mother + jmohep2(2,iorptl(io))=1 +c print *,'rcore',i,iorptl(io) + elseif(istptl(i).le.1)then + iadd=2 + idio=93 + jm1io=iorptl(io) + jd1io=nhep2+2 + jm1hep=nhep2+1 + jmohep2(2,jm1io)=-1 + jdahep2(2,jm1io)=i +c print *,'remn',i,iorptl(io) + endif + elseif(istptl(i).le.1.and.istptlio.eq.31)then !string + iadd=2 + idio=92 + if(pptl(3,i).ge.0.)then + jm1io=iorptl(io) + else + jm1io=jorptl(io) + endif + jd1io=nhep2+2 + jm1hep=nhep2+1 + jdahep2(2,jm1io)=i + jmohep2(2,jm1io)=-1 +c print *,'string',i,iorptl(io) + elseif(istptl(i).le.1.and.istptlio.eq.11)then !core + iadd=2 + idio=91 + jm1io=1 + dddmn=1e33 + if(jorptl(iorptlio).eq.0)then + jm1io=1 + dddmn=1e33 + do k=1,maproj !look for closest projectile nucleon + ddd=1e34 + if(iorptl(k).lt.0.and.ifrptl(1,k).eq.0) + & ddd=(xorptl(1,k)-xorptl(1,io))**2 + & +(xorptl(2,k)-xorptl(2,io))**2 + if(ddd.lt.dddmn)then + jm1io=k + dddmn=ddd + endif + enddo + jm2io=1 + dddmn=1e33 + do k=maproj+1,maproj+matarg !look for closest target nucleon + ddd=1e34 + if(iorptl(k).lt.0.and.ifrptl(1,k).eq.0) + & ddd=(xorptl(1,k)-xorptl(1,io))**2 + & +(xorptl(2,k)-xorptl(2,io))**2 + if(ddd.lt.dddmn)then + jm2io=k + dddmn=ddd + endif + enddo + iorptl(io)=jm1io + jorptl(io)=jm2io + jorptl(iorptl(io))=io + jm1io=0 + jm2io=0 + endif + if(pptl(3,i).ge.0.)then + jm1io=iorptl(io) + else + jm1io=jorptl(io) + endif + + jd1io=nhep2+2 + jm1hep=nhep2+1 + jdahep2(2,jm1io)=i + jmohep2(2,jm1io)=-1 +c print *,'core',i,iorptl(io) + elseif(istptl(i).le.1.and.istptlio.eq.51)then !nuclear fragment + idio=90 + if(jorptl(io).gt.0)then + iadd=2 + jm1io=iorptl(io) +c jm2io=jorptl(io) + jm1hep=nhep2+1 + jorptl(io)=0 + else + iadd=1 + jm1hep=iepo2hep(io) + endif + elseif(istptlio.eq.99)then !particle after cleaning + iadd=2 + idio=91 + if(pptl(3,i).ge.0.)then + ipro=ipro+1 + if(ipro.gt.maproj)ipro=1 + jm1io=ipro + else + itar=itar+1 + if(itar.gt.matarg)itar=1 + jm1io=maproj+itar + endif + + jd1io=nhep2+2 + jm1hep=nhep2+1 + jdahep2(2,jm1io)=i + jmohep2(2,jm1io)=-1 +c print *,'clean',i,iorptl(io),pptl(3,i),jm1io + endif + endif + else + jm1hep=-1 + jm2hep=-1 + jd1hep=ifrptl(1,i) + jd2hep=ifrptl(2,i) + endif + + if(istptl(i).gt.1)goto 100 !skip non final particles (allowed before to define correctly some spectators going to core) + + idpdg=idtrafo('nxs','pdg',idptl(i)) + if(idpdg.eq.99)then + print *,'Skip particle',i,idptl(i) + goto 100 + endif + + if(nhep2+iadd.gt.nmxhep)then + print *,'Warning : produced number of particles is too high' + print *,' Particle list is truncated, skip event !' + goto 10000 + endif + do j=1,iadd + nhep2=nhep2+1 + if(j.eq.1.and.iadd.eq.2)then + ii=io + ix=jm1io !for position we use father position + id=idio + jm1=iepo2hep(jm1io) + jm2=0 + if(jm2io.gt.0)jm2=iepo2hep(jm2io) + jd1=jd1io + jd2=jd2io + if(id.eq.90)ihep2epo2(nhep2)=ii + else + ii=i + ix=i + id=idpdg + jm1=jm1hep + jm2=jm2hep + jd1=jd1hep + jd2=jd2hep + if(ii.gt.maproj+matarg.or.jd1.gt.0)ihep2epo2(nhep2)=ii + endif + iepo2hep(ii)=nhep2 +c idptl(i) ...... particle id + idhep2(nhep2)=id +c pptl(1,i) ..... x-component of particle momentum (GeV/c) + phep2(1,nhep2)=dble(pptl(1,ii)) +c pptl(2,i) ..... y-component of particle momentum (GeV/c) + phep2(2,nhep2)=dble(pptl(2,ii)) +c pptl(3,i) ..... z-component of particle momentum (GeV/c) + phep2(3,nhep2)=dble(pptl(3,ii)) +c pptl(4,i) ..... particle energy (GeV) + phep2(4,nhep2)=dble(pptl(4,ii)) +c pptl(5,i) ..... particle mass (GeV/c2) + phep2(5,nhep2)=dble(pptl(5,ii)) +c istptl(i) ..... generation flag: last gen. (0) or not (1) + isthep2(nhep2)=min(2,istptl(ii)+1) !in hep:1=final, 2=decayed + if(i.le.maproj+matarg)isthep2(nhep2)=4 !beam particles +c ityptl(i) ..... particle type (string, remnant ...) +c xorptl(1,i) ... x-component of formation point (fm) + vhep2(1,nhep2)=xorptl(1,ix)*1e-12 !conversion to mm +c xorptl(2,i) ... y-component of formation point (fm) + vhep2(2,nhep2)=xorptl(2,ix)*1e-12 !conversion to mm +c xorptl(3,i) ... z-component of formation point (fm) + vhep2(3,nhep2)=xorptl(3,ix)*1e-12 !conversion to mm +c xorptl(4,i) ... formation time (fm/c) + vhep2(4,nhep2)=xorptl(4,ix)*1E-12 !conversion to mm/c +c tivptl(1,i) ... formation time (always in the pp-cms!) +c tivptl(2,i) ... destruction time (always in the pp-cms!) +c ifrptl(1,i) ..... particle number of first daughter (no daughter=0) + jdahep2(1,nhep2)=jd1 !need a second loop to calculated proper indice +c ifrptl(2,i) ..... particle number of last daughter (no daughter=0) + jdahep2(2,nhep2)=jd2 !need a second loop to calculated proper indice +c iorptl(i) ..... particle number of father (if .le. 0 : no father) + jmohep2(1,nhep2)=jm1 +c jorptl(i) ..... particle number of mother (if .le. 0 : no mother) + jmohep2(2,nhep2)=jm2 + + enddo + + 100 continue + + endif + enddo + +c copy first list in final list to define daughters of beam particles + + nhep=0 + nhepio=0 + if(istmaxhep.ne.0)nhep=maproj+matarg + lrcor0=.true. !link spectator remnants to core only once + lrcore=.false. + +c start with beam particles (except spectators producing fragments) + + do j=1,maproj+matarg + + if(istmaxhep.eq.0)then + +c when no daughter/mother informations, simply copy beam particles + nhep=nhep+1 + nhepio=nhepio+1 + idhep(nhep)=idhep2(j) + phep(1,nhep)=phep2(1,j) + phep(2,nhep)=phep2(2,j) + phep(3,nhep)=phep2(3,j) + phep(4,nhep)=phep2(4,j) + phep(5,nhep)=phep2(5,j) + isthep(nhep)=4 + vhep(1,nhep)=vhep2(1,j) + vhep(2,nhep)=vhep2(2,j) + vhep(3,nhep)=vhep2(3,j) + vhep(4,nhep)=vhep2(4,j) + jmohep(1,nhep)=-1 + jmohep(2,nhep)=-1 + jdahep(1,nhep)=0 + jdahep(2,nhep)=0 + iepo2hep(j)=nhep + isthep2(j)=-isthep2(j) + ihep2epo2(j)=-nhep + + else + + nhep0=nhep + nhepi0=nhepio+1 + isthep(nhepi0)=0 + nio=0 + +c copy all daughters after the mother + do k=maproj+matarg+1,nhep2 + + if(jmohep2(1,k).eq.j.and.idhep2(k).ne.90)then + if(isthep(nhepi0).eq.0)then !first save mother beam particle + nhepio=nhepio+1 + idhep(nhepio)=idhep2(j) + phep(1,nhepio)=phep2(1,j) + phep(2,nhepio)=phep2(2,j) + phep(3,nhepio)=phep2(3,j) + phep(4,nhepio)=phep2(4,j) + phep(5,nhepio)=phep2(5,j) + isthep(nhepio)=4 + vhep(1,nhepio)=vhep2(1,j) + vhep(2,nhepio)=vhep2(2,j) + vhep(3,nhepio)=vhep2(3,j) + vhep(4,nhepio)=vhep2(4,j) + jmohep(1,nhepio)=-1 + jmohep(2,nhepio)=-1 + iepo2hep(j)=nhepio + isthep2(j)=-isthep2(j) + ihep2epo2(j)=-nhepio + lrcore=.false. !link spectator remnants to core only once + if(lrcor0)then + kk=k + do while (kk.le.nhep2.and..not.lrcore) + if(idhep2(kk).eq.91.and.jmohep2(1,kk).eq.j)lrcore=.true. + kk=kk+1 + enddo + endif + endif + if(lrcore)then !save other mothers for same core + lrcor0=.false. + do i=1,maproj+matarg + if(isthep2(i).gt.0.and.jmohep2(2,i).gt.0)then + nhepio=nhepio+1 + nio=nio+1 + idhep(nhepio)=idhep2(i) + phep(1,nhepio)=phep2(1,i) + phep(2,nhepio)=phep2(2,i) + phep(3,nhepio)=phep2(3,i) + phep(4,nhepio)=phep2(4,i) + phep(5,nhepio)=phep2(5,i) + isthep(nhepio)=4 + vhep(1,nhepio)=vhep2(1,i) + vhep(2,nhepio)=vhep2(2,i) + vhep(3,nhepio)=vhep2(3,i) + vhep(4,nhepio)=vhep2(4,i) + jmohep(1,nhepio)=-1 + jmohep(2,nhepio)=-1 + isthep2(i)=-isthep2(i) + iepo2hep(i)=nhepio + ihep2epo2(i)=-nhepio + endif + enddo + endif + nhep=nhep+1 + idhep(nhep)=idhep2(k) + phep(1,nhep)=phep2(1,k) + phep(2,nhep)=phep2(2,k) + phep(3,nhep)=phep2(3,k) + phep(4,nhep)=phep2(4,k) + phep(5,nhep)=phep2(5,k) + isthep(nhep)=isthep2(k) + vhep(1,nhep)=vhep2(1,k) + vhep(2,nhep)=vhep2(2,k) + vhep(3,nhep)=vhep2(3,k) + vhep(4,nhep)=vhep2(4,k) + jdahep(1,nhep)=0 + if(jdahep2(1,k).gt.0)jdahep(1,nhep)=-ihep2epo2(jdahep2(1,k)) + jdahep(2,nhep)=0 + if(jdahep2(2,k).gt.0)jdahep(2,nhep)=-ihep2epo2(jdahep2(2,k)) + jmohep(1,nhep)=nhepi0 + jmohep(2,nhep)=nhepi0+nio + isthep2(k)=-isthep2(k) + if(ihep2epo2(k).le.0)then + ihep2epo2(k)=-nhep + else !for nuclear fragments + ihep2epo(nhep)=ihep2epo2(k) + if(ihep2epo(nhep).gt.0)iepo2hep(ihep2epo(nhep))=nhep + endif + + endif + + enddo + + if(nhepio.ge.nhepi0)then + do i=nhepi0,nhepi0+nio + jdahep(1,i)=nhep0+1 + jdahep(2,i)=nhep + enddo + endif + + endif + + enddo + + +c copy all other particles (secondary particles and spectators) + + do k=maproj+matarg+1,nhep2 + + if(isthep2(k).gt.0)then + +c look for mother of fragments + nhep0=nhep+1 + nhepi0=nhepio+1 + if(jmohep2(1,k).gt.0.and.jmohep2(1,k).le.maproj+matarg)then +c copy all mothers before the daughter + do j=1,maproj+matarg + + if(isthep2(j).gt.0.and.jdahep2(1,j).eq.ihep2epo2(k))then + nhepio=nhepio+1 + idhep(nhepio)=idhep2(j) + phep(1,nhepio)=phep2(1,j) + phep(2,nhepio)=phep2(2,j) + phep(3,nhepio)=phep2(3,j) + phep(4,nhepio)=phep2(4,j) + phep(5,nhepio)=phep2(5,j) + isthep(nhepio)=4 + vhep(1,nhepio)=vhep2(1,j) + vhep(2,nhepio)=vhep2(2,j) + vhep(3,nhepio)=vhep2(3,j) + vhep(4,nhepio)=vhep2(4,j) + jmohep(1,nhepio)=-1 + jmohep(2,nhepio)=-1 + jdahep(1,nhepio)=0 + if(jdahep2(1,j).gt.0)jdahep(1,nhepio)=-jdahep2(1,j) + jdahep(2,nhepio)=0 + if(jdahep2(2,j).gt.0)jdahep(2,nhepio)=-jdahep2(2,j) + isthep2(j)=-isthep2(j) + iepo2hep(j)=nhepio + ihep2epo(nhepio)=j + endif + + enddo + + endif + + nhep=nhep+1 + idhep(nhep)=idhep2(k) + phep(1,nhep)=phep2(1,k) + phep(2,nhep)=phep2(2,k) + phep(3,nhep)=phep2(3,k) + phep(4,nhep)=phep2(4,k) + phep(5,nhep)=phep2(5,k) + isthep(nhep)=isthep2(k) + vhep(1,nhep)=vhep2(1,k) + vhep(2,nhep)=vhep2(2,k) + vhep(3,nhep)=vhep2(3,k) + vhep(4,nhep)=vhep2(4,k) + jdahep(1,nhep)=0 + if(jdahep2(1,k).gt.0)jdahep(1,nhep)=-ihep2epo2(jdahep2(1,k)) + jdahep(2,nhep)=0 + if(jdahep2(2,k).gt.0)jdahep(2,nhep)=-ihep2epo2(jdahep2(2,k)) + ihep2epo(nhep)=ihep2epo2(k) + if(ihep2epo(nhep).gt.0)iepo2hep(ihep2epo(nhep))=nhep + if(nhepio.lt.nhepi0)then + if(jmohep2(1,k).gt.0)then + if(ihep2epo2(jmohep2(1,k)).le.0)then + jmohep(1,nhep)=-ihep2epo2(jmohep2(1,k)) + else + jmohep(1,nhep)=iepo2hep(ihep2epo2(jmohep2(1,k))) + endif + else + jmohep(1,nhep)=0 + endif + if(jmohep2(2,k).gt.0)then + if(ihep2epo2(jmohep2(2,k)).le.0)then + jmohep(2,nhep)=-ihep2epo2(jmohep2(2,k)) + else + jmohep(2,nhep)=iepo2hep(ihep2epo2(jmohep2(2,k))) + endif + else + jmohep(2,nhep)=0 + endif + else !for nuclear fragments + jmohep(1,nhep)=nhepi0 + jmohep(2,nhep)=nhepio + endif + isthep2(k)=-isthep2(k) + + endif + + enddo + + if(nhep.ne.nhep2.or.nhepio.ne.maproj+matarg)then + print *,'Warning : number of particles changed after copy' + nrem1=0 + do k=1,nhep2 + if(isthep2(k).eq.-4)then + nrem1=nrem1+1 + endif + if(isthep2(k).gt.0) + & print *,' ',k,idhep2(k),jmohep2(1,k),isthep2(k) + + & ,'from',ihep2epo2(k) + enddo + print *,' ',nhep2,'->',nhep + nrem2=0 + do k=1,nhep + if(isthep(k).eq.4)then + nrem2=nrem2+1 + endif +c print *,' ',k,idhep(k),isthep(k),'from',ihep2epo(k) + enddo + print *,' Particle list not consistent, skip event !' + print *,' ',nrem1,'->',nrem2 + goto 10000 + endif + +c update daughter list with correct index + + do j=1,nhep + + i=ihep2epo(j) + + if(jdahep(1,j).lt.0)then + + jdahep(1,j)=iepo2hep(-jdahep(1,j)) + if(jdahep(2,j).lt.0)jdahep(2,j)=iepo2hep(-jdahep(2,j)) + + + elseif(i.gt.0.and.jdahep(1,j).eq.0)then + +c ifrptl(1,i) ..... particle number of first daughter (no daughter=0) + if(ifrptl(1,i).gt.0)then + jdahep(1,j)=iepo2hep(ifrptl(1,i)) + else + jdahep(1,j)=0 + endif + + if(jdahep(2,j).eq.0)then +c ifrptl(2,i) ..... particle number of last daughter (no daughter=0) + if(ifrptl(2,i).gt.0)then + jdahep(2,j)=iepo2hep(ifrptl(2,i)) + else + jdahep(2,j)=0 + endif + endif + + endif + +c write(ifdt,130)jmohep(1,j),jmohep(2,j),j,jdahep(1,j),jdahep(2,j) +c &,idhep(j),isthep(j),(phep(k,j),k=1,5),(vhep(k,j),k=1,4) +c 130 format (1x,i6,i6,3x,i6,3x,i6,i6,i12,i4,8x,5(e8.2,1x) +c *,4x,4(e8.2,1x)) + + enddo + + + 9999 return +10000 nhep=0 + goto 9999 + end + +c----------------------------------------------------------------------- + subroutine lhestore(n) +c----------------------------------------------------------------------- +c writes the results of a simulation into the file with unit ifdt +c contains a description of the stored variables. +c use Les Houches Event File as defined in hep-ph/0109068 for the +c common block and hep-ph/0609017 for the XML output. +c some code taken from example from Torbjrn Sjstrand +c in http://www.thep.lu.se/~torbjorn/lhef +c----------------------------------------------------------------------- + include 'epos.inc' + +C...User process event common block. + INTEGER MAXNUP + PARAMETER (MAXNUP=50000) !extend array for file production +c PARAMETER (MAXNUP=500) + INTEGER NUP,IDPRUP,IDUP,ISTUP,MOTHUP,ICOLUP + DOUBLE PRECISION XWGTUP,SCALUP,AQEDUP,AQCDUP,PUP,VTIMUP,SPINUP + COMMON/HEPEUP/NUP,IDPRUP,XWGTUP,SCALUP,AQEDUP,AQCDUP,IDUP(MAXNUP), + &ISTUP(MAXNUP),MOTHUP(2,MAXNUP),ICOLUP(2,MAXNUP),PUP(5,MAXNUP), + &VTIMUP(MAXNUP),SPINUP(MAXNUP) + SAVE /HEPEUP/ + + + integer iepo2hep(mxptl) + +c count the number of particles to be stored (--> nptevt) + + nhep=0 + do i=1,nptl + if(istptl(i).le.istmax.and.abs(idptl(i)).le.10000)nhep=nhep+1 + enddo + if(nhep.gt.MAXNUP)then + print *,'Warning : produced number of particles is too high' + print *,' event is not stored' + goto 1000 + endif + +C...set event info and get number of particles. + NUP=nhep !number of particles + IDPRUP=nint(abs(typevt)) !type of event (ND,DD,CD,SD) + XWGTUP=1d0 !weight of event + SCALUP=-1d0 !scale for PDF (not used) + AQEDUP=-1d0 !alpha QED (not relevant) + AQCDUP=-1d0 !alpha QCD (not relevant) + +C...Copy event lines, omitting trailing blanks. +C...Embed in <event> ... </event> block. + write(ifdt,'(A)') '<event>' + write(ifdt,*)NUP,IDPRUP,XWGTUP,SCALUP,AQEDUP,AQCDUP + nhep=0 + DO 220 i=1,nptl + + if(istptl(i).le.istmax.and.abs(idptl(i)).le.10000)then !store events with istptl < istmax + + nhep=nhep+1 +c i ............. particle number +c idptl(i) ...... particle id + idpdg=idtrafo('nxs','pdg',idptl(i)) + if(idpdg.eq.99)idpdg=0 !unknown particle + iepo2hep(i)=nhep +c store particle variables: + IDUP(nhep)=idpdg + if(iorptl(i).lt.0)then + ISTUP(nhep)=-9 !incoming particle + else + ISTUP(nhep)=min(3,istptl(i)+1) !in LHEF:1=final, 2=decayed, 3=intermediate state + endif + if(iorptl(i).gt.0)then + MOTHUP(1,nhep)=iepo2hep(iorptl(i)) + else + MOTHUP(1,nhep)=0 + endif +c jorptl(i) ..... particle number of mother (if .le. 0 : no mother) + if(jorptl(i).gt.0)then + MOTHUP(2,nhep)=iepo2hep(jorptl(i)) + else + MOTHUP(2,nhep)=-1 + endif + ICOLUP(1,nhep)=0 !color flow + ICOLUP(2,nhep)=0 !color flow + do J=1,5 !particle momentum (GeV/c) + PUP(J,nhep)=dble(pptl(J,i)) + enddo + VTIMUP(nhep)=(dble(tivptl(2,i))-dble(tivptl(1,i)))*1d-12 !life time c*tau in mm + if(VTIMUP(nhep).gt.dble(ainfin) + & .or.VTIMUP(nhep).ne.VTIMUP(nhep))then + write(ifch,*)'ici',VTIMUP(nhep),tivptl(2,i),tivptl(1,i) + & ,i,nptl + VTIMUP(nhep)=ainfin + call utstop("aie&") + endif + SPINUP(nhep)=9 !polarization (not known) + write(ifdt,*)IDUP(nhep),ISTUP(nhep), + & MOTHUP(1,nhep),MOTHUP(2,nhep),ICOLUP(1,nhep),ICOLUP(2,nhep), + & (PUP(J,nhep),J=1,5),VTIMUP(nhep),SPINUP(nhep) + endif + 220 CONTINUE + +c optional informations + write(ifdt,*)'#geometry',bimevt,phievt + + write(ifdt,'(A)') '</event>' + + if(n.eq.nevent)then +C...Successfully reached end of event loop: write closing tag + write(ifdt,'(A)') '</LesHouchesEvents>' + write(ifdt,'(A)') ' ' + endif + + 1000 continue + + return + end + + +c----------------------------------------------------------------------- + subroutine ustore +c----------------------------------------------------------------------- +c writes the results of a simulation into the common hepevt +c contains a description of the stored variables. +c modifiable by the user +c----------------------------------------------------------------------- + include 'epos.inc' + integer iepo2hep(mxptl) + + +c count the number of particles to be stored (--> nptevt) + + nptevt=0 + do i=1,nptl + iepo2hep(i)=-1 !initialize hep index to epos index + if(istptl(i).le.istmax)nptevt=nptevt+1 + enddo + +c store event variables in HEP common : + + +c information available : +c nrevt.......... event number + nevhep=nrevt +c nptevt ........ number of (stored!) particles per event +c bimevt ........ absolute value of impact parameter +c phievt ........ angle of impact parameter +c kolevt ........ number of collisions +c pmxevt ........ reference momentum +c egyevt ........ pp cm energy (hadron) or string energy (lepton) +c npjevt ........ number of primary projectile participants +c ntgevt ........ number of primary target participants +c npnevt ........ number of primary projectile neutron spectators +c nppevt ........ number of primary projectile proton spectators +c ntnevt ........ number of primary target neutron spectators +c ntpevt ........ number of primary target proton spectators +c jpnevt ........ number of absolute projectile neutron spectators +c jppevt ........ number of absolute projectile proton spectators +c jtnevt ........ number of absolute target neutron spectators +c jtpevt ........ number of absolute target proton spectators + + nhep=0 + do i=1,nptl + + if(istptl(i).le.istmax.or.i.le.maproj+matarg)then !store events with istptl < istmax + + nhep=nhep+1 + if(nhep.gt.nmxhep)then + print *,'Warning : produced number of particles is too high' + print *,' Particle list is truncated' + goto 1000 + endif + +c store particle variables: + +c i ............. particle number +c idptl(i) ...... particle id + idpdg=idtrafo('nxs','pdg',idptl(i)) + if(idpdg.ne.99)then + idhep(nhep)=idpdg + iepo2hep(i)=nhep + else + print *,'Skip particle',i,idptl(i) + nhep=nhep-1 + goto 100 + endif +c pptl(1,i) ..... x-component of particle momentum (GeV/c) + phep(1,nhep)=dble(pptl(1,i)) +c pptl(2,i) ..... y-component of particle momentum (GeV/c) + phep(2,nhep)=dble(pptl(2,i)) +c pptl(3,i) ..... z-component of particle momentum (GeV/c) + phep(3,nhep)=dble(pptl(3,i)) +c pptl(4,i) ..... particle energy (GeV) + phep(4,nhep)=dble(pptl(4,i)) +c pptl(5,i) ..... particle mass (GeV/c2) + phep(5,nhep)=dble(pptl(5,i)) +c iorptl(i) ..... particle number of father (if .le. 0 : no father) + if(iorptl(i).gt.0)then + jmohep(1,nhep)=iepo2hep(iorptl(i)) + else + jmohep(1,nhep)=-1 + endif +c jorptl(i) ..... particle number of mother (if .le. 0 : no mother) + if(jorptl(i).gt.0)then + jmohep(2,nhep)=iepo2hep(jorptl(i)) + else + jmohep(2,nhep)=-1 + endif +c ifrptl(1,i) ..... particle number of first daughter (no daughter=0) + jdahep(1,nhep)=0 !need a second loop to calculated proper indice +c ifrptl(2,i) ..... particle number of last daughter (no daughter=0) + jdahep(2,nhep)=0 !need a second loop to calculated proper indice +c istptl(i) ..... generation flag: last gen. (0) or not (1) + isthep(nhep)=min(2,istptl(i)+1) !in hep:1=final, 2=decayed + if(i.le.maproj+matarg)isthep(nhep)=4 !beam particles +c ityptl(i) ..... particle type (string, remnant ...) +c xorptl(1,i) ... x-component of formation point (fm) + vhep(1,nhep)=xorptl(1,i)*1e-12 !conversion to mm +c xorptl(2,i) ... y-component of formation point (fm) + vhep(2,nhep)=xorptl(2,i)*1e-12 !conversion to mm +c xorptl(3,i) ... z-component of formation point (fm) + vhep(3,nhep)=xorptl(3,i)*1e-12 !conversion to mm +c xorptl(4,i) ... formation time (fm/c) + vhep(4,nhep)=xorptl(4,i)*1E-12 !conversion to mm/c +c tivptl(1,i) ... formation time (always in the pp-cms!) +c tivptl(2,i) ... destruction time (always in the pp-cms!) + + 100 continue + + endif + enddo + + 1000 continue +c Second list to update daughter list (only if mothers are in list) + if(istmax.ge.1)then + nhep=0 + do i=1,nptl + + if(istptl(i).le.istmax)then !store events with istptl < istmax + + nhep=nhep+1 + if(nhep.gt.nmxhep)return + +c ifrptl(1,i) ..... particle number of first daughter (no daughter=0) + if(ifrptl(1,i).gt.0)then + jdahep(1,nhep)=iepo2hep(ifrptl(1,i)) + else + jdahep(1,nhep)=0 + endif +c ifrptl(2,i) ..... particle number of last daughter (no daughter=0) + if(ifrptl(2,i).gt.0)then + jdahep(2,nhep)=iepo2hep(ifrptl(2,i)) + else + jdahep(2,nhep)=0 + endif + + endif + enddo + endif + + + return + end + +c----------------------------------------------------------------------- + subroutine bstora +c----------------------------------------------------------------------- +c writes the results of a simulation into the file with unit ifdt +c contains a description of the stored variables. +c----------------------------------------------------------------------- + include 'epos.inc' +C...User process initialization commonblock. + INTEGER MAXPUP + PARAMETER (MAXPUP=100) + INTEGER IDBMUP,PDFGUP,PDFSUP,IDWTUP,NPRUP,LPRUP + DOUBLE PRECISION EBMUP,XSECUP,XERRUP,XMAXUP + COMMON/HEPRUP/IDBMUP(2),EBMUP(2),PDFGUP(2),PDFSUP(2), + &IDWTUP,NPRUP,XSECUP(MAXPUP),XERRUP(MAXPUP),XMAXUP(MAXPUP), + &LPRUP(MAXPUP) + SAVE /HEPRUP/ + common/photrans/phoele(4),ebeam + + common/record/maxrec(2),irecty(30,2) + character code*8,version*8,frame*4,ldum*888 + + code='EPOS ' + if(iLHC.eq.1)code= 'EPOSLHC ' + if(model.eq.2)code='QGSJET01' + if(model.eq.3)code='GHEISHA ' + if(model.eq.4)code='PYTHIA ' + if(model.eq.5)code='HIJING ' + if(model.eq.6)code='SIBYLL ' + if(model.eq.7.or.model.eq.11)code='QGSJETII' + if(model.eq.8)code='PHOJET ' + if(model.eq.9)code='FLUKA ' + write(version,'(f5.2,3x)')iversn/100. + + if(iframe.eq. 1)frame='ttcm' + if(iframe.eq.11)frame='nncm' + if(iframe.eq.12)frame='targ' + if(iframe.eq.21)frame='gncm' + if(iframe.eq.22)frame='lncm' + ntest=1 + if (istore.eq.2) then ! OSC1997A + if(iappl.eq.3)then + read(ifdt,'(A)')ldum + read(ifdt,'(A)')ldum + read(ifdt,'(A)')ldum + else + write (ifdt,'(a)') 'OSC1997A' + write (ifdt,'(a)') 'final_id_p_x' + write(ifdt,100) code,version + * ,maproj,laproj,matarg,latarg,frame,engy,ntest + 100 format(2(a8,' '),'(',i3,',',i3,')+(',i3,',',i3,')', + * ' ',a4,' ',e10.4,' ',i8) + maxrec(1)=4 + irecty(1,1)=1 !nevt + irecty(2,1)=2 + irecty(3,1)=3 + irecty(4,1)=4 + maxrec(2)=11 + irecty(1,2)=1 !nr + irecty(2,2)=2 !id + irecty(3,2)=3 !px + irecty(4,2)=4 !py + irecty(5,2)=5 !pz + irecty(6,2)=6 !E + irecty(7,2)=7 !M + irecty(8,2)=11 !x + irecty(9,2)=12 !y + irecty(10,2)=13 !z + irecty(11,2)=14 !t + endif + elseif(istore.eq.3) then + if(iappl.eq.3)then + read(ifdt,'(A)')ldum + read(ifdt,'(A)')ldum + read(ifdt,'(A)')ldum + read(ifdt,'(A)')ldum + else + 201 format('# ',a) + write (ifdt,201) 'OSC1999A' + if(istmax.eq.0) then + write (ifdt,201) 'final_id_p_x' + elseif(istmax.ge.2) then + write (ifdt,201) 'full_event_history' + endif + 202 format('# ',a8,' ',a8) + write(ifdt,202) code,version !3rd line + 203 format('# (',i3,',',i3,')+(',i3,',',i3,')', + * ' ',a4,' ',e10.4,' ',i8) + write(ifdt,203) maproj,laproj,matarg,latarg,frame,engy,ntest + endif + maxrec(1)=5 + irecty(1,1)=2 !nevt + irecty(2,1)=0 !zero + irecty(3,1)=1 !additional information + irecty(4,1)=3 !additional information + irecty(5,1)=4 !additional information + maxrec(2)=12 + irecty(1,2)=1 !nr + irecty(2,2)=2 !id + irecty(3,2)=10 !ist + irecty(4,2)=3 !px + irecty(5,2)=4 !py + irecty(6,2)=5 !pz + irecty(7,2)=6 !E + irecty(8,2)=7 !M + irecty(9,2)=11 !x + irecty(10,2)=12 !y + irecty(11,2)=13 !z + irecty(12,2)=14 !t + ! nin nout [optional information] + ! ipart id ist px py pz p0 mass x y z t [optional information] + elseif(istore.eq.4)then + +C rename .data file .lhe file + if(kdtopen.eq.1)close(ifdt) + kdtopen=1 + fndt(nfndt-4:nfndt)=".lhe " + nfndt=nfndt-1 + if(iappl.eq.3)then + open(unit=ifdt,file=fndt(1:nfndt),status='old') + else + open(unit=ifdt,file=fndt(1:nfndt),status='unknown') +C...Write header info. + write(ifdt,'(A)') '<LesHouchesEvents version="1.0">' + write(ifdt,'(A)') '<!--' + write(ifdt,'(A,A8,A,A8)') '# File generated with ',code,' ' + * ,version + write(ifdt,'(A,I9)')'# Total number of min. bias events : ' + * ,nevent + write(ifdt,'(A)') '# 4 types of subprocess are defined : ' + write(ifdt,'(A)') + * '# -> 1 : Non Diffractive events AB-->X' + write(ifdt,'(A)') + * '# -> 2 : Double Diffractive events AB-->XX' + write(ifdt,'(A)') + * '# -> 3 : Central Diffractive events AB-->AXB' + write(ifdt,'(A)') + * '# -> 4 : Single Diffractive events AB-->XB or AB-->AX' + write(ifdt,'(A)') + * '#geometry gives impact parameter (fm) and phi (rad) of events' + write(ifdt,'(A)') '-->' + +C...Set initialization info and get number of processes. + IDBMUP(1)=idtrafo('nxs','pdg',idproj) !projectile + IDBMUP(2)=idtrafo('nxs','pdg',idtarg) !target + if(noebin.lt.0)then + EBMUP(1)=dble(elepti) !energy beam proj + EBMUP(2)=dble(ebeam) !energy beam targ + PDFGUP(1)=-1d0 !PDFlib group code for proj PDF (lepton) + PDFGUP(2)=1d0 !PDFlib group code for targ PDF (user defined) + PDFSUP(1)=-1d0 !PDFlib set code for proj PDF (lepton) + PDFSUP(2)=1d0 !PDFlib set code for targ PDF (user defined) + else + EBMUP(1)=dble(0.5*engy) !energy beam proj + EBMUP(2)=dble(0.5*engy) !energy beam targ + if(iappl.eq.6)then + PDFGUP(1)=-1d0 !PDFlib group code for proj PDF (lepton) + PDFGUP(2)=-1d0 !PDFlib group code for targ PDF (lepton) + PDFSUP(1)=-1d0 !PDFlib set code for proj PDF (lepton) + PDFSUP(2)=-1d0 !PDFlib set code for targ PDF (lepton) + elseif(iappl.eq.7)then + PDFGUP(1)=-1d0 !PDFlib group code for proj PDF (lepton) + PDFGUP(2)=1d0 !PDFlib group code for targ PDF (user defined) + PDFSUP(1)=-1d0 !PDFlib set code for proj PDF (lepton) + PDFSUP(2)=1d0 !PDFlib set code for targ PDF (user defined) + else + PDFGUP(1)=1d0 !PDFlib group code for proj PDF (user defined) + PDFGUP(2)=1d0 !PDFlib group code for targ PDF (user defined) + PDFSUP(1)=1d0 !PDFlib set code for proj PDF (user defined) + PDFSUP(2)=1d0 !PDFlib set code for targ PDF (user defined) + endif + endif + IDWTUP=3 !weight=1 for all events + NPRUP=4 !number of subprocess (ND,DD,CD,SD) + IPR=1 !subprocesses (store non diffractive events) + XSECUP(IPR)=dble(sigcut)*1d9 !cross section in pb + XERRUP(IPR)=0d0 !statistical error + XMAXUP(IPR)=1d0 !weight + LPRUP(IPR)=1 !ND event (typevt=1) + IPR=2 !subprocesses (store double diffractive events) + XSECUP(IPR)=dble(sigdd)*1d9 !cross section in pb + XERRUP(IPR)=0d0 !statistical error + XMAXUP(IPR)=1d0 !weight + LPRUP(IPR)=2 !DD event (typevt=2) + IPR=3 !subprocesses (store single diffractive events) + XSECUP(IPR)=dble(sigdif-sigdd-sigsd)*1d9 !cross section in pb + XERRUP(IPR)=0d0 !statistical error + XMAXUP(IPR)=1d0 !weight + LPRUP(IPR)=3 !CD event (typevt=3) + IPR=4 !subprocesses (store single diffractive events) + XSECUP(IPR)=dble(sigsd)*1d9 !cross section in pb + XERRUP(IPR)=0d0 !statistical error + XMAXUP(IPR)=1d0 !weight + LPRUP(IPR)=4 !SD event (typevt=4) + +C...Copy initialization lines, omitting trailing blanks. +C...Embed in <init> ... </init> block. + write(ifdt,'(A)') '<init>' + write(ifdt,*) IDBMUP(1),IDBMUP(2),EBMUP(1),EBMUP(2) + & ,PDFGUP(1),PDFGUP(2),PDFSUP(1),PDFSUP(2),IDWTUP,NPRUP + DO 120 IPR=1,NPRUP + write(ifdt,*) XSECUP(IPR),XERRUP(IPR),XMAXUP(IPR),LPRUP(IPR) + 120 CONTINUE + write(ifdt,'(A)') '</init>' + endif + + endif + + end + +c----------------------------------------------------------------------- + subroutine bstore +c----------------------------------------------------------------------- +c writes the results of a simulation into the file with unit ifdt +c contains a description of the stored variables. +c----------------------------------------------------------------------- + + include 'epos.inc' + common/record/maxrec(2),irecty(30,2) + common/dimensi/k2(100) + + nptevt=0 + do n=1,nptl + iok=1 !idcode simple + if(istptl(n).gt.istmax + & .or.(ioidch.eq.2.and.idptl(n).gt.10000))then + iok=0 + endif + if (iok.eq.1) nptevt=nptevt+1 + enddo + 11 format (i6,' ',$) + 12 format (e12.6,' ',$) + 13 format (f3.0,' ',$) + do i=1,maxrec(1) + l=irecty(i,1) + if(l.eq.0)write(ifdt,21) 0 + if(l.eq.1)write(ifdt,11)nrevt + if(l.eq.2)write(ifdt,11)nptevt + if(l.eq.3)write(ifdt,12)bimevt + if(l.eq.4)write(ifdt,12)phievt + if(l.eq.5)write(ifdt,11)kolevt + if(l.eq.6)write(ifdt,12)pmxevt + if(l.eq.7)write(ifdt,12)egyevt + if(l.eq.8)write(ifdt,11)npjevt + if(l.eq.9)write(ifdt,11)ntgevt + if(l.eq.10)write(ifdt,11)npnevt + if(l.eq.11)write(ifdt,11)nppevt + if(l.eq.12)write(ifdt,11)ntnevt + if(l.eq.13)write(ifdt,11)ntpevt + if(l.eq.14)write(ifdt,11)jpnevt + if(l.eq.15)write(ifdt,11)jppevt + if(l.eq.16)write(ifdt,11)jtnevt + if(l.eq.17)write(ifdt,11)jtpevt + if(l.eq.20)write(ifdt,12)amproj + if(l.eq.21)write(ifdt,12)amtarg + if(l.eq.22)write(ifdt,12)qsqevt + if(l.eq.23)write(ifdt,12)xbjevt + if(l.eq.24)write(ifdt,13)typevt + enddo + write (ifdt,*) !RETURN + 21 format (i6,' ',$) + 22 format (e12.6,' ',$) + 23 format (i10,' ',$) + do n=1,nptl + iok=1 !idcode simple + if(istptl(n).gt.istmax + & .or.(ioidch.eq.2.and.idptl(n).gt.10000))then + iok=0 + endif + if (iok.eq.1) then + id=idptl(n) + if(istore.eq.2.or.ioidch.eq.2)then + id=idtrafo('nxs','pdg',idptl(n)) + endif + do i=1,maxrec(2) + l=irecty(i,2) + if(l.eq.0)write(ifdt,21) 0 + if(l.eq.1)write(ifdt,21) n + if(l.eq.2)write(ifdt,23) id + if(l.eq.3.or.l.eq.17)write(ifdt,22) pptl(1,n) + if(l.eq.4.or.l.eq.17)write(ifdt,22) pptl(2,n) + if(l.eq.5.or.l.eq.17)write(ifdt,22) pptl(3,n) + if(l.eq.6.or.l.eq.17)write(ifdt,22) pptl(4,n) + if(l.eq.7.or.l.eq.17)write(ifdt,22) pptl(5,n) + if(l.eq.8)write(ifdt,21) iorptl(n) + if(l.eq.9)write(ifdt,21) jorptl(n) + if(l.eq.10)write(ifdt,21) istptl(n) + if(l.eq.11.or.l.eq.18)write(ifdt,22) xorptl(1,n) + if(l.eq.12.or.l.eq.18)write(ifdt,22) xorptl(2,n) + if(l.eq.13.or.l.eq.18)write(ifdt,22) xorptl(3,n) + if(l.eq.14.or.l.eq.18)write(ifdt,22) xorptl(4,n) + if(l.eq.19)write(ifdt,22) dezptl(n) + if(l.eq.21)write(ifdt,21) ifrptl(1,n) + if(l.eq.22)write(ifdt,21) ifrptl(2,n) + if(l.eq.23)write(ifdt,21) ityptl(n) + if(l.eq.15) then + if(iorptl(n).gt.0)then + write(ifdt,23) idptl(iorptl(n)) + else + write(ifdt,23) 0 + endif + endif + if(l.eq.16) then + if(jorptl(n).gt.0)then + write(ifdt,23) idptl(jorptl(n)) + else + write(ifdt,23) 0 + endif + endif + enddo + write (ifdt,*) !RETURN + endif + enddo + return + end + + +c----------------------------------------------------------------------- + subroutine bread +c----------------------------------------------------------------------- +c reads the results of a simulation into the file with unit ifdt +c contains a description of the stored variables. +c----------------------------------------------------------------------- + + include 'epos.inc' + common/record/maxrec(2),irecty(30,2) + character*255 line + dimension inptl(mxptl) + data ichkfile/0/ + save ichkfile + logical info +C...User process event common block. + INTEGER MAXNUP + PARAMETER (MAXNUP=50000) !extend array for file production +c PARAMETER (MAXNUP=500) + INTEGER NUP,IDPRUP,IDUP,ISTUP,MOTHUP,ICOLUP + DOUBLE PRECISION XWGTUP,SCALUP,AQEDUP,AQCDUP,PUP,VTIMUP,SPINUP + COMMON/HEPEUP/NUP,IDPRUP,XWGTUP,SCALUP,AQEDUP,AQCDUP,IDUP(MAXNUP), + &ISTUP(MAXNUP),MOTHUP(2,MAXNUP),ICOLUP(2,MAXNUP),PUP(5,MAXNUP), + &VTIMUP(MAXNUP),SPINUP(MAXNUP) + SAVE /HEPEUP/ + + if(istore.eq.-1.or.iappl.eq.-1)then + + ifinp=ifdt + if(ichkfile.eq.0)then + if(iappl.eq.-1)then + inquire(file=fnin(1:nfnin),exist=info) + if(info)then + open(unit=ifin,file=fnin(1:nfnin),status='old') + ifinp=ifin + else + call utstop('Cannot open file for conversion !&') + endif + endif + endif + + read(ifinp,*,end=999)nptevt,bimevt,phievt,kolevt,pmxevt,egyevt + * ,npjevt,ntgevt,qsqevt,typevt + if(nptevt.eq.0.or.nptevt.gt.mxptl)then + print *,'sorry, ' + print *,'there is wrong particle number in the event record ' + stop + endif + nptl=0 + do n=1,nptevt + nptl=nptl+1 + read(ifinp,*)nidp,id,pp1,pp2,pp3,pp4,pp5,io,jo,is,it + * ,xo1,xo2,xo3,xo4,ifr1,ifr2,dez +c keep the structure of the original event + do while(nptl.lt.nidp) + idptl(nptl)=0 + pptl(1,nptl)=0. + pptl(2,nptl)=0. + pptl(3,nptl)=0. + pptl(4,nptl)=0. + pptl(5,nptl)=0. + iorptl(nptl)=0 + jorptl(nptl)=0 + istptl(nptl)=5 + ityptl(nptl)=0 + xorptl(1,nptl)=0. + xorptl(2,nptl)=0. + xorptl(3,nptl)=0. + xorptl(4,nptl)=0. + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + dezptl(nptl)=0 + nptl=nptl+1 + enddo + idptl(nptl)=id + pptl(1,nptl)=pp1 + pptl(2,nptl)=pp2 + pptl(3,nptl)=pp3 + pptl(4,nptl)=pp4 + pptl(5,nptl)=pp5 + iorptl(nptl)=io + jorptl(nptl)=jo + istptl(nptl)=is + ityptl(nptl)=it + xorptl(1,nptl)=xo1 + xorptl(2,nptl)=xo2 + xorptl(3,nptl)=xo3 + xorptl(4,nptl)=xo4 + ifrptl(1,nptl)=ifr1 + ifrptl(2,nptl)=ifr2 + dezptl(nptl)=dez + enddo + + elseif(istore.eq.4)then + +c skip intro + 10 read(ifdt,'(a)',end=999)line + if(line(1:7).ne."<event>")goto 10 + +c write(ifdt,'(A)') '<event>' + read(ifdt,*)NUP,typevt,XWGTUP,SCALUP,AQEDUP,AQCDUP + nhep=0 + nptl=0 + DO 220 i=1,nup + + + nhep=nhep+1 + read(ifdt,*,end=999)IDUP(nhep),ISTUP(nhep), + & MOTHUP(1,nhep),MOTHUP(2,nhep),ICOLUP(1,nhep),ICOLUP(2,nhep), + & (PUP(J,nhep),J=1,5),VTIMUP(nhep),SPINUP(nhep) + + id=idtrafo('pdg','nxs',IDUP(nhep)) + if(id.eq.99)id=0 !unknown particle + nptl=nptl+1 + idptl(nptl)=id + if(ISTUP(nhep).eq.-9)then + istptl(nptl)=1 + iorptl(nptl)=-1 + jorptl(nptl)=0 + else + istptl(nptl)=ISTUP(nhep)-1 + iorptl(nptl)=MOTHUP(1,nhep) + jorptl(nptl)=max(0,MOTHUP(2,nhep)) + endif + do J=1,5 !particle momentum (GeV/c) + pptl(J,nptl)=sngl(PUP(J,nhep)) + enddo + + 220 CONTINUE + +c optional informations + read(ifdt,*,end=999)line,bimevt,phievt + + read(ifdt,*,end=999)line + +c read(ifdt,*,end=999)nptevt,bimevt,phievt,kolevt,pmxevt,egyevt +c * ,npjevt,ntgevt,qsqevt,typevt +c if(nptevt.eq.0.or.nptevt.gt.mxptl)then +c print *,'sorry, ' +c print *,'there is wrong particle number in the event record ' +c stop +c endif +c do n=1,nptevt +c read(ifdt,*)nidp,idptl(n),pptl(1,n),pptl(2,n),pptl(3,n),pptl(4,n) +c * ,pptl(5,n),iorptl(n),jorptl(n),istptl(n),ityptl(n) +c * ,xorptl(1,n),xorptl(2,n),xorptl(3,n),xorptl(4,n) +c inptl(nidp)=n +c if(iorptl(n).gt.0)iorptl(n)=inptl(iorptl(n)) +c if(jorptl(n).gt.0)jorptl(n)=inptl(jorptl(n)) +c enddo + + + elseif(istore.eq.5)then + + read(ifdt,*,end=999)nptevt,bimevt,phievt,kolevt,pmxevt,egyevt + * ,npjevt,ntgevt,qsqevt,typevt + if(nptevt.eq.0.or.nptevt.gt.mxptl)then + print *,'sorry, ' + print *,'there is wrong particle number in the event record ' + stop + endif + do n=1,nptevt + read(ifdt,*)nidp,idptl(n),pptl(1,n),pptl(2,n),pptl(3,n),pptl(4,n) + * ,pptl(5,n),iorptl(n),jorptl(n),istptl(n),ityptl(n) + * ,xorptl(1,n),xorptl(2,n),xorptl(3,n),xorptl(4,n) + inptl(nidp)=n + if(iorptl(n).gt.0)iorptl(n)=inptl(iorptl(n)) + if(jorptl(n).gt.0)jorptl(n)=inptl(jorptl(n)) + enddo + nptl=nptevt + + else + + info=.false. + do n=1,mxptl + inptl(n)=0 + enddo + + read(ifdt,'(a255)',end=1)line + 1 k=1 + nptevt=0 + do i=1,maxrec(1) + l=irecty(i,1) + if(l.eq.0)read(line(k:),'(i6)')ldummy !0 + if(l.eq.0) k=k+7 + if(l.eq.1)read(line(k:),'(i6)')ldummy !nrevt + if(l.eq.1) k=k+7 + if(l.eq.2)read(line(k:),'(i6)')nptevt + if(l.eq.2) k=k+7 + if(l.eq.3)read(line(k:),'(e12.6)')bimevt + if(l.eq.3) k=k+13 + if(l.eq.4)read(line(k:),'(e12.6)')phievt + if(l.eq.4) k=k+13 + if(l.eq.5)read(line(k:),'(i6)')kolevt + if(l.eq.5) k=k+7 + if(l.eq.6)read(line(k:),'(e12.6)')pmxevt + if(l.eq.6) k=k+13 + if(l.eq.7)read(line(k:),'(e12.6)')egyevt + if(l.eq.7) k=k+13 + if(l.eq.8)read(line(k:),'(i6)')npjevt + if(l.eq.8) k=k+7 + if(l.eq.9)read(line(k:),'(i6)')ntgevt + if(l.eq.9) k=k+7 + if(l.eq.10)read(line(k:),'(i6)')npnevt + if(l.eq.10) k=k+7 + if(l.eq.11)read(line(k:),'(i6)')nppevt + if(l.eq.11) k=k+7 + if(l.eq.12)read(line(k:),'(i6)')ntnevt + if(l.eq.12) k=k+7 + if(l.eq.13)read(line(k:),'(i6)')ntpevt + if(l.eq.13) k=k+7 + if(l.eq.14)read(line(k:),'(i6)')jpnevt + if(l.eq.14) k=k+7 + if(l.eq.15)read(line(k:),'(i6)')jppevt + if(l.eq.15) k=k+7 + if(l.eq.16)read(line(k:),'(i6)')jtnevt + if(l.eq.16) k=k+7 + if(l.eq.17)read(line(k:),'(i6)')jtpevt + if(l.eq.17) k=k+7 + if(l.eq.20)read(line(k:),'(e12.6)')amproj + if(l.eq.20) k=k+13 + if(l.eq.21)read(line(k:),'(e12.6)')amtarg + if(l.eq.21) k=k+13 + if(l.eq.22)read(line(k:),'(e12.6)')qsqevt + if(l.eq.22) k=k+13 + if(l.eq.23)read(line(k:),'(e12.6)')xbjevt + if(l.eq.23) k=k+13 + if(l.eq.24)read(line(k:),'(f3.0)')typevt + if(l.eq.24) k=k+4 + enddo + if(nptevt.eq.0)then + print *,'sorry, ' + print *,'there is no particle number in the event record ' + stop + endif + do n=1,nptevt + read(ifdt,'(a255)',end=2)line + 2 k=1 + do i=1,maxrec(2) + l=irecty(i,2) + if(l.eq.0)read(line(k:),'(i6)') ldummy + if(l.eq.0) k=k+7 + if(l.eq.1)then + read(line(k:),'(i6)') nidp + if(nidp.gt.0.and.nidp.le.mxptl)then + info=.true. + inptl(nidp)=n + endif + k=k+7 + endif + if(l.eq.2)read(line(k:),'(i10)') idptl(n) + if(l.eq.2) k=k+11 + if(l.eq.3.or.l.eq.17)read(line(k:),'(e12.6)') pptl(1,n) + if(l.eq.3.or.l.eq.17) k=k+13 + if(l.eq.4.or.l.eq.17)read(line(k:),'(e12.6)') pptl(2,n) + if(l.eq.4.or.l.eq.17) k=k+13 + if(l.eq.5.or.l.eq.17)read(line(k:),'(e12.6)') pptl(3,n) + if(l.eq.5.or.l.eq.17) k=k+13 + if(l.eq.6.or.l.eq.17)read(line(k:),'(e12.6)') pptl(4,n) + if(l.eq.6.or.l.eq.17) k=k+13 + if(l.eq.7.or.l.eq.17)read(line(k:),'(e12.6)') pptl(5,n) + if(l.eq.7.or.l.eq.17) k=k+13 + if(l.eq.8)then + read(line(k:),'(i6)') iorptl(n) + k=k+7 + if(info.and.iorptl(n).gt.0)iorptl(n)=inptl(iorptl(n)) + endif + if(l.eq.9)then + read(line(k:),'(i6)') jorptl(n) + k=k+7 + if(info.and.jorptl(n).gt.0)jorptl(n)=inptl(jorptl(n)) + endif + if(l.eq.10)read(line(k:),'(i6)') istptl(n) + if(l.eq.10) k=k+7 + if(l.eq.11.or.l.eq.18)read(line(k:),'(e12.6)')xorptl(1,n) + if(l.eq.11.or.l.eq.18) k=k+13 + if(l.eq.12.or.l.eq.18)read(line(k:),'(e12.6)')xorptl(2,n) + if(l.eq.12.or.l.eq.18) k=k+13 + if(l.eq.13.or.l.eq.18)read(line(k:),'(e12.6)')xorptl(3,n) + if(l.eq.13.or.l.eq.18) k=k+13 + if(l.eq.14.or.l.eq.18)read(line(k:),'(e12.6)')xorptl(4,n) + if(l.eq.14.or.l.eq.18) k=k+13 +c if(i.eq.15)read(line(k:),'(i6)') idiptl(n) + if(l.eq.15) k=k+7 +c if(i.eq.16)read(line(k:),'(i6)') idjptl(n) + if(l.eq.16) k=k+7 + if(l.eq.19)read(line(k:),'(e12.6)') dezptl(n) + if(l.eq.19) k=k+13 +c if(l.eq.21)read(line(k:),'(I6)') ifrptl(1,n) + if(l.eq.21) k=k+7 +c if(l.eq.22)read(line(k:),'(I6)') ifrptl(2,n) + if(l.eq.22) k=k+7 + if(l.eq.23)read(line(k:),'(I6)') ityptl(n) + if(l.eq.23) k=k+7 + enddo + enddo + + nptl=nptevt + + endif + + nevt=1 + 999 continue + end + +c----------------------------------------------------------------------- + subroutine aafinal +c----------------------------------------------------------------------- +c * calculates xorptl(j,i), representing formation points. +c (xorptl(j,i),j=1,4) is the 4-vector representing the space-time of +c creation of particle i. +c----------------------------------------------------------------------- + include 'epos.inc' + do i=1,nptl + if(idptl(i).ne.0.and.istptl(i).le.1)then + if( abs(tivptl(1,i)).le.ainfin + . .and.abs(xorptl(1,i)).le.ainfin + . .and.abs(xorptl(2,i)).le.ainfin + . .and.abs(xorptl(3,i)).le.ainfin + . .and.abs(xorptl(4,i)).le.ainfin + . .and.pptl(5,i).le.ainfin + . .and.pptl(4,i).gt.0.)then +c if(ish.ge.4)call alistc('afinal&',i,i) + t=tivptl(1,i) + xorptl(1,i)=xorptl(1,i)+pptl(1,i)/pptl(4,i)*(t-xorptl(4,i)) + xorptl(2,i)=xorptl(2,i)+pptl(2,i)/pptl(4,i)*(t-xorptl(4,i)) + xorptl(3,i)=xorptl(3,i)+pptl(3,i)/pptl(4,i)*(t-xorptl(4,i)) + xorptl(4,i)=t + else + if(ish.ge.1)then + if(iorptl(i).gt.0)idior=idptl(iorptl(i)) + write(ifmt,'(a)') + . '*** warning (afinal see check file): ' + write(ifch,'(a,i6,i10,i10,i3,1x,7(e7.1,1x))') + . '*** warning (afinal): ', + . i,idptl(i),idior,ityptl(i),tivptl(1,i), pptl(4,i) + . ,pptl(5,i),xorptl(1,i),xorptl(2,i),xorptl(3,i),xorptl(4,i) +c call alistc(' ici &',1,i) + endif + tivptl(1,i)=2*ainfin + tivptl(2,i)=2*ainfin + xorptl(1,i)=2*ainfin + xorptl(2,i)=2*ainfin + xorptl(3,i)=2*ainfin + xorptl(4,i)=2*ainfin + endif + endif + enddo + end + +c----------------------------------------------------------------------- + subroutine afinal +c----------------------------------------------------------------------- +c does some final calculations, to be called before call aasto. +c * calculates nptlu, the maximum nptl for all events. +c * in case of mod(iframe,10) .ne. 1, these vectors are transformed +c (being originally in the "natural frame", +c NB : boost of coordinates only if not a non-sense (otherwise put to inf) +c always boost of momentum if possible (if not STOP !) +c----------------------------------------------------------------------- + + include 'epos.inc' + common/geom/rmproj,rmtarg,bmax,bkmx + double precision pgampr,rgampr + common/cgampr/pgampr(5),rgampr(4) + + double precision pp1,pp2,pp3,pp4,pp5 + logical lclean + + call utpri('afinal',ish,ishini,4) + + lclean=.false. + nptlu=max0(nptl,nptlu) + + if(mod(iframe,10).ne.1)then + if(iframe.eq.12.or.iframe.eq.22)then !targ + pp1=0d0 + pp2=0d0 + pp3=dsinh(dble(yhaha)) + pp4=dcosh(dble(yhaha)) + pp5=1d0 + else + stop'transformation not yet defined' + endif + endif + + do i=1,nptl + if(idptl(i).ne.0.and.istptl(i).le.1)then + if(pptl(5,i).le.ainfin + . .and.pptl(4,i).gt.0.)then + + if( abs(tivptl(1,i)).le.ainfin + . .and.abs(xorptl(1,i)).le.ainfin + . .and.abs(xorptl(2,i)).le.ainfin + . .and.abs(xorptl(3,i)).le.ainfin + . .and.abs(xorptl(4,i)).le.ainfin)then + +c Space-time boost + if(mod(iframe,10).ne.1)then + + if(iframe.eq.12)then + call utlob4(-1,pp1,pp2,pp3,pp4,pp5 + . ,xorptl(1,i),xorptl(2,i),xorptl(3,i),xorptl(4,i)) + elseif(iframe.eq.22)then +c not the electron in lab frame in fake DIS + if(.not.((abs(iappl).eq.1.or.iappl.eq.3) + * .and.i.eq.2*(maproj+matarg)+1))then +c put particle from cms to target frame + call utlob4(-1,pp1,pp2,pp3,pp4,pp5 + . ,xorptl(1,i),xorptl(2,i),xorptl(3,i),xorptl(4,i)) +c do rotation of gamma in proton rest frame + call utrot4(-1,rgampr(1),rgampr(2),rgampr(3) + . ,xorptl(1,i),xorptl(2,i),xorptl(3,i)) +c boost in lab frame + call utlob4(-1,pgampr(1),pgampr(2),pgampr(3),pgampr(4) + . ,pgampr(5),xorptl(1,i),xorptl(2,i),xorptl(3,i),xorptl(4,i)) + endif + else + stop'transformation not yet defined' + endif + endif + else + tivptl(1,i)=ainfin + xorptl(1,i)=ainfin + xorptl(2,i)=ainfin + xorptl(3,i)=ainfin + xorptl(4,i)=ainfin + endif + +c Momentum boost + if(mod(iframe,10).ne.1)then + if(iframe.eq.12)then + call utlob5(-yhaha + . , pptl(1,i), pptl(2,i), pptl(3,i), pptl(4,i), pptl(5,i)) + elseif(iframe.eq.22)then +c not the electron in lab frame in fake DIS + if(.not.((abs(iappl).eq.1.or.iappl.eq.3) + * .and.i.eq.2*(maproj+matarg)+1))then +c put particle from cms to target frame + call utlob5(-yhaha + . , pptl(1,i), pptl(2,i), pptl(3,i), pptl(4,i), pptl(5,i)) +c do rotation of gamma in proton rest frame + call utrot4(-1,rgampr(1),rgampr(2),rgampr(3) + . , pptl(1,i), pptl(2,i), pptl(3,i)) +c boost in lab frame + call utlob4(-1,pgampr(1),pgampr(2),pgampr(3),pgampr(4) + . ,pgampr(5), pptl(1,i), pptl(2,i), pptl(3,i), pptl(4,i)) + endif + endif + endif + elseif(model.eq.6)then + lclean=.true. + istptl(i)=99 + else + call utstop("Negative energy in afinal&") + endif + endif + enddo + + if(lclean)then + nptl0=nptl + call utclea(maproj+matarg+1,nptl0) + endif + + if(ish.ge.2)then + if(model.eq.1)call alistf('EPOS&') + if(model.eq.2)call alistf('QGSJET01&') + if(model.eq.3)call alistf('GHEISHA&') + if(model.eq.4)call alistf('PYTHIA&') + if(model.eq.5)call alistf('HIJING&') + if(model.eq.6)call alistf('SIBYLL 2.1&') + if(model.eq.7.or.model.eq.11)call alistf('QGSJET II&') + if(model.eq.8)call alistf('PHOJET&') + if(model.eq.9)call alistf('FLUKA&') + if(model.eq.10)call alistf('URQMD&') + endif + +c if(isto.eq.1)stop +c$$$ call testconex(2) + + if(ntevt.gt.0)then + b1=bminim + b2=min(bmax,bmaxim) + a=pi*(b2**2-b1**2) + if(iappl.eq.3.or.iappl.eq.-1)then !read + ntevt=nint(float(nevent)/sigine*a*10.) + anintine=float(nevent) + anintdiff=anintine*sigdif/sigine + anintsdif=anintine*sigsd/sigine + endif + sigineex=anintine/float(ntevt)*a*10 + sigdifex=anintdiff/float(ntevt)*a*10 + sigsdex=anintsdif/float(ntevt)*a*10 + endif + + + if(imihis.eq.1)call wimi + if(imihis.eq.1.and.nrevt.eq.nevent)call wimino + if(isphis.eq.1)call xspace(1) + if(iclhis.eq.1)call wclu + if(iclhis.eq.1.and.nrevt.eq.nevent)call wclufi + if(iwtime.eq.1)call wtime(1) + if(iwtime.eq.1.and.nrevt.eq.nevent)call wtime(2) + + if(ish.ge.8)call alistc('afinal&',1,nptl) + + call utprix('afinal',ish,ishini,4) + return + end + +c----------------------------------------------------------------------- + subroutine bfinal +c----------------------------------------------------------------------- + include 'epos.inc' + if(jerr(1).gt.4.and.jerr(1).gt.0.01*nevent)then + write(ifch,'(3x,70a1)')('#',i=1,70) + write(ifch,*)' # number of events:',nevent + write(ifch,*)' # number of (flav > 9) warnings:',jerr(1) + write(ifch,*)' # (OK when happens rarely)' + write(ifch,'(3x,70a1)')('#',i=1,70) + endif + if(jerr(3).gt.4.and.jerr(3).gt.0.01*jerr(2))then + write(ifch,'(3x,70a1)')('#',i=1,70) + write(ifch,*)' # number of clusters:',jerr(2) + write(ifch,*)' # number of neg m^2 clusters:',jerr(3) + write(ifch,*)' # (OK when happens rarely)' + write(ifch,'(3x,70a1)')('#',i=1,70) + endif + if(jerr(5).gt.4.and.jerr(5).gt.0.01*jerr(4))then + write(ifch,'(3x,70a1)')('#',i=1,70) + write(ifch,*)' # number of successful remnant cluster' + & ,' decays:',jerr(4) + write(ifch,*)' # number of unsuccessful remnant cluster' + & ,' decays:',jerr(5) + write(ifch,*)' # (OK when happens rarely)' + write(ifch,'(3x,70a1)')('#',i=1,70) + endif + if(jerr(6).gt.4.and.jerr(6).gt.0.01*nevent)then + write(ifch,'(3x,70a1)')('#',i=1,70) + write(ifch,*)' # number of events:',nevent + write(ifch,*)' # number of low mass remnant clusters:' + & ,jerr(6) + write(ifch,*)' # (OK when happens rarely)' + write(ifch,'(3x,70a)')('#',i=1,70) + endif + if(jerr(7).gt.4.and.jerr(7).gt.0.01*nevent)then + write(ifch,'(3x,70a1)')('#',i=1,70) + write(ifch,*)' # number of events:',nevent + write(ifch,*)' # number of flav problem in SE:' + & ,jerr(7) + write(ifch,*)' # (OK when happens rarely)' + write(ifch,'(3x,70a)')('#',i=1,70) + endif + if(ish.ge.1.and.jerr(8).gt.4.and.jerr(8).gt.0.01*nevent)then + write(ifch,'(3x,70a1)')('#',i=1,70) + write(ifch,*)' # number of events:',nevent + write(ifch,*)' # number of events with all Pom lost:' + & ,jerr(8) + write(ifch,*)' # (OK when happens rarely)' + write(ifch,'(3x,70a)')('#',i=1,70) + endif + end + +c----------------------------------------------------------------------- + subroutine ainit +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + include 'epos.incpar' + common/cquama/quama + parameter (nptj=129) + common /cptj/xptj(nptj),qptj(nptj),wptj(nptj) + common/geom/rmproj,rmtarg,bmax,bkmx + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat!,seedp + common/cttaus/tpro,zpro,ttar,ztar,ttaus,detap,detat /ctain/mtain + double precision rcproj,rctarg + common/geom1/rcproj,rctarg + common/photrans/phoele(4),ebeam + + + external sptj + + call utpri('ainit ',ish,ishini,4) + + inicnt=inicnt+1 + + if(inicnt.eq.1)then + write(ifmt,'(a)')'initializations ...' + if(isigma.eq.1.and.ionudi.ne.1)then + write(ifmt,'(a)') + & '##################################################' + write(ifmt,'(a)') + & '# Warning X section calc. not consistent with MC #' + write(ifmt,'(a,i2,a,i2,a)') + & '# isigma=',isigma,', ionudi=',ionudi, + & ' #' + write(ifmt,'(a)') + & '##################################################' + endif + if(iLHC.eq.1)then + call atitle +c update file names + fnrj(1:nfnrj+4)=fnrj(1:nfnrj)//".lhc" + nfnrj=nfnrj+4 + fncs(1:nfncs+4)=fncs(1:nfncs)//".lhc" + nfncs=nfncs+4 + endif + endif + + if(noebin.ge.0)then + ntevt=0 + if(seedi.ne.0d0)then + call ranfini(seedi,iseqini,1) + else + stop 'seedi = 0 ... Please define it !' + endif + seedc=seedi + if(inicnt.eq.1)then + call aseedi + if(seedj2.ne.0d0)then + call ranfcv(seedj2) + write(ifmt,'(a)') + &"Random number sequence does not start at 0 ... please wait !" + endif + if(seedj.ne.0d0)then + call ranfini(seedj,iseqsim,2) + else + stop 'seedi = 0 ... Please define it !' + endif + endif + elseif(inicnt.eq.1)then !fake DIS, initialization is part of the event + if(seedj.ne.0d0)then + if(seedj2.ne.0d0)then + call ranfcv(seedj2) + write(ifmt,'(a)') + & "Random number sequence does not start at 0 ... please wait !" + endif + call ranfini(seedj,iseqsim,2) + else + stop 'seedj = 0 ... Please define it !' + endif + call aseed(2) + endif + + if(model.ne.1.and.inicnt.eq.1)then + if(model.eq.2)iversn=100 !'QGSJET01' + if(model.eq.3)iversn=100 !'GHEISHA ' + if(model.eq.4)iversn=611 !'PYTHIA ' + if(model.eq.5)iversn=138 !'HIJING ' + if(model.eq.6)iversn=210 !'SIBYLL ' + if(model.eq.7)iversn=400 !'QGSJETII-04' + if(model.eq.8)iversn=112 !'PHOJET ' + if(model.eq.9)iversn=201125 !'FLUKA ' + if(model.eq.11)iversn=300 !'QGSJETII-03' + if(model.ne.1)iverso=iversn + call IniModel(model) + endif + + if(isphis.eq.1)iframe=11 !nncm + if(icinpu.ge.1)elepti=engy +ctp060829 if(iopenu.eq.2)call smassi(themas) + if(iopenu.eq.2.and.ish.eq.19)stop'change this?????????' !call smassp + + if(iappl.eq.5)then + yhaha=0 + ypjtl=0 + endif + + if(ispherio.ne.0)ndecay=1 + if(ispherio.ne.0)idecay=0 + if(ispherio.ne.0)jdecay=0 + if(iurqmd.ne.0)ndecay=1 + if(iurqmd.ne.0)idecay=0 + if(ifrade.eq.0)irescl=0 + idtarg=idtargin + idproj=idprojin + do 111 iii=1,4 + 111 rexdif(iii)=abs(rexdifi(iii)) + if(noebin.gt.1)then + engy=-1 + ekin=-1 + if(iologe.eq.1)engy= + * engmin*(engmax/engmin)**((real(nrebin)-0.5)/noebin) + if(iologe.eq.0.or.(iologe.lt.0.and.iologl.lt.0))engy= + * engmin+(engmax-engmin)/noebin*(nrebin-0.5) + if(iologl.eq.1)ekin= + * engmin*(engmax/engmin)**((real(nrebin-0.5))/noebin) + if(iologl.eq.0)ekin= + * engmin+(engmax-engmin)/noebin*(real(nrebin)-0.5) + elab=-1 + ecms=-1 + pnll=-1 + if(jpsi.lt.0)then + 11 z=0.19*sqrt(-2*alog(rangen()))*cos(2*pi*rangen()) + engy=abs(z)*engmax + if(engy.lt.egymin)goto11 + endif + elseif(noebin.lt.0)then !fake e-A with pi0-A for hadron production + if(inicnt.eq.1)call phoGPHERAepo(0) !kinematic initialization + idproj=1120 !110 +c if(model.eq.2.or.model.eq.6)idproj=idtarg !for qgsjet01, projectile and target are not symetric and we want to look what happen on the projectile side (used for CR) + laproj=-1 + maproj=1 + engy=-1 + ekin=-1 + elab=-1 + ecms=-1 + pnll=-1 + call phoGPHERAepo(1) !fix energy according to gamma energy + endif + + if(iappl.le.3)then + + if(idtarg.eq.0)then !in case of Air target, initialize with Argon nucleus + if(model.eq.6)then !no Argon in Sibyll + latarg=7 + matarg=14 + else + latarg=20 + matarg=40 + endif + endif + + if((idproj.ne.1120.and.(laproj.ne.-1.or.maproj.ne.1)) + & .or.maproj.le.0) + & call utstop('Invalid projectile setup !&') +c if((idtarg.ne.1120.and.(latarg.ne.-1.or.matarg.ne.1)) +c & .or.matarg.le.0) +c & call utstop('Invalid target setup !&') + + if(iabs(idtarg).ne.1120.and.iabs(idtarg).ne.1220.and.idtarg.ne.0) + & call utstop('Invalid target !&') + if((((idtarg.eq.-1120.or.iabs(idtarg).eq.1220) + & .and.(latarg.ne.-1.or.matarg.ne.1)) + & .and.(idtarg.ne.1120.or.latarg.lt.0)) + & .or.matarg.le.0) + & call utstop('Invalid target setup !&') + + + call idmass(idproj,amproj) + call idmass(idtarg,amtarg) + call idspin(idproj,ispin,jspin,istra) + isoproj=sign(1,idproj)*ispin + call idspin(idtarg,ispin,jspin,istra) + isotarg=sign(1,idtarg)*ispin + nre=0 + if(engy.ge.0.)nre=nre+1 + if(pnll.ge.0.)nre=nre+1 + if(elab.ge.0.)nre=nre+1 + if(ekin.ge.0.)nre=nre+1 + if(ecms.ge.0.)nre=nre+1 + if(nre.ne.1)stop'invalid energy definition' + ifirstghe=0 + 101 continue + if(engy.gt.0.)then + pnll=sqrt(amproj**2+amtarg**2) + pnll=(engy-pnll)*(engy+pnll)*0.5/amtarg + pnll=sqrt(max(0.,(pnll-amproj)*(pnll+amproj))) +c pnll=sqrt(max(0., ((engy**2-amproj**2-amtarg**2)/2/amtarg)**2 +c & -amproj**2) ) + elab=sqrt(pnll**2+amproj**2) + ekin=elab-amproj + ecms=engy + elseif(ecms.gt.0.)then + engy=ecms + pnll=sqrt(amproj**2+amtarg**2) + pnll=(engy-pnll)*(engy+pnll)*0.5/amtarg + pnll=sqrt(max(0.,(pnll-amproj)*(pnll+amproj))) +c pnll=sqrt(max(0., ((engy**2-amproj**2-amtarg**2)/2/amtarg)**2 +c & -amproj**2) ) + elab=sqrt(pnll**2+amproj**2) + ekin=elab-amproj + elseif(elab.gt.0)then + pnll=sqrt(max(0.,(elab-amproj)*(elab+amproj))) + engy=sqrt( 2*elab*amtarg+amtarg**2+amproj**2 ) + ecms=engy + ekin=elab-amproj + elseif(pnll.gt.0)then + elab=sqrt(pnll**2+amproj**2) + engy=sqrt( 2*sqrt(pnll**2+amproj**2)*amtarg+amtarg**2+amproj**2 ) + ecms=engy + ekin=elab-amproj + elseif(ekin.gt.0.)then + elab=ekin+amproj + pnll=sqrt(max(0.,(elab-amproj)*(elab+amproj))) + engy=sqrt( 2*elab*amtarg+amtarg**2+amproj**2 ) + ecms=engy + endif + + if(model.eq.3.and.ifirstghe.eq.0)then !det, trit and alp + if(maproj.eq.2.and.laproj.eq.1)idproj=17 + if(maproj.eq.3.and.laproj.eq.1)idproj=18 + if(maproj.eq.4.and.laproj.eq.2)idproj=19 + if(idproj.ge.17.and.idproj.le.19)then + elab=elab*maproj + call idmass(idproj,amproj) + maproj=1 + laproj=-1 + ifirstghe=1 + engy=-1 + ecms=-1 + pnll=-1 + ekin=-1 + goto 101 + endif + endif + + if(pnll.le.0.001)call utstop('ainit: energy too low&') + if(engy.gt.egymax)call utstop('ainit: energy too high&') + s=engy**2 + pnullx=utpcm(engy,amproj,amtarg) + yhaha=alog((sqrt(pnll**2+s)+pnll)/sqrt(s)) + ypjtl=alog((sqrt(pnll**2+amproj**2)+pnll)/amproj) + if(noebin.lt.0)then + pnll=sqrt(max(0.,(ebeam-amtarg)*(ebeam+amtarg))) !in the lab system (not in the gamma-p system) + ecms=2.*sqrt(ebeam*elepti) !for plots + endif + + elseif(iappl.eq.7)then + + call idmass(idproj,amproj) + if(elab.gt.0)then + pnll=sqrt(max(0.,elab**2-amproj**2)) + engy=amproj + ecms=engy + ekin=elab-amproj + elseif(pnll.gt.0)then + elab=sqrt(pnll**2+amproj**2) + engy=amproj + ecms=engy + ekin=elab-amproj + elseif(ekin.gt.0.)then + elab=ekin+amproj + pnll=sqrt(max(0.,elab**2-amproj**2)) + engy=amproj + ecms=engy + else + engy=amproj + ecms=amproj + elab=0. + pnll=0. + ekin=0. + endif + + pnullx=0. + ypjtl=alog((sqrt(pnll**2+amproj**2)+pnll)/amproj) + yhaha=ypjtl + + elseif(engy.gt.0.)then + + ecms=engy + + + endif + + detap=(ypjtl-yhaha)*etafac + detat=-yhaha*etafac + tpro=dcosh(detap) + zpro=dsinh(detap) + ttar=dcosh(detat) + ztar=dsinh(detat) + + egyevt=engy + ekievt=ekin + pmxevt=pnll + + if(iappl.gt.9)stop'update following statement' + if(iappl.ge.5.and.iappl.le.9)then + s=12.**2 + endif + + !~~~~~redefine energy in case of imposed radial flow~~~~~~~~~~~~~~~~ +c Transfered in epos-con for "koll" dependency +c if(iappl.le.4.or.iappl.eq.9)then +cc yrmaxi=max( 0. , yradmx+yradmi*log(engy)**3 ) !better to have a unique definition for extrapolation (based on SPS AA, RHIC and Tevatron pp) --> but problem at ultra-high energy and from theory we don't know (yet) +c yrmaxi=max( 0. , yradmx+yradmi*log10(engy/200.) ) +c if(maproj.eq.1.and.matarg.eq.1)then +c yrmaxi=max(0.0,yradpp+yradpi*alog10(engy/1800.)) +c endif +c if(yrmaxi.gt.1e-5)then +c yyrmax=dble(yrmaxi) +c fradflii=sngl(1d0/ +c & ((sinh(yyrmax)*yyrmax-cosh(yyrmax)+1d0)/(yyrmax**2/2d0))) +c else +c fradflii=1. +c endif +c endif + + if(iappl.le.3)then + if(maproj.gt.1)then + rpj=1.19*maproj**(1./3.)-1.61*maproj**(-1./3.) + rmproj=rpj+fctrmx*.54 + rcproj=dble(rpj/cosh(yhaha)*facnuc) + else + rmproj=0 + rcproj=dble(0.8/cosh(yhaha)*facnuc) + endif + if(matarg.gt.1)then + rtg=1.19*matarg**(1./3.)-1.61*matarg**(-1./3.) + rmtarg=rtg+fctrmx*.54 + rctarg=dble(rtg/cosh(yhaha)*facnuc) + else + rmtarg=0 + rctarg=dble(0.8/cosh(yhaha)*facnuc) + endif + + endif + + call iclass(idproj,iclpro) + call iclass(idtarg,icltar) + call emsini(engy,idproj,idtarg) + + if(inicnt.eq.1)then + +c call ranfgt(seedp) !not to change the seed ... not needed with 2 sequence + + call hdecin(.false.) + + if(iappl.eq.1.or.iappl.ge.5)then + c=6 + call utquaf(sptj,nptj,xptj,qptj,0.,.33*c,.66*c,c) + endif + + if(iappl.ne.2)then + call hnbspd(iospec) + ktnbod=0 +c if(model.eq.1)call hnbxxxini + call hnbpajini + endif + + if(model.eq.1)then + if(iclegy2.gt.1)then + egyfac=(egymax*1.0001/egylow)**(1./float(iclegy2-1)) + else + egyfac=1. + endif + call psaini + call conini + else + iorsce=0 + iorsdf=0 + iorshh=0 + iorsdf=0 + endif + +c if(iappl.ne.6.and.model.eq.1)call psaini + +c call ranfst(seedp) ! ... after this initialization + + endif !inicnt=1 + +c$$$ if(idproj.eq.1120)icp=2 !????????????? for what ? +c$$$ if(idproj.eq.-1120)icp=-2 +c$$$ if(idproj.eq.120)icp=1 +c$$$ if(idproj.eq.-120)icp=-1 +c$$$ if(idproj.eq.130)icp=4 +c$$$ if(idproj.eq.-130)icp=-4 + + + + if(model.eq.1)then !only for epos + + koll=1 !because it's needed in Gfunpar + + if(iappl.le.3)then + call paramini(1) + if(ish.ge.4)then + do i=idxD0,idxD1 + write(ifch,'(9(a,f8.4))') + * 'AlpD:',alpD(i,iclpro,icltar) + * ,' AlpDp:',alpDp(i,iclpro,icltar) + * ,' AlpDpp:',alpDpp(i,iclpro,icltar) + * ,' BetD:',betD(i,iclpro,icltar) + * ,' BetDp:',betDp(i,iclpro,icltar) + * ,' BetDpp:',betDpp(i,iclpro,icltar) + * ,' GamD:',gamD(i,iclpro,icltar) + * ,' DelD:',delD(i,iclpro,icltar) + * ,' AlpPar:',alppar + * ,' bkmxdif:',bmxdif(iclpro,icltar) + enddo + endif + endif + + if(iappl.le.3)then + bkmxndif=conbmxndif() + bkmx=conbmx() + if(ish.ge.3)write(ifch,*)'bkmx,bkmxndif',bkmx,bkmxndif + + if(maproj.gt.1.or.matarg.gt.1)then + bmax=rmproj+rmtarg + else + bmax=bkmx + endif + endif + + if(ixtau.eq.1)call xtauev(0) + + if(model.eq.1)then + if(iEmsB.eq.1)call xEmsB(0,0,0) + if(iEmsBg.eq.1)call xEmsBg(0,0,0) + if(iEmsPm.eq.1)call xEmsPm(0,0,0,0) + if(iEmsPx.eq.1)call xEmsPx(0,0.,0.,0) + if(iEmsPBx.eq.1)call xEmsP2(0,0,0,0.,0.,0.,0.,0.,0.) +c if(iEmsPx.eq.1)call xEmsPxNo(0,0.,0.,0,0) + if(iEmsSe.eq.1)call xEmsSe(0,0.,0.,0,1) + if(iEmsSe.eq.1)call xEmsSe(0,0.,0.,0,2) + if(iEmsDr.eq.1)call xEmsDr(0,0.,0.,0) + if(iEmsRx.eq.1)call xEmsRx(0,0,0.,0.) + endif + +c G function parameters !-----> a verifier ?????????? (AA ??) + + if(iappl.eq.1)then + call Gfunpar(0.,0.,1,1,0.,s,alp,bet,betp,epsp,epst,epss,gamvv) + epszero=epss + do i=1,nclha + alpff(i)= engy**epszero*gamhad(i) + enddo + betff(1)= -alppar+epsp + betff(2)= -alppar+epst + else + epszero=0. + endif + + endif + +c additional initialization procedures + + if(model.ne.1)then + call IniEvtModel + elseif(iappl.le.3)then +c Cross section calculation + call xsigma + endif + + + if(idtarg.eq.0)idtarg=1120 !air = nucleus + + + + if(inicnt.eq.1.and.noebin.ge.0)then + call aseed(2) + else !to use the proper random sequence + call ranfini(seedc,iseqsim,0) + if(noebin.ge.0.and.nevent.gt.0)call aseed(2) + endif + +ccc call MakeFpartonTable + +c$$$ call testconex(1) + + call utprix('ainit ',ish,ishini,4) + return + end + +c--------------------------------------------------------------------- + subroutine aread +c--------------------------------------------------------------------- +c reads and interprets input commands +c--------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + include 'epos.incsem' + + double precision histoweight + common/chiswei/histoweight + common/cyield/yield/cifset/ifset/caverg/averg + common/csigma/sigma + double precision val,val1,val2 + character*1000 line,linex,cline + data nappl /0/ + common/record/maxrec(2),irecty(30,2) + common/cfacmss/facmss /cr3pomi/r3pomi,r4pomi + common /ems12/iodiba,bidiba ! defaut iodiba=0. if iodiba=1, study H-Dibaryon + character*500 fndat,fnncs,fnIIdat,fnIIncs,fnII03dat,fnII03ncs !qgs-II + common/qgsfname/ fndat, fnncs, ifdat, ifncs + common/qgsIIfname/fnIIdat, fnIIncs, ifIIdat, ifIIncs !qgs-II + common/qgsII03fname/fnII03dat, fnII03ncs, ifII03dat, ifII03ncs !qgs-II03 + common/qgsnfname/ nfndat, nfnncs + common/qgsIInfname/ nfnIIdat, nfnIIncs !qgs-II + common/qgsII03nfname/ nfnII03dat, nfnII03ncs !qgs-II03 + common/ghecsquel/anquasiel,iquasiel + common/cjjj/jjj,cline + character cmodel*21 + parameter(mxdefine=40) + character w1define*100,w2define*100 + common/cdefine/ndefine,l1define(mxdefine),l2define(mxdefine) + & ,w1define(mxdefine),w2define(mxdefine) + common/cbincond/nozero,ibmin,ibmax + common/photrans/phoele(4),ebeam + + + j=-1 + nhsto=0 + ndefine=0 + + 1 call utword(line,i,j,1) + + if(line(i:j).eq.'#define')then + + call utword(line,i,j,ne) + if(line(i:j).eq.'bim3')stop'****** bim3->bim03 ****** ' + if(line(i:j).eq.'bim5')stop'****** bim5->bim05 ****** ' + if(line(i:j).eq.'bim6')stop'****** bim6->bim06 ****** ' + if(ndefine+1.gt.mxdefine)stop'too many `define` statements. ' + l1=j-i+1 + if(l1.gt.99)stop'`define` argument 1 too long. ' + w1define(ndefine+1)(1:l1)=line(i:j) + w1define(ndefine+1)(l1+1:l1+1)=' ' + call utword(line,i,j,ne) + l2=j-i+1 + if(l2.gt.99)stop'`define` argument 2 too long. ' + w2define(ndefine+1)(1:l2)=line(i:j) + w2define(ndefine+1)(l2+1:l2+1)=' ' + ndefine=ndefine+1 + l1define(ndefine)=l1 + l2define(ndefine)=l2 + + elseif(line(i:j).eq.'goto')then + + call utword(line,i,j,ne) + ix=i + jx=j + linex=line + call utword(line,i,j,ne) + do while(line(i:j).ne.linex(ix:jx)) + call utword(line,i,j,ne) + enddo + goto1 + + elseif(line(i:j).eq.'application')then + + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'application?' + call utword(line,i,j,0) + if(nopen.ne.-1)then !only first read + if(line(i:j).eq.'conversion')iappl=-1 + if(line(i:j).eq.'analysis') iappl=0 + if(line(i:j).eq.'hadron') iappl=1 + if(line(i:j).eq.'geometry') iappl=2 + if(line(i:j).eq.'read') iappl=3 + if(line(i:j).eq.'micro') iappl=4 + if(line(i:j).eq.'kinky') iappl=5 + if(line(i:j).eq.'ee') iappl=6 + if(line(i:j).eq.'decay') iappl=7 + if(line(i:j).eq.'lepton') iappl=8 + if(line(i:j).eq.'hydro') iappl=9 + if(line(i:j).eq.'ee') then + naflav=5 ! number of flavors + endif + nappl=nappl+1 + if(iappl.ne.0.and.nappl.gt.1)call aaset(1) + if(iappl.eq.0.and.nappl.gt.1)call aaset(2) + if(iappl.eq.0)jframe=iframe + if(iappl.eq.0)kframe=iframe + if(iappl.eq.1)iframe=0 + if(iappl.eq.2)iframe=0 + if(iappl.eq.4)iframe=1 + if(iappl.eq.5)iframe=1 + if(iappl.eq.6)iframe=1 + if(iappl.eq.7)iframe=0 + if(iappl.eq.8)iframe=21 !gncm + endif + + elseif(line(i:j).eq.'call')then + + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'subroutine?' + call utword(line,i,j,0) + + if(nopen.eq.-1)then !-----only second run + + if(line(i:j).eq.'xEnergy')call xEnergy + if(line(i:j).eq.'xCoopFryRapPi')call xCoopFryRap(1) + if(line(i:j).eq.'xCoopFryRapKa')call xCoopFryRap(2) + if(line(i:j).eq.'xCoopFryPtPi')call xCoopFryPt(1) + if(line(i:j).eq.'xCoopFryPtKa')call xCoopFryPt(2) + if(line(i:j).eq.'xCoopFryV2Pi')call xCoopFryV2(1) + if(line(i:j).eq.'xCoopFryV2Ka')call xCoopFryV2(2) + if(line(i:j).eq.'xConThickProj')call xConThick(1) + if(line(i:j).eq.'xConThickTarg')call xConThick(2) + if(line(i:j).eq.'xConNuclDensProj')call xConNuclDens(1) + if(line(i:j).eq.'xConNuclDensTarg')call xConNuclDens(2) + if(line(i:j).eq.'xConNuclDensProjTarg')call xConNuclDens(1) + if(line(i:j).eq.'xConNuclDensProjTarg')call xConNuclDens(2) + if(line(i:j).eq.'xFom')call xfom + if(line(i:j).eq.'xGeometry')call xGeometry(2) + if(line(i:j).eq.'xbDens')call xbDens(2) + if(line(i:j).eq.'xEpsilon')call xEpsilon(2) + if(line(i:j).eq.'xZnucTheo')call xZnucTheo + if(line(i:j).eq.'xRanPt')call xRanPt + if(line(i:j).eq.'xParGam')call xParGam + if(line(i:j).eq.'xParGampp')call xParGampp + if(line(i:j).eq.'xParOmega1xy')call xParOmega1xy +c$$$ if(line(i:j).eq.'xParOmega3xyz')call xParOmega3xyz + if(line(i:j).eq.'xParPro')call xParPro + if(line(i:j).eq.'xParPro1')call xParPro1 + if(line(i:j).eq.'xParPomInc')call xParPomInc + if(line(i:j).eq.'xParPomIncX')call xParPomIncX + if(line(i:j).eq.'xParPomIncP')call xParPomIncP + if(line(i:j).eq.'xParPomIncM')call xParPomIncM + if(line(i:j).eq.'xParPomIncXI')call xParPomIncXI + if(line(i:j).eq.'xParPomIncPI')call xParPomIncPI + if(line(i:j).eq.'xParPomIncMI')call xParPomIncMI + if(line(i:j).eq.'xParPomIncJ')call xParPomIncJ + if(line(i:j).eq.'xParOmega1')call xParOmega1 +c$$$ if(line(i:j).eq.'xParOmega3')call xParOmega3 +c$$$ if(line(i:j).eq.'xParOmega5')call xParOmega5 + if(line(i:j).eq.'xParOmegaN')call xParOmegaN + if(line(i:j).eq.'xParGauss')call xParGauss + if(line(i:j).eq.'xParSigma')call xParSigma +c$$$ if(line(i:j).eq.'xParSigma2')call xParSigma2 +c$$$ if(line(i:j).eq.'xScrD')call xScrD + if(line(i:j).eq.'xFitD1')call xFitD1 +c$$$ if(line(i:j).eq.'xExaD2')call xExaD2 + if(line(i:j).eq.'xbExaD')call xbExaD +c$$$ if(line(i:j).eq.'xbExaD2')call xbExaD2 + if(line(i:j).eq.'xbnExaD')call xbnExaD +c$$$ if(line(i:j).eq.'xbnExaD2')call xbnExaD2 + if(line(i:j).eq.'xFitD2')call xFitD2 + if(line(i:j).eq.'xbParD')call xbParD +c$$$ if(line(i:j).eq.'xParD2')call xParD2 + if(line(i:j).eq.'xGexaJ')call xGexaJ + if(line(i:j).eq.'xbnParD')call xbnParD + if(line(i:j).eq.'xsParD')call xsParD +c$$$ if(line(i:j).eq.'xmParD2')call xmParD2 + if(line(i:j).eq.'xyParD')call xyParD +c$$$ if(line(i:j).eq.'xyParD2')call xyParD2 + if(line(i:j).eq.'xParPhi1')call xParPhi1 + if(line(i:j).eq.'xParPhi')call xParPhi + if(line(i:j).eq.'xParH')call xParH + if(line(i:j).eq.'xParHPhiInt')call xParHPhiInt + if(line(i:j).eq.'xParZ')call xParZ + if(line(i:j).eq.'xtauev')call xtauev(2) + if(line(i:j).eq.'xspace')call xspace(2) + if(line(i:j).eq.'gakjto' )call gakjto + if(line(i:j).eq.'psaevp')call psaevp +c if(line(i:j).eq.'pyarea')call pyarea + if(line(i:j).eq.'xjden1')call xjden1(2,0,0.,0.,0.,0.,0.) + if(line(i:j).eq.'xjden2')call xjden2(2,0,0.,0.,0.,0.) +c if(line(i:j).eq.'xjdis' )call xjdis(2,0,0) + if(model.eq.1)then + if(line(i:j).eq.'xEmsB' )call xEmsB(2,0,0) + if(line(i:j).eq.'xEmsBg')call xEmsBg(2,0,0) + if(line(i:j).eq.'xEmsPm')call xEmsPm(2,0,0,0) + if(line(i:j).eq.'xEmsPx')call xEmsPx(2,0.,0.,0) +c if(line(i:j).eq.'xEmsPx')call xEmsPxNo(2,0.,0.,0,0) + if(line(i:j).eq.'xEmsSe')call xEmsSe(2,0.,0.,0,1) + if(line(i:j).eq.'xEmsSe')call xEmsSe(2,0.,0.,0,2) + if(line(i:j).eq.'xEmsDr')call xEmsDr(2,0.,0.,0) + if(line(i:j).eq.'xEmsRx')call xEmsRx(2,0,0.,0.) + if(line(i:j-4).eq.'xEmsP2')then + read(line(j-1:j-1),*)val + idh=nint(val) + read(line(j:j),*)val + jex=nint(val) + if(line(j-3:j-2).eq.'PE') + & call xEmsP2(2,idh,jex,0.,0.,0.,0.,0.,0.) + if(line(j-3:j-2).eq.'IB') + & call xEmsP2(3,idh,jex,0.,0.,0.,0.,0.,0.) + if(line(j-3:j-2).eq.'OB') + & call xEmsP2(4,idh,jex,0.,0.,0.,0.,0.,0.) + endif + if(line(i:j).eq.'xConxyzProj') + &stop'xConxyzProj->xConNuclDensProj' + if(line(i:j).eq.'xConxyzTarg') + &stop'xConxyzTarg->xConNuclDensTarg' + if(line(i:j).eq.'xConxyzProjTarg') + &stop'xConxyzProjTarg->xConNuclDensProjTarg' + + endif + + elseif(model.eq.1)then !first run and epos + + if(line(i:j).eq.'xGeometry')then + call xGeometry(0) + ixgeometry=1 + elseif(line(i:j).eq.'xEpsilon')then + call xEpsilon(0) + elseif(line(i:j).eq.'xbDens')then + ixbDens=1 + elseif(line(i:j).eq.'xtauev')then + ixtau=1 + elseif(line(i:j).eq.'xEmsB')then + iEmsB=1 + elseif(line(i:j).eq.'xEmsBg')then + iEmsBg=1 + elseif(line(i:j).eq.'xEmsPm')then + iEmsPm=1 + elseif(line(i:j).eq.'xEmsPx')then + iEmsPx=1 + elseif(line(i:j-4).eq.'xEmsP2')then + iEmsPBx=1 + elseif(line(i:j).eq.'xEmsSe')then + iEmsSe=1 + elseif(line(i:j).eq.'xEmsDr')then + iEmsDr=1 + elseif(line(i:j).eq.'xEmsRx')then + iEmsRx=1 + elseif(line(i:j).eq.'xEmsI1')then + iEmsI1=1 + if(iEmsI1+iEmsI2.eq.1)write(ifhi,'(a)')'newpage zone 3 4 1' + elseif(line(i:j).eq.'xEmsI2')then + iEmsI2=1 + if(iEmsI1+iEmsI2.eq.1)write(ifhi,'(a)')'newpage zone 3 4 1' + elseif(line(i:j).eq.'xSpaceTime')then + iSpaceTime=1 + elseif(line(i:j).eq.'xxSpaceTime')then + stop'xxSpaceTime->xSpaceTime. ' + endif + endif + + elseif(line(i:j).eq.'decayall')then + + nrnody=0 + + elseif(line(i:j).eq.'echo')then + + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'on or off?' + call utword(line,i,j,0) + if(line(i:j).eq.'on')iecho=1 + if(line(i:j).eq.'off')iecho=0 + if(line(i:j).ne.'on'.and.line(i:j).ne.'off')stop'invalid option' + if(nopen.eq.-1)iecho=0 + + elseif(line(i:j).eq.'fqgsjet')then !QGSJet + + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'file-type file-name?' + call utword(line,i,j,0) + linex=line + ix=i + jx=j + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'file-name?' + call utword(line,i,j,0) + if(linex(ix:jx).eq.'dat')fndat(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'dat')nfndat=j-i+1 !length of qgsdat01-file name + if(linex(ix:jx).eq.'ncs')fnncs(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'ncs')nfnncs=j-i+1 !length of sectnu-file name + if(nfndat.gt.1)ifdat=1 + if(nfnncs.gt.1)ifncs=2 + + elseif(line(i:j).eq.'fqgsjetII03')then !QGSJET-II-03 + + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'file-type file-name?' + call utword(line,i,j,0) + linex=line + ix=i + jx=j + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'file-name?' + call utword(line,i,j,0) + if(linex(ix:jx).eq.'dat')fnII03dat(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'dat')nfnII03dat=j-i+1 !length of qgsjet-II.dat name + if(linex(ix:jx).eq.'ncs')fnII03ncs(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'ncs')nfnII03ncs=j-i+1 !length of qgsjet-II.ncs name + if(nfnII03dat.gt.1)ifII03dat=1 + if(nfnII03ncs.gt.1)ifII03ncs=2 + + elseif(line(i:j).eq.'fqgsjetII')then !QGSJET-II-03 + + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'file-type file-name?' + call utword(line,i,j,0) + linex=line + ix=i + jx=j + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'file-name?' + call utword(line,i,j,0) + if(linex(ix:jx).eq.'dat')fnIIdat(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'dat')nfnIIdat=j-i+1 !length of qgsjet-II.dat name + if(linex(ix:jx).eq.'ncs')fnIIncs(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'ncs')nfnIIncs=j-i+1 !length of qgsjet-II.ncs name + if(nfnIIdat.gt.1)ifIIdat=1 + if(nfnIIncs.gt.1)ifIIncs=2 + + elseif(line(i:j).eq.'fname')then + + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'file-type file-name?' + call utword(line,i,j,0) + linex=line + ix=i + jx=j + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'file-name?' + call utword(line,i,j,0) + if(linex(ix:jx).eq.'pathnx')fnnx(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'check')fnch(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'histo')fnhi(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'data') fndt(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'input')fnin(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'copy') fncp(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'initl') fnii(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'initl+') fnii(nfnii+1:nfnii+j-i+1)=line(i:j) + if(linex(ix:jx).eq.'inidi') fnid(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'inidi+') fnid(nfnid+1:nfnid+j-i+1)=line(i:j) + if(linex(ix:jx).eq.'inidr') fndr(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'inidr+') fndr(nfndr+1:nfndr+j-i+1)=line(i:j) + if(linex(ix:jx).eq.'iniev') fnie(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'iniev+') fnie(nfnie+1:nfnie+j-i+1)=line(i:j) + if(linex(ix:jx).eq.'inirj') fnrj(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'inirj+') fnrj(nfnrj+1:nfnrj+j-i+1)=line(i:j) + if(linex(ix:jx).eq.'inics') fncs(1:j-i+1)=line(i:j) + if(linex(ix:jx).eq.'inics+') fncs(nfncs+1:nfncs+j-i+1)=line(i:j) + if(linex(ix:jx).eq.'pathnx')nfnnx=j-i+1 + if(linex(ix:jx).eq.'check')nfnch=j-i+1 + if(linex(ix:jx).eq.'histo')nfnhi=j-i+1 + if(linex(ix:jx).eq.'data') nfndt=j-i+1 + if(linex(ix:jx).eq.'input')nfnin=j-i+1 + if(linex(ix:jx).eq.'copy') nfncp=j-i+1 + if(linex(ix:jx).eq.'initl') nfnii=j-i+1 + if(linex(ix:jx).eq.'initl+')nfnii=nfnii+j-i+1 + if(linex(ix:jx).eq.'inidi') nfnid=j-i+1 + if(linex(ix:jx).eq.'inidi+')nfnid=nfnid+j-i+1 + if(linex(ix:jx).eq.'inidr') nfndr=j-i+1 + if(linex(ix:jx).eq.'inidr+')nfndr=nfndr+j-i+1 + if(linex(ix:jx).eq.'iniev') nfnie=j-i+1 + if(linex(ix:jx).eq.'iniev+')nfnie=nfnie+j-i+1 + if(linex(ix:jx).eq.'inirj') nfnrj=j-i+1 + if(linex(ix:jx).eq.'inirj+')nfnrj=nfnrj+j-i+1 + if(linex(ix:jx).eq.'inics') nfncs=j-i+1 + if(linex(ix:jx).eq.'inics+')nfncs=nfncs+j-i+1 + if(linex(ix:jx).eq.'check'.and.fnch(1:nfnch).ne.'none') then + open(unit=ifcx,file=fnch(1:nfnch),status='unknown') + kchopen=1 + elseif(linex(ix:jx).eq.'pathnx'.and.fnnx(1:nfnnx).ne.'none')then + knxopen=1 + elseif(linex(ix:jx).eq.'histo'.and.fnhi(1:nfnhi).ne.'none')then + open(unit=ifhi,file=fnhi(1:nfnhi),status='unknown') + khiopen=1 + elseif(linex(ix:jx).eq.'data'.and.fndt(1:nfndt).ne.'none')then + open(unit=ifdt,file=fndt(1:nfndt),status='unknown') + kdtopen=1 + elseif(linex(ix:jx).eq.'copy'.and.fncp(1:nfncp).ne.'none')then + open(unit=ifcp,file=fncp(1:nfncp),status='unknown') + kcpopen=1 + endif + + elseif(line(i:j).eq.'frame')then + + + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'frame?' + call utword(line,i,j,0) + if(nopen.ne.-1)then ! event definition only, not analysis + if(line(i:j).eq.'nucleon-nucleon')then + if(iappl.eq.0)jframe=11 + if(abs(iappl).eq.1)iframe=11 + if(iappl.eq.3)iframe=11 + if(iappl.gt.3.or.iappl.eq.2)stop'invalid option nucleon-nucleon' + elseif(line(i:j).eq.'target')then + if(iappl.eq.0)jframe=12 + if(abs(iappl).eq.1)iframe=12 + if(iappl.eq.3)iframe=12 + if(iappl.gt.3.or.iappl.eq.2)stop'invalid option target' + elseif(line(i:j).eq.'gamma-nucleon')then + if(iappl.eq.0)then + jframe=21 + elseif(iappl.le.3.and.iappl.ne.2)then + iframe=21 + endif + if((iappl+1)/2.eq.4)iframe=21 + if(iappl.ne.0.and.(iappl+1)/2.ne.4.and.iappl.ne.3 + * .and.abs(iappl).ne.1)stop'invalid option gamma-nucleon' + elseif(line(i:j).eq.'lab')then + if(iappl.eq.0)then + jframe=22 + elseif(iappl.le.3.and.iappl.ne.2)then + iframe=22 + endif + if((iappl+1)/2.eq.4)iframe=22 + if(iappl.ne.0.and.(iappl+1)/2.ne.4.and.iappl.ne.3 + * .and.abs(iappl).ne.1)stop'invalid option lab' + elseif(line(i:j).eq.'sphericity')then + if(iappl.eq.0)jframe=32 + if(iappl.ne.0)stop'invalid option sphericity' + elseif(line(i:j).eq.'thrust')then + if(iappl.eq.0)jframe=33 + if(iappl.ne.0)stop'invalid option thrust' + elseif(line(i:j).eq.'breit')then + if(iappl.ne.0)stop'invalid option breit' + else + stop'frame not recognized' + endif + endif + + elseif(line(i:j).eq.'frame+')then + + call utword(line,i,j,0) + + elseif(line(i:j).eq.'binning')then + + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'log/lin?' + call utword(line,i,j,0) + if(line(i:j).eq.'lin')iologb=0 + if(line(i:j).eq.'log')iologb=1 + + elseif(line(i:j).eq.'beginhisto'.or.line(i:j).eq.'bh')then + + if(nopen.ne.-1)then + jjj=j + cline=line + call xini + j=jjj + line=cline + endif + + elseif(line(i:j).eq.'endhisto'.or.line(i:j).eq.'eh')then + + if(nopen.eq.-1)then + nhsto=nhsto+1 + call xhis(nhsto) + endif + + elseif(line(i:j).eq.'noweak')then + + !only used in xini + + elseif(line(i:j).eq.'histogram'.or.line(i:j).eq.'hi')then + + call utword(line,i,j,0) + call utword(line,i,j,0) + call utword(line,i,j,0) + call utword(line,i,j,0) + call utword(line,i,j,0) + call utword(line,i,j,0) + + elseif(line(i:j).eq.'plot')then + + stop' "plot" not used any more' + + elseif(line(i:j).eq.'root')then + + stop' "root" not used any more' + + elseif(line(i:j).eq.'idcode')then + + call utword(line,i,j,0) + + elseif(line(i:j).eq.'xpara')then + + call utword(line,i,j,0) + call utword(line,i,j,0) + + elseif(line(i:j).eq.'xparas')then + + call utword(line,i,j,1) + read(line(i:j),*)ipara + do ii=1,ipara + call utword(line,i,j,1) + enddo + + elseif(line(i:j).eq.'histoweight')then + + if(nopen.eq.-1)then + write(ifhi,'(a,e22.14)')'histoweight ',histoweight + endif + + elseif(line(i:j).eq.'histoweight-1')then + + if(nopen.eq.-1)then + write(ifhi,'(a,e22.14)')'histoweight -1' + endif + + + elseif(line(i:j).eq.'input')then + + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'input file?' + call utword(line,i,j,0) + if(nopen.ge.0)then + nopen=nopen+1 + if(nopen.gt.9)stop'too many nested input commands' + open(unit=20+nopen,file=line(i:j),status='old') + if(iprmpt.eq.1)iprmpt=-1 + endif + + elseif(line(i:j).eq.'nodecays')then + + call utword(line,i,j,0) + do while (line(i:j).ne.'end') + if(nrnody.ge.mxnody)then + write(ifmt,'(a)')'too many nodecays; command ignored' + else + nrnody=nrnody+1 + read(line(i:j),*)val + nody(nrnody)=nint(val) + endif + call utword(line,i,j,0) + enddo + + elseif(line(i:j).eq.'nodecay')then + + call utword(line,i,j,0) + if(nopen.ne.-1)then + if(nrnody.ge.mxnody)then + write(ifmt,'(a)')'too many nodecay commands; command ignored' + j=1000 + i=j+1 + goto1 + endif + nrnody=nrnody+1 + read(line(i:j),*)val + nody(nrnody)=nint(val) + endif + + elseif(line(i:j).eq.'dodecay')then + + call utword(line,i,j,0) + if(nopen.ne.-1)then + read(line(i:j),*)val + idx=nint(val) + nrn=0 + imv=0 + do while(nrn.lt.nrnody) + nrn=nrn+1 + if(idx.eq.nody(nrn))then + nrnody=nrnody-1 + imv=1 + endif + if(imv.eq.1.and.nrn.le.nrnody)nody(nrn)=nody(nrn+1) + enddo + endif + + elseif(line(i:j).eq.'MinDecayLength')then + + call utword(line,i,j,0) + if(nopen.ne.-1)then + read(line(i:j),*)val + ctaumin=val + endif + + elseif(line(i:j).eq.'print')then + + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'subroutine?' + call utword(line,i,j,0) + if(line(i:j).eq.'*')then + nrpri=0 + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'level?' + call utword(line,i,j,0) + read(line(i:j),*)val + ish=nint(val) + else + nrpri=nrpri+1 + subpri(nrpri)=' ' + subpri(nrpri)(1:j-i+1)=line(i:j) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'level?' + call utword(line,i,j,0) + read(line(i:j),*)val + ishpri(nrpri)=nint(val) + endif + + elseif(line(i:j).eq.'printcheck')then + + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'screen or file?' + call utword(line,i,j,0) + if(line(i:j).eq.'screen')ifch=ifmt + if(line(i:j).eq.'file')ifch=ifcx + if(line(i:j).ne.'screen'.and.line(i:j).ne.'file') + *write(ifmt,'(a)')'invalid option; command ignored' + + elseif(line(i:j).eq.'prompt')then + + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'on or off or auto?' + call utword(line,i,j,0) + if(line(i:j).eq.'on')iprmpt=2 + if(line(i:j).eq.'off')iprmpt=-2 + if(line(i:j).eq.'auto'.and.nopen.eq.0)iprmpt=1 + if(line(i:j).eq.'auto'.and.nopen.eq.1)iprmpt=-1 + if(line(i:j).ne.'on'.and.line(i:j).ne.'off' + *.and.line(i:j).ne.'auto')stop'invalid option' + + elseif(line(i:j).eq.'return')then + + if(nopen.ne.-1)then + close(ifop) + nopen=nopen-1 + if(nopen.eq.0.and.iprmpt.eq.-1)iprmpt=1 +ccc close(20+nopen) +ccc nopen=nopen-1 +ccc if(nopen.eq.0.and.iprmpt.eq.-1)iprmpt=1 + endif + + elseif(line(i:j).eq.'run')then + + elseif(line(i:j).eq.'runprogram')then + + if(kchopen.eq.0.and.fnch(1:nfnch).ne.'none')then + open(unit=ifcx,file=fnch(1:nfnch),status='unknown') + kchopen=1 + endif + if(khiopen.eq.0.and.fnhi(1:nfnhi).ne.'none')then + open(unit=ifhi,file=fnhi(1:nfnhi),status='unknown') + khiopen=1 + endif + if(kdtopen.eq.0.and.fndt(1:nfndt).ne.'none')then + open(unit=ifdt,file=fndt(1:nfndt),status='unknown') + kdtopen=1 + endif + if(kcpopen.eq.0.and.fncp(1:nfncp).ne.'none')then + open(unit=ifcp,file=fncp(1:nfncp),status='unknown') + kcpopen=1 + endif + return + + elseif(line(i:j).eq.'if')then + + call utword(line,i,j,0) + ix=i + jx=j + linex=line + call utword(line,i,j,0) + read(line(i:j),*)val1 + call utword(line,i,j,0) + read(line(i:j),*)val2 + ifset=1 + if(linex(ix:jx).eq.'engy')then + call idmass(idproj,amproj) + call idmass(idtarg,amtarg) + xxengy=0. + if(engy.gt.0.)then + xxengy=engy + elseif(ecms.gt.0.)then + xxengy=ecms + elseif(elab.gt.0)then + xxengy=sqrt( 2*elab*amtarg+amtarg**2+amproj**2 ) + elseif(pnll.gt.0)then + xxengy=sqrt( 2*sqrt(pnll**2+amproj**2)*amtarg + * +amtarg**2+amproj**2 ) + elseif(ekin.gt.0.)then + xxelab=ekin+amproj + xxengy=sqrt( 2*xxelab*amtarg+amtarg**2+amproj**2 ) + endif + if(xxengy.lt.val1.or.xxengy.gt.val2)ifset=0 + elseif(linex(ix:jx).eq.'projtarg')then + if(maproj.ne.nint(val1).or.matarg.ne.nint(val2))ifset=0 + endif + + elseif(line(i:j).eq.'set'.and.ifset.eq.1)then + + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'p/o-name p/o-value?' + call utword(line,i,j,0) + linex=line + ix=i + jx=j + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'p/o-value?' + call utword(line,i,j,0) + if(linex(ix:jx).eq.'hydtab')then + hydt=line(i:j) + elseif(linex(ix:jx).eq.'xvaria')then + xvaria=' ' + xvaria(1:j-i+1)=line(i:j) + elseif(linex(ix:jx).eq.'yvaria')then + yvaria=' ' + yvaria(1:j-i+1)=line(i:j) + else + read(line(i:j),*)val +c general + if(linex(ix:jx).eq.'model') model=nint(val) + if(linex(ix:jx).eq.'iquasiel') iquasiel=nint(val) + if(linex(ix:jx).eq.'iversn')iversn=nint(val) + if(linex(ix:jx).eq.'iappl' )iappl=nint(val) + if(linex(ix:jx).eq.'nevent')nevent=nint(val) + if(linex(ix:jx).eq.'nfull') nfull=nint(val) + if(linex(ix:jx).eq.'nfreeze')nfreeze=nint(val) + if(linex(ix:jx).eq.'ninicon')ninicon=nint(val) + if(linex(ix:jx).eq.'egymin' )egymin=sngl(val) + if(linex(ix:jx).eq.'egymax' )egymax=sngl(val) +c constants + if(linex(ix:jx).eq.'ainfin')ainfin=sngl(val) +c printout options + if(linex(ix:jx).eq.'iprmpt')iprmpt=nint(val) + if(linex(ix:jx).eq. 'ish' )ish=nint(val) + if(linex(ix:jx).eq.'ishsub')ishsub=nint(val) + if(linex(ix:jx).eq.'irandm')irandm=nint(val) + if(linex(ix:jx).eq.'irewch')irewch=nint(val) + if(linex(ix:jx).eq.'iecho ')iecho =nint(val) + if(linex(ix:jx).eq.'modsho')modsho=nint(val) + if(linex(ix:jx).eq.'idensi')idensi=nint(val) + if(linex(ix:jx).eq.'infragm')infragm=nint(val) + if(linex(ix:jx).eq.'ishevt')ishevt=nint(val) + if(linex(ix:jx).eq.'iwseed')iwseed=nint(val) + if(linex(ix:jx).eq.'jwseed')jwseed=nint(val) +c fragmentation and decay + if(linex(ix:jx).eq.'pdiqua')pdiqua=sngl(val) + if(linex(ix:jx).eq.'pud' )pud =sngl(val) + if(linex(ix:jx).eq.'pmqu' )pmqu =sngl(val) + if(linex(ix:jx).eq.'pmqd' )pmqd =sngl(val) + if(linex(ix:jx).eq.'pmqs ' )pmqs =sngl(val) + if(linex(ix:jx).eq.'pmqc ' )pmqc =sngl(val) + if(linex(ix:jx).eq.'pmqq ' )then + pmqq =sngl(val) + qmass(0)=pmqq + endif + if(linex(ix:jx).eq.'fkappa' )fkappa =sngl(val) + if(linex(ix:jx).eq.'fkappag' )fkappag =sngl(val) + if(linex(ix:jx).eq.'pudd ' )pudd =sngl(val) + if(linex(ix:jx).eq.'puds ' )puds =sngl(val) + if(linex(ix:jx).eq.'pudc ' )pudc =sngl(val) + if(linex(ix:jx).eq.'strcut' )strcut =sngl(val) + if(linex(ix:jx).eq.'diqcut' )diqcut =sngl(val) + if(linex(ix:jx).eq.'ioptf ')ioptf =nint(val) + if(linex(ix:jx).eq.'delrex')delrex=sngl(val) + if(linex(ix:jx).eq.'ndecay')ndecay=nint(val) + if(linex(ix:jx).eq.'maxres')maxres=nint(val) + if(linex(ix:jx).eq.'pbreak')pbreak=sngl(val) + if(linex(ix:jx).eq.'pbreakg')pbreakg=sngl(val) + if(linex(ix:jx).eq.'zetacut')zetacut=sngl(val) + if(linex(ix:jx).eq.'ptfra')ptfra=sngl(val) + if(linex(ix:jx).eq.'ptfraqq')ptfraqq=sngl(val) + if(linex(ix:jx).eq.'aouni ')aouni=sngl(val) +c lepton-nucleon and e+e- + if(linex(ix:jx).eq.'iolept')iolept=nint(val) + if(linex(ix:jx).eq.'ydmin')ydmin=sngl(val) + if(linex(ix:jx).eq.'ydmax')ydmax=sngl(val) + if(linex(ix:jx).eq.'qdmin')qdmin=sngl(val) + if(linex(ix:jx).eq.'qdmax')qdmax=sngl(val) + if(linex(ix:jx).eq.'themin')themin=sngl(val) + if(linex(ix:jx).eq.'themax')themax=sngl(val) + if(linex(ix:jx).eq.'elomin')elomin=sngl(val) + if(linex(ix:jx).eq.'engy' )engy=sngl(val) + if(linex(ix:jx).eq.'elab' )elab=sngl(val) + if(linex(ix:jx).eq.'ekin' )ekin=sngl(val) + if(linex(ix:jx).eq.'ecms' )ecms=sngl(val) + if(linex(ix:jx).eq.'ebeam' )ebeam=sngl(val) + if(linex(ix:jx).eq.'elepti')elepti=sngl(val) + if(linex(ix:jx).eq.'elepto')elepto=sngl(val) + if(linex(ix:jx).eq.'angmue')angmue=sngl(val) + if(linex(ix:jx).eq.'noebin')noebin=nint(val) + if(linex(ix:jx).eq.'engmin')engmin=sngl(val) + if(linex(ix:jx).eq.'engmax')engmax=sngl(val) + if(linex(ix:jx).eq.'iologe')iologe=nint(val) + if(linex(ix:jx).eq.'iologl')iologl=nint(val) + if(linex(ix:jx).eq.'itflav')itflav=nint(val) + if(linex(ix:jx).eq.'idisco')idisco=nint(val) +c hadron-hadron + if(linex(ix:jx).eq. 'pnll' )pnll=sngl(val) + if(linex(ix:jx).eq.'idproj')idprojin=nint(val) + idproj=idprojin + if(linex(ix:jx).eq.'idtarg')idtargin=nint(val) + idtarg=idtargin + if(idtarg.eq.0)idtarg=1120 + if(linex(ix:jx).eq.'ptq ')ptq =sngl(val) + if(linex(ix:jx).eq.'rstrau(1)')rstrau(1)=sngl(val) + if(linex(ix:jx).eq.'rstrad(1)')rstrad(1)=sngl(val) + if(linex(ix:jx).eq.'rstras(1)')rstras(1)=sngl(val) + if(linex(ix:jx).eq.'rstrac(1)')rstrac(1)=sngl(val) + if(linex(ix:jx).eq.'rstrau(2)')rstrau(2)=sngl(val) + if(linex(ix:jx).eq.'rstrad(2)')rstrad(2)=sngl(val) + if(linex(ix:jx).eq.'rstras(2)')rstras(2)=sngl(val) + if(linex(ix:jx).eq.'rstrac(2)')rstrac(2)=sngl(val) + if(linex(ix:jx).eq.'rstrau(3)')rstrau(3)=sngl(val) + if(linex(ix:jx).eq.'rstrad(3)')rstrad(3)=sngl(val) + if(linex(ix:jx).eq.'rstras(3)')rstras(3)=sngl(val) + if(linex(ix:jx).eq.'rstrac(3)')rstrac(3)=sngl(val) + if(linex(ix:jx).eq.'rstrau(4)')rstrau(4)=sngl(val) + if(linex(ix:jx).eq.'rstrad(4)')rstrad(4)=sngl(val) + if(linex(ix:jx).eq.'rstras(4)')rstras(4)=sngl(val) + if(linex(ix:jx).eq.'rstrac(4)')rstrac(4)=sngl(val) + if(linex(ix:jx).eq.'rstrasi')rstrasi=sngl(val) + if(linex(ix:jx).eq.'wgtval')wgtval=sngl(val) + if(linex(ix:jx).eq.'wgtsea')wgtsea=sngl(val) + if(linex(ix:jx).eq.'wgtdiq')wgtdiq=sngl(val) + if(linex(ix:jx).eq.'wgtqqq(1)')wgtqqq(1)=sngl(val) + if(linex(ix:jx).eq.'wgtqqq(2)')wgtqqq(2)=sngl(val) + if(linex(ix:jx).eq.'wgtqqq(3)')wgtqqq(3)=sngl(val) + if(linex(ix:jx).eq.'wgtqqq(4)')wgtqqq(4)=sngl(val) + if(linex(ix:jx).eq.'wproj ')wproj =sngl(val) + if(linex(ix:jx).eq.'wtarg ')wtarg =sngl(val) + if(linex(ix:jx).eq.'wexcit')wexcit=sngl(val) +c if(linex(ix:jx).eq.'cutmsq')cutmsq=sngl(val) + if(linex(ix:jx).eq.'cutmss')cutmss=sngl(val) + if(linex(ix:jx).eq.'exmass')exmass=sngl(val) + if(linex(ix:jx).eq.'iregge')iregge=nint(val) + if(linex(ix:jx).eq.'isopom')isopom=nint(val) + if(linex(ix:jx).eq.'ishpom')ishpom=nint(val) + if(linex(ix:jx).eq.'iscreen')iscreen=nint(val) + if(linex(ix:jx).eq.'isplit')isplit=nint(val) + if(linex(ix:jx).eq.'irzptn')irzptn=nint(val) + if(linex(ix:jx).eq.'irmdrop')irmdrop=nint(val) + if(linex(ix:jx).eq.'nprmax')nprmax=nint(val) + if(linex(ix:jx).eq.'iemspl')iemspl=nint(val) + if(linex(ix:jx).eq.'intpol')intpol=nint(val) + if(linex(ix:jx).eq.'isigma')isigma=nint(val) + if(linex(ix:jx).eq.'iomega')iomega=nint(val) + if(linex(ix:jx).eq.'isetcs')isetcs=nint(val) + if(linex(ix:jx).eq.'iemsb' )iemsb= nint(val) + if(linex(ix:jx).eq.'iemspm')iemspm=nint(val) + if(linex(ix:jx).eq.'iemspx')iemspx=nint(val) + if(linex(ix:jx).eq.'iemsse')iemsse=nint(val) + if(linex(ix:jx).eq.'iemsdr')iemsdr=nint(val) + if(linex(ix:jx).eq.'iemsrx')iemsrx=nint(val) + if(linex(ix:jx).eq.'iemsi2')iemsi2=nint(val) + if(linex(ix:jx).eq.'iemsi1')iemsi1=nint(val) + if(linex(ix:jx).eq.'ioems' )ioems= nint(val) + if(linex(ix:jx).eq.'ispacetime')ispacetime= nint(val) +c unified parameters + if(linex(ix:jx).eq.'iclpro1')iclpro1=nint(val) + if(linex(ix:jx).eq.'iclpro2')iclpro2=nint(val) + if(linex(ix:jx).eq.'icltar1')icltar1=nint(val) + if(linex(ix:jx).eq.'icltar2')icltar2=nint(val) + if(linex(ix:jx).eq.'iclegy1')iclegy1=nint(val) + if(linex(ix:jx).eq.'iclegy2')iclegy2=nint(val) + if(linex(ix:jx).eq.'egylow')egylow=sngl(val) + if(linex(ix:jx).eq.'alppom')alppom=sngl(val) + if(linex(ix:jx).eq.'gamhad(1)')stop'gamhad(1) not allowed' + if(linex(ix:jx).eq.'gamhad(2)')gamhad(2)=sngl(val) + if(linex(ix:jx).eq.'gamhad(3)')stop'gamhad(3) not allowed' + if(linex(ix:jx).eq.'gamhads(1)')gamhadsi(1)=sngl(val) + if(linex(ix:jx).eq.'gamhads(2)')gamhadsi(2)=sngl(val) + if(linex(ix:jx).eq.'gamhads(3)')gamhadsi(3)=sngl(val) + if(linex(ix:jx).eq.'gamhads(4)')gamhadsi(4)=sngl(val) + if(linex(ix:jx).eq.'gamtil')gamtil=sngl(val) + if(linex(ix:jx).eq.'slopom')slopom=sngl(val) + if(linex(ix:jx).eq.'slopoms')slopoms=sngl(val) + if(linex(ix:jx).eq.'r2had(1)' )r2had(1)= sngl(val) + if(linex(ix:jx).eq.'r2had(2)' )r2had(2)= sngl(val) + if(linex(ix:jx).eq.'r2had(3)' )r2had(3)= sngl(val) + if(linex(ix:jx).eq.'r2had(4)' )r2had(4)= sngl(val) + if(linex(ix:jx).eq.'r2hads(1)' )r2hads(1)= sngl(val) + if(linex(ix:jx).eq.'r2hads(2)' )r2hads(2)= sngl(val) + if(linex(ix:jx).eq.'r2hads(3)' )r2hads(3)= sngl(val) + if(linex(ix:jx).eq.'r2hads(4)' )r2hads(4)= sngl(val) + if(linex(ix:jx).eq.'r3pom' )r3pom= sngl(val) + if(linex(ix:jx).eq.'r4pom' )r4pom= sngl(val) + if(linex(ix:jx).eq.'egyscr' )egyscr= sngl(val) + if(linex(ix:jx).eq.'epscrw' )epscrw= sngl(val) + if(linex(ix:jx).eq.'epscrx' )epscrx= sngl(val) + if(linex(ix:jx).eq.'zbrads' )zbrads= sngl(val) + if(linex(ix:jx).eq.'epscrs' )epscrs= sngl(val) + if(linex(ix:jx).eq.'epscrh' )epscrh= sngl(val) + if(linex(ix:jx).eq.'epscrp' )epscrp= sngl(val) + if(linex(ix:jx).eq.'znurho' )znurho= sngl(val) + if(linex(ix:jx).eq.'epscrd' )epscrd= sngl(val) + if(linex(ix:jx).eq.'gfactor' )gfactor= sngl(val) + if(linex(ix:jx).eq.'gwidth' )gwidth= sngl(val) + if(linex(ix:jx).eq.'chad(1)' )chad(1)= sngl(val) + if(linex(ix:jx).eq.'chad(2)' )chad(2)= sngl(val) + if(linex(ix:jx).eq.'chad(3)' )chad(3)= sngl(val) + if(linex(ix:jx).eq.'chad(4)' )chad(4)= sngl(val) + if(linex(ix:jx).eq.'wdiff(1)')wdiff(1)=sngl(val) + if(linex(ix:jx).eq.'wdiff(2)')wdiff(2)=sngl(val) + if(linex(ix:jx).eq.'wdiff(3)')wdiff(3)=sngl(val) + if(linex(ix:jx).eq.'wdiff(4)')wdiff(4)=sngl(val) + if(linex(ix:jx).eq.'facdif') facdif=sngl(val) + if(linex(ix:jx).eq.'facmc') facmc=sngl(val) + if(linex(ix:jx).eq.'rexndf') rexndf=sngl(val) + if(linex(ix:jx).eq.'rexndi(1)')rexndii(1)=sngl(val) + if(linex(ix:jx).eq.'rexndi(2)')rexndii(2)=sngl(val) + if(linex(ix:jx).eq.'rexndi(3)')rexndii(3)=sngl(val) + if(linex(ix:jx).eq.'rexndi(4)')rexndii(4)=sngl(val) + if(linex(ix:jx).eq.'rexdif(1)')rexdifi(1)=sngl(val) + if(linex(ix:jx).eq.'rexdif(2)')rexdifi(2)=sngl(val) + if(linex(ix:jx).eq.'rexdif(3)')rexdifi(3)=sngl(val) + if(linex(ix:jx).eq.'rexdif(4)')rexdifi(4)=sngl(val) + if(linex(ix:jx).eq.'rexpdif(1)')rexpdif(1)=sngl(val) + if(linex(ix:jx).eq.'rexpdif(2)')rexpdif(2)=sngl(val) + if(linex(ix:jx).eq.'rexpdif(3)')rexpdif(3)=sngl(val) + if(linex(ix:jx).eq.'rexpdif(4)')rexpdif(4)=sngl(val) + if(linex(ix:jx).eq.'rexres(1)')rexres(1)=sngl(val) + if(linex(ix:jx).eq.'rexres(2)')rexres(2)=sngl(val) + if(linex(ix:jx).eq.'rexres(3)')rexres(3)=sngl(val) + if(linex(ix:jx).eq.'rexres(4)')rexres(4)=sngl(val) + if(linex(ix:jx).eq.'zrminc')zrminc=sngl(val) + if(linex(ix:jx).eq.'alpreg')alpreg=sngl(val) + if(linex(ix:jx).eq.'sloreg')sloreg=sngl(val) + if(linex(ix:jx).eq.'gamreg')gamreg=sngl(val) + if(linex(ix:jx).eq.'r2reg' )r2reg= sngl(val) +c if(linex(ix:jx).eq.'amhdibar')amhdibar= sngl(val) + if(linex(ix:jx).eq.'ptdiff')ptdiff=sngl(val) + if(linex(ix:jx).eq.'alppar')alppar=sngl(val) + if(linex(ix:jx).eq.'alpsea')alpsea=sngl(val) + if(linex(ix:jx).eq.'alpval')alpval=sngl(val) + if(linex(ix:jx).eq.'alpdiq')alpdiq=sngl(val) + if(linex(ix:jx).eq.'alplea(1)')alplea(1)=sngl(val) + if(linex(ix:jx).eq.'alplea(2)')alplea(2)=sngl(val) + if(linex(ix:jx).eq.'alplea(3)')alplea(3)=sngl(val) + if(linex(ix:jx).eq.'alplea(4)')alplea(4)=sngl(val) + if(linex(ix:jx).eq.'alpdif')alpdif=sngl(val) + if(linex(ix:jx).eq.'alpdi')alpdi=sngl(val) + if(linex(ix:jx).eq.'alpndi')alpndi=sngl(val) + if(linex(ix:jx).eq.'ammsqq')ammsqq=sngl(val) + if(linex(ix:jx).eq.'ammsqd')ammsqd=sngl(val) + if(linex(ix:jx).eq.'ammsdd')ammsdd=sngl(val) + if(linex(ix:jx).eq.'cumpom')cumpom=sngl(val) + if(linex(ix:jx).eq.'reminv')reminv=sngl(val) + if(linex(ix:jx).eq.'ptsend')ptsend=sngl(val) + if(linex(ix:jx).eq.'ptsendi')ptsendi=sngl(val) + if(linex(ix:jx).eq.'ptsems')ptsems=sngl(val) + if(linex(ix:jx).eq.'zdrinc')zdrinc=sngl(val) + if(linex(ix:jx).eq.'zmsinc')zmsinc=sngl(val) + if(linex(ix:jx).eq.'edmaxi')edmaxi=sngl(val) + if(linex(ix:jx).eq.'epmaxi')epmaxi=sngl(val) + if(linex(ix:jx).eq.'zopinc')zopinc=sngl(val) + if(linex(ix:jx).eq.'zipinc')zipinc=sngl(val) + if(linex(ix:jx).eq.'fkainc')fkainc=sngl(val) + if(linex(ix:jx).eq.'fkamax')fkamax=sngl(val) + if(linex(ix:jx).eq.'zodinc')zodinc=sngl(val) + if(linex(ix:jx).eq.'zbrmax')zbrmax=sngl(val) + if(linex(ix:jx).eq.'zoeinc')zoeinc=sngl(val) + if(linex(ix:jx).eq.'xmxrem')xmxrem=sngl(val) + if(linex(ix:jx).eq.'ptsecu')ptsecu=sngl(val) + if(linex(ix:jx).eq.'zdfinc')zdfinc=sngl(val) + if(linex(ix:jx).eq.'zbcut') zbcut=sngl(val) + if(linex(ix:jx).eq.'xzcut') xzcut=sngl(val) + if(linex(ix:jx).eq.'xminremn')xminremn=sngl(val) + if(linex(ix:jx).eq.'xmindiff')xmindiff=sngl(val) + if(linex(ix:jx).eq.'alpdro(1)')alpdro(1)=sngl(val) + if(linex(ix:jx).eq.'alpdro(2)')alpdro(2)=sngl(val) + if(linex(ix:jx).eq.'alpdro(3)')alpdro(3)=sngl(val) + if(linex(ix:jx).eq.'amdrmax')amdrmax=sngl(val) + if(linex(ix:jx).eq.'amdrmin')amdrmin=sngl(val) + if(linex(ix:jx).eq.'iodiba')iodiba=nint(val) + if(linex(ix:jx).eq.'bidiba')bidiba=sngl(val) + +c hard pomeron parameters + if(linex(ix:jx).eq.'q2min' )q2min=sngl(val) + if(linex(ix:jx).eq.'q2ini' )q2ini=sngl(val) + if(linex(ix:jx).eq.'q2fin' )q2fin=sngl(val) + if(linex(ix:jx).eq.'betpom')betpom=sngl(val) + if(linex(ix:jx).eq.'alpfom')alpfomi=sngl(val) + if(linex(ix:jx).eq.'betfom')betfom=dble(val) + if(linex(ix:jx).eq.'gamfom')gamfom=dble(val) + if(linex(ix:jx).eq.'glusea')glusea=sngl(val) + if(linex(ix:jx).eq.'factk' )factk=sngl(val) + if(linex(ix:jx).eq.'naflav')naflav=nint(val) + if(linex(ix:jx).eq.'nrflav')nrflav=nint(val) + if(linex(ix:jx).eq.'pt2cut')pt2cut=sngl(val) + if(linex(ix:jx).eq.'factgam')factgam=sngl(val) + if(linex(ix:jx).eq.'delh')delh=sngl(val) +c nucleus-nucleus + if(linex(ix:jx).eq.'iokoll')iokoll=nint(val) + if(linex(ix:jx).eq.'laproj')laproj=nint(val) + if(linex(ix:jx).eq.'maproj')maproj=nint(val) + if(linex(ix:jx).eq.'latarg')latarg=nint(val) + if(linex(ix:jx).eq.'matarg')matarg=nint(val) + if(linex(ix:jx).eq.'core' )core =sngl(val) +c if(linex(ix:jx).eq.'ncolmx')ncolmx=nint(val) + if(linex(ix:jx).eq.'fctrmx')fctrmx=sngl(val) + if(linex(ix:jx).eq.'bmaxim')bmaxim=sngl(val) + if(linex(ix:jx).eq.'bminim')bminim=sngl(val) + if(linex(ix:jx).eq.'phimax')phimax=sngl(val) + if(linex(ix:jx).eq.'phimin')phimin=sngl(val) +c rescattering parameters + if(linex(ix:jx).eq.'iorsce')iorsce=nint(val) + if(linex(ix:jx).eq.'iorsdf')iorsdf=nint(val) + if(linex(ix:jx).eq.'iorshh')iorshh=nint(val) + if(linex(ix:jx).eq.'iocluin')iocluin=nint(val) + if(linex(ix:jx).eq.'ioquen')ioquen=nint(val) + if(linex(ix:jx).eq.'iohole')iohole=nint(val) + if(linex(ix:jx).eq.'fploss')fploss=sngl(val) + if(linex(ix:jx).eq.'fvisco')fvisco=sngl(val) + if(linex(ix:jx).eq.'fplmin')fplmin=sngl(val) + if(linex(ix:jx).eq.'hacore')hacore=sngl(val) + if(linex(ix:jx).eq.'amimfs')amimfs=sngl(val) + if(linex(ix:jx).eq.'amimel')amimel=sngl(val) + if(linex(ix:jx).eq.'cepara')cepara=sngl(val) + if(linex(ix:jx).eq.'dscale')dscale=sngl(val) + if(linex(ix:jx).eq.'iceopt')iceopt=nint(val) + if(linex(ix:jx).eq.'delamf')delamf=sngl(val) + if(linex(ix:jx).eq.'deuamf')deuamf=sngl(val) + if(linex(ix:jx).eq.'taurea')taurea=sngl(val) + if(linex(ix:jx).eq.'nsegsu')nsegsu=nint(val) + if(linex(ix:jx).eq.'nsegce')nsegce=nint(val) + if(linex(ix:jx).eq.'kigrid')kigrid=nint(val) + if(linex(ix:jx).eq.'fsgrid')fsgrid=sngl(val) + if(linex(ix:jx).eq.'ptclu') ptclu=sngl(val) + if(linex(ix:jx).eq.'epscri(1)')epscri(1)=sngl(val) + if(linex(ix:jx).eq.'epscri(3)')epscri(3)=sngl(val) + if(linex(ix:jx).eq.'amsiac')amsiac=sngl(val) + if(linex(ix:jx).eq.'amprif')amprif=sngl(val) + if(linex(ix:jx).eq.'delvol')delvol=sngl(val) + if(linex(ix:jx).eq.'deleps')deleps=sngl(val) + if(linex(ix:jx).eq.'taumin')taumin=sngl(val) + if(linex(ix:jx).eq.'deltau')deltau=sngl(val) + if(linex(ix:jx).eq.'factau')factau=sngl(val) + if(linex(ix:jx).eq.'numtau')numtau=nint(val) + if(linex(ix:jx).eq.'dlzeta')dlzeta=sngl(val) + if(linex(ix:jx).eq.'etafac')etafac=sngl(val) + if(linex(ix:jx).eq.'facnuc')facnuc=sngl(val) +c urqmd + if(linex(ix:jx).eq.'iurqmd')iurqmd=int(val) +c spherio + if(linex(ix:jx).eq.'ispherio')ispherio=int(val) +c ico + if(linex(ix:jx).eq.'cutico') cutico=sngl(val) + if(linex(ix:jx).eq.'dssico') dssico=sngl(val) + if(linex(ix:jx).eq.'icocore')icocore=int(val) + if(linex(ix:jx).eq.'icotabm')icotabm=int(val) + if(linex(ix:jx).eq.'icotabr')icotabr=int(val) +c droplet decay + if(linex(ix:jx).eq.'dezzer')dezzer=sngl(val) + if(linex(ix:jx).eq.'ioclude')ioclude=nint(val) + if(linex(ix:jx).eq.'amuseg')amuseg=sngl(val) + if(linex(ix:jx).eq.'yradmx')yradmx=sngl(val) + if(linex(ix:jx).eq.'yradmi')yradmi=sngl(val) + if(linex(ix:jx).eq.'yradpp')yradpp=sngl(val) + if(linex(ix:jx).eq.'yradpi')yradpi=sngl(val) + if(linex(ix:jx).eq.'yradpx')yradpx=sngl(val) + if(linex(ix:jx).eq.'facecc')facecc=sngl(val) + if(linex(ix:jx).eq.'rcoll' )rcoll= sngl(val) + if(linex(ix:jx).eq.'ylongmx' )ylongmx= sngl(val) + if(linex(ix:jx).eq.'bag4rt')bag4rt=sngl(val) + if(linex(ix:jx).eq.'taunll')taunll=sngl(val) +c droplet specification + if(linex(ix:jx).eq. 'keu' )keu=nint(val) + if(linex(ix:jx).eq. 'ked' )ked=nint(val) + if(linex(ix:jx).eq. 'kes' )kes=nint(val) + if(linex(ix:jx).eq. 'kec' )kec=nint(val) + if(linex(ix:jx).eq. 'keb' )keb=nint(val) + if(linex(ix:jx).eq. 'ket' )ket=nint(val) + if(linex(ix:jx).eq. 'tecm' )tecm=sngl(val) + if(linex(ix:jx).eq. 'volu' )volu=sngl(val) + if(linex(ix:jx).eq. 'vrad' )vrad=sngl(val) + if(linex(ix:jx).eq. 'facts')facts=sngl(val) + if(linex(ix:jx).eq. 'factb')factb=sngl(val) + if(linex(ix:jx).eq. 'factq')factq=sngl(val) + if(linex(ix:jx).eq.'inbxxx')inbxxx=sngl(val) +c metropolis + if(linex(ix:jx).eq.'iospec')iospec=nint(val) + if(linex(ix:jx).eq.'iocova')iocova=nint(val) + if(linex(ix:jx).eq.'iopair')iopair=nint(val) + if(linex(ix:jx).eq.'iozero')iozero=nint(val) + if(linex(ix:jx).eq.'ioflac')ioflac=nint(val) + if(linex(ix:jx).eq.'iostat')iostat=nint(val) + if(linex(ix:jx).eq.'ioinco')ioinco=nint(val) + if(linex(ix:jx).eq.'iograc')iograc=nint(val) + if(linex(ix:jx).eq.'epsgc' )epsgc=sngl(val) + if(linex(ix:jx).eq.'iocite')iocite=nint(val) + if(linex(ix:jx).eq.'ioceau')ioceau=nint(val) + if(linex(ix:jx).eq.'iociau')iociau=nint(val) + if(linex(ix:jx).eq.'ioinct')ioinct=nint(val) + if(linex(ix:jx).eq.'ioinfl')ioinfl=nint(val) + if(linex(ix:jx).eq.'iowidn')iowidn=nint(val) + if(linex(ix:jx).eq.'ionlat')ionlat=nint(val) + if(linex(ix:jx).eq.'iomom')iomom=nint(val) + if(linex(ix:jx).eq.'ioobsv')ioobsv=nint(val) + if(linex(ix:jx).eq.'iosngl')iosngl=nint(val) + if(linex(ix:jx).eq.'iorejz')iorejz=nint(val) + if(linex(ix:jx).eq.'iompar')iompar=nint(val) + if(linex(ix:jx).eq.'iozinc')iozinc=nint(val) + if(linex(ix:jx).eq.'iozevt')iozevt=nint(val) + if(linex(ix:jx).eq. 'nadd' )nadd=nint(val) + if(linex(ix:jx).eq.'iterma')iterma=nint(val) + if(linex(ix:jx).eq.'itermx')stop'STOP: set iterma, not itermx' + if(linex(ix:jx).eq.'iterpr')iterpr=nint(val) + if(linex(ix:jx).eq.'iterpl')iterpl=nint(val) + if(linex(ix:jx).eq.'iternc')iternc=nint(val) + if(linex(ix:jx).eq.'epsr' )epsr=sngl(val) + if(linex(ix:jx).eq.'keepr' )keepr=nint(val) +c strangelets + if(linex(ix:jx).eq.'iopenu')iopenu=nint(val) + if(linex(ix:jx).eq.'themas')themas=sngl(val) +c tests + if(linex(ix:jx).eq.'iotst1')iotst1=nint(val) + if(linex(ix:jx).eq.'iotst2')iotst2=nint(val) + if(linex(ix:jx).eq.'iotst3')iotst3=nint(val) + if(linex(ix:jx).eq.'iotst4')iotst4=nint(val) +c jpsi + if(linex(ix:jx).eq.'jpsi ')jpsi =nint(val) + if(linex(ix:jx).eq.'jpsifi')jpsifi=nint(val) + if(linex(ix:jx).eq.'sigj ')sigj =sngl(val) + if(linex(ix:jx).eq.'taumx ')taumx =sngl(val) + if(linex(ix:jx).eq.'nsttau')nsttau=nint(val) + if(linex(ix:jx).eq.'ijphis')ijphis=nint(val) +c analysis: intermittency, space-time, droplets, formation time + if(linex(ix:jx).eq.'ymximi')ymximi=sngl(val) + if(linex(ix:jx).eq.'imihis')imihis=nint(val) + if(linex(ix:jx).eq.'isphis')isphis=nint(val) + if(linex(ix:jx).eq.'iologb')iologb=nint(val) + if(linex(ix:jx).eq.'ispall')ispall=nint(val) + if(linex(ix:jx).eq.'wtmini')wtmini=sngl(val) + if(linex(ix:jx).eq.'wtstep')wtstep=sngl(val) + if(linex(ix:jx).eq.'iwcent')iwcent=nint(val) + if(linex(ix:jx).eq.'iclhis')iclhis=nint(val) + if(linex(ix:jx).eq.'iwtime')iwtime=nint(val) + if(linex(ix:jx).eq.'wtimet')wtimet=sngl(val) + if(linex(ix:jx).eq.'wtimei')wtimei=sngl(val) + if(linex(ix:jx).eq.'wtimea')wtimea=sngl(val) +c other + if(linex(ix:jx).eq.'gaumx ')gaumx =sngl(val) + if(linex(ix:jx).eq.'nclean')nclean=nint(val) + if(linex(ix:jx).eq.'istore')istore=nint(val) + if(linex(ix:jx).eq.'ioidch')ioidch=nint(val) + if(linex(ix:jx).eq.'iframe')iframe=nint(val) + if(linex(ix:jx).eq.'jframe')jframe=nint(val) + if(linex(ix:jx).eq.'labsys')stop'labsys no longer supported' + if(linex(ix:jx).eq.'irescl')irescl=nint(val) + if(linex(ix:jx).eq.'iremn')iremn=nint(val) + if(linex(ix:jx).eq.'ifrade')ifrade=nint(val) + if(linex(ix:jx).eq.'idecay')idecay=nint(val) + if(linex(ix:jx).eq.'jdecay')jdecay=nint(val) + if(linex(ix:jx).eq.'ntrymx')ntrymx=nint(val) + if(linex(ix:jx).eq.'istmax')istmax=nint(val) + if(linex(ix:jx).eq.'ionudi')ionudi=nint(val) + if(linex(ix:jx).eq.'seedi') seedi =val + if(linex(ix:jx).eq.'seedj') seedj =val + if(linex(ix:jx).eq.'seedf') seedj2=val + if(linex(ix:jx).eq.'normal')normal=nint(val) + if(linex(ix:jx).eq.'xminim')xminim=sngl(val) + if(linex(ix:jx).eq.'xmaxim')xmaxim=sngl(val) + if(linex(ix:jx).eq.'nrbins')nrbins=nint(val) + if(linex(ix:jx).eq.'hisfac')hisfac=sngl(val) + if(linex(ix:jx).eq.'xshift')xshift=sngl(val) + if(linex(ix:jx).eq.'etacut')etacut=sngl(val) + if(linex(ix:jx).eq.'xpar1' )xpar1=sngl(val) + if(linex(ix:jx).eq.'xpar2' )xpar2=sngl(val) + if(linex(ix:jx).eq.'xpar3' )xpar3=sngl(val) + if(linex(ix:jx).eq.'xpar4' )xpar4=sngl(val) + if(linex(ix:jx).eq.'xpar5' )xpar5=sngl(val) + if(linex(ix:jx).eq.'xpar6' )xpar6=sngl(val) + if(linex(ix:jx).eq.'xpar7' )xpar7=sngl(val) + if(linex(ix:jx).eq.'xpar8' )xpar8=sngl(val) + if(linex(ix:jx).eq.'irdmpr')irdmpr=nint(val) + if(linex(ix:jx).eq.'ilprtg')ilprtg=nint(val) + if(linex(ix:jx).eq.'iLHC')then + if(nint(val).eq.1)call LHCparameters + endif +c frame definitions + if(linex(ix:jx).eq.'engy'.and.iframe.eq.0)iframe=11 + if(linex(ix:jx).eq.'ecms'.and.iframe.eq.0)iframe=11 + if(linex(ix:jx).eq.'elab'.and.iframe.eq.0)iframe=12 + if(linex(ix:jx).eq.'ekin'.and.iframe.eq.0)iframe=12 + if(linex(ix:jx).eq.'pnll'.and.iframe.eq.0)iframe=12 + if(linex(ix:jx).eq.'ebeam'.and.iframe.eq.0)iframe=21 + if(linex(ix:jx).eq.'noebin'.and.dabs(val-1.d0).gt.1.d-10)iframe=11 + endif + + elseif(line(i:j).eq.'set')then + + call utword(line,i,j,0) + call utword(line,i,j,0) + ifset=1 + + elseif(line(i:j).eq.'stop')then !same as return + + if(nopen.ne.-1)then + close(20+nopen) + nopen=nopen-1 + if(nopen.eq.0.and.iprmpt.eq.-1)iprmpt=1 + endif + + elseif(line(i:j).eq.'stopprogram')then + + close(unit=ifcx) + close(unit=ifhi) + close(unit=ifdt) + stop + + elseif(line(i:j).eq.'EndEposInput')then + + return + + elseif(line(i:j).eq.'string')then + + nstmax=nstmax+1 + ns=nstmax + icinpu=0 + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0) + *write(ifmt,'(a)')'string: prob icbac1 icbac2 icfor1 icfor2?' + call utword(line,i,j,0) + read(line(i:j),*)val + prob(ns)=sngl(val) + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0) + *write(ifmt,'(a)')'string: icbac1 icbac2 icfor1 icfor2?' + call utword(line,i,j,0) + read(line(i:j),*)val + icbac(ns,1)=nint(val) + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0) + *write(ifmt,'(a)')'string: icbac2 icfor1 icfor2?' + call utword(line,i,j,0) + read(line(i:j),*)val + icbac(ns,2)=nint(val) + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0) + *write(ifmt,'(a)')'string: icfor1 icfor2?' + call utword(line,i,j,0) + read(line(i:j),*)val + icfor(ns,1)=nint(val) + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0) + *write(ifmt,'(a)')'string: icfor2?' + call utword(line,i,j,0) + read(line(i:j),*)val + icfor(ns,2)=nint(val) + + elseif(line(i:j).eq.'kinks')then + + nptl=0 +ctp290806 nrow=0 + nel=0 + 10 continue + call utword(line,i,j,0) + if(line(i:j).eq.'endkinks')goto 12 + nel=nel+1 +ctp290806 nrow=1+(nel-1)/4 + nc=mod(nel-1,4)+1 + read(line(i:j),*)a + if(nc.eq.1)nptl=nptl+1 + if(nc.eq.1)idptl(nptl)=nint(a) + if(nc.eq.2)pptl(1,nptl)=a + if(nc.eq.3)pptl(2,nptl)=a + if(nc.eq.4)then + pptl(3,nptl)=a + istptl(nptl)=20 + pptl(4,nptl)=sqrt(pptl(3,nptl)**2+pptl(2,nptl)**2 + $ +pptl(1,nptl)**2) + endif + goto 10 + 12 continue + + elseif(line(i:j).eq.'record')then + + call utworn(line,j,ne) +c if(ne.eq.0.and.iprmpt.gt.0) +c * write(ifmt,'(a)')'kinks: icbac1 icbac2 icfor1 icfor2?' + call utword(line,i,j,0) + ir=0 + if(line(i:j).eq.'event')then + ir=1 + elseif(line(i:j).eq.'particle')then + ir=2 + else + call utstop("Wrong definition for record!&") + endif + maxrec(ir)=0 + 20 call utworn(line,j,ne) +c if(ne.eq.0.and.iprmpt.gt.0) +c * write(6,'(a)')'<kinks-data (px-py-pz)>? (End=endkinks)' + call utword(line,i,j,0) + if(line(i:j).eq.'endrecord')then + goto 22 + endif + maxrec(ir)=maxrec(ir)+1 + irecty(maxrec(ir),ir)=-1 + if(ir.eq.1)then + if(line(i:j).eq.'0') irecty(maxrec(ir),ir)=0 + if(line(i:j).eq.'nevt') irecty(maxrec(ir),ir)=1 + if(line(i:j).eq.'nptl') irecty(maxrec(ir),ir)=2 + if(line(i:j).eq.'b') irecty(maxrec(ir),ir)=3 + if(line(i:j).eq.'phi') irecty(maxrec(ir),ir)=4 + if(line(i:j).eq.'ncol') irecty(maxrec(ir),ir)=5 + if(line(i:j).eq.'pmx') irecty(maxrec(ir),ir)=6 + if(line(i:j).eq.'egy') irecty(maxrec(ir),ir)=7 + if(line(i:j).eq.'npj') irecty(maxrec(ir),ir)=8 + if(line(i:j).eq.'ntg') irecty(maxrec(ir),ir)=9 + if(line(i:j).eq.'npn') irecty(maxrec(ir),ir)=10 + if(line(i:j).eq.'npp') irecty(maxrec(ir),ir)=11 + if(line(i:j).eq.'ntn') irecty(maxrec(ir),ir)=12 + if(line(i:j).eq.'ntp') irecty(maxrec(ir),ir)=13 + if(line(i:j).eq.'jpn') irecty(maxrec(ir),ir)=14 + if(line(i:j).eq.'jpp') irecty(maxrec(ir),ir)=15 + if(line(i:j).eq.'jtn') irecty(maxrec(ir),ir)=16 + if(line(i:j).eq.'jtp') irecty(maxrec(ir),ir)=17 + if(line(i:j).eq.'amp') irecty(maxrec(ir),ir)=20 + if(line(i:j).eq.'amt') irecty(maxrec(ir),ir)=21 + if(line(i:j).eq.'qsq') irecty(maxrec(ir),ir)=22 + if(line(i:j).eq.'xbj') irecty(maxrec(ir),ir)=23 + if(line(i:j).eq.'typ') irecty(maxrec(ir),ir)=24 + else + if(line(i:j).eq.'0') irecty(maxrec(ir),ir)=0 + if(line(i:j).eq.'i') irecty(maxrec(ir),ir)=1 + if(line(i:j).eq.'id') irecty(maxrec(ir),ir)=2 + if(line(i:j).eq.'p1') irecty(maxrec(ir),ir)=3 + if(line(i:j).eq.'p2') irecty(maxrec(ir),ir)=4 + if(line(i:j).eq.'p3') irecty(maxrec(ir),ir)=5 + if(line(i:j).eq.'p4') irecty(maxrec(ir),ir)=6 + if(line(i:j).eq.'p5') irecty(maxrec(ir),ir)=7 + if(line(i:j).eq.'fa') irecty(maxrec(ir),ir)=8 + if(line(i:j).eq.'mo') irecty(maxrec(ir),ir)=9 + if(line(i:j).eq.'st') irecty(maxrec(ir),ir)=10 + if(line(i:j).eq.'x1') irecty(maxrec(ir),ir)=11 + if(line(i:j).eq.'x2') irecty(maxrec(ir),ir)=12 + if(line(i:j).eq.'x3') irecty(maxrec(ir),ir)=13 + if(line(i:j).eq.'x4') irecty(maxrec(ir),ir)=14 + if(line(i:j).eq.'idfa') irecty(maxrec(ir),ir)=15 + if(line(i:j).eq.'idmo') irecty(maxrec(ir),ir)=16 + if(line(i:j).eq.'p') irecty(maxrec(ir),ir)=17 + if(line(i:j).eq.'x') irecty(maxrec(ir),ir)=18 + if(line(i:j).eq.'dez') irecty(maxrec(ir),ir)=19 + if(line(i:j).eq.'c1') irecty(maxrec(ir),ir)=21 + if(line(i:j).eq.'c2') irecty(maxrec(ir),ir)=22 + if(line(i:j).eq.'ty') irecty(maxrec(ir),ir)=23 + endif + if(irecty(maxrec(ir),ir).eq.-1)then + write(*,*) 'unknown variable ',line(i:j) + stop + endif + goto 20 + 22 continue + + elseif(line(i:j).eq.'switch')then + + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'option on/off?' + call utword(line,i,j,0) + call utworn(line,j,ne) + if(ne.eq.0.and.iprmpt.gt.0)write(ifmt,'(a)')'on/off?' + if(line(i:j).eq.'droplet')then + call utword(line,i,j,0) + if(line(i:j).eq.'on' )iorsdf=1 + if(line(i:j).eq.'off')iorsdf=0 + elseif(line(i:j).eq.'cascade')then + call utword(line,i,j,0) +c if(line(i:j).eq.'on' )iorsce=1 + if(line(i:j).eq.'on' )iorshh=1 +c if(line(i:j).eq.'off')iorsce=0 + if(line(i:j).eq.'off')iorshh=0 + elseif(line(i:j).eq.'soft')then + call utword(line,i,j,0) + if(line(i:j).eq.'on' )isopom=1 + if(line(i:j).eq.'off')isopom=0 + elseif(line(i:j).eq.'hard')then + call utword(line,i,j,0) + if(line(i:j).eq.'on' )ishpom=1 + if(line(i:j).eq.'off')ishpom=0 + elseif(line(i:j).eq.'splitting')then + call utword(line,i,j,0) + if(line(i:j).eq.'on' )isplit=1 + if(line(i:j).eq.'on' )iscreen=1 + if(line(i:j).eq.'off')isplit=0 + if(line(i:j).eq.'off')iscreen=0 + elseif(line(i:j).eq.'fusion')then + call utword(line,i,j,0) + if(line(i:j).eq.'on' )iorsce=0 + if(line(i:j).eq.'on' )iorsdf=3 + if(line(i:j).eq.'on' )iorshh=0 + if(line(i:j).eq.'off')iorsce=0 + if(line(i:j).eq.'off')iorsdf=0 + if(line(i:j).eq.'off')iorshh=0 + elseif(line(i:j).eq.'urqmd')then + call utword(line,i,j,0) + if(line(i:j).eq.'on' ) iurqmd=1 + if(line(i:j).eq.'off') iurqmd=0 + elseif(line(i:j).eq.'spherio')then + call utword(line,i,j,0) + if(line(i:j).eq.'on' ) ispherio=1 + if(line(i:j).eq.'off') ispherio=0 + elseif(line(i:j).eq.'decay')then + call utword(line,i,j,0) + if(line(i:j).eq.'on' ) ndecay=0 + if(line(i:j).eq.'off') ndecay=1 + if(line(i:j).eq.'on' ) idecay=1 + if(line(i:j).eq.'off') idecay=0 + elseif(line(i:j).eq.'clusterdecay')then + call utword(line,i,j,0) + if(line(i:j).eq.'on' ) jdecay=1 + if(line(i:j).eq.'off') jdecay=0 + elseif(line(i:j).eq.'fragdecay')then + call utword(line,i,j,0) + if(line(i:j).eq.'on' ) ifrade=1 + if(line(i:j).eq.'off') ifrade=0 + elseif(line(i:j).eq.'icocore')then + stop'switch icocore not supported any more. ' + endif + + elseif(line(i:j).eq.'idchoice')then + + call utword(line,i,j,0) + if(line(i:j).eq.'nxs')then + ioidch=1 + elseif(line(i:j).eq.'pdg')then + ioidch=2 + else + stop'invalid idchoice. ' + endif + + elseif(line(i:j).eq.'make')then + + call utword(line,i,j,0) + if(line(i:j).eq.'icotable')icotabm=1 + + elseif(line(i:j).eq.'read')then + + call utword(line,i,j,0) + if(line(i:j).eq.'icotable')icotabr=1 + + elseif(line(i:j).eq.'output')then + + call utword(line,i,j,0) + if(line(i:j).eq.'full' ) istore=-1 + if(line(i:j).eq.'epos' ) istore=1 + if(line(i:j).eq.'osc1997a' ) istore=2 + if(line(i:j).eq.'osc1999a' ) istore=3 + if(line(i:j).eq.'lhef' ) istore=4 + if(line(i:j).eq.'ustore' ) istore=5 + if(line(i:j).eq.'hepmc' ) istore=6 + + elseif(line(i:j).eq.'model')then + + call utword(line,i,j,0) + if(line(i:j).eq.'epos')then + model=1 + elseif(line(i:j).eq.'lhc'.or.line(i:j).eq.'LHC')then + model=1 + call LHCparameters + else + nij=j-i+1 + if(nij.gt.20)stop'cmodel too small' + cmodel(1:nij)=line(i:j) + cmodel(nij+1:nij+1)=' ' + call NumberModel(cmodel,model) + endif + if(abs(iappl).ne.1.and.iappl.ne.3.and.model.ne.1 + &.and..not.(model.eq.4.and.iappl.eq.7)) + &call utstop('Application not possible with this model&') + + elseif(line(i:j).eq.'trigger')then + + call utword(line,i,j,0) + ntc=1 + if(line(i:j).eq.'or'.or.line(i:j).eq.'contr')then + call utword(line,i,j,0) + read(line(i:j),*)ztc + ntc=nint(ztc) + call utword(line,i,j,1) + endif + do n=1,ntc + if(n.ne.1)call utword(line,i,j,0) + call utword(line,i,j,0) + call utword(line,i,j,0) + enddo + + elseif(line(i:j).eq.'noerrorbut')then + + call utword(line,i,j,0) + + elseif(line(i:j).eq.'b')then + + nbarray=nbarray+1 + call utword(line,i,j,0) + read(line(i:j),*)val + barray(nbarray)=val + + elseif(line(i:j).eq.'message')then + + call utword(line,i,j,0) + if(nopen.eq.-1)then !only write in second read + write(ifmt,'(a,$)')line(i:j) + endif + + elseif(line(i:j).eq.'endmessage')then + + if(nopen.eq.-1)then !only write in second read + write(ifmt,'(a)')' ' + endif + + elseif(line(i:j).eq.'write'.or.line(i:j).eq.'writex')then + + ii=0 + if(line(i:j).eq.'write')then + ii=1 + elseif(line(i:j).eq.'writex')then + ii=2 + else + call utstop("Wrong definition for write!&") + endif + call utword(line,i,j,0) + idol=0 + if(line(i:j).eq.'$')then + idol=1 + call utword(line,i,j,0) + endif + !write: only write in second read; writex: only write in first read + if(ii.eq.1.and.nopen.eq.-1.or.ii.eq.2.and.nopen.ne.-1)then + if(j-4.ge.i)then + do l=i,j-4 + if(line(l:l+4).eq.'$hydt')then + line(l+3:l+4)=' ' + write(line(l:l+2),'(a)')hydt + endif + enddo + endif + if(j-6.ge.i)then + do l=i,j-6 + if(line(l:l+6).eq.'$iversn')then + if(mod(iversn,100).le.9)then + write(line(l:l+6),'(i1,a,i1,3x)') + * int(iversn/100),'.0',mod(iversn,100) + else + write(line(l:l+6),'(i1,a,i2,3x)') + * int(iversn/100),'.',mod(iversn,100) + endif + endif + enddo + endif + if(j-8.ge.i)then + do l=i,j-8 + if(line(l:l+8).eq.'$xxxyield')then + write(line(l:l+8),'(f8.6,1x)')yield + endif + if(line(l:l+7).eq.'$xxyield')then + write(line(l:l+8),'(f7.5,1x)')yield + endif + if(line(l:l+6).eq.'$xyield')then + write(line(l:l+8),'(f6.4,1x)')yield + endif + enddo + endif + if(j-5.ge.i)then + do l=i,j-5 + if(line(l:l+5).eq.'$yield')then + if(yield.lt.1.0)then + write(line(l:l+5),'(f5.3,1x)')yield + elseif(yield.lt.100.)then + write(line(l:l+5),'(f5.2,1x)')yield + elseif(yield.lt.1000.)then + write(line(l:l+5),'(f5.1,1x)')yield + elseif(yield.lt.10000.)then + write(line(l:l+5),'(f6.1)')yield + else + write(line(l:l+5),'(i6)')nint(yield) + endif + endif + enddo + do l=i,j-5 + if(line(l:l+5).eq.'$averg')then + if(averg.lt.1.0)then + write(line(l:l+5),'(f5.3,1x)')averg + elseif(averg.lt.100.)then + write(line(l:l+5),'(f5.2,1x)')averg + elseif(averg.lt.1000.)then + write(line(l:l+5),'(f5.1,1x)')averg + elseif(averg.lt.10000.)then + write(line(l:l+5),'(f6.1)')averg + else + write(line(l:l+5),'(i6)')nint(averg) + endif + endif + enddo + do l=i,j-5 + if(line(l:l+5).eq.'$sigma')then + if(sigma.lt.1.0)then + write(line(l:l+5),'(f5.3,1x)')sigma + elseif(sigma.lt.100.)then + write(line(l:l+5),'(f5.2,1x)')sigma + elseif(sigma.lt.1000.)then + write(line(l:l+5),'(f5.1,1x)')sigma + elseif(sigma.lt.10000.)then + write(line(l:l+5),'(f6.1)')sigma + else + write(line(l:l+5),'(i6)')nint(sigma) + endif + endif + enddo + endif + if(idol.eq.0)then + write(ifhi,'(a)')line(i:j) + else + write(ifhi,'(a,a,$)')line(i:j),' ' + endif + endif + + elseif(line(i:j).eq.'nozero')then + + nozero=1 + + elseif(line(i:j).eq.'ibmin')then + + call utword(line,i,j,0) + read(line(i:j),*)val + ibmin=nint(val) + + elseif(line(i:j).eq.'ibmax')then + + call utword(line,i,j,0) + read(line(i:j),*)val + ibmax=nint(val) + + elseif(line(i:j).eq.'writearray' + $ .or.line(i:j).eq.'writehisto')then + + if(nopen.eq.-1)then !second run + ih=0 + if(line(i:j).eq.'writearray') ih=1 + call utword(line,i,j,0) + if(line(i:j).eq.'s')then + call utword(line,i,j,0) + linex=line + ix=i + jx=j + call utword(line,i,j,0) + if(linex(ix:jx).eq.'inicon')stop'error 060307' + else + ioint=0 + iocontr=0 + ncontr=0 + if(line(i:j).eq.'int')then + ioint=1 + call utword(line,i,j,0) + endif + if(line(i:j).eq.'contr')then + iocontr=1 + call utword(line,i,j,0) + read(line(i:j),*)val + ncontr=nint(val) + call utword(line,i,j,0) + endif + read(line(i:j),*)val + nco=nint(val) + if(ih.eq.1)write(ifhi,'(a,i3)')'array',nco + if(ioint.eq.0)then + sum=0 + averg=0 + do k=1,nrbins + if(iocontr.eq.0.and.ionoerr.eq.0)then + ar3=ar(k,3) + ar4=ar(k,4) + elseif(ionoerr.eq.1)then + ar3=ar(k,3) + ar4=ar(k,4) + elseif(ionoerr.eq.2)then + ar3=ar(k,3) + ar4=ar(k,4) + ar5=ar(k,5) + else + ar3=ary(k,ncontr) + ar4=ardy(k,ncontr) + endif + iok=1 + if(k.lt.ibmin.or.k.gt.ibmax)iok=0 + sum=sum+ar3 + averg=averg+ar(k,1)*ar3 + if(nco.eq.2)then + if(nozero.eq.1.and.ar3.eq.0.)iok=0 + if(iok.eq.1)write(ifhi,'(3e12.4)')ar(k,1),ar3 + elseif(nco.eq.3)then + if(nozero.eq.1.and.ar3.eq.0..and.ar4.eq.0.)iok=0 + if(iok.eq.1)write(ifhi,'(3e12.4)')ar(k,1),ar3,ar4 + elseif(nco.eq.4)then + if(nozero.eq.1.and.ar3.eq.0..and.ar4.eq.0..and.ar5.eq.0.)iok=0 + if(iok.eq.1)write(ifhi,'(4e12.4)')ar(k,1),ar3,ar4,ar5 + endif + enddo + if(sum.gt.0.)averg=averg/sum + else + sum=0. + sum2=0. + sum3=0. + err2=0. + do k=1,nrbins + if(iocontr.eq.0.and.ionoerr.eq.0)then + ar3=ar(k,3) + ar4=ar(k,4) + elseif(ionoerr.eq.1)then + ar3=ar(k,3) + ar4=ar(k,4) + elseif(ionoerr.eq.2)then + ar3=ar(k,3) + ar4=ar(k,4) + ar5=ar(k,5) + else + ar3=ary(k,ncontr) + ar4=ardy(k,ncontr) + endif + sum=sum+ar3*(ar(2,1)-ar(1,1)) + if(nco.eq.2)write(ifhi,'(3e12.4)')ar(k,1),sum + if(ionoerr.eq.0)then + err2=err2+(ar4*(ar(2,1)-ar(1,1)))**2 + if(nco.eq.3)write(ifhi,'(3e12.4)')ar(k,1),sum,sqrt(err2) + elseif(ionoerr.eq.1)then + sum2=sum2+(ar4*(ar(2,1)-ar(1,1))) + if(nco.eq.3)write(ifhi,'(3e12.4)')ar(k,1),sum,sum2 + elseif(ionoerr.eq.2)then + sum2=sum2+(ar4*(ar(2,1)-ar(1,1))) + sum3=sum3+(ar5*(ar(2,1)-ar(1,1))) + if(nco.eq.3)write(ifhi,'(3e12.4)')ar(k,1),sum,sum2 + if(nco.eq.4)write(ifhi,'(3e12.4)')ar(k,1),sum,sum2,sum3 + endif + enddo + endif + if(ih.eq.1)write(ifhi,'(a)')' endarray' + endif + else !nopen .ge. 0 -- first run + call utword(line,i,j,0) + if(line(i:j).eq.'s')then + call utword(line,i,j,0) + call utword(line,i,j,0) + elseif(line(i:j).eq.'int')then + call utword(line,i,j,0) + elseif(line(i:j).eq.'contr')then + call utword(line,i,j,0) + call utword(line,i,j,0) + endif + endif + nozero=0 + ibmin=1 + ibmax=1e8 + + else + + write(ifmt,'(a,a,a)')'command "',line(i:j),'" not found' + j=1000 + stop + + endif + + i=j+1 + goto 1 + + end + +c----------------------------------------------------------------------- + subroutine aseed(modus) +c----------------------------------------------------------------------- + + include 'epos.inc' + double precision seedf + call utpri('aseed ',ish,ishini,3) + + call ranfgt(seedf) + if(iwseed.eq.1)then + if(nrevt.eq.0)then + write(ifmt,'(a,i10,d27.16)')'seedj:',nint(seedj),seedf + elseif(mod(nrevt,modsho).eq.0)then + if(modus.eq.1) + * write(ifmt,'(a,i10,5x,a,i10,a,d27.16)') + * 'nrevt:',nrevt,'seedj:',nint(seedj),' seedf:',seedf + if(modus.eq.2) + * write(ifmt,'(a,i10,d27.16)')'seed:',nint(seedj),seedf + endif + if(jwseed.eq.1)then + open(unit=1,file=fnch(1:nfnch-5)//'see',status='unknown') + write(1,'(a,i10,5x,a,i10,a,d27.16)') + * 'nrevt:',nrevt,'seedj:',nint(seedj),' seedf:',seedf + close(1) + endif + endif + seedc=seedf + + call utprix('aseed ',ish,ishini,3) + return + end + +c----------------------------------------------------------------------- + subroutine aseedi +c----------------------------------------------------------------------- + + include 'epos.inc' + call utpri('aseedi',ish,ishini,3) + + if(ish.ge.1)write(ifmt,'(a,i10)')'seedi:',nint(seedi) + + call utprix('aseedi',ish,ishini,3) + return + end + +c$$$c----------------------------------------------------------------------- +c$$$ subroutine aseed(modus) !Flush ???? +c$$$c----------------------------------------------------------------------- +c$$$ +c$$$ include 'epos.inc' +c$$$ double precision seedf +c$$$ call utpri('aseed',ish,ishini,4) +c$$$ +c$$$ call ranfgt(seedf) +c$$$ if(modus.eq.2)then +c$$$ write(ifmt,'(a,d26.15)')'seed:',seedf +c$$$ elseif(modus.eq.1)then +c$$$ if(mod(nrevt,modsho).eq.0)then +c$$$ write(ifmt,100)'nrevt:',nrevt,'seedf:',seedf +c$$$ call flush(ifmt) +c$$$ endif +c$$$ endif +c$$$ seedc=seedf +c$$$ +c$$$ 100 format(a,i10,10x,a,d26.15) +c$$$ call utprix('aseed',ish,ishini,4) +c$$$ return +c$$$ end +c$$$ +c----------------------------------------------------------------------- + subroutine astati +c----------------------------------------------------------------------- + + include 'epos.inc' + common/geom/rmproj,rmtarg,bmax,bkmx + common/ghecsquel/anquasiel,iquasiel + + call utpri('astati',ish,ishini,1) + if(ish.ge.1.and.iappl.eq.1.)then + if(abs(accept+reject).gt.1.e-5)write(ifch,'(a,f9.5)') + *'EMS acc.rate:',accept/(accept+reject) + if(antot.ne.0.)write(ifch,*)'initial soft,hard(%)' + * ,ansf/antot*100. + * ,ansh/antot*100.,' of' ,antot + if(antotf.ne.0.)write(ifch,*)'final soft,hard(%)' + * ,ansff/antotf*100. + * ,anshf/antotf*100.,' of' ,antotf + if(antotre.ne.0.)write(ifch,*) + * 'droplet,string(+d),reson(+d), (had)(%) ' + if(antotre.ne.0.)write(ifch,*)' ' + * ,andropl/antotre*100. + * ,anstrg0/antotre*100. + * ,'(',anstrg1/antotre*100.,') ' + * ,anreso0/antotre*100. + * ,'(',anreso1/antotre*100.,') ' + if(antotre.ne.0.)write(ifch,*)' ' + * ,' (',anghadr/antotre*100.,')',' of' ,antotre + if(pp4ini.gt.0.)write(ifch,*)'Energy loss',(pp4ini-pp4max)/pp4ini + write(ifch,*)'ine cross section:',sigineex + write(ifch,*)'diffr cross section:',sigdifex + write(ifch,*)'SD cross section:',sigsdex +c if(model.eq.3)write(ifch,*)'quasi-elastic cross section:' +c &,anquasiel/float(ntevt)*a*10 + endif + +c$$$ call testconex(3) + + if(iprmpt.le.0)goto1000 + + write(ifch,'(77a1)')('-',i=1,77) + write(ifch,'(a)')'statistics' + write(ifch,'(77a1)')('-',i=1,77) + write(ifch,'(a,i6)')'nr of messages:',imsg + write(ifch,'(a,i8)')'maximum nptl:',nptlu + write(ifch,'(77a1)')('-',i=1,77) + +1000 continue + call utprix('astati',ish,ishini,1) + + return + end + +c----------------------------------------------------------------------- + subroutine atitle +c----------------------------------------------------------------------- + + include 'epos.inc' + + if(iLHC.eq.1)then + write(ifmt,'(67a1/a1,8x,a,5x,a,23x,a1/a,22x,a,13x,a1/67a1)') + *('#',l=1,68),'EPOS LHC ' + *,'K. WERNER, T. PIEROG','#' + *,'#','Contact: tanguy.pierog@kit.edu' + *,('#',l=1,68) + write(ifmt,'(a,8x,a,11x,a/a,5x,a,6x,a/67a1)') + * '#','WARNING: This is a special retuned version !!!','#' + *,'#','Do not publish results without contacting the authors.','#' + *,('#',l=1,67) + else + write(ifmt,'(67a1/a1,8x,a,f5.2,5x,a,7x,a1/a,22x,a,10x,a1/67a1)') + *('#',l=1,68),'EPOS',iversn/100. + *,'K. WERNER, T. PIEROG, S. PORTEBOEUF.','#' + *,'#','Contact: werner@subatech.in2p3.fr' + *,('#',l=1,68) + endif + if(iversn.eq.iverso)return + write(ifmt,'(a,8x,a,10x,a/a,5x,a,6x,a/67a1)') + * '#','WARNING: This is a non-official beta version!!!','#' + *,'#','Do not publish results without contacting the authors.','#' + *,('#',l=1,67) + + return + end + +c----------------------------------------------------------------------- + subroutine avehep +c----------------------------------------------------------------------- + + include 'epos.inc' + + call utpri('avehep',ish,ishini,4) + + + call utprix('avehep',ish,ishini,4) + end + + +c----------------------------------------------------------------------- + subroutine aepos(nin) +c----------------------------------------------------------------------- +c Generate event +c * calculates numbers of spectators: +c npnevt (number of primary proj neutron spectators) +c nppevt (number of primary proj proton spectators) +c ntnevt (number of primary targ neutron spectators) +c ntpevt (number of primary targ proton spectators) +c jpnevt (number of absolute proj neutron spectators) +c jppevt (number of absolute proj proton spectators) +c jtnevt (number of absolute targ neutron spectators) +c jtpevt (number of absolute targ proton spectators) +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + double precision eppass,etpass + common/emnpass/eppass(mamx,4),etpass(mamx,4) + common/photrans/phoele(4),ebeam +c integer iutime(5) + call utpri('aepos',ish,ishini,4) + +c call timer(iutime) +c timeini=iutime(3)+float(iutime(4))/1000. + if(ish.ge.2)then + call alist('start event&',0,0) + write(ifch,*)'event number:',nrevt+1 + endif + +c if random sign for projectile, set it here + if(irdmpr.ne.0.and.laproj.eq.-1)then + idproj=idprojin*(1-2*int(rangen()+0.5d0)) + call emsini(engy,idproj,idtarg) !recall emsini to set initial valence quark properly + endif + +c for Air target, set the target nucleus + if(idtargin.eq.0.and.model.ne.6)then + call getairmol(latarg,matarg) + if(ish.ge.2)write(ifch,*)'Air Target, select (Z,A) :' + & ,latarg,matarg + endif + + if(iappl.eq.4)then + ntry=0 + 1 ntry=ntry+1 + if(ntry.gt.100)stop'in aepos, to many amicro attempts. ' + call amicro(iret) + if(iret.ne.0)goto 1 + if(ish.ge.2)call alist('list before int/decays&',1,nptl) + nevt=1 + nbdky=nptl + call bjinta(ier) + if(ier.eq.1)stop'error in bjinta' + if(ish.ge.2)call alist('list after int/decays&',1,nptl) + goto 1000 + endif + + if(iappl.eq.9)then + call ahydro + if(ish.ge.2)call alist('list before int/decays&',1,nptl) + nevt=1 + nbdky=nptl + call bjinta(ier) + if(ier.eq.1)stop'error in bjinta' + if(ish.ge.2)call alist('list after int/decays&',1,nptl) + goto 1000 + endif + + ntry=0 + nptly=0 + if(nin.le.1)bimevt=-1 +c save statistic at last inelastic event + ntevt0=ntevt + andropl0=andropl + anstrg00=anstrg0 + anstrg10=anstrg1 + anreso00=anreso0 + anreso10=anreso1 + anghadr0=anghadr + antotre0=antotre + anintdiff0=anintdiff + anintsdif0=anintsdif + anintine0=anintine + 3 continue !set value back to last inelastic event + ntevt=ntevt0 + andropl=andropl0 + anstrg0=anstrg00 + anstrg1=anstrg10 + anreso0=anreso00 + anreso1=anreso10 + anghadr=anghadr0 + antotre=antotre0 + anintdiff=anintdiff0 + anintsdif=anintsdif0 + anintine=anintine0 +c elastic event + 2 ntevt=ntevt+1 + iret=0 + ntry=ntry+1 + if(iappl.eq.1.or.iappl.eq.2)naevt=naevt+1 + 5 nevt=0 + if(nrevt.eq.0)nptly=nptl + if(iappl.ne.5)call cleanup + nptl=0 + + minfra=mxptl + maxfra=0 + if(iappl.eq.1.or.iappl.eq.2)then !---hadron---geometry--- + if(iret.eq.0.and.ntry.lt.10000.and.engy.ge.egymin)then !if no inel scattering -> nothing ! + if(model.eq.1)then + call emsaaa(iret) + else + call emsaaaModel(model,idtargin,iret) + endif + if(iret.eq.-2)then !ncol=0 (force elastic) + goto 5 + elseif(iret.lt.0)then !ncol=0 + goto 2 + elseif(iret.gt.0)then + goto 3 !error + endif + else + if(iret.eq.0)then + ntevt=ntevt0+100 + if(ish.ge.2) + & write(ifch,*)'Nothing done after ',ntry,' ntry ... continue' + if(ish.ge.1) + & write(ifmt,*)'Nothing done after ',ntry,' ntry ... continue' + elseif(ish.ge.2)then + write(ifch,*)'Elastic event.' + endif + iret=0 + nevt=1 + call conre !define projectile and target (elastic scattering) + call conwr !when the MC is suppose to produce something but failed + do i=1,nptl !activate projectile and target as final particles + istptl(i)=0 + iorptl(i)=0 + enddo + endif + if(iappl.eq.2)then + nevt=1 + goto 1000 + endif + + elseif(iappl.eq.3.or.iappl.eq.-1) then + nevt=1 + call bread + if(ish.ge.2)call alist('list after reading&',1,nptl) + goto 500 + + elseif(iappl.eq.5) then !---kinky--- + nptl=nptly + nevt=1 + do i=1,nptl + istptl(i)=20 + enddo + + elseif(iappl.eq.6)then !---ee--- + + call timann + nevt=1 + + elseif(iappl.eq.7)then !---decay--- + + call conwr + nevt=1 + + elseif(iappl.eq.8)then !---lepton--- + + call psadis(iret) + if(iret.gt.0)goto5 + nevt=1 + + endif + + if(nevt.eq.0)stop'************ should not be ***************' + + if(ish.ge.2)call alist('list before fragmentation&',1,nptl) + nptlx=nptl+1 + if(iappl.ne.2.and.iappl.ne.7.and.nevt.eq.1.and.ifrade.ne.0)then + iclu=0 + if(iLHC.eq.1.and.iorsdf.eq.3)iclu=1 !in case of fusion, don't use Z first time + call gakfra(iclu,iret) + if(iret.gt.0)goto 3 + maxfra=nptl + if(ish.ge.2.and.model.eq.1) + & call alist('list after fragmentation&',nptlx,nptl) + if(irescl.eq.1)then + call utghost(iret) + if(iret.gt.0)goto 3 + endif +c nptlx=nptl+1 + endif + + 500 continue + + if(ispherio.eq.1.and.irescl.eq.1)then + call utrsph(iret) + if(iret.gt.0)goto 3 + endif + + + + if(iappl.ne.2.and.nevt.eq.1)then + nbdky=nptl + call bjinta(ier) + if(ier.eq.1)goto 3 + if(iappl.eq.1.and.irescl.eq.1)then + call utresc(iret) + if(iret.gt.0)goto 3 + endif + +c calculates numbers of spectators: + + npnevt=0 + nppevt=0 + ntnevt=0 + ntpevt=0 + jpnevt=0 + jppevt=0 + jtnevt=0 + jtpevt=0 + if(ish.ge.2)write(ifch,'(/31a1/a/31a1)')('-',l=1,31) + * ,'primary and absolute spectators',('-',l=1,31) + if(ish.ge.3)write(ifch,'(/a//a/)')'projectile nucleons:' + * ,' i id ior ist' + do i=1,maproj + if(ish.ge.3)write(ifch,'(4i6)')i,idptl(i),iorptl(i),istptl(i) + io=iorptl(i) + id=idptl(i) + is=istptl(i) + if(io.eq.0.and.id.eq.1220)npnevt=npnevt+1 + if(io.eq.0.and.id.eq.1120)nppevt=nppevt+1 + if(io.eq.0.and.is.eq.0.and.id.eq.1220)jpnevt=jpnevt+1 + if(io.eq.0.and.is.eq.0.and.id.eq.1120)jppevt=jppevt+1 + enddo + if(ish.ge.3)write(ifch,'(/a//a/)')'target nucleons:' + * ,' i id ior ist' + do i=maproj+1,maproj+matarg + if(ish.ge.3)write(ifch,'(4i6)')i,idptl(i),iorptl(i),istptl(i) + io=iorptl(i) + id=idptl(i) + is=istptl(i) + if(io.eq.0.and.id.eq.1220)ntnevt=ntnevt+1 + if(io.eq.0.and.id.eq.1120)ntpevt=ntpevt+1 + if(io.eq.0.and.is.eq.0.and.id.eq.1220)jtnevt=jtnevt+1 + if(io.eq.0.and.is.eq.0.and.id.eq.1120)jtpevt=jtpevt+1 + enddo + if(ish.ge.2)then + write(ifch,'(/a/)')'numbers of participants and spectators:' + write(ifch,'(a,i4,a,i4)')'primary participants: projectile:' + * ,npjevt,' target:',ntgevt + write(ifch,'(a,i4,a,i4)')'primary spectators: projectile:' + * ,npnevt+nppevt,' target:',ntnevt+ntpevt + write(ifch,'(a,i4,a,i4)') + * 'primary spectator neutrons: projectile:',npnevt + * ,' target:',ntnevt + write(ifch,'(a,i4,a,i4)') + * 'primary spectator protons: projectile:',nppevt + * ,' target:',ntpevt + write(ifch,'(a,i4,a,i4)')'absolute spectators: projectile:' + * ,jpnevt+jppevt,' target:',jtnevt+jtpevt + endif + +c Form nuclear fragments + if(model.eq.1.and.(maproj.gt.1.or.matarg.gt.1))then + call emsfrag(iret) + if(iret.gt.0)goto 3 + endif + + if(ish.ge.1)then + if(abs(iappl).eq.1.or.iappl.eq.3)then + numbar=0 + pp4=0. + do j=1,nptl + if(istptl(j).eq.0)then + if(idptl(j).gt. 1000.and.idptl(j).lt. 10000)numbar=numbar+1 + if(idptl(j).lt.-1000.and.idptl(j).gt.-10000)numbar=numbar-1 + if(abs(idptl(j)).eq.17)then + numbar=numbar+sign(2,idptl(j)) + elseif(abs(idptl(j)).eq.18)then + numbar=numbar+sign(3,idptl(j)) + elseif(abs(idptl(j)).eq.19)then + numbar=numbar+sign(4,idptl(j)) + elseif(abs(idptl(j)).gt.1000000000)then + numbar=numbar+mod(idptl(j),10000)/10 + endif + if((((idptl(j).eq.1120.or.idptl(j).eq.1220) + * .and.idproj.gt.1000).or.(iabs(idptl(j)).gt.100 + * .and.idproj.lt.1000)).and.pptl(4,j) + * .gt.pp4.and.pptl(3,j).gt.0.)pp4=pptl(4,j) + endif + enddo + pp4max=pp4max+pp4 + pp4ini=pp4ini+pptl(4,1) + nvio=isign(matarg,idtarg)-numbar + if(iabs(idproj).gt.1000)then + nvio=nvio+isign(maproj,idproj) + elseif(iabs(idproj).eq.17)then + nvio=nvio+isign(2,idproj) + elseif(iabs(idproj).eq.18)then + nvio=nvio+isign(3,idproj) + elseif(iabs(idproj).eq.19)then + nvio=nvio+isign(4,idproj) + endif + if(ish.ge.2)write (ifch,*)'- Baryon number conservation : ' + & ,nvio,' -' + + endif + if(ish.ge.2.and.ifrade.ne.0) + * call alist('list after int/decays&',1,nptl) + endif + endif + + + if((iappl.eq.1.or.iappl.eq.2).and.nevt.eq.0)then + if(nin.le.1)bimevt=-1 + goto 2 + endif + + if(ifrade.ne.0.and.iappl.eq.2.and. + $ idproj.eq.1120.and.idtarg.eq.1120)then + numbar=0 + do j=1,nptl + if(istptl(j).eq.0)then + if(idptl(j).gt. 1000.and.idptl(j).lt. 10000)numbar=numbar+1 + if(idptl(j).lt.-1000.and.idptl(j).gt.-10000)numbar=numbar-1 + endif + enddo + nvio=maproj+matarg-numbar + if(nvio.ne.0)then + call alist('complete list&',1,nptl) + write(6,'(//10x,a,i3//)')'ERROR: baryon number violation:',nvio + write(6,'(10x,a//)') + * 'a complete list has been printed into the check-file' + stop + endif + endif + + + ifirst=0 + if(nrevt+1.eq.1)ifirst=1 + if(jpsi.gt.0)then + npjpsi=0 + do i=1,jpsi + call jpsifo(npjpsi) + call jpsian(ifirst) + enddo + if(ish.ge.1)call jtauan(0,0) + if(nrevt+1.eq.nevent)call jpsihi + endif + + if(ixtau.eq.1)call xtauev(1) + +1000 continue + if(iabs(nin).eq.iabs(ninicon))nrevt=nrevt+1 + + nglacc=nglacc+nglevt + +c call timer(iutime) +c timefin=iutime(3)+float(iutime(4))/1000. + call utprix('aepos',ish,ishini,4) + return + end + +c----------------------------------------------------------------------- + subroutine cleanup +c----------------------------------------------------------------------- + include 'epos.inc' + do i=1,nptl + do k=1,5 + pptl(k,i)=0 + enddo + iorptl(i) =0 + jorptl(i) =0 + idptl(i) =0 + istptl(i) =0 + tivptl(1,i)=0 + tivptl(2,i)=0 + ifrptl(1,i)=0 + ifrptl(2,i)=0 + ityptl(i) =0 + iaaptl(i) =0 + radptl(i) =0 + dezptl(i) =0 + itsptl(i) =0 + rinptl(i) =-9999 + do k=1,4 + xorptl(k,i)=0 + ibptl(k,i) =0 + enddo + enddo + end + +c----------------------------------------------------------------------- + subroutine emsaaa(iret) +c----------------------------------------------------------------------- +c basic EMS routine to determine Pomeron configuration +c----------------------------------------------------------------------- + + include 'epos.inc' + common/col3/ncol,kolpt + + call utpri('emsaaa',ish,ishini,4) + if(ish.ge.3)call alist('Determine Pomeron Configuration&',0,0) + + iret=0 + + nptl=0 + call conaa(iret) + if(iret.gt.0)goto 1001 !no interaction + if(iappl.eq.2.and.ixgeometry.eq.1)call xGeometry(1) + if(iappl.eq.2)goto 1000 + call conre + call conwr + call GfunParK(iret) + if(iret.gt.0)goto 1000 !error + if(ionudi.eq.0 + & .and.(maproj.ne.1.or.matarg.ne.1).and.nglevt.eq.0)goto 1001 + call integom1(iret) + if(iret.gt.0)goto 1000 !error + call emsaa(iret) + if(iret.gt.0)goto 1000 !error + if(ncol.eq.0)goto 1001 !no interaction + +1000 call utprix('emsaaa',ish,ishini,4) + return + +1001 iret=-1 !no interaction + goto 1000 + + end + + +c---------------------------------------------------------------------- + subroutine alist(text,n1,n2) +c---------------------------------------------------------------------- +c ior jor i ifr1 ifr2 id ist ity pt m y +c---------------------------------------------------------------------- +c ist ity +c light cluster ........ 19 +c ptl ... 0 1 soft pom ............. 20-23 25(reggeon) +c clu ... 10 11 hard pom low mass .... 30 +c ptn ... 20 21 proj remnant ......... 40-49 +c str ... 29 targ remnant ......... 50-59 +c pom ... 30 31 32(virtual) cluster .............. 60 +c rem ... 40 41 direct photon ........ 71,72 +c---------------------------------------------------------------------- + include 'epos.inc' + common/cxyzt/xptl(mxptl),yptl(mxptl),zptl(mxptl),tptl(mxptl) + *,optl(mxptl),uptl(mxptl),sptl(mxptl),rptl(mxptl,3) +c parameter(itext=40) + character text*(*) + dimension pp(5) + if(n1.gt.n2)return + imax=index(text,'&') + if(imax.gt.1)then + write(ifch,'(/1x,89a1/1x,a,a,a,90a1)') + *('#',k=1,89),'############ ',text(1:imax-1),' ' + *,('#',k=1,74-imax) + write(ifch,'(1x,89a1/)')('#',k=1,89) + endif + if(n1.eq.0.and.n2.eq.0)return + if(imax.gt.1)then + write(ifch,'(1x,a,a/1x,89a1)') + *' ior jor i ifr1 ifr2 id ist ity', + *' pt m E y' + *,('-',k=1,89) + endif + + do j=1,5 + pp(j)=0. + enddo + nqu=0 + nqd=0 + nqs=0 + do i=n1,n2 + ptptl=pptl(1,i)**2.+pptl(2,i)**2. + if(ptptl.le.0.)then + ptptl=0. + else + ptptl=sqrt(ptptl) + endif + amtptl=pptl(1,i)**2.+pptl(2,i)**2.+pptl(5,i)**2. + if(amtptl.le.0.)then + amtptl=0. + if(abs(idptl(i)).lt.10000)then + call idmass(idptl(i),amtptl) + endif + amtptl=sqrt(amtptl*amtptl+pptl(1,i)**2.+pptl(2,i)**2.) + else + amtptl=sqrt(amtptl) + endif + rap=0. + if(amtptl.gt.0..and.pptl(4,i).gt.0.) + & rap=sign(1.,pptl(3,i))*alog((pptl(4,i)+abs(pptl(3,i)))/amtptl) + write(ifch,'(1x,i6,i6,i6,i6,i6,i10,2i3,2x,4(e9.3,1x),$)') + & iorptl(i),jorptl(i),i,ifrptl(1,i),ifrptl(2,i) + & ,idptl(i),istptl(i),ityptl(i),ptptl,pptl(5,i),pptl(4,i),rap + write(ifch,*)' ' +c if(istptl(i).ne.12)write(ifch,*)' ' +c if(istptl(i).eq.12)write(ifch,'(1x,3(e9.3,1x))') +c & sptl(i),sqrt(uptl(i)-xorptl(1,i)**2) +c & ,sqrt(optl(i)-xorptl(2,i)**2) + if(mod(istptl(i),10).eq.0.and.n1.eq.1.and.n2.eq.nptl)then + do j=1,4 + pp(j)=pp(j)+pptl(j,i) + enddo + if(istptl(i).ne.40.and.istptl(i).ne.30)then + call idqufl(i,idptl(i),ifl1,ifl2,ifl3) + nqu=nqu+ifl1 + nqd=nqd+ifl2 + nqs=nqs+ifl3 + endif + endif + enddo + end + +c---------------------------------------------------------------------- + subroutine blist(text,n1,n2) +c---------------------------------------------------------------------- + include 'epos.inc' +c parameter(itext=40) + character text*(*) + dimension pp(5) + if(n1.gt.n2)return + imax=index(text,'&') + if(imax.gt.1)then + write(ifch,'(/1x,89a1/1x,a,a,a,90a1)') + *('#',k=1,89),'############# ',text(1:imax-1),' ' + *,('#',k=1,74-imax) + write(ifch,'(1x,89a1/)')('#',k=1,89) + endif + if(n1.eq.0.and.n2.eq.0)return + if(imax.gt.1)then + write(ifch,'(1x,a,a,a/1x,90a1)') + *' ior jor i ifr1 ifr2 id ist ity', + *' pt mass energy',' rap' + *,('-',k=1,90) + endif + + do j=1,5 + pp(j)=0. + enddo + nqu=0 + nqd=0 + nqs=0 + do i=n1,n2 + amtptl=pptl(1,i)**2.+pptl(2,i)**2.+pptl(5,i)**2. + if(amtptl.le.0.)then + amtptl=0. + if(abs(idptl(i)).lt.10000)then + call idmass(idptl(i),amtptl) + endif + amtptl=sqrt(amtptl*amtptl+pptl(1,i)**2.+pptl(2,i)**2.) + else + amtptl=sqrt(amtptl) + endif + pt=pptl(1,i)**2.+pptl(2,i)**2. + if(pt.gt.0.)pt=sqrt(pt) + rap=0. + if(amtptl.gt.0..and.pptl(4,i).gt.0.) + & rap=sign(1.,pptl(3,i))*alog((pptl(4,i)+abs(pptl(3,i)))/amtptl) + write(ifch,125)iorptl(i),jorptl(i),i,ifrptl(1,i),ifrptl(2,i) + & ,idptl(i),istptl(i),ityptl(i) + & ,pt,pptl(5,i),pptl(4,i),rap + 125 format (1x,i6,i6,i6,i6,i6,i10,2i3,2x,5(e9.3,1x) + * ,f9.2,4x,5(e8.2,1x)) + if(mod(istptl(i),10).eq.0.and.n1.eq.1.and.n2.eq.nptl)then + do j=1,4 + pp(j)=pp(j)+pptl(j,i) + enddo + if(istptl(i).ne.40.and.istptl(i).ne.30)then + call idqufl(i,idptl(i),ifl1,ifl2,ifl3) + nqu=nqu+ifl1 + nqd=nqd+ifl2 + nqs=nqs+ifl3 + endif + endif + enddo + end + +c---------------------------------------------------------------------- + subroutine clist(text,n1,n2,ity1,ity2) +c---------------------------------------------------------------------- + include 'epos.inc' +c parameter(itext=40) + character text*(*) + dimension pp(5) + if(n1.gt.n2)return + imax=index(text,'&') + if(imax.gt.1)then + write(ifch,'(/1x,a,a,a,90a1)') + *'------------- ',text(1:imax-1),' ',('-',k=1,74-imax) + endif + if(n1.eq.0.and.n2.eq.0)return + if(imax.gt.1)then + write(ifch,'(1x,a,a/1x,90a1)') + *' i id ist ity', + *' pt pz p0 mass' + *,('-',k=1,90) + endif + + do j=1,5 + pp(j)=0. + enddo + do i=n1,n2 + pt=sqrt(pptl(1,i)**2+pptl(2,i)**2) + write(ifch,127)i,idptl(i),istptl(i),ityptl(i) + & ,pt,pptl(3,i),pptl(4,i),pptl(5,i) + 127 format (1x,i6,i10,2i3,2x,4(e9.3,1x)) + if(ityptl(i).ge.ity1.and.ityptl(i).le.ity2)then + do j=1,4 + pp(j)=pp(j)+pptl(j,i) + enddo + endif + enddo + write(ifch,'(90a1)')('-',k=1,90) + write(ifch,127)0,0,0,0 + & ,sqrt(pp(1)**2+pp(2)**2),pp(3),pp(4) + & ,sqrt(max(0.,pp(4)-pp(3))*max(0.,pp(4)+pp(3))-pp(1)**2-pp(2)**2) + write(ifch,*)' ' + end + +c---------------------------------------------------------------------- + subroutine alistf(text) +c---------------------------------------------------------------------- + include 'epos.inc' +c parameter(itext=40) + character text*(*) + dimension pp(5),erest(5),errp(4) + n1=1 + if(iframe.eq.21.and.(abs(iappl).eq.1.or.iappl.eq.3)) + *n1=2*(maproj+matarg+1) + n2=nptl + imax=index(text,'&') + if(imax.gt.1)then + write(ifch,'(/1x,124a1/1x,a,a,a,108a1)') + *('#',k=1,124),'############# ',text(1:imax-1),' ' + *,('#',k=1,108-imax) + write(ifch,'(1x,124a1/)')('#',k=1,124) + endif + if(imax.gt.1)then + write(ifch,'(1x,a,a,a/1x,124a1)') + *' ior jor i ifr1 ifr2 id ist ity', + *' px py pz p0 mass', + *' rap' + *,('-',k=1,124) + endif + + do j=1,4 + pp(j)=0. + errp(j)=0. + enddo + pp(5)=0. + do i=n1,n2 + if(istptl(i).eq.0)then + amtptl=pptl(1,i)**2.+pptl(2,i)**2.+pptl(5,i)**2. + if(amtptl.le.0.)then + amtptl=0. + if(abs(idptl(i)).lt.10000)then + call idmass(idptl(i),amtptl) + endif + amtptl=sqrt(amtptl*amtptl+pptl(1,i)**2.+pptl(2,i)**2.) + else + amtptl=sqrt(amtptl) + endif + rap=0. + if(amtptl.gt.0..and.pptl(4,i).gt.0.) + & rap=sign(1.,pptl(3,i))*alog((pptl(4,i)+abs(pptl(3,i)))/amtptl) + write(ifch,125)iorptl(i),jorptl(i),i,ifrptl(1,i),ifrptl(2,i) + & ,idptl(i),istptl(i),ityptl(i),(pptl(j,i),j=1,5),rap +c &,(xorptl(j,i),j=1,4) + do j=1,4 + pp(j)=pp(j)+pptl(j,i) + enddo + endif + enddo + 125 format (1x,i6,i6,3x,i6,3x,i6,i6,i12,2i4,4x,5(e10.4,1x) + * ,f9.2,4x,4(e8.2,1x)) + 126 format (51x,5(e10.4,1x)) + 128 format (51x,65('-')) + pp(5)=(pp(4)-pp(3))*(pp(4)+pp(3))-pp(2)**2-pp(1)**2 + if(pp(5).gt.0.)then + pp(5)=sqrt(pp(5)) + else + pp(5)=0. + endif + write (ifch,128) + write (ifch,126) (pp(i),i=1,5) + erest(1)=0. + erest(2)=0. + if(iframe.eq.22.and.(abs(iappl).eq.1.or.iappl.eq.3))then + i=maproj+matarg+1 + erest(3)=pptl(3,i)+matarg*pptl(3,i+1) + erest(4)=pptl(4,i)+matarg*pptl(4,i+1) + else + erest(3)=maproj*pptl(3,1)+matarg*pptl(3,maproj+1) + erest(4)=maproj*pptl(4,1) + & +matarg*pptl(4,maproj+1) + endif + erest(5)=amproj + write (ifch,129) (erest(j),j=1,5) + 129 format (50x,'(',5(e10.4,1x),')') + do j=1,4 + if(abs(pp(j)).gt.0.d0)errp(j)=100.*(pp(j)-erest(j))/pp(j) + enddo + write (ifch,130) (errp(j),j=1,4) + 130 format (50x,'(',3x,4(f7.2,4x),2x,'err(%))') + end + +c---------------------------------------------------------------------- + subroutine alist2(text,n1,n2,n3,n4) +c---------------------------------------------------------------------- + include 'epos.inc' +c parameter(itext=40) + character text*(*) + if(n1.gt.n2)return + imax=index(text,'&') + write(ifch,'(1x,a,a,a)') + *'--------------- ',text(1:imax-1),' --------------- ' + do i=n1,n2 + write(ifch,125)iorptl(i),jorptl(i),i,ifrptl(1,i),ifrptl(2,i) + &,idptl(i),istptl(i),ityptl(i),(pptl(j,i),j=1,5) +c &,(xorptl(j,i),j=1,4) + enddo + write(ifch,'(1x,a)')'----->' + do i=n3,n4 + write(ifch,125)iorptl(i),jorptl(i),i,ifrptl(1,i),ifrptl(2,i) + &,idptl(i),istptl(i),ityptl(i),(pptl(j,i),j=1,5) +c &,(xorptl(j,i),j=1,4) + enddo + 125 format (1x,i6,i6,3x,i6,3x,i6,i6,i12,2i4,4x,5(e8.2,1x)) +c *,4x,4(e8.2,1x)) + end + +c---------------------------------------------------------------------- + subroutine alistc(text,n1,n2) +c---------------------------------------------------------------------- + include 'epos.inc' +c parameter(itext=40) + character text*(*) + if(n1.gt.n2)return + imax=index(text,'&') + if(n1.ne.n2)write(ifch,'(1x,a,a,a)') + *'--------------- ',text(1:imax-1),' --------------- ' + do i=n1,n2 + write(ifch,130)iorptl(i),jorptl(i),i,ifrptl(1,i),ifrptl(2,i) + &,idptl(i),istptl(i),ityptl(i),(pptl(j,i),j=1,5) + &,(xorptl(j,i),j=1,4),tivptl(1,i),tivptl(2,i) + enddo + 130 format (1x,i6,i6,3x,i6,3x,i6,i6,i12,2i4,4x,5(e8.2,1x) + *,4x,6(e8.2,1x)) + end + +c----------------------------------------------------------------------- + subroutine sigmaint(g0,gz,sigdo) +c----------------------------------------------------------------------- +c hadron-hadron cross sections integration +c----------------------------------------------------------------------- + common /ar3/ x1(7),a1(7) + include 'epos.inc' + include 'epos.incpar' + include 'epos.incsem' + include 'epos.incems' + double precision PhiExact,vvv11,vvv12,vvv21,om1intbi!,PomNbri + *,vvv22,ww01,ww02,ww11,ww12,ww21,ww22,gz(0:3) + *,vvv11e,vvv12e,vvv21e,vvv22e,PhiExpo + + kollini=koll + koll=1 +c rs=r2had(iclpro)+r2had(icltar)+slopom*log(engy**2) + rs=r2had(iclpro)+r2had(icltar)+max(slopom,slopoms)*log(engy**2) + & +gwidth*(r2had(iclpro)+r2had(icltar)) + & +bmxdif(iclpro,icltar)/4./0.0389 + rpom=4.*.0389*rs + e1=exp(-1.) +c cpt=chad(iclpro)*chad(icltar) + + gz(0)=0.d0 + gz(1)=0.d0 + gz(2)=0.d0 + gz(3)=0.d0 + + e2=engy**2 + + sigdo=0. + do i1=1,7 + do m=1,2 + + z=.5+x1(i1)*(m-1.5) + zv1=exp(-z) + zv2=(e1*z) + b1=sqrt(-rpom*log(zv1)) + b2=sqrt(-rpom*log(zv2)) + zz=0.!znurho + + if(isetcs.eq.0)then + vvv11=max(0.d0,PhiExact(zz,zz,.5,1.d0,1.d0,e2,b1)) + vvv12=max(0.d0,PhiExact(zz,zz,.5,1.d0,1.d0,e2,b2)) + vvv21=max(0.d0,PhiExact(zz,zz,1.,1.d0,1.d0,e2,b1)) + vvv22=max(0.d0,PhiExact(zz,zz,1.,1.d0,1.d0,e2,b2)) + else + vvv11=max(0.d0,PhiExpo(zz,zz,.5,1.d0,1.d0,e2,b1)) + vvv12=max(0.d0,PhiExpo(zz,zz,.5,1.d0,1.d0,e2,b2)) + vvv21=max(0.d0,PhiExpo(zz,zz,1.,1.d0,1.d0,e2,b1)) + vvv22=max(0.d0,PhiExpo(zz,zz,1.,1.d0,1.d0,e2,b2)) +c vvv11=sqrt(vvv21) +c vvv12=sqrt(vvv21) + if(isetcs.eq.1.and.ionudi.eq.1)then !to test simulations + vvv11e=max(0.d0,PhiExact(zz,zz,.5,1.d0,1.d0,e2,b1)) + vvv12e=max(0.d0,PhiExact(zz,zz,.5,1.d0,1.d0,e2,b2)) + vvv21e=max(0.d0,PhiExact(zz,zz,1.,1.d0,1.d0,e2,b1)) + vvv22e=max(0.d0,PhiExact(zz,zz,1.,1.d0,1.d0,e2,b2)) + vvv11=0.5d0*(vvv11+vvv11e) !to be as close as possible + vvv12=0.5d0*(vvv12+vvv12e) !than the value with + vvv21=0.5d0*(vvv21+vvv21e) !isetcs > 0 + vvv22=0.5d0*(vvv22+vvv22e) + endif + endif + ww11=1.d0-vvv11 + ww12=1.d0-vvv12 + ww21=1.d0-vvv21 + ww22=1.d0-vvv22 + ww01=vvv21-2d0*vvv11+1d0 + ww02=vvv22-2d0*vvv12+1d0 + + gz(0)=gz(0)+a1(i1)*(ww01+ww02/z) + gz(1)=gz(1)+a1(i1)*(ww11+ww12/z) + gz(2)=gz(2)+a1(i1)*(ww21+ww22/z) + gz(3)=gz(3)+a1(i1)*(ww11*z+ww12/z*(1.-log(z))) + + phi1=vvv21 + phi2=vvv22 + phi1x=sngl(min(50d0,exp(om1intbi(b1,2)/dble(r2hads(iclpro) + & +r2hads(icltar))))) + phi2x=sngl(min(50d0,exp(om1intbi(b2,2)/dble(r2hads(iclpro) + & +r2hads(icltar))))) + sigdo=sigdo+a1(i1)*(phi1*(phi1x-1.)+phi2*(phi2x-1.)/z) + + enddo + enddo + g0=pi*rpom*10./2. !common factor (pi*rpom because of b->z, 10 to have mbarn and /2. because z is from -1 to 1 but we need 0 to 1. + + koll=kollini + + return + end +c----------------------------------------------------------------------- + subroutine xsigma +c----------------------------------------------------------------------- +c hadron-hadron and hadron-nucleus cross sections calculation +c b - impact parameter squared (in case of hadron-nucleus interaction); +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + double precision gz(0:3),gzp(0:3),GZ0(2) +c Model 2 Common + COMMON /Q_AREA1/ IA(2),ICZ,ICP + COMMON /Q_AREA6/ PIQGS,BM,AM + COMMON /Q_AREA15/ FP(5),RQ(5),CD(5) + COMMON /Q_AREA7/ RP1 + COMMON /Q_AREA16/ CC(5) + double precision RP1,FP,RQ,CD,PIQGS,BM,AM,CC,GDP,GDT,GDD + +C...Total cross sections in Pythia + double precision SIGT + COMMON/PYINT7/SIGT(0:6,0:6,0:5) + +c Model 5 Common + COMMON/HIPARNT/HIPR1(100), IHPR2(50), HINT1(100), IHNT2(50) + +c theoretical cross sections + sigcut=0. + sigtot=0. + sigela=0. + sigine=0. + sigtotold=0. + sigtotf=0. + sigelaold=0. + sigelaf=0. + sigineold=0. + sigineaa=0. + sigtotaa=0. + sigelaaa=0. + sigcutaa=0. + sigdif=0. + sloela=0. + sigsd=0. + sigdd=0. +c simulated cross sections + sigineex=0. !calculated in ems if isigma>0 + sigdifex=0. + sigsdex=0. + + + call utpri('xsigma',ish,ishini,4) + + if(model.eq.1)then !epos + + if(icltar.ne.2)stop'xsigma: only icltar=2 allowed.' + + call sigmaint(g0,gz,sigdifold) + + sigelaold=g0*gz(0) !elastic cross section + rs=g0*0.4091 !=g0/pi/10.*2./4./.0389 + if(gz(1).gt.0d0)sloela=2.*rs*gz(3)/gz(1) + + sigineold=g0*gz(2) !inelastic pomerons cross-section + sigtotold=2.*g0*gz(1) !tot cross-section + sigdifold=sigdifold * g0 !xs in mb + sigcut=sigineold-sigdifold !cut cross section + x=engy +c fit to data + sigtotf=14.5*x**0.21+20.*x**(-0.2)+19.*(x-1.)**(-1) + sigelaf=35.*(x-1)**(-2.8)+17.*x**(-0.47)+0.31*log(x)**2 +c sigtotfp=sigtotf +c sigelafp=sigelaf + if(iclpro.eq.1)then !pi+p + sigtotf=10.*(x-1)**(-3)+16.*x**0.13+40.*x**(-1.2) + sigelaf=20.*(x-1)**(-3)+6.*x**(-0.4)+0.15*log(x)**2. + elseif(iclpro.eq.3)then !K+p + sigtotf=13.*x**0.15+35.*x**(-1.5) + sigelaf=15.*(x-1)**(-3)+5.*x**(-0.4)+0.1*log(x)**2 + elseif(iclpro.eq.4)then !D+p + sigtotf=0.!12.5*x**0.15+35.*x**(-1.5) + sigelaf=0.!15.*(x-1)**(-3)+3.*x**(-0.4)+0.2*alog(x)**2 + endif + if(engy.lt.20.)then + sigcoul=max(0.,sigtotf-sigtotold) + else + sigcoul=0. + endif + + + sigdif=sigdifold + sigdelaf=max(0.,(sigelaf+sigineold-sigtotf)) +c sigdelaf=max(0.,(sigelaf-sigelaold)) + edlim=0.015 + if(rexdifi(iclpro).lt.0..or.rexdifi(icltar).lt.0.)then +c print *,'sig',sigdelaf,sigdif,sigelaf,sigineold,sigtotf + sigdela=min(sigdelaf,sigdif) + +c calculate rexdif for proton first (always needed) + if(rexdifi(icltar).lt.0.)then +c use fit of sigela to get rexdif + if(engy.lt.min(30.,-log(-rexdifi(icltar))/edlim))then +c pi or K - p, calculate sigdif for pp + if(iclpro+icltar.ne.4)then + iclprosave=iclpro + iclpro=2 + call sigmaint(g0p,gzp,sigdifp) +c siginep=g0p*gzp(2) + sigdifp=sigdifp * g0p +c sigdelafp=max(0.,(sigelafp+siginep-sigtotfp)) +c sigdelap=min(sigdelafp,sigdifp) + iclpro=iclprosave + else + sigdifp=sigdif +c sigdelafp=sigdelaf +c sigdelap=sigdela + endif + if(sigdifp.gt.0.)then +c ratioSig=sigdelap/sigdifp +c rexdif(icltar)=1.-sqrt(ratioSig) +c if(rexdif(icltar).ge.exp(-edlim*engy)) +c & rexdif(icltar)=exp(-edlim*engy) + rexdif(icltar)=exp(-edlim*engy) + rexdif(icltar)=max(rexdif(icltar),abs(rexdifi(icltar))) + else + rexdif(icltar)=1. + endif + else +c rexdif(icltar)=max(exp(-1.7/engy**0.3),abs(rexdifi(icltar))) !strong reduction +c rexdif(icltar)=max(exp(-0.33/engy**0.066),abs(rexdifi(icltar))) !moderate one (constant sig NSD) + rexdif(icltar)=abs(rexdifi(icltar)) + endif + else + rexdif(icltar)=rexdifi(icltar) + endif + + if(iclpro.ne.2)then !pi or K rexdif knowing p rexdif + if(rexdifi(iclpro).lt.0.)then + if(engy.lt.min(30.,-log(-rexdifi(iclpro))/edlim) + & .and.sigdif.gt.0.)then !use fit of sigela to get rexdif +c ratioSig=sigdela/sigdif +c if(abs(1.-rexdif(icltar)).gt.1.e-6)then +c rexdif(iclpro)=1.-ratioSig/(1.-rexdif(icltar)) +c else +c rexdif(iclpro)=abs(rexdifi(iclpro)) +c endif +c if(rexdif(iclpro).ge.exp(-edlim*engy)) +c & rexdif(iclpro)=exp(-edlim*engy) + rexdif(iclpro)=exp(-edlim*engy) + rexdif(iclpro)=max(rexdif(iclpro),abs(rexdifi(iclpro))) + elseif(sigdif.le.0.)then + rexdif(iclpro)=1. + else +c rexdif(iclpro)=max(exp(-1.7/engy**0.3),abs(rexdifi(iclpro))) !strong reduction +c rexdif(iclpro)=max(exp(-0.33/engy**0.066),abs(rexdifi(iclpro))) !moderate one (constant sig NSD) + rexdif(iclpro)=abs(rexdifi(iclpro)) + endif + else + rexdif(iclpro)=abs(rexdifi(iclpro)) + endif + endif + sigdela=(1.-rexdif(iclpro)) + & *(1.-rexdif(icltar)) *sigdif + + else + rexdif(iclpro)=rexdifi(iclpro) + rexdif(icltar)=rexdifi(icltar) + sigdela=(1.-rexdif(iclpro)) + & *(1.-rexdif(icltar)) *sigdif + endif + + +c if(rexndf.gt.0..and.iclpro.eq.2)then + if(rexndf.gt.0.)then + rexndi(iclpro)=rexndf*rexdif(iclpro) + else + rexndi(iclpro)=rexndii(iclpro) + endif +c if(rexndf.gt.0..and.icltar.eq.2)then + if(rexndf.gt.0.)then + rexndi(icltar)=rexndf*rexdif(icltar) + else + rexndi(icltar)=rexndii(icltar) + endif + if(ish.ge.2)write(ifch,*)'Xsigma : rexdif/ndi=',rexdif(iclpro) + & ,rexdif(icltar) + & ,rexndi(iclpro) + & ,rexndi(icltar) + + sigsd=( (1.-rexdif(icltar))*rexdif(iclpro) + & +(1.-rexdif(iclpro))*rexdif(icltar) )*sigdif + sigdd=rexdif(iclpro)*rexdif(icltar)*sigdif +c if(engy.lt.10.)sigela=max(sigelaf,sigela) + sigela=sigelaold+sigcoul + sigine=sigineold + if(ionudi.ne.1.and.iLHC.eq.0)then + sigela=sigela+sigdela + sigine=sigine-sigdela + endif + sigtot=sigine+sigela + sigineaa=eposcrse(ekin,maproj,matarg,idtarg) + +c write(ifmt,*)'Rexdif',rexdif(iclpro),rexdif(icltar) + + elseif(model.eq.2)then + + g0=real(PIQGS*RP1/CD(ICZ)*AM**2*10.D0) + CALL m2XXFZ(0.D0,GZ0) + gz(1)=GZ0(1) + gz(2)=GZ0(2) + gz(3)=0d0 + sigcut=g0*gz(2)/2. !cut pomerons cross-section + sigtot=g0*gz(1) !tot cross-section + gz(0)=sigtot-sigcut + sigela=gz(0)*CC(ICZ)*CC(2) !elastic cross section +c GDP - projectile diffraction cross section + GDP=(1.D0-CC(ICZ))*CC(2)*gz(0) +c GDT - target diffraction cross section + GDT=(1.D0-CC(2))*CC(ICZ)*gz(0) +c GDD - double diffractive cross section + GDD=(1.D0-CC(ICZ))*(1.D0-CC(2))*gz(0) + sigsd=GDT+GDP + sigdd=GDD + sigdif=sigsd+sigdd + sigine=sigcut+sigdif + rs=g0*0.4091 !=g0/pi/10.*2./4./.0389 + if(gz(1).gt.0.)sloela=2.*rs*gz(3)/gz(1) + sigdifold=sigtot-sigcut-sigela !diffractive cross section + sigineaa=qgsincs + + elseif(model.eq.3)then + + call m3SIGMA(ekin,idproj,1120,1,1,sigi,sige) + sigine=sigi + sigela=sige + sigcut=sigine + sigtot=sigine+sigela + sigdif=sigtot-sigcut-sigela !diffractive cross section + sigineaa=gheincs + + elseif(model.eq.4)then !PYTHIA + + sigsd=sngl(SIGT(0,0,2)+SIGT(0,0,3)) + sigela=sngl(SIGT(0,0,1)) + sigcut=sngl(SIGT(0,0,5)) + sigtot=sngl(SIGT(0,0,0)) + sigine=sigtot-sigela + sigdif=sigtot-sigcut-sigela !diffractive cross section + sigineaa=pytincs + + elseif(model.eq.5)then !HIJING + + sigsd=HIPR1(33)*HINT1(12) + sigdif=0. + sigcut=0. + sigtot=HINT1(13) + sigine=HINT1(12) + sigela=sigtot-sigine + sigineaa=hijincs + + elseif(model.eq.6)then !for Sibyll + + call m6SIGMA(iclpro,engy,stot,sela,sine,sdifr,slela,Rho) + sigtot=stot + sigela=sela + sigine=sine + sigdif=sdifr + sloela=slela + sigcut=sigtot-sigdif-sigela ! cut cross section + sigsd=sigdif/2. + sigineaa=sibincs + + elseif(model.eq.7.or.model.eq.11)then !for QGSJET-II + + call m7SIGMA(stot,scut,sine,slela) + sigtot=stot + sigcut=scut + sigine=sine + sloela=slela + sigela=sigtot-sigine ! elastic cross section + sigdif=sigine-sigcut + sigsd=sigdif + sigineaa=qgsIIincs + + elseif(model.eq.8)then !for PHOJET + + call m8SIGMA(stot,scut,sine,sela,slela,ssd) + sigtot=stot + sigcut=scut + sigine=sine + sloela=slela + sigela=sela + sigdif=sigine-sigcut + sigsd=ssd + sigineaa=phoincs + + elseif(model.eq.9)then !for Fluka + + call m9SIGMA(stot,sine,sela) + sigtot=stot + sigine=sine + sigcut=sigine + sigela=sela + sigineaa=fluincs + + elseif(model.eq.10)then !for Urqmd + + sigtot=urqincs + sigineaa=urqincs + + endif + + if(isigma.ge.1)then !===============! + + if(ish.ge.1.and.noebin.ge.0) + *write (ifmt,225)engy,ekin,sigtot,sigtotf,sigtotold + *,sigine,sigtotf-sigelaf,sigineold + *,sigela,sigelaf,sigelaold,sigcut,sloela,sigdif,sigsd + *,sigineaa + if(ish.ge.1.and.ifch.ne.ifmt) + *write (ifch,225)engy,ekin,sigtot,sigtotf,sigtotold + *,sigine,sigtotf-sigelaf,sigineold + *,sigela,sigelaf,sigelaold,sigcut,sloela,sigdif,sigsd + *,sigineaa + +c (from tabulation) for pA/AA + if((isigma.eq.2.and.noebin.ge.0) + & .or..not.(maproj.eq.1.and.matarg.eq.1))then + + sigtotaa=0. + sigelaaa=0. + if(model.eq.1)then + if(isigma.ne.2)then + if(maproj.gt.5.and.matarg.gt.5)write(ifmt,*) + & 'Cross-section may be wrong, use isigma=2 instead ! ', + & '(if you care about it ...)' +c eposcrse depends of ionudi while eposinecrse corresponds to ionudi=1 always + sigineaa=eposinecrse(ekin,maproj,matarg,idtarg) + sigelaaa=eposelacrse(ekin,maproj,matarg,idtarg) + sigtotaa=sigelaaa+sigineaa + sigcutaa=eposcutcrse(ekin,maproj,matarg,idtarg) + if(ionudi.gt.1)then +c First order approximation. Better to use isigma=2 for that + difpart=max(0.,sigineaa-sigcutaa) +c non excited projectile + sigqela=(1.-rexdif(iclpro)) + & **(1.+rexres(iclpro)*0.3*log(float(matarg))) + sigqela=sigqela**(1.+float(maproj)**0.3) + sdpart=1.d0-sigqela +c non excited target + if(iLHC.eq.1)then + sigqelap=sigqela + sigqela=sigqela*((1.-rexdif(icltar)) + & **(1.+rexres(icltar)*0.3*log(float(maproj)))) + & **(1.+float(matarg)**0.3) + if(ionudi.eq.2)sigqela=sigqelap-sigqela + sdpart=1.d0-sigqela + sigqela=0. + elseif(ionudi.eq.3)then + sigqela=sigqela*((1.-rexdif(icltar)) + & **(1.+rexres(icltar)*0.3*log(float(maproj)))) + & **(1.+float(matarg)**0.3) + sdpart=1.d0-sigqela + endif +c excited diffractive part + sigqela=sigqela*difpart + sigineaa=sigineaa-sigqela + sigelaaa=sigelaaa+sigqela +c here cut is absorbtion xs : cut + 95 % of excited diff. + sigcutaa=sigcutaa+0.95*difpart*sdpart + elseif(ionudi.eq.0)then + write(ifmt,*) + & 'Cross-section can not be calculated with ionudi=0' + endif + else + write(ifmt,*) + & 'Compute Cross-section (can take a while...)' + call crseaaEpos(sigtotaa,sigineaa,sigcutaa,sigelaaa) + endif + elseif(isigma.eq.2.and.matarg.gt.1)then + call crseaaModel(sigtotaa,sigineaa,sigcutaa,sigelaaa) + endif + if(ish.ge.1.and.noebin.ge.0) + & write (ifmt,226)sigtotaa,sigineaa,sigcutaa,sigelaaa + if(ish.ge.1.and.ifch.ne.ifmt) + & write (ifch,226)sigtotaa,sigineaa,sigcutaa,sigelaaa + + endif !================! + + + endif + + + +225 format(' hadron-proton cross sections for ',f10.2,' GeV', + *' (ekin:',g13.5,' GeV)'/ + *4x,'total cross section: ',f8.2,3x,f8.2,3x,f8.2/ + *4x,'inelastic cross section: ',f8.2,3x,f8.2,3x,f8.2/ + *4x,'elastic cross section: ',f8.2,3x,f8.2,3x,f8.2/ + *4x,'cut cross section: ',f8.2/ + *4x,'elastic slope parameter: ',f8.2/ + *4x,'diffr. cross section: ',f8.2,14x,f8.2/ + *4x,'inelastic (tab) cross section: ',f8.2) + 226 format(' hadron/nucleus-hadron/nucleus cross sections'/ + *4x,'total pA/AA cross section: ',f8.2/ + *4x,'inelastic pA/AA cross section: ',f8.2/ + *4x,'cut pA/AA cross section: ',f8.2/ + *4x,'elastic pA/AA cross section: ',f8.2) + + call utprix('xsigma',ish,ishini,4) + + return + end + diff --git a/modules/epos/epos-con-lhc.f b/modules/epos/epos-con-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..fb6f28efebec8347dde663eb992e7976924b6150 --- /dev/null +++ b/modules/epos/epos-con-lhc.f @@ -0,0 +1,1323 @@ +c----------------------------------------------------------------------- + subroutine conaa(iret) +c----------------------------------------------------------------------- +c determines interaction configuration +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + include 'epos.incpar' + + common/geom/rmproj,rmtarg,bmax,bkmx + common/nucl3/phi,bimp + common /cncl/xproj(mamx),yproj(mamx),zproj(mamx) + * ,xtarg(mamx),ytarg(mamx),ztarg(mamx) + common/cfacmss/facmss + double precision yyrmax + common/scrangle/ phik3(kollmx),thetak3(kollmx) + + call utpri('conaa ',ish,ishini,4) + + iret=0 + +c initialisations +c --------------- + + vel=tanh(ypjtl-yhaha)+tanh(yhaha) + +c determine phi, bimp, coll, iproj, itarg, x/y/zproj, x/y/ztarg +c --------------------------------------------------------------- + + if(iokoll.eq.1)then + + koll=matarg + do k=1,koll + do n=1,4 + coord(n,k)=0. + enddo + enddo + bimp=0 + phi=0 + xproj(1)=0 + yproj(1)=0 + zproj(1)=0 + lproj(1)=koll + lproj3(1)=0 + do k=1,koll + bij=bkmx*sqrt(rangen()) + bk(k)=bij + iproj(k)=1 + itarg(k)=k + phi=2.*pi*rangen() + xtarg(k)=bij*cos(phi) + ytarg(k)=bij*sin(phi) + ztarg(k)=0 + ltarg(k)=1 + kproj(1,k)=k + ktarg(k,1)=k + ltarg3(k)=0 + ktarg3(k,1)=0 + kproj3(k,1)=0 + if(iscreen.ne.0.and.bij.le.bkmxndif)then + if(zbrmax.le.0..or. bij.lt.zbcutx+zbrmax*rangen())then + lproj3(1)=lproj3(1)+1 + ltarg3(k)=1 + kproj3(1,lproj3(1))=k + ktarg3(k,1)=k + endif + endif + enddo + + elseif(maproj.eq.1.and.matarg.eq.1)then + + b1=bminim + b2=amin1(bkmx,bmaxim) + if(b1.gt.b2)call utstop('conaa: bmin > bmax&') + bimp=sqrt(b1*b1+(b2*b2-b1*b1)*rangen()) + koll=1 + do n=1,4 + coord(n,1)=0. + enddo + bk(1)=bimp + iproj(1)=1 + itarg(1)=1 + phi=2.*pi*rangen() + xproj(1)=bimp*cos(phi) + yproj(1)=bimp*sin(phi) + zproj(1)=0 + xtarg(1)=0 + ytarg(1)=0 + ztarg(1)=0 + lproj(1)=1 + ltarg(1)=1 + lproj3(1)=1 + ltarg3(1)=1 + kproj3(1,1)=1 + ktarg3(1,1)=1 + kproj(1,1)=1 + ktarg(1,1)=1 + + else + + call conxyz('p',mamx,xproj,yproj,zproj,ypjtl-yhaha) + call conxyz('t',mamx,xtarg,ytarg,ztarg,yhaha) + + bx=0 + by=0 + if(maproj.gt.0)then + if(bimevt.lt.0)then + b1=bminim + b2=amin1(rmproj+rmtarg,bmaxim) + if(b1.gt.b2)call utstop('conaa: bmin > bmax&') + bimp=sqrt(b1**2+(b2**2-b1**2)*rangen()) + if(nbarray.gt.0)bimp=barray(mod(nrevt,nbarray)+1) + if(jpsi.gt.0)then + bimp=b1+(b2-b1)*(float(mod(nrevt,12))+rangen())/12. + bimevt=bimp + endif + phi=phimin+rangen()*(phimax-phimin) + else + phi=phievt + bimp=bimevt + endif + bx=cos(phi)*bimp + by=sin(phi)*bimp + endif + if(jpsi.lt.0)then !modify b + bx=xtarg(1) + by=ytarg(1) + endif + if(maproj.eq.0)goto1000 + koll=0 + do i=1,maproj + lproj(i)=0 + lproj3(i)=0 + enddo + do j=1,matarg + ltarg(j)=0 + ltarg3(j)=0 + enddo + do 12 i=1,maproj + do 11 j=1,matarg + if(jpsi.lt.0.and.ztarg(j).le.ztarg(1))goto11 + bij=sqrt((xproj(i)+bx-xtarg(j))**2+(yproj(i)+by-ytarg(j))**2) + if(ish.ge.7)write(ifch,*)'i_p:',i,' i_t:',j,' b_ij:',bij + if(bij.gt.bkmx)goto 11 + + koll=koll+1 + if(koll.gt.kollmx)call utstop('conaa: kollmx too small&') + bk(koll)=bij + bkx(koll)=xproj(i)+bx-xtarg(j) + bky(koll)=yproj(i)+by-ytarg(j) + iproj(koll)=i + itarg(koll)=j + lproj(i)=lproj(i)+1 + ltarg(j)=ltarg(j)+1 + kproj(i,lproj(i))=koll + ktarg(j,ltarg(j))=koll + phik3(koll)=0. + thetak3(koll)=0. + if(iscreen.ne.0.and.bij.le.bkmxndif)then + if(zbrmax.gt.0..and.bij.gt.zbcutx+zbrmax*rangen())goto 11 + lproj3(i)=lproj3(i)+1 + ltarg3(j)=ltarg3(j)+1 + kproj3(i,lproj3(i))=koll + ktarg3(j,ltarg3(j))=koll +c define angle for anti-shadowing + if(abs(bky(koll)).gt.1.e-6)then + if(abs(bkx(koll)).gt.1.e-6)then + phik3(koll)=atan(bky(koll)/bkx(koll)) + else + phik3(koll)=sign(0.5*pi,bky(koll)) + endif + elseif(bkx(koll).lt.0.)then + phik3(koll)=pi + endif + if(bk(koll).gt.0.)then + thetak3(koll)=atan(bglaubx/bk(koll)) + else + thetak3(koll)=0.5*pi + endif + endif + +11 continue +12 continue + + do k=1,koll + do n=1,4 + coord(n,k)=0. + enddo + enddo + + + endif + + if(ish.ge.3)write(ifch,*)'koll=',koll + if(koll.eq.0)goto 1001 + + +c determine coord +c --------------- + do kl=1,koll + i=iproj(kl) + j=itarg(kl) + dist=ztarg(j)-zproj(i) + coord(1,kl)=(xproj(i)+xtarg(j))*0.5 + coord(2,kl)=(yproj(i)+ytarg(j))*0.5 + coord(3,kl)=(zproj(i)+ztarg(j))*0.5 + coord(4,kl)=dist/vel + enddo + + if(iscreen.ne.0)call CalcScrPair(bimp) + + !~~~~~redefine energy in case of imposed radial flow~~~~~~~~~~~~~~~~ + yrmaxi=max(0.,yradmx+yradmi*log(1.+engy/sqrt(float(koll)))) + if(yrmaxi.gt.1e-5)then + yyrmax=dble(yrmaxi) + fradflii=sngl(1d0/ + & ((sinh(yyrmax)*yyrmax-cosh(yyrmax)+1d0)/(yyrmax**2/2d0))) + else + fradflii=1. + endif + if(ish.ge.3)write(ifch,*)'yrmaxi=',yrmaxi + + +c exit +c ---- +1000 continue + if(ish.ge.5)then + write(ifch,*)'ia,x/y/zproj:' + do mm=1,maproj + write(ifch,*)mm,xproj(mm),yproj(mm),zproj(mm) + enddo + write(ifch,*)'ia,x/y/ztarg:' + do mm=1,matarg + write(ifch,*)mm,xtarg(mm),ytarg(mm),ztarg(mm) + enddo + write(ifch,*)'iret',iret + endif + call utprix('conaa ',ish,ishini,4) + return + +1001 continue !iret=1 causes redo of whole collision + iret=1 + if(ish.ge.3)then + write(ifch,*) + write(ifch,*)'***** subroutine conaa:' + write(ifch,*)'***** no nucleon pair found --> no interaction' + write(ifch,*) + endif + goto 1000 + + end + +c----------------------------------------------------------------------- + function frdmzcut(b) +c----------------------------------------------------------------------- +c determines interaction configuration +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + + frdmzcut=zbcutx*exp(-(b*rangen())) +c frdmzcut=zbcutx*rangen() +c bdum=b + return + end + +c----------------------------------------------------------------------- + subroutine CalcScrPair(b) +c----------------------------------------------------------------------- +c determines interaction configuration +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + include 'epos.incpar' + + common/scrangle/ phik3(kollmx),thetak3(kollmx) + logical lascr(kollmx),cont + + +c order pairs for splitting as a function of b +c --------------- + do i=1,maproj + if(lproj3(i).gt.1)then + do l=2,lproj3(i) + m=l + 100 continue + kp=kproj3(i,m-1) + kl=kproj3(i,m) + if(bk(kl).lt.bk(kp))then + kproj3(i,m-1)=kl + kproj3(i,m)=kp + m=m-1 + if(m.gt.1)goto 100 + endif + enddo + endif + enddo + do j=1,matarg + if(ltarg3(j).gt.1)then + do l=2,ltarg3(j) + m=l + 200 continue + kp=ktarg3(j,m-1) + kl=ktarg3(j,m) + if(bk(kl).lt.bk(kp))then + ktarg3(j,m-1)=kl + ktarg3(j,m)=kp + m=m-1 + if(m.gt.1)goto 200 + endif + enddo + endif + enddo + + if(koll.gt.1)then +c Define anti-shadowing as a consequence of geometrical screening of +c nucleons at large b by the one at small b + +c Projectile +c Check phi not to be in the range of a nucleon with smaller b + do i=1,maproj + if(lproj3(i).gt.1)then + kl=kproj3(i,1) + lascr(kl)=.true. + do 300 l=lproj3(i),2,-1 + kl=kproj3(i,l) + lascr(kl)=.true. + if(bk(kl).ge.frdmzcut(b))then + do m=1,l-1 + km=kproj3(i,m) + if(kl.ne.km.and.bk(km).ge.frdmzcut(b) + & .and.phik3(kl).ge.phik3(km)-thetak3(km) + & .and.phik3(kl).le.phik3(km)+thetak3(km))then + lascr(kl)=.false. + goto 300 + endif + enddo + endif + 300 continue + endif + enddo +c suppress screened pair from the list + do i=1,maproj + if(lproj3(i).gt.1)then + do l=1,lproj3(i) + kl=kproj3(i,l) + enddo + endif + enddo + do i=1,maproj + if(lproj3(i).gt.1)then + n=2 + cont=lproj3(i).gt.1 + do while(cont) + l=lproj3(i) + kl=kproj3(i,l) +c suppress end of the list in order to have the last pair active + do while(.not.lascr(kl).and.l.gt.1) + kproj3(i,l)=0 + lproj3(i)=lproj3(i)-1 + l=lproj3(i) + kl=kproj3(i,l) + enddo + cont=lproj3(i).gt.n + if(cont)then +c compress list + kn=kproj3(i,n) + if(.not.lascr(kn))then + m=lproj3(i) !last pair always active + km=kproj3(i,m) + kproj3(i,n)=km + kproj3(i,m)=0 + lproj3(i)=lproj3(i)-1 + endif + endif + n=min(lproj3(i)-1,n)+1 + cont=lproj3(i).ne.n + enddo + endif + enddo + +c Target +c Check phi not to be in the range of a nucleon with smaller b + do j=1,matarg + if(ltarg3(j).gt.1)then + kl=ktarg3(j,1) + lascr(kl)=.true. + do 400 l=ltarg3(j),2,-1 + kl=ktarg3(j,l) + lascr(kl)=.true. + if(bk(kl).ge.frdmzcut(b))then + do m=1,l-1 + km=ktarg3(j,m) + if(km.ne.kl.and.bk(km).ge.frdmzcut(b) + & .and.phik3(kl).ge.phik3(km)-thetak3(km) + & .and.phik3(kl).le.phik3(km)+thetak3(km))then + lascr(kl)=.false. + goto 400 + endif + enddo + endif + 400 continue + endif + enddo +c suppress screened pair from the list + do j=1,matarg + if(ltarg3(j).gt.1)then + n=2 + cont=ltarg3(j).gt.1 + do while(cont) + l=ltarg3(j) + kl=ktarg3(j,l) +c suppress end of the list in order to have the last pair active + do while(.not.lascr(kl).and.l.gt.1) + ktarg3(j,l)=0 + ltarg3(j)=ltarg3(j)-1 + l=ltarg3(j) + kl=ktarg3(j,l) + enddo + cont=ltarg3(j).gt.n + if(cont)then +c compress list + kn=ktarg3(j,n) + if(.not.lascr(kn))then + m=ltarg3(j) !last pair always active + km=ktarg3(j,m) + ktarg3(j,n)=km + ktarg3(j,m)=0 + ltarg3(j)=ltarg3(j)-1 + endif + endif + n=min(ltarg3(j)-1,n)+1 + cont=ltarg3(j).ne.n + enddo + endif + enddo + endif + + + end + +c----------------------------------------------------------------------- + subroutine xGeometry(iii) +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + common/xgeom/nnn,naa(kollmx),nbb(kollmx) + character*5 fmt1,fmt2 + + if(iii.eq.0)then + + do k=1,kollmx + naa(k)=0 + enddo + nnn=0 + + + elseif(iii.eq.1)then + + ngl=0 + do k=1,koll + r=bk(k) + if(r.le.sqrt(sigine/10./pi))ngl=ngl+1 + enddo + if(ngl.ne.0)then + nnn=nnn+1 + naa(ngl)=naa(ngl)+1 + endif + + elseif(iii.eq.2)then + + if(xpar1.eq.0..and.xpar2.eq.0.)then + print*,'---------- xGeometry -----------------------' + return + endif + x1=1-0.01*xpar2 + x2=1-0.01*xpar1 + kmx=0 + nbb(1)=naa(1) + do k=2,kollmx + if(naa(k).ne.0.)kmx=k + nbb(k)=nbb(k-1)+naa(k) + enddo + k1=0 + k2=0 + do k=1,kmx + x=nbb(k)/float(nnn) + if(x.lt.x1)k1=k + if(x.lt.x2)k2=k + enddo + k1=k1+1 + k2=k2+1 + x=0 + av=0 + su=0 + p1=0. + p2=0. + do k=1,kmx + xb=x + x=nbb(k)/float(nnn) + y=naa(k)/float(nnn) + dx=x-xb + p=0. + if(k.eq.k1)then + p=(x-x1)/dx + p1=p + elseif(k.eq.k2)then + p=(x2-xb)/dx + p2=p + elseif(k.gt.k1.and.k.lt.k2)then + p=1 + endif + av=av+y*p*k + su=su+y*p + enddo + av=av/su + n1=nint(100*p1) + n2=nint(100*p2) + if(n1.eq.0)then + k1=k1+1 + n1=100 + endif + if(k1.le.9)fmt1='i1,4x' + if(k1.gt.9.and.k1.le.99)fmt1='i2,3x' + if(k1.gt.99.and.k1.le.999)fmt1='i3,2x' + if(k1.gt.999.and.k1.le.9999)fmt1='i4,1x' + if(k2.le.9)fmt2='i1,4x' + if(k2.gt.9.and.k2.le.99)fmt2='i2,3x' + if(k2.gt.99.and.k2.le.999)fmt2='i3,2x' + if(k2.gt.999.and.k2.le.9999)fmt2='i4,1x' + write(6,'(i4,a,i5,a,'//fmt1//',i6,a,i5,a,'//fmt2//',5x,a,f8.2)') + & nint(xpar2),':MIN',n1,'%',k1 + & ,nint(xpar1),':MAX',n2,'%',k2 ,'av:',av + endif + + end + +c----------------------------------------------------------------------- + function conbmx() +c----------------------------------------------------------------------- + double precision om1intbc,p,eps + include 'epos.inc' + include 'epos.incsem' + + conbmx=0. + b1=0. + b2=7. + eps=5.0d-3 + p=1.d0-dexp(-om1intbc(b2)) + if(p.gt.2.d0*eps)return + + ntry=0 + +10 ntry=ntry+1 + b=b1+.5*(b2-b1) + + p=(1.d0-dexp(-om1intbc(b))) + + if(p.gt.eps)then + if(p.gt.2.d0*eps)then + b1=b + else + conbmx=b + return + endif + else + if(p.lt.eps/5.d0)then + b2=b + else + conbmx=b + return + endif + endif + + if(ntry.le.1000)goto 10 + write(ifmt,*)'Too much try in conbmx ... bmax=',b + conbmx=b + return + + end + +c----------------------------------------------------------------------- + function conbmxndif() +c----------------------------------------------------------------------- + double precision om1intbc,p,eps + include 'epos.inc' + include 'epos.incsem' + + + iomegasave=iomega + iomega=2 + conbmxndif=0. + b1=0. + b2=7. + conbmxndif=b2 + eps=1d-10 + p=1.d0-dexp(-om1intbc(b2)) + if(p.gt.2.d0*eps)goto 100 + + ntry=0 + +10 ntry=ntry+1 + b=b1+.5*(b2-b1) + + p=(1.d0-dexp(-om1intbc(b))) + + if(p.gt.eps)then + if(p.gt.2.d0*eps)then + b1=b + else + conbmxndif=b + goto 100 + endif + else + if(p.lt.eps/5.d0)then + b2=b + else + conbmxndif=b + goto 100 + endif + endif + + if(ntry.le.1000)goto 10 + write(ifmt,*)'Too much try in conbmxndif ... bkmxndif=',b + conbmxndif=b + 100 iomega=iomegasave + return + + end + +c----------------------------------------------------------------------- + function conbmxdif() +c----------------------------------------------------------------------- +c find b to have (1-exp(-om))pmax=pdiff +c----------------------------------------------------------------------- + double precision om1intbc,pmax,drootom,pdiff + include 'epos.inc' + include 'epos.incsem' + + conbmxdif=0. + b1=0. + bmax=7. + iomegasave=iomega + iomega=2 + + eps=1.e-5 + pmax=1.d0-dexp(-om1intbc(b1)) + pdiff=facdif + if(pmax.gt.eps)then + conbmxdif=drootom(pdiff,pmax,bmax,eps) + endif + iomega=iomegasave + + return + + end + +c----------------------------------------------------------------------- + subroutine conre +c----------------------------------------------------------------------- +c initializes remnants +c----------------------------------------------------------------------- + include "epos.incems" + include 'epos.inc' + + call utpri('conre ',ish,ishini,6) + +c proj +c ---- + la=laproj + ma=iabs(maproj) + las=0 + mas=0 + do l=1,ma + if(la.lt.0)then + if(iabs(idproj).lt.20)then + id=idproj + else + ia=iabs(idproj/10) + is=idproj/iabs(idproj) + if(ia.ne.111.and.ia.ne.222.and.ia.ne.333)id=idproj/10*10 + if(ia.eq.111.or. ia.eq.222.or. ia.eq.333)id=idproj/10*10+is + if(ia.eq.213)id=1230*is + endif + else + id=1220 + if(rangen().le.(la-las)*1./(ma-mas))id=1120 + if(id.eq.1120)las=las+1 + mas=mas+1 + endif + ic1=idtrai(1,id,1) + ic2=idtrai(2,id,1) + icproj(1,l)=ic1 + icproj(2,l)=ic2 + enddo + +c targ +c ---- + la=latarg + ma=iabs(matarg) + las=0 + mas=0 + do l=1,ma + if(la.lt.0)then + if(iabs(idtarg).lt.20)then + id=idtarg + else + ia=iabs(idtarg/10) + is=idtarg/iabs(idtarg) + if(ia.ne.111.and.ia.ne.222.and.ia.ne.333)id=idtarg/10*10 + if(ia.eq.111.or. ia.eq.222.or. ia.eq.333)id=idtarg/10*10+is + if(ia.eq.213)id=1230*is + endif + else + id=1220 + if(rangen().le.(la-las)*1./(ma-mas))id=1120 + if(id.eq.1120)las=las+1 + mas=mas+1 + endif + ic1=idtrai(1,id,1) + ic2=idtrai(2,id,1) + ictarg(1,l)=ic1 + ictarg(2,l)=ic2 + enddo + + call utprix('conre ',ish,ishini,6) + return + end + +c----------------------------------------------------------------------- + subroutine conrl +c----------------------------------------------------------------------- +c initializes target remnant in case of appl lepton +c----------------------------------------------------------------------- + include "epos.incems" + common/nucl1/laproj,maproj,latarg,matarg,core,fctrmx + common/hadr2/iomodl,idproj,idtarg,wexcit + +c targ +c ---- + la=latarg + ma=iabs(matarg) + las=0 + mas=0 + do l=1,ma + if(la.lt.0)then + id=idtarg + else + id=1220 + if(rangen().le.(la-las)*1./(ma-mas))id=1120 + if(id.eq.1120)las=las+1 + mas=mas+1 + endif + ic1=idtrai(1,id,1) + ic2=idtrai(2,id,1) + ictarg(1,l)=ic1 + ictarg(2,l)=ic2 + enddo + + return + end + +c----------------------------------------------------------------------- + subroutine conwr +c----------------------------------------------------------------------- +c writes /cptl/ +c----------------------------------------------------------------------- + include "epos.inc" + include "epos.incems" + double precision XA(64,3),XB(64,3),BQGS,BMAXQGS,BMAXNEX,BMINNEX + COMMON /Q_QGSNEX1/ XA,XB,BQGS,BMAXQGS,BMAXNEX,BMINNEX + common/nucl3/phi,bimp + common /cncl/xproj(mamx),yproj(mamx),zproj(mamx) + *,xtarg(mamx),ytarg(mamx),ztarg(mamx) + parameter(iapmax=208) + double precision bqgs2,bmaxqgs2,bmaxnex2,bminnex2,xan,xbn + common /qgsIInex1/xan(iapmax,3),xbn(iapmax,3) + *,bqgs2,bmaxqgs2,bmaxnex2,bminnex2 + common/photrans/phoele(4),ebeam + integer ic(2) + + call utpri('conwr ',ish,ishini,6) + + bx=cos(phi)*bimp + by=sin(phi)*bimp + +c write /cptl/ +c ------------ + nptl=0 + + if(iokoll.eq.1)then ! precisely matarg collisions + + nptl=nptl+1 + do 3 i=1,4 +3 xorptl(i,nptl)=0 + tivptl(1,nptl)=-ainfin + tivptl(2,nptl)=0 + istptl(nptl)=1 + iorptl(nptl)=-1 + jorptl(nptl)=0 + do 1 k=1,koll + nptl=nptl+1 + do 4 i=1,4 +4 xorptl(i,nptl)=0 + tivptl(1,nptl)=-ainfin + tivptl(2,nptl)=0 + istptl(nptl)=1 + iorptl(nptl)=-1 + jorptl(nptl)=0 +1 continue + + elseif(iappl.ne.7)then + +c print *,'proj' + + do 6 i=1,maproj + nptl=nptl+1 + istptl(nptl)=0 + iorptl(nptl)=0 + jorptl(nptl)=0 + if(model.eq.2)then !QGSJet + xproj(i)=XA(i,1) + yproj(i)=XA(i,2) + zproj(i)=XA(i,3) + istptl(nptl)=1 + iorptl(nptl)=-1 + elseif(model.eq.7.or.model.eq.11)then !QGSJetII + xproj(i)=xan(i,1) + yproj(i)=xan(i,2) + zproj(i)=xan(i,3) + istptl(nptl)=1 + iorptl(nptl)=-1 + elseif(model.ge.3)then !Gheisha, ... + istptl(nptl)=1 + iorptl(nptl)=-1 + endif + xorptl(1,nptl)=xproj(i)+bx/2 + xorptl(2,nptl)=yproj(i)+by/2 + xorptl(3,nptl)=zproj(i) + xorptl(4,nptl)=0 + tivptl(1,nptl)=-ainfin +c for visualisation uncomment +c-c tivptl(1,nptl)=-100 + tivptl(2,nptl)= ainfin +c print *,i,xorptl(1,nptl),xorptl(2,nptl),xorptl(3,nptl) +6 continue +c print *,'targ' + do 7 i=1,matarg + nptl=nptl+1 + istptl(nptl)=0 + iorptl(nptl)=0 + jorptl(nptl)=0 + if(model.eq.2)then !QGSJet + xtarg(i)=XB(i,1) + ytarg(i)=XB(i,2) + ztarg(i)=XB(i,3) + istptl(nptl)=1 + iorptl(nptl)=-1 + elseif(model.eq.7.or.model.eq.11)then !QGSJetII + xtarg(i)=xbn(i,1) + ytarg(i)=xbn(i,2) + ztarg(i)=xbn(i,3) + istptl(nptl)=1 + iorptl(nptl)=-1 + elseif(model.ge.3)then !Gheisha, ... + istptl(nptl)=1 + iorptl(nptl)=-1 + endif + xorptl(1,nptl)=xtarg(i)-bx/2 + xorptl(2,nptl)=ytarg(i)-by/2 + xorptl(3,nptl)=ztarg(i) + xorptl(4,nptl)=0 + tivptl(1,nptl)=-ainfin +c for visualisation uncomment +c-c tivptl(1,nptl)=-100 + tivptl(2,nptl)= ainfin +c print *,i,xorptl(1,nptl),xorptl(2,nptl),xorptl(3,nptl) +7 continue + if(abs(idprojin).eq.12)then !electron for fake DIS +c electron projectile + nptl=nptl+1 + istptl(nptl)=41 + iorptl(nptl)=-1 + jorptl(nptl)=-1 + iorptl(1)=nptl !pi0 (porjectile) coming from lepton + xorptl(1,nptl)=bx/2 + xorptl(2,nptl)=by/2 + xorptl(3,nptl)=0. + xorptl(4,nptl)=0. + tivptl(1,nptl)=-ainfin + tivptl(2,nptl)=0. +c target nucleons (in lab frame) + do i=1,matarg + nptl=nptl+1 + istptl(nptl)=41 + iorptl(nptl)=-1 + jorptl(nptl)=-1 + xorptl(1,nptl)=xtarg(i)-bx/2 + xorptl(2,nptl)=ytarg(i)-by/2 + xorptl(3,nptl)=ztarg(i) + xorptl(4,nptl)=0 + tivptl(1,nptl)=-ainfin +c for visualisation uncomment +c -c tivptl(1,nptl)=-100 + tivptl(2,nptl)= ainfin + enddo +c electron remnant + nptl=nptl+1 + istptl(nptl)=0 + iorptl(nptl)=maproj+matarg+1 + jorptl(nptl)=-1 + xorptl(1,nptl)=bx/2 + xorptl(2,nptl)=by/2 + xorptl(3,nptl)=0. + xorptl(4,nptl)=0. + tivptl(1,nptl)=0. + tivptl(2,nptl)= ainfin + endif + + endif + + nptl=0 + if(iappl.le.2)then + do i=1,maproj + nptl=nptl+1 + ic(1)=icproj(1,i) + ic(2)=icproj(2,i) + id=idtra(ic,0,0,0) +c id=idtra(ic,0,0,3) !tp071107 imix=3 ?????????? + call idmass(id,ams) + idptl(nptl)=id + pptl(1,nptl)=0. + pptl(2,nptl)=0. + pptl(3,nptl)=pnullx + pptl(4,nptl)=sqrt(pnullx**2+ams**2) + pptl(5,nptl)=ams + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + ityptl(nptl)=0 + enddo + endif + if(iappl.ne.7)then + do i=1,matarg + nptl=nptl+1 + ic(1)=ictarg(1,i) + ic(2)=ictarg(2,i) + id=idtra(ic,0,0,0) +c id=idtra(ic,0,0,3) !tp071107 imix=3 ?????????? + call idmass(id,ams) + idptl(nptl)=id + pptl(1,nptl)=0. + pptl(2,nptl)=0. + pptl(3,nptl)=-pnullx + pptl(4,nptl)=sqrt(pnullx**2+ams**2) + pptl(5,nptl)=ams + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + ityptl(nptl)=0 + enddo + if(abs(idprojin).eq.12)then !electron for fake DIS +c electron projectile + nptl=nptl+1 + id=idprojin + call idmass(id,ams) + idptl(nptl)=id + pptl(1,nptl)=0. + pptl(2,nptl)=0. + pptl(3,nptl)=sqrt(max(0.,(elepti+ams)*(elepti-ams))) + pptl(4,nptl)=elepti + pptl(5,nptl)=ams + ifrptl(1,nptl)=1 + ifrptl(2,nptl)=1 + ityptl(nptl)=40 +c target nucleons (in lab frame) + do i=1,matarg + nptl=nptl+1 + idptl(nptl)=idptl(maproj+i) + pptl(1,nptl)=0. + pptl(2,nptl)=0. + pptl(3,nptl)=-pnll + pptl(4,nptl)=ebeam + pptl(5,nptl)=pptl(5,maproj+i) + ifrptl(1,nptl)=maproj+i + ifrptl(2,nptl)=maproj+i + ityptl(nptl)=50 + enddo +c electron remnant + nptl=nptl+1 + idptl(nptl)=id + pptl(1,nptl)=phoele(1) + pptl(2,nptl)=phoele(2) + pptl(3,nptl)=phoele(3) + pptl(4,nptl)=phoele(4) + pptl(5,nptl)=ams + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + ityptl(nptl)=40 + endif + + else + + nptl=nptl+1 + id=idproj + call idmass(id,ams) + idptl(nptl)=id + pptl(1,nptl)=0. + pptl(2,nptl)=0. + pptl(3,nptl)=pnullx + pptl(4,nptl)=sqrt(pnullx**2+ams**2) + pptl(5,nptl)=ams + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + ityptl(nptl)=0 + iorptl(nptl)=-1 + jorptl(nptl)=0 + istptl(nptl)=0 + do 5 i=1,4 + 5 xorptl(i,nptl)=0 + tivptl(1,nptl)=0 + tivptl(2,nptl)=0 + endif + +c exit +c ---- + + call utprix('conwr ',ish,ishini,6) + return + end + +c------------------------------------------------------------------------ + subroutine conxyz(ch,n,x,y,z,ynuc) +c----------------------------------------------------------------------- + include 'epos.inc' + + real x(n),y(n),z(n) + character ch*1 + + massnr=0 + iii=0 + if(ch.eq.'p')then + massnr=maproj + iii=1 + elseif(ch.eq.'t')then + massnr=matarg + iii=2 + else + call utstop('conxyz: nucleus neither proj nor targ&') + endif + + if(massnr.eq.0)return + if(massnr.gt.n)call utstop('conxyz: massnr.gt.n&') + if(massnr.eq.1)then + x(1)=0 + y(1)=0 + z(1)=0 + return + endif + + rad=radnuc(massnr) + + if(massnr.ge.10)then !---wood-saxon density--- + + rad=rad/difnuc(massnr) + cr1=1.+3./rad+6./rad**2+6./rad**3 + cr2=3./rad + cr3=3./rad+6./rad**2 + do i=1,massnr + 1 zuk=rangen()*cr1-1. + if(zuk.le.0.)then + tt=rad*(rangen()**.3333-1.) + elseif(zuk.le.cr2 )then + tt=-log(rangen()) + elseif(zuk.lt.cr3 )then + tt=-log(rangen())-log(rangen()) + else + tt=-log(rangen())-log(rangen())-log(rangen()) + endif + if(rangen().gt.1./(1.+exp(-abs(tt))))goto 1 + rim=tt+rad + zz=rim*(2.*rangen()-1.) + rim=sqrt(rim*rim-zz*zz) + z(i)=zz*difnuc(massnr) + call pscs(c,s) + x(i)=rim*c*difnuc(massnr) + y(i)=rim*s*difnuc(massnr) + enddo + + elseif(massnr.ge.3)then ! ---gaussian density--- + + rad=rad*sqrt(2.*massnr/(massnr-1.)) !van hove simulation + do l=1,3 + summ=0. + do i=1,massnr-1 + j=massnr-i + aks=rad *(rangen()+rangen()+rangen()-1.5) + k=j+1 + if(l.eq.1)x(k)=summ-aks*sqrt(float(j)/k) + if(l.eq.2)y(k)=summ-aks*sqrt(float(j)/k) + if(l.eq.3)z(k)=summ-aks*sqrt(float(j)/k) + summ=summ+aks/sqrt(float(j*k)) + enddo + if(l.eq.1)x(1)=summ + if(l.eq.2)y(1)=summ + if(l.eq.3)z(1)=summ + enddo + + elseif(massnr.eq.2)then ! ---deuteron--- + + !.........r=t*difnuc(massnr), t~exp(-2*t)*(1-exp(-a*t)) + a=radnuc(massnr) + 2 t=-0.5*alog(rangen()) !~exp(-2*t) + if(rangen().gt.(1-exp(-a*t))**2)goto2 + r=t*difnuc(massnr) + zz=r*(2.*rangen()-1.) + call pscs(c,s) + rxy=sqrt(r*r-zz*zz) + z(1)=0.5*zz + x(1)=0.5*rxy*c + y(1)=0.5*rxy*s + z(2)=-z(1) + x(2)=-x(1) + y(2)=-y(1) + + else + + stop'conxyz: wrong massnr. ' + + endif + +c...plot preparation + + rmax=(radnuc(massnr)+3) + drnucl(iii)=rmax/mxnucl + nrnucl(iii)=nrnucl(iii)+1 + do i=1,massnr + r=sqrt(x(i)**2+y(i)**2+z(i)**2) + k=1+int(r/drnucl(iii)) + if(k.le.mxnucl)rnucl(k,iii)=rnucl(k,iii)+1 + enddo + +c...lorentz trafo + + do i=1,massnr + z(i)=z(i)/cosh(ynuc) + enddo + + return + end + +c----------------------------------------------------------------------- + subroutine conini +c----------------------------------------------------------------------- + include 'epos.inc' + + imax=max(maproj,matarg) + if(idtargin.eq.0)imax=max(imax,40) + do massnr=1,mamxx + dif=0.54 + rad=0. + if(massnr.gt.imax.or.massnr.eq.1)then + dif=0 + rad=0 + elseif(massnr.eq.197)then + dif=0.562 + rad=6.5 + elseif(massnr.ge.10)then + rad=1.12*massnr**0.33333-0.86*massnr**(-0.33333) + elseif(massnr.ge.3)then + rad=.9*float(massnr)**.3333 + elseif(massnr.eq.2)then + dif=4.316 + rad=4.68 + endif + difnuc(massnr)=dif + radnuc(massnr)=rad + enddo + + end + +c----------------------------------------------------------------------- + subroutine xConNuclDens(iii) +c----------------------------------------------------------------------- +c plots distribution of nucleons in nuclei +c iii = 1 (proj) or 2 (targ) +c----------------------------------------------------------------------- + include 'epos.inc' + if(model.ne.1)return + massnr=1 + if(iii.eq.1)then + massnr=maproj + elseif(iii.eq.2)then + massnr=matarg + endif + if(massnr.eq.1)return + a=1./4.316 + b=4.68 + write(ifhi,'(a)') '!-----------------------------------------' + write(ifhi,'(a)') '! nuclear density ' + write(ifhi,'(a)') '!-----------------------------------------' + write(ifhi,'(a)') 'openhisto' + if(massnr.ge.10)write(ifhi,'(a)')'htyp lin xmod lin ymod lin' + if(massnr.lt.10)write(ifhi,'(a)')'htyp lin xmod lin ymod log' + write(ifhi,'(a)') 'text 0 0 "title nuclear density"' + write(ifhi,'(a)') 'text 0.99 -0.15 " r (fm) "' + write(ifhi,'(a)') 'text 0 0 "yaxis rho(r)"' + write(ifhi,'(a,2e11.3)')'xrange',0.,mxnucl*drnucl(iii) + write(ifhi,'(3a)')'yrange',' 0 ',' auto' + write(ifhi,'(a)') 'array 2' + do j=1,mxnucl + r=(j-0.5)*drnucl(iii) + d=0.5*drnucl(iii) + write(ifhi,'(2e12.4)') r,rnucl(j,iii)/nrnucl(iii)/ + * (4./3.*pi*((r+d)**3-(r-d)**3)) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lbo ' + write(ifhi,'(a)') 'array 2' + do j=1,mxnucl + r=(j-0.5)*drnucl(iii) + rr=2*r + rho=1 + if(massnr.eq.2)then + rho=1.00*((1-exp(-b*a*rr))*exp(-a*rr)/rr)**2 + elseif(massnr.eq.197)then + rho=0.16/(1+exp((r-6.5)/0.562)) + elseif(massnr.ge.10)then + rho=0.16/(1+exp((r-radnuc(massnr))/difnuc(massnr))) + endif + write(ifhi,'(2e12.4)') r,rho + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + end + +c----------------------------------------------------------------------- + subroutine xConThick(iii) +c----------------------------------------------------------------------- + ! plots sigma_pp *T_A (b) (=average number of collisions) + ! T_A = thickness function + ! iii = 1 (proj) or 2 (targ) + !---------------------------------------------------------------- + include 'epos.inc' + parameter(iconimax=20,iconkmax=100) + real thick(2,0:iconimax) + imax=iconimax + kmax=iconkmax + if(model.ne.1)return + ramx=mxnucl*drnucl(iii) + do i=0,imax + x=i/float(imax)*ramx + sum=0 + rho0=conrho(iii,0.) + h=ramx/kmax + do k=1,kmax + z=k*h + r=sqrt(x*x+z*z) + rho2=conrho(iii,r) + z=(k-0.5)*h + r=sqrt(x*x+z*z) + rho1=conrho(iii,r) + sum=sum+h/6.*(rho0+4*rho1+rho2) + rho0=rho2 + enddo + sum=sum*2 ! integral fro -infty to +infty + thick(1,i)=x + thick(2,i)=sum + enddo + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lbo ' + write(ifhi,'(a)') 'txt "xaxis b (fm)" ' + write(ifhi,'(a)') 'txt "yaxis [s]?pp! T?A! (b) " ' + write(ifhi,'(a)') 'array 2' + do i=0,imax + write(ifhi,'(2e12.4)') thick(1,i),sigine/10.*thick(2,i) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + end + +c----------------------------------------------------------------------- + function conrho(iii,r) +c----------------------------------------------------------------------- + ! nuclear density + ! iii = 1 (proj) or 2 (targ) + !---------------------------------------------------------------- + include 'epos.inc' + conrho=1. + if(model.ne.1)return + massnr=1 + if(iii.eq.1)then + massnr=maproj + elseif(iii.eq.2)then + massnr=matarg + endif + if(massnr.eq.1)return + a=1./4.316 + b=4.68 + rr=2*r + rho=1 + if(massnr.eq.2.and.rr.gt.0.)then + rho=1.00*((1-exp(-b*a*rr))*exp(-a*rr)/rr)**2 + elseif(massnr.eq.197)then + rho=0.16/(1+exp((r-6.5)/0.562)) + elseif(massnr.ge.10)then + rho=0.16/(1+exp((r-radnuc(massnr))/difnuc(massnr))) + endif + conrho=rho + end + + + + + + + diff --git a/modules/epos/epos-dky-lhc.f b/modules/epos/epos-dky-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..1b0bcb6f8274b45bc8d61e954676e3808c2bfd6e --- /dev/null +++ b/modules/epos/epos-dky-lhc.f @@ -0,0 +1,2155 @@ +c----------------------------------------------------------------------- + subroutine decayall(n) +c----------------------------------------------------------------------- +c decay of objects n to nptl, including their children +c----------------------------------------------------------------------- + include 'epos.inc' + common/cttaus/tpro,zpro,ttar,ztar,ttaus,detap,detat + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat + ttaus=1 + np1=n + 1 np2=nptl + do ip=np1,np2 + if(istptl(ip).eq.0)then !consider last generation particles + call hdecas(ip,iret) + if(iret.eq.1)stop'error in hdecas detected in decay' + endif + enddo + np1=np2+1 + if(np1.le.nptl)goto1 + end + + +c----------------------------------------------------------------------- + subroutine hdecas(i,iret) +c----------------------------------------------------------------------- +c decay of object i (main decay routine) +c----------------------------------------------------------------------- + + include 'epos.inc' + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat,zor,tor + common/cttaus/tpro,zpro,ttar,ztar,ttaus,detap,detat + double precision ttaux,ttauz + integer jcdu(nflav,2) + + iret=0 + nptlb=nptl + +c no last generation -> no decay + + if(istptl(i).ne.0)return + + if(nptl.gt.mxptl-10)then + call alist('end&',1,nptl) + call utstop('hdecas: mxptl too small&') + endif +c entry + + call utpri('hdecas',ish,ishini,5) + ttauz=ttaus + + +c skip nuclei + + if(idptl(i).gt.1e9)return + +c small droplet decay + + if(iabs(idptl(i)).gt.1e8)then + stop'hdecas: no longer supported (2). ' + endif + +c ordinary decay + + call idmass(111,amrho0) + call idmass(221,amomeg) + ioi=iorptl(i) + if(ioi.gt.0.and.(idptl(i).eq.111.or.idptl(i).eq.221))then + if(.not.(iabs(idptl(ioi)).lt.10000 + * .and.jorptl(i).eq.0))then + + if(iLHC.eq.1.and.((ityptl(i).ge.20.and.ityptl(i).le.39) + * .or.ityptl(i).eq.42.or.ityptl(i).eq.52))then +c mix rho and omegas only from string production and if not decay product + if(idptl(i).eq.111)idptl(i)=221 + if(idptl(i).eq.221.and.ityptl(i).ge.30.and.ityptl(i).le.39 + * .and.rangen().gt.0.5)idptl(i)=111 + elseif(iLHC.eq.0.and..not.(ityptl(i).eq.60))then + if(idptl(i).eq.111)idptl(i)=221 + if(idptl(i).eq.221.and.rangen().gt.0.5)idptl(i)=111 + endif + + endif + endif + + if(ctaumin.gt.0.)then + call idtau(idptl(i),1.,1.,ctau) !ctau in fm + if(ctau*1.e-13.gt.ctaumin)goto 1000 !ctaumin in cm + endif + + ida=iabs(idptl(i)) + + if(.not.(iappl.eq.7.and.i.eq.1))then + if(mod(ndecay ,10).eq.1 + *.and.ida.ne.0.and.ida.lt.10000)goto1000 + if(mod(ndecay/10 ,10).eq.1.and.ida.eq. 20)goto1000 + if(mod(ndecay/100 ,10).eq.1.and.ida.eq.2130)goto1000 + if(mod(ndecay/1000 ,10).eq.1.and.ida.eq.1130)goto1000 + if(mod(ndecay/1000 ,10).eq.1.and.ida.eq.2230)goto1000 + if(mod(ndecay/10000 ,10).eq.1.and.ida.eq.2330)goto1000 + if(mod(ndecay/10000 ,10).eq.1.and.ida.eq.1330)goto1000 + if(mod(ndecay/100000 ,10).eq.1.and.ida.eq.3331)goto1000 + if(mod(ndecay/1000000,10).eq.1.and.ida.eq. 110)goto1000 + + if(nrnody.gt.0)then + do nod=1,nrnody + if(idptl(i).eq.nody(nod))goto 1000 + enddo + endif + + + endif + + call hdecay(i,iret) + if(iret.eq.1)goto1000 + if(nptl.le.nptlb)then + iret=-1 + goto 1000 + endif + +c ---successful decay--- + + istptl(i)=1 + ifrptl(1,i)=nptlb+1 + ifrptl(2,i)=nptl + + t=tivptl(2,i) + x=xorptl(1,i)+(t-xorptl(4,i))*pptl(1,i)/pptl(4,i) + y=xorptl(2,i)+(t-xorptl(4,i))*pptl(2,i)/pptl(4,i) + z=xorptl(3,i)+(t-xorptl(4,i))*pptl(3,i)/pptl(4,i) + call jtaux(t,z,ttaux) + ttaus=ttaux + if( ttaus.gt.0d0 ) then + call jtauin + call jtaus(z,ttest,sz) + if (abs(t-ttest).gt.1e-5.and.ish.ge.1) then + call utmsg('hdecas') + write(ifch,*)'***** t /= ttest' + write(ifch,*)t,ttest,i,z,t,xorptl(3,i),xorptl(4,i) + $ ,pptl(3,i),pptl(4,i) + call utmsgf + endif + endif + +c loop over decay products + + do 20 n=nptlb+1,nptl + iorptl(n)=i + jorptl(n)=0 + istptl(n)=0 + ifrptl(1,n)=0 + ifrptl(2,n)=0 + rad=0 + phi=0 + ti=t + zi=z + xorptl(1,n)=x + rad*cos(phi) + xorptl(2,n)=y + rad*sin(phi) + xorptl(3,n)=zi + xorptl(4,n)=ti + io=n +1 io=iorptl(io) + if(ish.ge.4)write(ifch,*)'io = ',io,' origin: ',iorptl(io) + if(io.eq.iorptl(io))call utmsg("Strange iorptl in hdecas&") +c security to avoid infinite loop + if(iorptl(io).gt.0.and.io.ne.iorptl(io))goto 1 + if(ish.ge.4)write(ifch,*)'origin: ',io,idptl(io) + zor=xorptl(3,io) + tor=xorptl(4,io) + call idquac(io,nq,ndummy1,ndummy2,jcdu) + r=rangen() + tauran=-taurea*alog(r) + call jtaix(n,tauran,zor,tor,zis,tis) + tivptl(1,n)=amax1(ti,tis) + call idtau(idptl(n),pptl(4,n),pptl(5,n),taugm) + r=rangen() + tivptl(2,n)=t+taugm*(-alog(r)) + ityptl(n)=ityptl(i) + radptl(n)=0. + dezptl(n)=0. + itsptl(n)=itsptl(i) + rinptl(n)=rinptl(i) +20 continue + + if(iabs(idptl(nptlb+1)).le.6) then + call gakli2(0,0) + write (*,*) 'nptlb+1,nptl:',nptlb+1,nptl + istptl(nptlb+1)=1 + do n=nptlb+2,nptl + istptl(n)=20 + enddo + call gakfra(0,iret) + if(iret.eq.1)goto1000 + call gakli2(0,0) + endif + +1000 continue + ttaus=ttauz + call jtauin + call utprix('hdecas',ish,ishini,5) + return + end + +c----------------------------------------------------------------------- + subroutine hdecay(ip,iret) +c----------------------------------------------------------------------- +c decays particle ip from /cptl/ +c for ip being no resonance: call StaHad +c for ip being resonance: standard resonance decay procedure +c----------------------------------------------------------------------- + include 'epos.inc' + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat + common/cttaus/tpro,zpro,ttar,ztar,ttaus,detap,detat + common/wco/wmass2,wgam2 + parameter (mxlook=10000,mxdky=2000) + common/dkytab/look(mxlook),cbr(mxdky),mode(5,mxdky) + dimension pgen(5,10),rnd(10),u(3),beta(3) + 1 ,reduce(10) + dimension prest(4,10),kno(10) + data reduce/1.,1.,2.,5.,15.,60.,250.,1500.,1.2E4,1.2E5/ + data twome/1.022006e-3/ + +c fctn definitions + dot(i1,i2)=prest(4,i1)*prest(4,i2)-prest(1,i1)*prest(1,i2) + *-prest(2,i1)*prest(2,i2)-prest(3,i1)*prest(3,i2) +c charged w propagator. + wprop(z)=(z-wmass2**2)**2+(wmass2*wgam2)**2 + + call utpri('hdecay',ish,ishini,5) + + ipp=ip + iret=0 + nptlb=nptl + + if(ish.ge.5)write(ifch,*)'ip,id,mass: ',ip,idptl(ip),pptl(5,ip) + + + if(model.eq.4.and.iappl.eq.7)then + if(abs(idptl(ipp)).gt.13.and.abs(idptl(ipp)).ne.1120 + &.and.abs(idptl(ipp)).ne.15)call decaymod(ipp,iret) + if(iret.gt.0)goto 1000 + naddptl=0 + goto 900 + endif + +c no k_long decay +c --------------- +c if(idptl(ip).eq.-20)goto1000 + +c select decay mode +c ----------------- + ntry=0 +2 ntry=ntry+1 + if(ntry.gt.100)then + if(ish.ge.1)then + call utmsg('hdecay') + write(ifch,*)'***** decay not possible. iret = 1.' + call utmsgf + endif + iret=1 + goto1000 + endif + idlv1=idptl(ip) + amss=pptl(5,ip) + +c Decay of deuteron + + if(abs(idlv1).eq.17)then + amss=1.01*amss + naddptl=2 + call idmass(1120,amnew) + pptl(5,nptl+1)=amnew + idptl(nptl+1)=sign(1120,idlv1) + sum=amnew + call idmass(1220,amnew) + pptl(5,nptl+2)=amnew + idptl(nptl+2)=sign(1220,idlv1) + sum=sum+amnew + goto 111 + endif + +c Decay of triton + + if(abs(idlv1).eq.18)then + amss=1.01*amss + naddptl=3 + call idmass(1120,amnew) + pptl(5,nptl+1)=amnew + idptl(nptl+1)=sign(1120,idlv1) + sum=amnew + call idmass(1220,amnew) + pptl(5,nptl+2)=amnew + idptl(nptl+2)=sign(1220,idlv1) + sum=sum+amnew + call idmass(1220,amnew) + pptl(5,nptl+3)=amnew + idptl(nptl+3)=sign(1220,idlv1) + sum=sum+amnew + goto 111 + endif + +c Decay of alpha + + if(abs(idlv1).eq.19)then + amss=1.01*amss + naddptl=4 + call idmass(1120,amnew) + pptl(5,nptl+1)=amnew + idptl(nptl+1)=sign(1120,idlv1) + sum=amnew + call idmass(1220,amnew) + pptl(5,nptl+2)=amnew + idptl(nptl+2)=sign(1220,idlv1) + sum=sum+amnew + call idmass(1120,amnew) + pptl(5,nptl+3)=amnew + idptl(nptl+3)=sign(1120,idlv1) + sum=sum+amnew + call idmass(1220,amnew) + pptl(5,nptl+4)=amnew + idptl(nptl+4)=sign(1220,idlv1) + sum=sum+amnew + goto 111 + endif + +c select one of the decay channel + ipoint=look(iabs(idlv1))-1 + if(idlv1.eq.-20)ipoint=look(320)-1 + if(ipoint.lt.0) goto1000 + try=rangen() +100 ipoint=ipoint+1 + if(ish.ge.4)write(ifch,*)'ipoint,cbr,try',ipoint,cbr(ipoint),try + if(try.gt.cbr(ipoint)) goto100 + naddptl=0 + sum=0. +c nstart=nptl+1 !?????????????????unused + new=0 + do 110 i=1,5 !store id and mass of products + if(mode(i,ipoint).eq.0) goto 110 + if(nptl+naddptl+1.gt.mxptl) goto 9999 + if(iabs( mode(1,ipoint)) .le. 6.and.i.eq.2)then !decay into quark ??? + call vedi(mode(1,ipoint),mode(2,ipoint),k3,idlv1) + idptl(new)=idlv1 + call idmass(idlv1,amnew) + pptl(5,new)=amnew + sum=pptl(5,new) + else !decay into particles + naddptl=naddptl+1 + new=nptl+naddptl + idptl(new)=mode(i,ipoint) + idlv1=idptl(new) + call idmass(idlv1,pptl(5,new)) + sum=sum+pptl(5,new) + endif + 110 continue + 111 continue + if(naddptl.ne.1.and.sum.ge.amss)goto 2 + 112 naddptl1=naddptl-1 + do 120 j=1,5 + pgen(j,1)=pptl(j,ip) +120 continue + pgen(5,1)=amss !needed because of deuteron, triton and alpha decay and OK + + pgen(5,naddptl)=pptl(5,nptl+naddptl) + if(naddptl.eq.1) goto 700 !one body decay + if(naddptl.eq.2) goto 400 !two body decay + + if(ish.ge.4)write(ifch,*)'>= 3 body decay' + +c use kroll-wada distribution for pi0 and eta dalitz decays. +c ---------------------------------------------- + if(.not.((idptl(ip).eq.110.or.idptl(ip).eq.220).and. + 1iabs(idptl(nptl+2)).eq.12)) goto 130 + ntry=0 !decay of pi0 or eta into electron +125 ntry=ntry+1 + if(ntry.gt.10)then + if(ish.ge. 0)then + call utmsg('hdecay') + write(ifch,*)'***** ntry > 10. iret = 1.' + write(ifch,*)'***** amee,ree,wtee',amee,ree,wtee + call utmsgf + endif + iret=1 + goto1000 + endif + amee=twome*(pptl(5,ip)/twome)**rangen() + ree=(twome/amee)**2 + wtee=(1.-(amee/pptl(5,ip))**2)**3*sqrt(1.-ree)*(1.+.5*ree) + if(wtee.lt.rangen()) goto125 + pgen(5,2)=amee + goto400 +130 continue + +c calculate maximum phase-space weight +c ------------------------------------ + wtmax=1./reduce(naddptl) + sum1=pgen(5,1) + sum2=sum-pptl(5,nptl+1) + do 200 i=1,naddptl1 + wtmax=wtmax*utpcm(sum1,sum2,pptl(5,nptl+i)) + sum1=sum1-pptl(5,nptl+i) + sum2=sum2-pptl(5,nptl+i+1) +200 continue + +c generate uniform naddptl-body phase space +c -------------------------------------- + ntry=0 +300 ntry=ntry+1 + if(ntry.gt.10000)then + if(ish.ge. 0)then + call utmsg('hdecay') + write(ifch,*)'***** infinite loop (2). iret = 1.' + write(ifch,*)'***** ip,idptl(ip),pptl(5,ip):' + *,ip,idptl(ip),pptl(5,ip) + write(ifch,*)'***** wt,wtmax:',wt,wtmax + write(ifch,*)'***** i,pgen(5,i),pptl(5,nptl+i),idptl(nptl+i):' + do i=1,naddptl + write(ifch,*)i,pgen(5,i),pptl(5,nptl+i),idptl(nptl+i) + enddo + call utmsgf + endif + iret=1 + goto1000 + endif + rnd(1)=1. + jsave=1 + do 310 i=2,naddptl1 + rnew=rangen() + i1=i-1 + do 320 jj1=1,i1 + j=i-jj1 + jsave=j+1 + if(rnew.le.rnd(j)) goto310 + rnd(jsave)=rnd(j) +320 continue +310 rnd(jsave)=rnew + rnd(naddptl)=0. + wt=1. + sum1=sum + do 330 i=2,naddptl + sum1=sum1-pptl(5,nptl+i-1) + pgen(5,i)=sum1+rnd(i)*(pgen(5,1)-sum) + a=pgen(5,i-1) + b=pgen(5,i) + c=pptl(5,nptl+i-1) + wt=wt*utpcm(a,b,c) +330 continue + if(wt.lt.rangen()*wtmax) goto300 + +c carry out two-body decays in pgen frames +c ---------------------------------------- +400 continue + if(ish.ge.4)write(ifch,*)'2 body decay' + do 410 i=1,naddptl1 + qcm=utpcm(pgen(5,i),pgen(5,i+1),pptl(5,nptl+i)) + u(3)=2.*rangen()-1. + phi=2.*pi*rangen() + u(1)=sqrt(1.-u(3)**2)*cos(phi) + u(2)=sqrt(1.-u(3)**2)*sin(phi) + do 420 j=1,3 + pptl(j,nptl+i)=qcm*u(j) + pgen(j,i+1)=-pptl(j,nptl+i) +420 continue + pptl(4,nptl+i)=sqrt(qcm**2+pptl(5,nptl+i)**2) + pgen(4,i+1)=sqrt(qcm**2+pgen(5,i+1)**2) +410 continue + do 430 j=1,4 + pptl(j,nptl+naddptl)=pgen(j,naddptl) +430 continue + +c boost pgen frames to lab frame +c also save momenta in rest frame (last frame) +c ------------------------------------------------- + do 500 ii=1,naddptl1 + i=naddptl-ii + do 510 j=1,3 + beta(j)=pgen(j,i)/pgen(4,i) +510 continue + gamma=pgen(4,i)/pgen(5,i) + do 520 k=i,naddptl + k1=nptl+k + bp=beta(1)*pptl(1,k1)+beta(2)*pptl(2,k1)+beta(3)*pptl(3,k1) + do 530 j=1,3 + prest(j,k)=pptl(j,k1) + pptl(j,k1)=pptl(j,k1)+gamma*beta(j)*(pptl(4,k1) + 1+bp*gamma/(gamma+1.)) +530 continue + prest(4,k)=pptl(4,k1) + pptl(4,k1)=gamma*(pptl(4,k1)+bp) + if(pptl(4,k1).lt.1.d-5)then + pptl(4,k1)=sqrt(pptl(1,k1)*pptl(1,k1)+pptl(2,k1)*pptl(2,k1) + & +pptl(3,k1)*pptl(3,k1)) + endif +520 continue +500 continue + +c matrix elements +c --------------- + if(iabs(idptl(ip)).eq.14)then !muon decay + goto 650 + elseif(naddptl.eq.3)then + if(idptl(ip).eq.221.or.idptl(ip).eq.331)then !omeg and phi decay + goto 610 + elseif(iabs(idptl(ip)).eq.130.or. !Kl and K decay + 1 idptl(ip).eq.-20)then + if(iabs(idptl(nptl+2)).lt.20)then !semi-leptonic + goto 630 + else !hadronic + goto 640 + endif + elseif(iabs(idptl(nptl+1)).lt.20.and. !other semi-leptonic decay + 1 idptl(nptl+1).ne.10)then + goto 620 + elseif(iabs(idptl(nptl+2)).le.6)then + goto 605 !decay into quark + else + goto 800 + endif + else + goto 800 + endif + + 605 wt=pptl(5,ip)*pptl(5,nptl+1)*dot(2,3) + IF(wt.LT.rangen()*pptl(5,ip)**4/16.) goto 300 + ams=sqrt(dot(2,2)+dot(3,3)+2.*dot(2,3)) + kno(1)=idptl(nptl+2) + kno(2)=idptl(nptl+3) + if(ammin(kno(1),kno(2)).gt.ams)then + call vedi(kno(1),kno(2),iddum,idlv2) + idptl(nptl+2)=idlv2 + call idmass(idlv2,amnew2) + pptl(5,nptl+2)=amnew2 + naddptl=2 + goto 112 + endif +c......multiplicity + PS =sqrt(dot(2,2)) + psq=sqrt(dot(3,3)) +c PSP=PS !!???????????????unused + np=0 !!!!????? + nq=2 + CNDE=4.5*LOG(MAX((ams-PS-PSQ)/0.7,1.1)) +c IF(MMAT.EQ.12) CNDE=CNDE+PARJ(63) + 769 NTRY=NTRY+1 + IF(NTRY.GT.1000) THEN + write(*,*)'hdecay caught in infinite loop' + write(ifch,*)'hdecay caught in infinite loop' + iret=1 + goto 1000 + ENDIF + GAUSS=SQRT(-2.*CNDE*LOG(MAX(1E-10,rangen())))* + & SIN(2.*pi*rangen()) + ND=0.5+0.5*NP+0.25*NQ+CNDE+GAUSS + IF(ND.LT.NP+NQ/2.OR.ND.LT.2.OR.ND.GT.10) GOTO 769 + + +c......choose hadrons + + + kno(3)=kno(1) + kno(4)=kno(2) + + CONTINUE + IF(ND.EQ.NP+NQ/2) GOTO 773 + DO I=nptl+2,nptl+2+nd-nq/2-1 + JT=2+1+INT((NQ-1) * rangen() ) + CALL vedi(kno(JT),0,KFL2,idlv3) + idptl(i)=idlv3 +c IF(K(I,2).EQ.0) GOTO 769 + kno(JT)=-KFL2 + enddo + 773 CONTINUE + CALL vedi(kno(3),kno(4),KFLDMP,idlv4) + idptl(nptl+2+nd-nq/2)=idlv4 + sum=0. + do i=nptl+2,nptl+2+nd-nq/2 + call idmass(idptl(i),am) + pptl(5,i)=am + sum=sum+am + enddo + if(sum.gt.ams) goto 769 +c......goto phase space dis.... + ip=nptl+2+nd-nq/2+1 + do j=1,4 + pptl(j,ip)=pptl(j,ipp)-pptl(j,nptl+1) + enddo + pptl(5,ip)=ams + idptl(ip)=sign(80,idptl(ipp)) + nptl=nptl+1 + naddptl=nd + goto 112 + + +c omeg and phi decay +c use vectors in rest frame +c ------------------------------ +610 wt=(pptl(5,nptl+1)*pptl(5,nptl+2)*pptl(5,nptl+3))**2 + 1-(pptl(5,nptl+1)*dot(2,3))**2 + 2-(pptl(5,nptl+2)*dot(1,3))**2 + 3-(pptl(5,nptl+3)*dot(1,2))**2 + 4+2.*dot(1,2)*dot(2,3)*dot(1,3) + if(wt.lt.rangen()*pptl(5,ip)**6/108.) goto300 + goto800 + +c semileptonic and quark decays +c use vectors in rest frame, where ip has (m,0,0,0) +c include w propagator +c ------------------------------------------------------ +620 wt=(pptl(5,ip)*prest(4,2))*dot(1,3) + s12=pptl(5,nptl+1)**2+pptl(5,nptl+2)**2+2.*dot(1,2) + s12max=pptl(5,ip)**2 + wt=wt*wprop(s12max)/wprop(s12) + if(wt.lt.rangen()*pptl(5,ip)**4/16.) goto 300 + goto 800 + +c semileptonic kaon decays +c use vectors in rest frame, where ip has (m,0,0,0) +c include form factor FML +c ------------------------------------------------------ +630 if(iabs(idptl(ip)).eq.130)then + if(iabs(idptl(nptl+2)).eq.12)then + ncha=1 !K -> Pi0 + e + Nu + else + ncha=2 !K -> Pi0 + Mu + Nu + endif + else + if(iabs(idptl(nptl+2)).eq.12)then + ncha=3 !K0 -> Pi + e + Nu + else + ncha=4 !K0 -> Pi + Mu + Nu + endif + endif + + wt=FML(ncha,pptl(5,ip),pptl(5,nptl+1),pptl(5,nptl+2) + & ,prest(4,1),prest(4,2),prest(4,3)) + if(wt.lt.rangen()) goto 300 + goto 800 + +c hadronic kaon decays +c use vectors in rest frame, where ip has (m,0,0,0) +c include form factor FM +c ------------------------------------------------------ +640 if(iabs(idptl(ip)).eq.130)then + if(iabs(idptl(nptl+3)).eq.120)then + ncha=1 !K -> 3 Pi + else + ncha=2 !K -> Pi + 2 Pi0 + endif + else + if(iabs(idptl(nptl+1)).eq.110)then + ncha=3 !K0 -> 3 Pi0 + else + ncha=4 !K0 -> 2 Pi + Pi0 + endif + endif + S0=(pptl(5,ip)**2+pptl(5,nptl+1)**2+pptl(5,nptl+2)**2 + & +pptl(5,nptl+3)**2)/3.d0 + S1=pptl(5,ip)**2+pptl(5,nptl+1)**2-2.*prest(4,1)*pptl(5,ip) + S2=pptl(5,ip)**2+pptl(5,nptl+2)**2-2.*prest(4,2)*pptl(5,ip) + S3=pptl(5,ip)**2+pptl(5,nptl+3)**2-2.*prest(4,3)*pptl(5,ip) + wt=FM(ncha,S0,S1,S2,S3) + if(wt.lt.rangen()) goto 300 + goto 800 + +c muon decays +c use vectors in rest frame, where ip has (m,0,0,0) +c include form factor FMU +c ------------------------------------------------------ +650 xxx=2.*prest(4,1)/pptl(5,ip) !reduced energy of electron + if(xxx.gt.1.) goto 300 + wt=FMU(xxx) + rrr=rangen() + if(wt.lt.rrr) goto 300 + goto 800 + +c one-particle decays +c ------------------- +700 continue + do 710 j=1,5 + pptl(j,nptl+1)=pptl(j,ip) +710 continue + +c swap particles and antiparticles if idptl(ip)<0 +c ----------------------------------------------- + 800 continue + if(iabs(idptl(ip)).eq.80)then + nptl=nptl-1 + naddptl=naddptl+1 + endif + if(idptl(ipp).ge.0.or.iabs(idptl(ipp)).eq.20) goto 900 + do 810 i=1,naddptl + idabs=iabs(idptl(nptl+i)) + ifl1=idabs/1000 + ifl2=mod(idabs/100,10) + ifl3=mod(idabs/10,10) + if(ifl1.eq.0.and.ifl2.ne.0.and.ifl2.eq.ifl3) goto 810 + if(idabs.eq.9.or.idabs.eq.10.or.idabs.eq.20) goto 810 + if(idabs.eq.29.or.idabs.eq.30.or.idabs.eq.40) goto 810 + idptl(nptl+i)=-idptl(nptl+i) + 810 continue + + 900 continue + nptl=nptl+naddptl + if(nptl.gt.mxptl)call utstop('hdecay: nptl>mxptl&') +c nqk=0 !???????????????????unused + if(iabs(idptl(nptl)).lt.10.or.mod(idptl(nptl),100).eq.0)then +c call utstop('hdecay: decay ptcl is parton&') + endif + +c print +c ----- + + if(ish.ge.3)then + write(ifch,140)sngl(ttaus) + 140 format(/' ----------------------------'/ + *' decay at tau =',f6.2/ + *' ----------------------------') + write(ifch,*)'decaying object:' + call alist('&',ip,ip) + write(ifch,*)'decay products:' + call alist('&',nptlb+1,nptl) + endif + if(ish.ge.5)then + write(ifch,*)'momentum sum:' + do kk=1,5 + pptl(kk,nptl+1)=0 + do ii=nptlb+1,nptl + pptl(kk,nptl+1)=pptl(kk,nptl+1)+pptl(kk,ii) + enddo + enddo + call alist('&',nptl+1,nptl+1) + endif + +c exit +c ---- + + 1000 continue + ip=ipp + if(iret.ne.0.and.ish.ge.1)then + write(ifmt,'(a)')'hdecay: redo event' + write(ifch,'(a)')'hdecay: redo event' + endif + call utprix('hdecay',ish,ishini,5) + return + + 9999 call utstop('hdecay: mxptl too small&') + end + +c--------------------------------------------------------------------- + subroutine vedi(k1,k2,k3,id) +c--------------------------------------------------------------------- + include 'epos.inc' + if(k2.eq.0)then + if(rangen().lt.pdiqua.and.iabs(k1).lt.6)then + ifl1=int(rangen()/pud)+1 + ifl2=int(rangen()/pud)+1 + k3=-min(ifl1,ifl2)*1000-max(ifl1,ifl2)*100 + else + k3=int(rangen()/pud)+1 + endif + if(k1.gt.0.and.k1.le.6)k3=-k3 + if(k1.lt.-1000)k3=-k3 + else + k3=k2 + endif + id=idsp(k1,k3) + if(iabs(id).le.999) then + ids=max(mod(iabs(id)/100,10),mod(iabs(id)/10,10)) + if(ids.le.2)then + idr=sign(iabs(id)+int(rangen()+0.5),id) + elseif(ids.eq.3)then + idr=sign(iabs(id)+int(rangen()+0.6),id) + else + idr=sign(iabs(id)+int(rangen()+0.75),id) + endif + else + idr=sign(iabs(id)+int(0.5+rangen()),id) + endif + id=idr + if(ish.ge.5)write(ifch,*) 'Flavor:',k1,k2,k3,id + end + +c----------------------------------------------------------------------- + subroutine hdecin(lprint) +c----------------------------------------------------------------------- +c sets up /dkytab/ +c----------------------------------------------------------------------- + include 'epos.inc' + common/wco/wmass2,wgam2 + dimension imode(6) + character*8 idlabl,lmode(6),lres + character*8 iblank + logical lprint + parameter (mxlook=10000,mxdky=2000) + common/dkytab/look(mxlook),cbr(mxdky),mode(5,mxdky) + common/nodcay/nodcay,noeta,nopi0,nonunu,noevol,nohadr + logical nodcay,noeta,nopi0,nonunu,noevol,nohadr + parameter (ndectb=1193) + real dectab(7,ndectb) + + data ((dectab(i,j),i=1,7),j= 1, 18)/ + * 110., .98850, 10., 10., 0., 0., 0. + *, 110.,1.00000, 10., 12., -12., 0., 0. + *, 220., .38000, 10., 10., 0., 0., 0. + *, 220., .71000, 110., 110., 110., 0., 0. + *, 220., .94600, 120.,-120., 110., 0., 0. + *, 220., .99500, 120.,-120., 10., 0., 0. + *, 220.,1.00000, 10., 12., -12., 0., 0. + *, 330., .44100, 220., 120.,-120., 0., 0. + *, 330., .66100, 220., 110., 110., 0., 0. + *, 330., .95900, 111., 10., 0., 0., 0. + *, 330., .98000, 221., 10., 0., 0., 0. + *, 330.,1.00000, 10., 10., 0., 0., 0. + *, 121.,1.00000, 120., 110., 0., 0., 0. + *, 111., .99989, 120.,-120., 0., 0., 0. + *, 111., .99993, 12., -12., 0., 0., 0. + *, 111.,1.00000, 14., -14., 0., 0., 0. + *, 221., .89900, 120.,-120., 110., 0., 0. + *, 221., .91200, 120.,-120., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j= 19, 36)/ + * 221., .99992, 110., 10., 0., 0., 0. + *, 221.,1.00000, 12., -12., 0., 0., 0. + *, 331., .48600, 130.,-130., 0., 0., 0. + *, 331., .83700, 230.,-230., 0., 0., 0. + *, 331., .98400, 120.,-120., 110., 0., 0. + *, 331., .99944, 220., 10., 0., 0., 0. + *, 331., .99975, 12., -12., 0., 0., 0. + *, 331.,1.00000, 14., -14., 0., 0., 0. + *, 230., .50000, 20., 0., 0., 0., 0. + *, 230.,1.00000, -20., 0., 0., 0., 0. + *, 131., .66670, 230., 120., 0., 0., 0. + *, 131.,1.00000, 130., 110., 0., 0., 0. + *, 231., .66670, 130.,-120., 0., 0., 0. + *, 231.,1.00000, 230., 110., 0., 0., 0. + *, 240., .11000, 12., -11., 230., 0., 0. + *, 240., .17000, 12., -11., 231., 0., 0. + *, 240., .28000, 14., -13., 230., 0., 0. + *, 240., .34000, 14., -13., 231., 0., 0./ + data ((dectab(i,j),i=1,7),j= 37, 54)/ + * 240., .37800, 230.,-120., 0., 0., 0. + *, 240., .56300, 230.,-121., 0., 0., 0. + *, 240., .60800, 231.,-120., 0., 0., 0. + *, 240., .62100, 230.,-120., 110., 0., 0. + *, 240., .71000, 130.,-120.,-120., 0., 0. + *, 240., .80100, 230.,-120.,-120., 120., 0. + *, 240., .87900, 130.,-120.,-120., 110., 0. + *, 240., .95400, 230.,-120., 110., 110., 0. + *, 240., .96600, 230.,-130., 0., 0., 0. + *, 240., .97600, 331.,-120., 0., 0., 0. + *, 240., .98800,-130., 231., 0., 0., 0. + *, 240.,1.00000,-131., 230., 0., 0., 0. + *, 140., .04500, -12., 11., 130., 0., 0. + *, 140., .07500, -12., 11., 131., 0., 0. + *, 140., .12000, -14., 13., 130., 0., 0. + *, 140., .15000, -14., 13., 131., 0., 0. + *, 140., .20300, 130.,-120., 0., 0., 0. + *, 140., .22700, 230., 110., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j= 55, 72)/ + * 140., .24700, 230., 220., 0., 0., 0. + *, 140., .28900, 230., 221., 0., 0., 0. + *, 140., .45100, 130.,-121., 0., 0., 0. + *, 140., .53600, 131.,-120., 0., 0., 0. + *, 140., .56200, 231., 110., 0., 0., 0. + *, 140., .57600, 230., 111., 0., 0., 0. + *, 140., .58700, 130.,-120., 110., 0., 0. + *, 140., .60300, 230.,-120., 120., 0., 0. + *, 140., .72700, 130.,-120.,-120., 120., 0. + *, 140., .87600, 230.,-120., 120., 110., 0. + *, 140., .96900, 130.,-120., 110., 110., 0. + *, 140.,1.00000, 230., 110., 110., 110., 0. + *, 340., .03250, 12., -11., 220., 0., 0. + *, 340., .06500, 12., -11., 331., 0., 0. + *, 340., .09750, 14., -13., 220., 0., 0. + *, 340., .13000, 14., -13., 331., 0., 0. + *, 340., .17900,-130., 230., 0., 0., 0. + *, 340., .22800,-120., 220., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j= 73, 90)/ + * 340., .33800,-131., 230., 0., 0., 0. + *, 340., .44800,-130., 231., 0., 0., 0. + *, 340., .55800,-120., 331., 0., 0., 0. + *, 340., .57500,-130., 230., 110., 0., 0. + *, 340., .59200,-230., 230.,-120., 0., 0. + *, 340., .69400,-130., 230.,-120., 120., 0. + *, 340., .79600,-130., 230., 110., 110., 0. + *, 340., .89800,-130., 130.,-120., 110., 0. + *, 340.,1.00000,-230., 230.,-120., 110., 0. + *, 241., .64000, 140.,-120., 0., 0., 0. + *, 241., .92000, 240., 110., 0., 0., 0. + *, 241.,1.00000, 240., 10., 0., 0., 0. + *, 141., .55000, 140., 110., 0., 0., 0. + *, 141.,1.00000, 140., 10., 0., 0., 0. + *, 341.,1.00000, 340., 10., 0., 0., 0. + *, 441., .07400, 12., -12., 0., 0., 0. + *, 441., .14800, 14., -14., 0., 0., 0. + *, 441., .15210,-121., 120., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j= 91,108)/ + * 441., .15620, 111., 110., 0., 0., 0. + *, 441., .16020, 121.,-120., 0., 0., 0. + *, 441., .16300,-121., 111., 120., 0., 0. + *, 441., .16580, 121.,-121., 110., 0., 0. + *, 441., .16860, 121., 111.,-120., 0., 0. + *, 441., .28740, 120.,-120., 130.,-130., 0. + *, 441., .40620, 110., 110., 130.,-130., 0. + *, 441., .52500, 120.,-120., 120.,-120., 0. + *, 441., .64380, 120.,-120., 110., 110., 0. + *, 441., .76260, 110., 110., 110., 110., 0. + *, 441., .88130, 120.,-120., 230.,-230., 0. + *, 441.,1.00000, 110., 110., 230., 230., 0. + *, 150., .06000, -12., 11., 140., 0., 0. + *, 150., .12000, -12., 11., 141., 0., 0. + *, 150., .18000, -14., 13., 140., 0., 0. + *, 150., .24000, -14., 13., 141., 0., 0. + *, 150., .25500, -16., 15., 140., 0., 0. + *, 150., .27000, -16., 15., 141., 0., 0./ + data ((dectab(i,j),i=1,7),j=109,122)/ + * 150., .28050, 140., 120., 0., 0., 0. + *, 150., .29100, 140., 121., 0., 0., 0. + *, 150., .30150, 141., 120., 0., 0., 0. + *, 150., .31200, 141., 121., 0., 0., 0. + *, 150., .32650, 140.,-340., 0., 0., 0. + *, 150., .34100, 140.,-341., 0., 0., 0. + *, 150., .35550, 141.,-340., 0., 0., 0. + *, 150., .37000, 141.,-341., 0., 0., 0. + *, 150., 0.820 , 1., -4., 1., -2., 0. + *, 150., 0.920 , 1., -2., 1., -4., 0. + *, 150., 0.975 , 1., -4., 4., -3., 0. + *, 150., 0.985 , 1., -3., 4., -4., 0. + *, 150., 0.995 , 1., -1., 1., -2., 0. + *, 150., 1. , 1., -1., 4., -3., 0./ + data ((dectab(i,j),i=1,7),j=123,142) + */ 250., .06000, -12., 11., 240., 0., 0. + *, 250., .12000, -12., 11., 241., 0., 0. + *, 250., .18000, -14., 13., 240., 0., 0. + *, 250., .24000, -14., 13., 241., 0., 0. + *, 250., .25500, -16., 15., 240., 0., 0. + *, 250., .27000, -16., 15., 241., 0., 0. + *, 250., .28050, 240., 120., 0., 0., 0. + *, 250., .29100, 240., 121., 0., 0., 0. + *, 250., .30150, 241., 120., 0., 0., 0. + *, 250., .31200, 241., 121., 0., 0., 0. + *, 250., .32650, 240.,-340., 0., 0., 0. + *, 250., .34100, 240.,-341., 0., 0., 0. + *, 250., .35550, 241.,-340., 0., 0., 0. + *, 250., .37000, 241.,-341., 0., 0., 0. + *, 250., 0.820 , 2., -4., 1., -2., 0. + *, 250., 0.920 , 2., -2., 1., -4., 0. + *, 250., 0.975 , 2., -4., 4., -3., 0. + *, 250., 0.985 , 2., -3., 4., -4., 0. + *, 250., 0.995 , 2., -1., 1., -2., 0. + *, 250., 1. , 2., -1., 4., -3., 0./ + data ((dectab(i,j),i=1,7),j=143,176)/ + * 238*1. / + data ((dectab(i,j),i=1,7),j=177,190) + * /350., .06000, 12., -11., 340., 0., 0. + *, 350., .12000, 12., -11., 341., 0., 0. + *, 350., .18000, 14., -13., 340., 0., 0. + *, 350., .24000, 14., -13., 341., 0., 0. + *, 350., .25500, 16., -15., 340., 0., 0. + *, 350., .27000, 16., -15., 341., 0., 0. + *, 350., .28050, 340., 120., 0., 0., 0. + *, 350., .29100, 340., 121., 0., 0., 0. + *, 350., .30150, 341., 120., 0., 0., 0. + *, 350., .31200, 341., 121., 0., 0., 0. + *, 350., .32650, 340.,-340., 0., 0., 0. + *, 350., .34100, 340.,-341., 0., 0., 0. + *, 350., .35550, 341.,-340., 0., 0., 0. + *, 350., .37000, 341.,-341., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=191,196)/ + * 350., 0.820 , 3., -4., 1., -2., 0. + *, 350., 0.920 , 3., -2., 1., -4., 0. + *, 350., 0.975 , 3., -4., 4., -3., 0. + *, 350., 0.985 , 3., -3., 4., -4., 0. + *, 350., 0.995 , 3., -1., 1., -2., 0. + *, 350., 1. , 3., -1., 4., -3., 0./ + data ((dectab(i,j),i=1,7),j=197,244)/ + * 336*1. / + data ((dectab(i,j),i=1,7),j=245,262)/ + * 160., .33330, -1., 2., -5., 0., 0. + *, 160., .66660, -4., 3., -5., 0., 0. + *, 160., .77770, 11., -12., -5., 0., 0. + *, 160., .88880, 13., -14., -5., 0., 0. + *, 160.,1.00000, -15., 16., -5., 0., 0. + *, 260., .33330, -1., 2., -5., 0., 0. + *, 260., .66660, -4., 3., -5., 0., 0. + *, 260., .77770, -11., 12., -5., 0., 0. + *, 260., .88880, -13., 14., -5., 0., 0. + *, 260.,1.00000, -15., 16., -5., 0., 0. + *, 360., .33330, -1., 2., -5., 0., 0. + *, 360., .66660, -4., 3., -5., 0., 0. + *, 360., .77770, -11., 12., -5., 0., 0. + *, 360., .88880, -13., 14., -5., 0., 0. + *, 360.,1.00000, -15., 16., -5., 0., 0. + *, 151.,1.00000, 150., 10., 0., 0., 0. + *, 251.,1.00000, 250., 10., 0., 0., 0. + *, 351.,1.00000, 350., 10., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=263,280)/ + * 161.,1.00000, 160., 10., 0., 0., 0. + *, 261.,1.00000, 260., 10., 0., 0., 0. + *, 361.,1.00000, 360., 10., 0., 0., 0. + *,1230.,1.00000,2130., 10., 0., 0., 0. + *,1111.,1.00000,1120., 120., 0., 0., 0. + *,1121., .66670,1120., 110., 0., 0., 0. + *,1121.,1.00000,1220., 120., 0., 0., 0. + *,1221., .66670,1220., 110., 0., 0., 0. + *,1221.,1.00000,1120.,-120., 0., 0., 0. + *,2221.,1.00000,1220.,-120., 0., 0., 0. + *,1131., .88000,2130., 120., 0., 0., 0. + *,1131., .94000,1130., 110., 0., 0., 0. + *,1131.,1.00000,1230., 120., 0., 0., 0. + *,1231., .88000,2130., 110., 0., 0., 0. + *,1231., .94000,1130.,-120., 0., 0., 0. + *,1231.,1.00000,2230., 120., 0., 0., 0. + *,2231., .88000,2130.,-120., 0., 0., 0. + *,2231., .94000,1230.,-120., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=281,298)/ + * 2231.,1.00000,2230., 110., 0., 0., 0. + *,1331., .66670,2330., 120., 0., 0., 0. + *,1331.,1.00000,1330., 110., 0., 0., 0. + *,2331., .66670,1330.,-120., 0., 0., 0. + *,2331.,1.00000,2330., 110., 0., 0., 0. + *, 16., .18000, 12., -11., 15., 0., 0. + *, 16., .36000, 14., -13., 15., 0., 0. + *, 16., .45100,-120., 15., 0., 0., 0. + *, 16., .66000,-121., 15., 0., 0., 0. + *, 16., .78000, 110., 110.,-120., 15., 0. + *, 16., .83600, 120.,-120.,-120., 15., 0. + *, 16.,1.00000, 120., 110.,-120.,-120., 15. + *,2140., .03750, -12., 11.,2130., 0., 0. + *,2140., .07500, -12., 11.,1231., 0., 0. + *,2140., .11250, -14., 13.,2130., 0., 0. + *,2140., .15000, -14., 13.,1231., 0., 0. + *,2140., .18200,2130., 120., 0., 0., 0. + *,2140., .21300,1230., 120., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=299,316)/ + * 2140., .24400,1120.,-230., 0., 0., 0. + *,2140., .29500,1131., 110., 0., 0., 0. + *,2140., .34600,1231., 120., 0., 0., 0. + *,2140., .39700,1121.,-230., 0., 0., 0. + *,2140., .44800,1111.,-130., 0., 0., 0. + *,2140., .49900,1130., 111., 0., 0., 0. + *,2140., .55000,1230., 121., 0., 0., 0. + *,2140., .60100,1120.,-231., 0., 0., 0. + *,2140., .65800,1120.,-230., 120.,-120., 0. + *,2140., .71500,1120.,-230., 110., 110., 0. + *,2140., .77200,1120.,-130., 120., 110., 0. + *,2140., .82900,1220.,-230., 120., 110., 0. + *,2140., .88600,1220.,-130., 120., 120., 0. + *,2140., .94300,2130., 120., 120.,-120., 0. + *,2140.,1.00000,2130., 120., 110., 110., 0. + *,1140.,1.00000,2140., 120., 0., 0., 0. + *,1240.,1.00000,2140., 110., 0., 0., 0. + *,2240.,1.00000,2140.,-120., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=317,334)/ + * 1340., .03750, -12., 11.,1330., 0., 0. + *,1340., .07500, -12., 11.,1331., 0., 0. + *,1340., .11250, -14., 13.,1330., 0., 0. + *,1340., .15000, -14., 13.,1331., 0., 0. + *,1340., .19900,1330., 120., 0., 0., 0. + *,1340., .24800,1231., 130., 0., 0., 0. + *,1340., .28800,1330., 120., 0., 0., 0. + *,1340., .32800,1131.,-230., 0., 0., 0. + *,1340., .36800,1330., 121., 0., 0., 0. + *,1340., .40800,1130.,-230., 0., 0., 0. + *,1340., .44800,1330., 120., 110., 0., 0. + *,1340., .48800,2330., 120., 120., 0., 0. + *,1340., .52800,1130.,-130., 120., 0., 0. + *,1340., .56800,1130.,-230., 110., 0., 0. + *,1340., .60800,1230.,-230., 120., 0., 0. + *,1340., .66400,2130.,-230., 120., 110., 0. + *,1340., .72000,2130.,-130., 120., 120., 0. + *,1340., .77600,1130.,-230., 120.,-120., 0./ + data ((dectab(i,j),i=1,7),j=335,352)/ + * 1340., .83200,1130.,-230., 110., 110., 0. + *,1340., .88800,1330., 120., 120.,-120., 0. + *,1340., .94400,1330., 120., 110., 110., 0. + *,1340.,1.00000,2330., 120., 120., 110., 0. + *,3140., .03750, -12., 11.,1330., 0., 0. + *,3140., .07500, -12., 11.,1331., 0., 0. + *,3140., .11250, -14., 13.,1330., 0., 0. + *,3140., .15000, -14., 13.,1331., 0., 0. + *,3140., .19900,1330., 120., 0., 0., 0. + *,3140., .24800,1231., 130., 0., 0., 0. + *,3140., .28800,1330., 120., 0., 0., 0. + *,3140., .32800,1131.,-230., 0., 0., 0. + *,3140., .36800,1330., 121., 0., 0., 0. + *,3140., .40800,1130.,-230., 0., 0., 0. + *,3140., .44800,1330., 120., 110., 0., 0. + *,3140., .48800,2330., 120., 120., 0., 0. + *,3140., .52800,1130.,-130., 120., 0., 0. + *,3140., .56800,1130.,-230., 110., 0., 0./ + data ((dectab(i,j),i=1,7),j=353,370)/ + * 3140., .60800,1230.,-230., 120., 0., 0. + *,3140., .66400,2130.,-230., 120., 110., 0. + *,3140., .72000,2130.,-130., 120., 120., 0. + *,3140., .77600,1130.,-230., 120.,-120., 0. + *,3140., .83200,1130.,-230., 110., 110., 0. + *,3140., .88800,1330., 120., 120.,-120., 0. + *,3140., .94400,1330., 120., 110., 110., 0. + *,3140.,1.00000,2330., 120., 120., 110., 0. + *,2340., .03750, -12., 11.,2330., 0., 0. + *,2340., .07500, -12., 11.,2331., 0., 0. + *,2340., .11250, -14., 13.,2330., 0., 0. + *,2340., .15000, -14., 13.,2331., 0., 0. + *,2340., .17500,2330., 120., 0., 0., 0. + *,2340., .20000,1330., 110., 0., 0., 0. + *,2340., .22500,1130.,-130., 0., 0., 0. + *,2340., .25000,1230.,-230., 0., 0., 0. + *,2340., .29500,2331., 120., 0., 0., 0. + *,2340., .34000,1331., 110., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=371,388)/ + * 2340., .38500,1131.,-130., 0., 0., 0. + *,2340., .43000,1231.,-230., 0., 0., 0. + *,2340., .47500,2330., 121., 0., 0., 0. + *,2340., .52000,1330., 111., 0., 0., 0. + *,2340., .56500,1130.,-131., 0., 0., 0. + *,2340., .61000,1230.,-231., 0., 0., 0. + *,2340., .64900,2130.,-230., 120.,-120., 0. + *,2340., .68800,2130.,-230., 110., 110., 0. + *,2340., .72700,2130.,-130., 120., 110., 0. + *,2340., .76600,1130.,-230.,-120., 110., 0. + *,2340., .80500,1130.,-130., 120.,-120., 0. + *,2340., .84400,1130.,-130., 110., 110., 0. + *,2340., .88300,1330., 120.,-120., 110., 0. + *,2340., .92200,1330., 110., 110., 110., 0. + *,2340., .96100,2330., 120., 120.,-120., 0. + *,2340.,1.00000,2330., 120., 110., 110., 0. + *,3240., .03750, -12., 11.,2330., 0., 0. + *,3240., .07500, -12., 11.,2331., 0., 0./ + data ((dectab(i,j),i=1,7),j=389,406)/ + * 3240., .11250, -14., 13.,2330., 0., 0. + *,3240., .15000, -14., 13.,2331., 0., 0. + *,3240., .17500,2330., 120., 0., 0., 0. + *,3240., .20000,1330., 110., 0., 0., 0. + *,3240., .22500,1130.,-130., 0., 0., 0. + *,3240., .25000,1230.,-230., 0., 0., 0. + *,3240., .29500,2331., 120., 0., 0., 0. + *,3240., .34000,1331., 110., 0., 0., 0. + *,3240., .38500,1131.,-130., 0., 0., 0. + *,3240., .43000,1231.,-230., 0., 0., 0. + *,3240., .47500,2330., 121., 0., 0., 0. + *,3240., .52000,1330., 111., 0., 0., 0. + *,3240., .56500,1130.,-131., 0., 0., 0. + *,3240., .61000,1230.,-231., 0., 0., 0. + *,3240., .64900,2130.,-230., 120.,-120., 0. + *,3240., .68800,2130.,-230., 110., 110., 0. + *,3240., .72700,2130.,-130., 120., 110., 0. + *,3240., .76600,1130.,-230.,-120., 110., 0./ + data ((dectab(i,j),i=1,7),j=407,424)/ + * 3240., .80500,1130.,-130., 120.,-120., 0. + *,3240., .84400,1130.,-130., 110., 110., 0. + *,3240., .88300,1330., 120.,-120., 110., 0. + *,3240., .92200,1330., 110., 110., 110., 0. + *,3240., .96100,2330., 120., 120.,-120., 0. + *,3240.,1.00000,2330., 120., 110., 110., 0. + *,3340., .07500, -12., 11.,3331., 0., 0. + *,3340., .15000, -12., 11.,3331., 0., 0. + *,3340., .25000,1330.,-230., 0., 0., 0. + *,3340., .31000,3331., 120., 0., 0., 0. + *,3340., .37000,1331.,-230., 0., 0., 0. + *,3340., .43000,1330.,-231., 0., 0., 0. + *,3340., .49000,2330.,-230., 120., 0., 0. + *,3340., .55000,1330.,-230., 110., 0., 0. + *,3340., .61000,1330.,-130., 120., 0., 0. + *,3340., .67500,3331., 120., 120.,-120., 0. + *,3340., .74000,3331., 120., 110., 110., 0. + *,3340., .80500,1330.,-230., 120.,-120., 0./ + data ((dectab(i,j),i=1,7),j=425,442)/ + * 3340., .87000,1330.,-230., 110., 110., 0. + *,3340., .93500,2330.,-230., 120., 110., 0. + *,3340.,1.00000,2330.,-130., 120., 120., 0. + *,1141.,1.00000,2140., 120., 0., 0., 0. + *,1241.,1.00000,2140., 110., 0., 0., 0. + *,2241.,1.00000,2140.,-120., 0., 0., 0. + *,1341., .66670,2340., 120., 0., 0., 0. + *,1341.,1.00000,1340., 110., 0., 0., 0. + *,2341., .66670,1340.,-120., 0., 0., 0. + *,2341.,1.00000,2340., 110., 0., 0., 0. + *,3341.,1.00000,3340., 110., 0., 0., 0. + *,1150., .06000, 12., -11.,1140., 0., 0. + *,1150., .12000, 12., -11.,1141., 0., 0. + *,1150., .18000, 14., -13.,1140., 0., 0. + *,1150., .24000, 14., -13.,1141., 0., 0. + *,1150., .25500, 16., -15.,1140., 0., 0. + *,1150., .27000, 16., -15.,1141., 0., 0. + *,1150., .28925,1140.,-120., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=443,460)/ + * 1150., .30850,1140.,-121., 0., 0., 0. + *,1150., .32775,1141.,-120., 0., 0., 0. + *,1150., .34700,1141.,-121., 0., 0., 0. + *,1150., .35775,1140., 340., 0., 0., 0. + *,1150., .36850,1140., 341., 0., 0., 0. + *,1150., .37925,1141., 340., 0., 0., 0. + *,1150., .39000,1141., 341., 0., 0., 0. + *,1150., .42050,1140.,-120., 110., 0., 0. + *,1150., .45100,1140.,-120., 220., 0., 0. + *,1150., .48150,1140.,-120., 111., 0., 0. + *,1150., .51200,1140.,-120., 221., 0., 0. + *,1150., .54250,1140.,-121., 110., 0., 0. + *,1150., .57300,1140.,-121., 220., 0., 0. + *,1150., .60350,1140.,-121., 111., 0., 0. + *,1150., .63400,1140.,-121., 221., 0., 0. + *,1150., .66450,1141.,-120., 110., 0., 0. + *,1150., .69500,1141.,-120., 220., 0., 0. + *,1150., .72550,1141.,-120., 111., 0., 0./ + data ((dectab(i,j),i=1,7),j=461,478)/ + * 1150., .75600,1141.,-120., 221., 0., 0. + *,1150., .78650,1141.,-121., 110., 0., 0. + *,1150., .81700,1141.,-121., 220., 0., 0. + *,1150., .84750,1141.,-121., 111., 0., 0. + *,1150., .87800,1141.,-121., 221., 0., 0. + *,1150., .89325,1140.,-130., 230., 0., 0. + *,1150., .90850,1140.,-130., 231., 0., 0. + *,1150., .92375,1140.,-131., 230., 0., 0. + *,1150., .93900,1140.,-131., 231., 0., 0. + *,1150., .95425,1141.,-130., 230., 0., 0. + *,1150., .96950,1141.,-130., 231., 0., 0. + *,1150., .98475,1141.,-131., 230., 0., 0. + *,1150.,1.00000,1141.,-131., 231., 0., 0. + *,1250., .06000, 12., -11.,1240., 0., 0. + *,1250., .12000, 12., -11.,1241., 0., 0. + *,1250., .18000, 14., -13.,1240., 0., 0. + *,1250., .24000, 14., -13.,1241., 0., 0. + *,1250., .25500, 16., -15.,1240., 0., 0./ + data ((dectab(i,j),i=1,7),j=479,496)/ + * 1250., .27000, 16., -15.,1241., 0., 0. + *,1250., .28925,1240.,-120., 0., 0., 0. + *,1250., .30850,1240.,-121., 0., 0., 0. + *,1250., .32775,1241.,-120., 0., 0., 0. + *,1250., .34700,1241.,-121., 0., 0., 0. + *,1250., .35775,1240., 340., 0., 0., 0. + *,1250., .36850,1240., 341., 0., 0., 0. + *,1250., .37925,1241., 340., 0., 0., 0. + *,1250., .39000,1241., 341., 0., 0., 0. + *,1250., .42050,1240.,-120., 110., 0., 0. + *,1250., .45100,1240.,-120., 220., 0., 0. + *,1250., .48150,1240.,-120., 111., 0., 0. + *,1250., .51200,1240.,-120., 221., 0., 0. + *,1250., .54250,1240.,-121., 110., 0., 0. + *,1250., .57300,1240.,-121., 220., 0., 0. + *,1250., .60350,1240.,-121., 111., 0., 0. + *,1250., .63400,1240.,-121., 221., 0., 0. + *,1250., .66450,1241.,-120., 110., 0., 0./ + data ((dectab(i,j),i=1,7),j=497,514)/ + * 1250., .69500,1241.,-120., 220., 0., 0. + *,1250., .72550,1241.,-120., 111., 0., 0. + *,1250., .75600,1241.,-120., 221., 0., 0. + *,1250., .78650,1241.,-121., 110., 0., 0. + *,1250., .81700,1241.,-121., 220., 0., 0. + *,1250., .84750,1241.,-121., 111., 0., 0. + *,1250., .87800,1241.,-121., 221., 0., 0. + *,1250., .89325,1240.,-130., 230., 0., 0. + *,1250., .90850,1240.,-130., 231., 0., 0. + *,1250., .92375,1240.,-131., 230., 0., 0. + *,1250., .93900,1240.,-131., 231., 0., 0. + *,1250., .95425,1241.,-130., 230., 0., 0. + *,1250., .96950,1241.,-130., 231., 0., 0. + *,1250., .98475,1241.,-131., 230., 0., 0. + *,1250.,1.00000,1241.,-131., 231., 0., 0. + *,1350., .06000, 12., -11.,1340., 0., 0. + *,1350., .12000, 12., -11.,1341., 0., 0. + *,1350., .18000, 14., -13.,1340., 0., 0./ + data ((dectab(i,j),i=1,7),j=515,532)/ + * 1350., .24000, 14., -13.,1341., 0., 0. + *,1350., .25500, 16., -15.,1340., 0., 0. + *,1350., .27000, 16., -15.,1341., 0., 0. + *,1350., .28925,1340.,-120., 0., 0., 0. + *,1350., .30850,1340.,-121., 0., 0., 0. + *,1350., .32775,1341.,-120., 0., 0., 0. + *,1350., .34700,1341.,-121., 0., 0., 0. + *,1350., .35775,1340., 340., 0., 0., 0. + *,1350., .36850,1340., 341., 0., 0., 0. + *,1350., .37925,1341., 340., 0., 0., 0. + *,1350., .39000,1341., 341., 0., 0., 0. + *,1350., .42050,1340.,-120., 110., 0., 0. + *,1350., .45100,1340.,-120., 220., 0., 0. + *,1350., .48150,1340.,-120., 111., 0., 0. + *,1350., .51200,1340.,-120., 221., 0., 0. + *,1350., .54250,1340.,-121., 110., 0., 0. + *,1350., .57300,1340.,-121., 220., 0., 0. + *,1350., .60350,1340.,-121., 111., 0., 0./ + data ((dectab(i,j),i=1,7),j=533,550)/ + * 1350., .63400,1340.,-121., 221., 0., 0. + *,1350., .66450,1341.,-120., 110., 0., 0. + *,1350., .69500,1341.,-120., 220., 0., 0. + *,1350., .72550,1341.,-120., 111., 0., 0. + *,1350., .75600,1341.,-120., 221., 0., 0. + *,1350., .78650,1341.,-121., 110., 0., 0. + *,1350., .81700,1341.,-121., 220., 0., 0. + *,1350., .84750,1341.,-121., 111., 0., 0. + *,1350., .87800,1341.,-121., 221., 0., 0. + *,1350., .89325,1340.,-130., 230., 0., 0. + *,1350., .90850,1340.,-130., 231., 0., 0. + *,1350., .92375,1340.,-131., 230., 0., 0. + *,1350., .93900,1340.,-131., 231., 0., 0. + *,1350., .95425,1341.,-130., 230., 0., 0. + *,1350., .96950,1341.,-130., 231., 0., 0. + *,1350., .98475,1341.,-131., 230., 0., 0. + *,1350.,1.00000,1341.,-131., 231., 0., 0. + *,2150., .06000, 12., -11.,2140., 0., 0./ + data ((dectab(i,j),i=1,7),j=551,568)/ + * 2150., .12000, 12., -11.,1241., 0., 0. + *,2150., .18000, 14., -13.,2140., 0., 0. + *,2150., .24000, 14., -13.,1241., 0., 0. + *,2150., .25500, 16., -15.,2140., 0., 0. + *,2150., .27000, 16., -15.,1241., 0., 0. + *,2150., .28925,2140.,-120., 0., 0., 0. + *,2150., .30850,2140.,-121., 0., 0., 0. + *,2150., .32775,1241.,-120., 0., 0., 0. + *,2150., .34700,1241.,-121., 0., 0., 0. + *,2150., .35775,2140., 340., 0., 0., 0. + *,2150., .36850,2140., 341., 0., 0., 0. + *,2150., .37925,1241., 340., 0., 0., 0. + *,2150., .39000,1241., 341., 0., 0., 0. + *,2150., .42050,2140.,-120., 110., 0., 0. + *,2150., .45100,2140.,-120., 220., 0., 0. + *,2150., .48150,2140.,-120., 111., 0., 0. + *,2150., .51200,2140.,-120., 221., 0., 0. + *,2150., .54250,2140.,-121., 110., 0., 0./ + data ((dectab(i,j),i=1,7),j=569,586)/ + * 2150., .57300,2140.,-121., 220., 0., 0. + *,2150., .60350,2140.,-121., 111., 0., 0. + *,2150., .63400,2140.,-121., 221., 0., 0. + *,2150., .66450,1241.,-120., 110., 0., 0. + *,2150., .69500,1241.,-120., 220., 0., 0. + *,2150., .72550,1241.,-120., 111., 0., 0. + *,2150., .75600,1241.,-120., 221., 0., 0. + *,2150., .78650,1241.,-121., 110., 0., 0. + *,2150., .81700,1241.,-121., 220., 0., 0. + *,2150., .84750,1241.,-121., 111., 0., 0. + *,2150., .87800,1241.,-121., 221., 0., 0. + *,2150., .89325,2140.,-130., 230., 0., 0. + *,2150., .90850,2140.,-130., 231., 0., 0. + *,2150., .92375,2140.,-131., 230., 0., 0. + *,2150., .93900,2140.,-131., 231., 0., 0. + *,2150., .95425,1241.,-130., 230., 0., 0. + *,2150., .96950,1241.,-130., 231., 0., 0. + *,2150., .98475,1241.,-131., 230., 0., 0./ + data ((dectab(i,j),i=1,7),j=587,604)/ + * 2150.,1.00000,1241.,-131., 231., 0., 0. + *,2250., .06000, 12., -11.,2240., 0., 0. + *,2250., .12000, 12., -11.,2241., 0., 0. + *,2250., .18000, 14., -13.,2240., 0., 0. + *,2250., .24000, 14., -13.,2241., 0., 0. + *,2250., .25500, 16., -15.,2240., 0., 0. + *,2250., .27000, 16., -15.,2241., 0., 0. + *,2250., .28925,2240.,-120., 0., 0., 0. + *,2250., .30850,2240.,-121., 0., 0., 0. + *,2250., .32775,2241.,-120., 0., 0., 0. + *,2250., .34700,2241.,-121., 0., 0., 0. + *,2250., .35775,2240., 340., 0., 0., 0. + *,2250., .36850,2240., 341., 0., 0., 0. + *,2250., .37925,2241., 340., 0., 0., 0. + *,2250., .39000,2241., 341., 0., 0., 0. + *,2250., .42050,2240.,-120., 110., 0., 0. + *,2250., .45100,2240.,-120., 220., 0., 0. + *,2250., .48150,2240.,-120., 111., 0., 0./ + data ((dectab(i,j),i=1,7),j=605,622)/ + * 2250., .51200,2240.,-120., 221., 0., 0. + *,2250., .54250,2240.,-121., 110., 0., 0. + *,2250., .57300,2240.,-121., 220., 0., 0. + *,2250., .60350,2240.,-121., 111., 0., 0. + *,2250., .63400,2240.,-121., 221., 0., 0. + *,2250., .66450,2241.,-120., 110., 0., 0. + *,2250., .69500,2241.,-120., 220., 0., 0. + *,2250., .72550,2241.,-120., 111., 0., 0. + *,2250., .75600,2241.,-120., 221., 0., 0. + *,2250., .78650,2241.,-121., 110., 0., 0. + *,2250., .81700,2241.,-121., 220., 0., 0. + *,2250., .84750,2241.,-121., 111., 0., 0. + *,2250., .87800,2241.,-121., 221., 0., 0. + *,2250., .89325,2240.,-130., 230., 0., 0. + *,2250., .90850,2240.,-130., 231., 0., 0. + *,2250., .92375,2240.,-131., 230., 0., 0. + *,2250., .93900,2240.,-131., 231., 0., 0. + *,2250., .95425,2241.,-130., 230., 0., 0./ + data ((dectab(i,j),i=1,7),j=623,640)/ + * 2250., .96950,2241.,-130., 231., 0., 0. + *,2250., .98475,2241.,-131., 230., 0., 0. + *,2250.,1.00000,2241.,-131., 231., 0., 0. + *,2350., .06000, 12., -11.,2340., 0., 0. + *,2350., .12000, 12., -11.,2341., 0., 0. + *,2350., .18000, 14., -13.,2340., 0., 0. + *,2350., .24000, 14., -13.,2341., 0., 0. + *,2350., .25500, 16., -15.,2340., 0., 0. + *,2350., .27000, 16., -15.,2341., 0., 0. + *,2350., .28925,2340.,-120., 0., 0., 0. + *,2350., .30850,2340.,-121., 0., 0., 0. + *,2350., .32775,2341.,-120., 0., 0., 0. + *,2350., .34700,2341.,-121., 0., 0., 0. + *,2350., .35775,2340., 340., 0., 0., 0. + *,2350., .36850,2340., 341., 0., 0., 0. + *,2350., .37925,2341., 340., 0., 0., 0. + *,2350., .39000,2341., 341., 0., 0., 0. + *,2350., .42050,2340.,-120., 110., 0., 0./ + data ((dectab(i,j),i=1,7),j=641,658)/ + * 2350., .45100,2340.,-120., 220., 0., 0. + *,2350., .48150,2340.,-120., 111., 0., 0. + *,2350., .51200,2340.,-120., 221., 0., 0. + *,2350., .54250,2340.,-121., 110., 0., 0. + *,2350., .57300,2340.,-121., 220., 0., 0. + *,2350., .60350,2340.,-121., 111., 0., 0. + *,2350., .63400,2340.,-121., 221., 0., 0. + *,2350., .66450,2341.,-120., 110., 0., 0. + *,2350., .69500,2341.,-120., 220., 0., 0. + *,2350., .72550,2341.,-120., 111., 0., 0. + *,2350., .75600,2341.,-120., 221., 0., 0. + *,2350., .78650,2341.,-121., 110., 0., 0. + *,2350., .81700,2341.,-121., 220., 0., 0. + *,2350., .84750,2341.,-121., 111., 0., 0. + *,2350., .87800,2341.,-121., 221., 0., 0. + *,2350., .89325,2340.,-130., 230., 0., 0. + *,2350., .90850,2340.,-130., 231., 0., 0. + *,2350., .92375,2340.,-131., 230., 0., 0./ + data ((dectab(i,j),i=1,7),j=659,720)/ + * 434*1./ + data ((dectab(i,j),i=1,7),j=721,738)/ + * 2350., .93900,2340.,-131., 231., 0., 0. + *,2350., .95425,2341.,-130., 230., 0., 0. + *,2350., .96950,2341.,-130., 231., 0., 0. + *,2350., .98475,2341.,-131., 230., 0., 0. + *,2350.,1.00000,2341.,-131., 231., 0., 0. + *,3150., .06000, 12., -11.,3140., 0., 0. + *,3150., .12000, 12., -11.,1341., 0., 0. + *,3150., .18000, 14., -13.,3140., 0., 0. + *,3150., .24000, 14., -13.,1341., 0., 0. + *,3150., .25500, 16., -15.,3140., 0., 0. + *,3150., .27000, 16., -15.,1341., 0., 0. + *,3150., .28925,3140.,-120., 0., 0., 0. + *,3150., .30850,3140.,-121., 0., 0., 0. + *,3150., .32775,1341.,-120., 0., 0., 0. + *,3150., .34700,1341.,-121., 0., 0., 0. + *,3150., .35775,3140., 340., 0., 0., 0. + *,3150., .36850,3140., 341., 0., 0., 0. + *,3150., .37925,1341., 340., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=739,756)/ + * 3150., .39000,1341., 341., 0., 0., 0. + *,3150., .42050,3140.,-120., 110., 0., 0. + *,3150., .45100,3140.,-120., 220., 0., 0. + *,3150., .48150,3140.,-120., 111., 0., 0. + *,3150., .51200,3140.,-120., 221., 0., 0. + *,3150., .54250,3140.,-121., 110., 0., 0. + *,3150., .57300,3140.,-121., 220., 0., 0. + *,3150., .60350,3140.,-121., 111., 0., 0. + *,3150., .63400,3140.,-121., 221., 0., 0. + *,3150., .66450,1341.,-120., 110., 0., 0. + *,3150., .69500,1341.,-120., 220., 0., 0. + *,3150., .72550,1341.,-120., 111., 0., 0. + *,3150., .75600,1341.,-120., 221., 0., 0. + *,3150., .78650,1341.,-121., 110., 0., 0. + *,3150., .81700,1341.,-121., 220., 0., 0. + *,3150., .84750,1341.,-121., 111., 0., 0. + *,3150., .87800,1341.,-121., 221., 0., 0. + *,3150., .89325,3140.,-130., 230., 0., 0./ + data ((dectab(i,j),i=1,7),j=757,774)/ + * 3150., .90850,3140.,-130., 231., 0., 0. + *,3150., .92375,3140.,-131., 230., 0., 0. + *,3150., .93900,3140.,-131., 231., 0., 0. + *,3150., .95425,1341.,-130., 230., 0., 0. + *,3150., .96950,1341.,-130., 231., 0., 0. + *,3150., .98475,1341.,-131., 230., 0., 0. + *,3150.,1.00000,1341.,-131., 231., 0., 0. + *,3250., .06000, 12., -11.,3240., 0., 0. + *,3250., .12000, 12., -11.,2341., 0., 0. + *,3250., .18000, 14., -13.,3240., 0., 0. + *,3250., .24000, 14., -13.,2341., 0., 0. + *,3250., .25500, 16., -15.,3240., 0., 0. + *,3250., .27000, 16., -15.,2341., 0., 0. + *,3250., .28925,3240.,-120., 0., 0., 0. + *,3250., .30850,3240.,-121., 0., 0., 0. + *,3250., .32775,2341.,-120., 0., 0., 0. + *,3250., .34700,2341.,-121., 0., 0., 0. + *,3250., .35775,3240., 340., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=775,792)/ + * 3250., .36850,3240., 341., 0., 0., 0. + *,3250., .37925,2341., 340., 0., 0., 0. + *,3250., .39000,2341., 341., 0., 0., 0. + *,3250., .42050,3240.,-120., 110., 0., 0. + *,3250., .45100,3240.,-120., 220., 0., 0. + *,3250., .48150,3240.,-120., 111., 0., 0. + *,3250., .51200,3240.,-120., 221., 0., 0. + *,3250., .54250,3240.,-121., 110., 0., 0. + *,3250., .57300,3240.,-121., 220., 0., 0. + *,3250., .60350,3240.,-121., 111., 0., 0. + *,3250., .63400,3240.,-121., 221., 0., 0. + *,3250., .66450,2341.,-120., 110., 0., 0. + *,3250., .69500,2341.,-120., 220., 0., 0. + *,3250., .72550,2341.,-120., 111., 0., 0. + *,3250., .75600,2341.,-120., 221., 0., 0. + *,3250., .78650,2341.,-121., 110., 0., 0. + *,3250., .81700,2341.,-121., 220., 0., 0. + *,3250., .84750,2341.,-121., 111., 0., 0./ + data ((dectab(i,j),i=1,7),j=793,810)/ + * 3250., .87800,2341.,-121., 221., 0., 0. + *,3250., .89325,3240.,-130., 230., 0., 0. + *,3250., .90850,3240.,-130., 231., 0., 0. + *,3250., .92375,3240.,-131., 230., 0., 0. + *,3250., .93900,3240.,-131., 231., 0., 0. + *,3250., .95425,2341.,-130., 230., 0., 0. + *,3250., .96950,2341.,-130., 231., 0., 0. + *,3250., .98475,2341.,-131., 230., 0., 0. + *,3250.,1.00000,2341.,-131., 231., 0., 0. + *,3350., .06000, 12., -11.,3340., 0., 0. + *,3350., .12000, 12., -11.,3341., 0., 0. + *,3350., .18000, 14., -13.,3340., 0., 0. + *,3350., .24000, 14., -13.,3341., 0., 0. + *,3350., .25500, 16., -15.,3340., 0., 0. + *,3350., .27000, 16., -15.,3341., 0., 0. + *,3350., .28925,3340.,-120., 0., 0., 0. + *,3350., .30850,3340.,-121., 0., 0., 0. + *,3350., .32775,3341.,-120., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=811,828)/ + * 3350., .34700,3341.,-121., 0., 0., 0. + *,3350., .35775,3340., 340., 0., 0., 0. + *,3350., .36850,3340., 341., 0., 0., 0. + *,3350., .37925,3341., 340., 0., 0., 0. + *,3350., .39000,3341., 341., 0., 0., 0. + *,3350., .42050,3340.,-120., 110., 0., 0. + *,3350., .45100,3340.,-120., 220., 0., 0. + *,3350., .48150,3340.,-120., 111., 0., 0. + *,3350., .51200,3340.,-120., 221., 0., 0. + *,3350., .54250,3340.,-121., 110., 0., 0. + *,3350., .57300,3340.,-121., 220., 0., 0. + *,3350., .60350,3340.,-121., 111., 0., 0. + *,3350., .63400,3340.,-121., 221., 0., 0. + *,3350., .66450,3341.,-120., 110., 0., 0. + *,3350., .69500,3341.,-120., 220., 0., 0. + *,3350., .72550,3341.,-120., 111., 0., 0. + *,3350., .75600,3341.,-120., 221., 0., 0. + *,3350., .78650,3341.,-121., 110., 0., 0./ + data ((dectab(i,j),i=1,7),j=829,846)/ + * 3350., .81700,3341.,-121., 220., 0., 0. + *,3350., .84750,3341.,-121., 111., 0., 0. + *,3350., .87800,3341.,-121., 221., 0., 0. + *,3350., .89325,3340.,-130., 230., 0., 0. + *,3350., .90850,3340.,-130., 231., 0., 0. + *,3350., .92375,3340.,-131., 230., 0., 0. + *,3350., .93900,3340.,-131., 231., 0., 0. + *,3350., .95425,3341.,-130., 230., 0., 0. + *,3350., .96950,3341.,-130., 231., 0., 0. + *,3350., .98475,3341.,-131., 230., 0., 0. + *,3350.,1.00000,3341.,-131., 231., 0., 0. + *,1160., .33300, 1., -2.,1500., 0., 0. + *,1160., .66700, 4., -3.,1500., 0., 0. + *,1160., .77800, -12., 11.,1500., 0., 0. + *,1160., .88900, -14., 13.,1500., 0., 0. + *,1160.,1.00000, -16., 15.,1500., 0., 0. + *,1260., .33300, 1., -2.,2500., 0., 0. + *,1260., .66700, 4., -3.,2500., 0., 0./ + data ((dectab(i,j),i=1,7),j=847,864)/ + * 1260., .77800, -12., 11.,2500., 0., 0. + *,1260., .88900, -14., 13.,2500., 0., 0. + *,1260.,1.00000, -16., 15.,2500., 0., 0. + *,2260., .33300, 1., -2.,2500., 0., 0. + *,2260., .66700, 4., -3.,2500., 0., 0. + *,2260., .77800, -12., 11.,2500., 0., 0. + *,2260., .88900, -14., 13.,2500., 0., 0. + *,2260.,1.00000, -16., 15.,2500., 0., 0. + *,2160., .33300, 1., -2.,1500., 0., 0. + *,2160., .66700, 4., -3.,1500., 0., 0. + *,2160., .77800, -12., 11.,1500., 0., 0. + *,2160., .88900, -14., 13.,1500., 0., 0. + *,2160.,1.00000, -16., 15.,1500., 0., 0. + *,1360., .33300, 1., -2.,3500., 0., 0. + *,1360., .66700, 4., -3.,3500., 0., 0. + *,1360., .77800, -12., 11.,3500., 0., 0. + *,1360., .88900, -14., 13.,3500., 0., 0. + *,1360.,1.00000, -16., 15.,3500., 0., 0./ + data ((dectab(i,j),i=1,7),j=865,882)/ + * 2360., .33300, 1., -2.,3500., 0., 0. + *,2360., .66700, 4., -3.,3500., 0., 0. + *,2360., .77800, -12., 11.,3500., 0., 0. + *,2360., .88900, -14., 13.,3500., 0., 0. + *,2360.,1.00000, -16., 15.,3500., 0., 0. + *,3360., .33300, 1., -2.,3500., 0., 0. + *,3360., .66700, 4., -3.,3500., 0., 0. + *,3360., .77800, -12., 11.,3500., 0., 0. + *,3360., .88900, -14., 13.,3500., 0., 0. + *,3360.,1.00000, -16., 15.,3500., 0., 0. + *,1151.,1.00000,1150., 10., 0., 0., 0. + *,1251.,1.00000,1250., 10., 0., 0., 0. + *,2251.,1.00000,2250., 10., 0., 0., 0. + *,1351.,1.00000,1350., 10., 0., 0., 0. + *,2351.,1.00000,2350., 10., 0., 0., 0. + *,3351.,1.00000,3350., 10., 0., 0., 0. + *,1161.,1.00000,1160., 10., 0., 0., 0. + *,1261.,1.00000,1260., 10., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=883,886)/ + * 2261.,1.00000,2260., 10., 0., 0., 0. + *,1361.,1.00000,1360., 10., 0., 0., 0. + *,2361.,1.00000,2360., 10., 0., 0., 0. + *,3361.,1.00000,3360., 10., 0., 0., 0./ +c *--------------------------------------------- +c * delta++ resonances +c *--------------------------------------------- + data ((dectab(i,j),i=1,7),j=887,900)/ +c *--dl++(1620)--------------------------------- + * 1112., .30000,1120., 120., 0., 0., 0. + *,1112., .66000,1111., 110., 0., 0., 0. + *,1112., .90000,1121., 120., 0., 0., 0. + *,1112.,1.00000,1120., 120., 110., 0., 0. +c *--dl++(1700)--------------------------------- + *,1113., .15000,1120., 120., 0., 0., 0. + *,1113., .51000,1111., 110., 0., 0., 0. + *,1113., .75000,1121., 120., 0., 0., 0. + *,1113.,1.00000,1120., 120., 110., 0., 0. +c *--dl++(1925)--------------------------------- + *,1114., .28000,1120., 120., 0., 0., 0. + *,1114., .40600,1111., 110., 0., 0., 0. + *,1114., .49000,1121., 120., 0., 0., 0. + *,1114., .69000,1120., 121., 0., 0., 0. + *,1114., .70000,1130., 130., 0., 0., 0. + *,1114.,1.00000,1122., 120., 0., 0., 0./ +c *--------------------------------------------- +c * delta- resonances +c *--------------------------------------------- + data ((dectab(i,j),i=1,7),j=901,914)/ +c *--dl-(1620)---------------------------------- + * 2222., .30000,1220.,-120., 0., 0., 0. + *,2222., .66000,2221., 110., 0., 0., 0. + *,2222., .90000,1221.,-120., 0., 0., 0. + *,2222.,1.00000,1220., 110.,-120., 0., 0. +c *--dl-(1700)---------------------------------- + *,2223., .15000,1220.,-120., 0., 0., 0. + *,2223., .51000,2221., 110., 0., 0., 0. + *,2223., .75000,1221.,-120., 0., 0., 0. + *,2223.,1.00000,1220., 110.,-120., 0., 0. +c *--dl-(1925)---------------------------------- + *,2224., .28000,1220.,-120., 0., 0., 0. + *,2224., .40600,2221., 110., 0., 0., 0. + *,2224., .49000,1221.,-120., 0., 0., 0. + *,2224., .69000,1220.,-121., 0., 0., 0. + *,2224., .70000,2230., 230., 0., 0., 0. + *,2224.,1.00000,1222.,-120., 0., 0., 0./ +c *--------------------------------------------- +c * n*+ resonances + delta+ resonances +c *--------------------------------------------- + data ((dectab(i,j),i=1,7),j=915,931)/ +c *--n*+(1440)---------------------------------- + * 1122., .20000,1120., 110., 0., 0., 0. + *,1122., .60000,1220., 120., 0., 0., 0. + *,1122., .68000,1111.,-120., 0., 0., 0. + *,1122., .73000,1121., 110., 0., 0., 0. + *,1122., .76000,1221., 120., 0., 0., 0. + *,1122., .84000,1120., 120.,-120., 0., 0. + *,1122., .87000,1120., 110., 110., 0., 0. + *,1122.,1.00000,1220., 120., 110., 0., 0. +c *--n*+(1530)---------------------------------- + *,1123., .17000,1120., 110., 0., 0., 0. + *,1123., .51000,1220., 120., 0., 0., 0. + *,1123., .57000,1111.,-120., 0., 0., 0. + *,1123., .61000,1121., 110., 0., 0., 0. + *,1123., .63000,1221., 120., 0., 0., 0. + *,1123., .67000,1120., 120.,-120., 0., 0. + *,1123., .68000,1120., 110., 110., 0., 0. + *,1123., .75000,1220., 120., 110., 0., 0. + *,1123.,1.00000,1120., 220., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=932,948)/ +c *--dl+(1620)---------------------------------- + * 1124., .20000,1120., 110., 0., 0., 0. + *,1124., .30000,1220., 120., 0., 0., 0. + *,1124., .54000,1111.,-120., 0., 0., 0. + *,1124., .58000,1121., 110., 0., 0., 0. + *,1124., .90000,1221., 120., 0., 0., 0. + *,1124., .96000,1120., 120.,-120., 0., 0. + *,1124.,1.00000,1220., 120., 110., 0., 0. +c *--n*+(1665)---------------------------------- + *,1125., .16700,1120., 110., 0., 0., 0. + *,1125., .49970,1220., 120., 0., 0., 0. + *,1125., .62470,1111.,-120., 0., 0., 0. + *,1125., .70800,1121., 110., 0., 0., 0. + *,1125., .74970,1221., 120., 0., 0., 0. + *,1125., .82080,1120., 120.,-120., 0., 0. + *,1125., .85190,1120., 110., 110., 0., 0. + *,1125., .96300,1220., 120., 110., 0., 0. + *,1125., .97300,1120., 220., 0., 0., 0. + *,1125.,1.00000,2130., 130., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=949,955)/ +c *--dl+(1700)---------------------------------- + * 1126., .10000,1120., 110., 0., 0., 0. + *,1126., .15000,1220., 120., 0., 0., 0. + *,1126., .39000,1111.,-120., 0., 0., 0. + *,1126., .43000,1121., 110., 0., 0., 0. + *,1126., .75000,1221., 120., 0., 0., 0. + *,1126., .91500,1120., 120.,-120., 0., 0. + *,1126.,1.00000,1220., 120., 110., 0., 0./ + data ((dectab(i,j),i=1,7),j=956,969)/ +c *--n*+(1710)---------------------------------- + * 1127., .04430,1120., 110., 0., 0., 0. + *,1127., .13290,1220., 120., 0., 0., 0. + *,1127., .23790,1111.,-120., 0., 0., 0. + *,1127., .30790,1121., 110., 0., 0., 0. + *,1127., .34290,1221., 120., 0., 0., 0. + *,1127., .41190,1120., 120.,-120., 0., 0. + *,1127., .48090,1120., 110., 110., 0., 0. + *,1127., .54990,1220., 120., 110., 0., 0. + *,1127., .66070,1120., 220., 0., 0., 0. + *,1127., .72800,2130., 130., 0., 0., 0. + *,1127., .74930,1230., 130., 0., 0., 0. + *,1127., .76000,1130., 230., 0., 0., 0. + *,1127., .84000,1120., 111., 0., 0., 0. + *,1127.,1.00000,1220., 121., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=970,980)/ +c *--dl+(1925)---------------------------------- + * 1128., .18700,1120., 110., 0., 0., 0. + *,1128., .28000,1220., 120., 0., 0., 0. + *,1128., .36400,1111.,-120., 0., 0., 0. + *,1128., .37800,1121., 110., 0., 0., 0. + *,1128., .49000,1221., 120., 0., 0., 0. + *,1128., .62300,1120., 111., 0., 0., 0. + *,1128., .69000,1220., 121., 0., 0., 0. + *,1128., .69350,1130., 230., 0., 0., 0. + *,1128., .69900,1230., 130., 0., 0., 0. + *,1128., .89900,1122., 110., 0., 0., 0. + *,1128.,1.00000,1222., 120., 0., 0., 0./ +c *--------------------------------------------- +c * n*0 resonances + delta0 resonances +c *--------------------------------------------- + data ((dectab(i,j),i=1,7),j=981,997)/ +c *----------n*0(1440)-------------------------- + * 1222., .20000,1220., 110., 0., 0., 0. + *,1222., .60000,1120.,-120., 0., 0., 0. + *,1222., .68000,2221., 120., 0., 0., 0. + *,1222., .73000,1221., 110., 0., 0., 0. + *,1222., .76000,1121.,-120., 0., 0., 0. + *,1222., .84000,1220., 120.,-120., 0., 0. + *,1222., .87000,1220., 110., 110., 0., 0. + *,1222.,1.00000,1120.,-120., 110., 0., 0. +c *----------n*0(1530)-------------------------- + *,1223., .17000,1220., 110., 0., 0., 0. + *,1223., .51000,1120.,-120., 0., 0., 0. + *,1223., .57000,2221., 120., 0., 0., 0. + *,1223., .61000,1221., 110., 0., 0., 0. + *,1223., .63000,1121.,-120., 0., 0., 0. + *,1223., .67000,1220., 120.,-120., 0., 0. + *,1223., .68000,1220., 110., 110., 0., 0. + *,1223., .75000,1120.,-120., 110., 0., 0. + *,1223.,1.00000,1220., 220., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=998,1014)/ +c *----------dl0(1620)-------------------------- + * 1224., .20000,1220., 110., 0., 0., 0. + *,1224., .30000,1120.,-120., 0., 0., 0. + *,1224., .54000,2221., 120., 0., 0., 0. + *,1224., .58000,1221., 110., 0., 0., 0. + *,1224., .90000,1121.,-120., 0., 0., 0. + *,1224., .96500,1220., 120.,-120., 0., 0. + *,1224.,1.00000,1120.,-120., 110., 0., 0. +c *----------n*0(1665)-------------------------- + *,1225., .16700,1220., 110., 0., 0., 0. + *,1225., .49970,1120.,-120., 0., 0., 0. + *,1225., .62470,2221., 120., 0., 0., 0. + *,1225., .70800,1221., 110., 0., 0., 0. + *,1225., .74970,1121.,-120., 0., 0., 0. + *,1225., .82080,1220., 120.,-120., 0., 0. + *,1225., .85190,1220., 110., 110., 0., 0. + *,1225., .96300,1120.,-120., 110., 0., 0. + *,1225., .97300,1220., 220., 0., 0., 0. + *,1225.,1.00000,2130., 230., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=1015,1021)/ +c *----------dl0(1700)-------------------------- + * 1226., .10000,1220., 110., 0., 0., 0. + *,1226., .15000,1120.,-120., 0., 0., 0. + *,1226., .39000,2221., 120., 0., 0., 0. + *,1226., .43000,1221., 110., 0., 0., 0. + *,1226., .75000,1121.,-120., 0., 0., 0. + *,1226., .91500,1220., 120.,-120., 0., 0. + *,1226.,1.00000,1120.,-120., 110., 0., 0./ + data ((dectab(i,j),i=1,7),j=1022,1035)/ +c *----------n*0(1710)-------------------------- + * 1227., .04430,1220., 110., 0., 0., 0. + *,1227., .13290,1120.,-120., 0., 0., 0. + *,1227., .23790,2221., 120., 0., 0., 0. + *,1227., .30790,1221., 110., 0., 0., 0. + *,1227., .34290,1121.,-120., 0., 0., 0. + *,1227., .41190,1220., 120.,-120., 0., 0. + *,1227., .48090,1220., 110., 110., 0., 0. + *,1227., .54990,1120.,-120., 110., 0., 0. + *,1227., .66070,1220., 220., 0., 0., 0. + *,1227., .72800,2130., 230., 0., 0., 0. + *,1227., .73870,1230., 230., 0., 0., 0. + *,1227., .76000,2230., 130., 0., 0., 0. + *,1227., .92000,1120.,-121., 0., 0., 0. + *,1227.,1.00000,1220., 111., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=1036,1046)/ +c *----------dl0(1925)-------------------------- + * 1228., .18700,1220., 110., 0., 0., 0. + *,1228., .28000,1120.,-120., 0., 0., 0. + *,1228., .36400,2221., 120., 0., 0., 0. + *,1228., .37800,1221., 110., 0., 0., 0. + *,1228., .49000,1121.,-120., 0., 0., 0. + *,1228., .55700,1220., 111., 0., 0., 0. + *,1228., .69000,1120.,-121., 0., 0., 0. + *,1228., .69350,2230., 130., 0., 0., 0. + *,1228., .70000,1230., 230., 0., 0., 0. + *,1228., .80000,1122.,-120., 0., 0., 0. + *,1228.,1.00000,1222., 110., 0., 0., 0./ +c *--------------------------------------------- +c * lambda resonances + sigma0 resonances +c *--------------------------------------------- + data ((dectab(i,j),i=1,7),j=1047,1059)/ +c *----------lambda(1405)----------------------- + * 1233., .33000,1230., 110., 0., 0., 0. + *,1233., .66000,2230., 120., 0., 0., 0. + *,1233.,1.00000,1130.,-120., 0., 0., 0. +c *----------lambda(1520)----------------------- + *,1234., .22500,1120.,-130., 0., 0., 0. + *,1234., .48000,1220.,-230., 0., 0., 0. + *,1234., .62000,1230., 110., 0., 0., 0. + *,1234., .76000,2230., 120., 0., 0., 0. + *,1234., .90000,1130.,-120., 0., 0., 0. + *,1234., .96000,2130., 120.,-120., 0., 0. + *,1234., .99000,2130., 110., 110., 0., 0. + *,1234., .99330,1130.,-120., 110., 0., 0. + *,1234., .99660,2230., 120., 110., 0., 0. + *,1234.,1.00000,1230., 120.,-120., 0., 0./ + data ((dectab(i,j),i=1,7),j=1060,1075)/ +c *----------lambda(1645)----------------------- + * 1235., .10000,1120.,-130., 0., 0., 0. + *,1235., .20000,1220.,-230., 0., 0., 0. + *,1235., .35000,1230., 110., 0., 0., 0. + *,1235., .50000,2230., 120., 0., 0., 0. + *,1235., .65000,1130.,-120., 0., 0., 0. + *,1235., .75000,2130., 120.,-120., 0., 0. + *,1235., .80000,2130., 110., 110., 0., 0. + *,1235., .84500,1130.,-120., 110., 0., 0. + *,1235., .89000,2230., 120., 110., 0., 0. + *,1235., .93500,1230., 120.,-120., 0., 0. + *,1235.,1.00000,2130., 220., 0., 0., 0. +c *----------sigma0(1665)----------------------- + *,1236., .10000,1120.,-130., 0., 0., 0. + *,1236., .20000,1220.,-230., 0., 0., 0. + *,1236., .40000,2230., 120., 0., 0., 0. + *,1236., .60000,1130.,-120., 0., 0., 0. + *,1236.,1.00000,2130., 110., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=1076,1084)/ +c *----------sigma0(1776)----------------------- + * 1237., .17500,1120.,-130., 0., 0., 0. + *,1237., .35000,1220.,-230., 0., 0., 0. + *,1237., .38750,2230., 120., 0., 0., 0. + *,1237., .42500,1130.,-120., 0., 0., 0. + *,1237., .57500,2130., 110., 0., 0., 0. + *,1237., .60000,2231., 120., 0., 0., 0. + *,1237., .62500,1131.,-120., 0., 0., 0. + *,1237., .75000,1234., 110., 0., 0., 0. + *,1237.,1.00000,1230., 220., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=1085,1094)/ +c *----------lambda(1845)----------------------- + * 1238., .17000,1120.,-130., 0., 0., 0. + *,1238., .34000,1220.,-230., 0., 0., 0. + *,1238., .44000,1230., 110., 0., 0., 0. + *,1238., .54000,2230., 120., 0., 0., 0. + *,1238., .64000,1130.,-120., 0., 0., 0. + *,1238., .70000,1231., 110., 0., 0., 0. + *,1238., .76000,2231., 120., 0., 0., 0. + *,1238., .82000,1131.,-120., 0., 0., 0. + *,1238., .91000,1120.,-131., 0., 0., 0. + *,1238.,1.00000,1220.,-231., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=1095,1106)/ +c *----------sigma0(1930)----------------------- + * 1239., .07500,1120.,-130., 0., 0., 0. + *,1239., .15000,1220.,-230., 0., 0., 0. + *,1239., .20000,1121.,-130., 0., 0., 0. + *,1239., .25000,1221.,-230., 0., 0., 0. + *,1239., .32500,1120.,-131., 0., 0., 0. + *,1239., .40000,1220.,-231., 0., 0., 0. + *,1239., .47500,2230., 120., 0., 0., 0. + *,1239., .55000,1130.,-120., 0., 0., 0. + *,1239., .70000,2130., 110., 0., 0., 0. + *,1239., .77500,2231., 120., 0., 0., 0. + *,1239., .85000,1131.,-120., 0., 0., 0. + *,1239.,1.00000,1234., 110., 0., 0., 0./ +c *--------------------------------------------- +c * sigma+ resonances +c *--------------------------------------------- + data ((dectab(i,j),i=1,7),j=1107,1118)/ +c *----------sigma+(1665)----------------------- + * 1132., .20000,1120.,-230., 0., 0., 0. + *,1132., .40000,1130., 110., 0., 0., 0. + *,1132., .60000,1230., 120., 0., 0., 0. + *,1132.,1.00000,2130., 120., 0., 0., 0. +c *----------sigma+(1776)----------------------- + *,1133., .35000,1120.,-230., 0., 0., 0. + *,1133., .38750,1130., 110., 0., 0., 0. + *,1133., .42500,1230., 120., 0., 0., 0. + *,1133., .57500,2130., 120., 0., 0., 0. + *,1133., .60000,1131., 110., 0., 0., 0. + *,1133., .62500,1231., 120., 0., 0., 0. + *,1133., .75000,1234., 120., 0., 0., 0. + *,1133.,1.00000,1130., 220., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=1119,1128)/ +c *----------sigma+(1930)----------------------- + * 1134., .15000,1120.,-230., 0., 0., 0. + *,1134., .22500,1111.,-130., 0., 0., 0. + *,1134., .25000,1121.,-230., 0., 0., 0. + *,1134., .40000,1120.,-231., 0., 0., 0. + *,1134., .47500,1130., 110., 0., 0., 0. + *,1134., .55000,1230., 120., 0., 0., 0. + *,1134., .70000,2130., 120., 0., 0., 0. + *,1134., .77500,1131., 110., 0., 0., 0. + *,1134., .85000,1231., 120., 0., 0., 0. + *,1134.,1.00000,1234., 120., 0., 0., 0./ +c *--------------------------------------------- +c * sigma- resonances +c *--------------------------------------------- + data ((dectab(i,j),i=1,7),j=1129,1140)/ +c *----------sigma-(1665)----------------------- + * 2232., .20000,1220.,-130., 0., 0., 0. + *,2232., .40000,2230., 110., 0., 0., 0. + *,2232., .60000,1230.,-120., 0., 0., 0. + *,2232.,1.00000,2130.,-120., 0., 0., 0. +c *----------sigma-(1776)----------------------- + *,2233., .35000,1220.,-130., 0., 0., 0. + *,2233., .38750,2230., 110., 0., 0., 0. + *,2233., .42500,1230.,-120., 0., 0., 0. + *,2233., .57500,2130.,-120., 0., 0., 0. + *,2233., .60000,2231., 110., 0., 0., 0. + *,2233., .62500,1231.,-120., 0., 0., 0. + *,2233., .75000,1234.,-120., 0., 0., 0. + *,2233.,1.00000,2230., 220., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=1141,1150)/ +c *----------sigma-(1930)----------------------- + * 2234., .15000,1220.,-130., 0., 0., 0. + *,2234., .17500,1221.,-130., 0., 0., 0. + *,2234., .25000,2221.,-230., 0., 0., 0. + *,2234., .40000,1220.,-131., 0., 0., 0. + *,2234., .47500,2230., 110., 0., 0., 0. + *,2234., .55000,1230.,-120., 0., 0., 0. + *,2234., .70000,2130.,-120., 0., 0., 0. + *,2234., .77500,2231., 110., 0., 0., 0. + *,2234., .85000,1231.,-120., 0., 0., 0. + *,2234.,1.00000,1234.,-120., 0., 0., 0./ +c *--------------------------------------------- +c * additional mesonresonances +c *--------------------------------------------- + data ((dectab(i,j),i=1,7),j=1151,1159)/ +c *-----------f0(975)--------------------------- + * 332., .50000, 120.,-120., 0., 0., 0. + *, 332., .75000, 110., 110., 0., 0., 0. + *, 332., .87500, 130.,-130., 0., 0., 0. + *, 332.,1.00000, 230.,-230., 0., 0., 0. +c *-----------a0(980)--------------------------- + *, 112., .56000, 110., 220., 0., 0., 0. + *, 112., .78000, 130.,-130., 0., 0., 0. + *, 112.,1.00000, 230.,-230., 0., 0., 0. +c *-----------a+(980)--------------------------- + *, 122., .60000, 120., 220., 0., 0., 0. + *, 122.,1.00000, 130.,-230., 0., 0., 0./ +c *--------------------------------------------- +c * weak baryon decays +c *--------------------------------------------- + data ((dectab(i,j),i=1,7),j=1160,1169)/ +c *-----------lambda(1116)---------------------- + * 2130.,0.64200,1120.,-120., 0., 0., 0. + *,2130.,1.00000,1220., 110., 0., 0., 0. +c *-----------sigma+(1180)---------------------- + *,1130.,0.51580,1120., 110., 0., 0., 0. + *,1130.,1.00000,1220., 120., 0., 0., 0. +c *-----------sigma-(1180)---------------------- + *,2230.,1.00000,1220.,-120., 0., 0., 0. +c *---------kaskade-(1360)---------------------- + *,2330.,1.00000,2130.,-120., 0., 0., 0. +c *---------kaskade0(1360)---------------------- + *,1330.,1.00000,2130., 110., 0., 0., 0. +c *---------omega-(1680)------------------------ + *,3331.,0.68000,2130.,-130., 0., 0., 0. + *,3331.,0.82000,1330.,-120., 0., 0., 0. + *,3331.,1.00000,2330., 110., 0., 0., 0./ +c *--------------------------------------------- +c * weak meson decays +c *--------------------------------------------- + data ((dectab(i,j),i=1,7),j=1170,1171)/ +c *-----------k0s()-------------------------- + * 20., .68610, 120.,-120., 0., 0., 0. + *, 20.,1.00000, 110., 110., 0., 0., 0./ + data ((dectab(i,j),i=1,7),j=1172,ndectb)/ +c *-----------k0l------------------------------- + * 320., .2113, 110., 110., 110., 0., 0. + *, 320., .2113, 110., 110., 110., 0., 0. + *, 320., .2120, 110., 110., 110., 0., 0. + *, 320., .3380, 120.,-120., 110., 0., 0. + *, 320., .4744, 120., 14., -13., 0., 0. + *, 320., .6108,-120., -14., 13., 0., 0. + *, 320., .8054, 120., 12., -11., 0., 0. + *, 320.,1.0000,-120., -12., 11., 0., 0. +c *-----------k+------------------------------- + *, 130., .6352 , -14., 13., 0., 0., 0. + *, 130., .8468 , 120., 110., 0., 0., 0. + *, 130., .9027 , 120., 120.,-120., 0., 0. + *, 130., .92 , 120., 110., 110., 0., 0. + *, 130., .9518 , 110., -14., 13., 0., 0. + *, 130.,1. , 110., -12., 11., 0., 0. +c *-----------pi+------------------------------ + *, 120., 1. , -14., 13., 0., 0., 0. +c *-----------mu------------------------------- + *, 14., 1. , 12., -11., 13., 0., 0. +c *-----------etac------------------------------- + *, 440., .32 , 230.,-230., 110., 0., 0. + *, 440., .64 , 220., 110., 110., 0., 0. + *, 440., .76 , 120.,-120., 130.,-130., 0. + *, 440., .88 , 120.,-120., 120.,-120., 0. + *, 440., 1. , 130.,-130., 130.,-130., 0. +c *-----------etac------------------------------- + *,1220., 1. ,1120., 12., -11., 0., 0./ + + call idresi + +c determine wmass2,wgam2 +c ---------------------- + alfa=1./137.036 + gf=1.16570e-5 + sin2w=.215 + sinw=sqrt(sin2w) +c cosw=sqrt(1.-sin2w) !?????????????????unused + amw=sqrt(pi*alfa/(.9304*sqrt(2.)*gf))/sinw + wmass2=amw + call idmass(5,amlep5) + call idmass(6,amlep6) + ngam=12 + if(amlep5+amlep6.gt.amw) ngam=9 + wgam2=gf*amw**3/(6.*pi*sqrt(2.))*ngam + + data iblank/' '/ + ird=0 + do 1 i=1,mxlook +1 look(i)=0 + do 2 i=1,mxdky + do 3 j=1,5 +3 mode(j,i)=0 +2 cbr(i)=0. + nodcay=.false. + noeta=.false. + nopi0=.false. + nonunu=.false. + noevol=.false. + nohadr=.false. + if(lprint) write(ifch,10) +10 format('1',30('*')/' *',28x,'*'/ + 1' *',5x,'isajet decay table',5x,'*'/ + 2' *',28x,'*'/' ',30('*')// + 36x,'part',18x,'decay mode',19x,'cum br',15x,'ident',17x, + 4'decay ident') + loop=0 + iold=0 + if(nodcay) return + +200 loop=loop+1 + if(loop.gt.mxdky) goto9999 +220 do 210 i=1,5 + imode(i)=0 + lmode(i)=iblank +210 continue + ird=ird+1 + if(ird.gt.ndectb)return +c if(ird.gt.1171)return ! ?????????????????????????? + ires=nint(dectab(1,ird)) + br=dectab(2,ird) + do 215 i=1,5 +215 imode(i)=nint(dectab(2+i,ird)) + if(nopi0.and.ires.eq.110) goto220 + if(noeta.and.ires.eq.220) goto220 + if(ires.eq.iold) goto230 + if(ires.lt.0.or.ires.gt.mxlook) + *call utstop('hdecin: ires out of range&') + look(ires)=loop +230 iold=ires + cbr(loop)=br + do 240 i=1,5 + mode(i,loop)=imode(i) + if(imode(i).ne.0) lmode(i)=idlabl(imode(i)) +240 continue + lres=idlabl(ires) + if(lprint) write(ifch,20) lres,(lmode(k),k=1,5), + 1br,ires,(imode(k),k=1,5) +20 format(6x,a5,6x,5(a5,2x),3x,f8.5,15x,i5,4x,5(i5,2x)) + goto200 + +9999 write(ifch,*)'loop=', loop + call utstop('hdecin: loop > mxdky&') + + end + +C ----------------------------------------------- + FUNCTION FM(NQ,S0,S1,S2,S3) +C ----------------------------------------------- +C Normalized TRANSITION MATRIX FOR THE DALIZT PLOT DISTRI. +C OF K -> 3 PIONS. PARAMETRIZATION OF WEINBERG +C AS DESCRIBE IN PARTICLE DATA BOOK. +C G IS THE LINEAR COEFFICIENT (SLOPE g) +C H IS THE QUADRATIC COEFFICIENT h +C D IS THE QUADRATIC COEFFICIENT k +C Amax is the maximum of this amplitude (taken from Corsika by D. Heck) +C NQ is the decay channel : +C 1 - K -> 3 Pi +C 2 - K -> Pi + 2 Pi0 +C 3 - K0 -> 3 Pi0 +C 4 - K0 -> 2 Pi + Pi0 +C ----------------------------------------------- + DIMENSION G(4),H(4),D(4),Amax(4) + PARAMETER (PIM=139.57E-3) + DATA G/-0.2154,0.594,0.,0.67/ + DATA H/0.01,0.035,0.,0.079/ + DATA D/-0.01,0.,0.,0.0098/ + DATA Amax/1.27,1.84,1.,2.22/ + + FM=1.+G(NQ)*(S3-S0)/(PIM*PIM)+H(NQ)*((S3-S0)/(PIM*PIM))**2 + *+D(NQ)*((S2-S1)/(PIM*PIM))**2 + FM=FM/Amax(NQ) + + RETURN + END +C ----------------------------------------------- + FUNCTION FML(N,AM,RM1,RM2,E1S,E2S,E3S) +C ----------------------------------------------- +C Normalized DALITZ PLOT DENSITY (RHO) +C OF K -> 1 PION + 2 LEPTONS +C AS DESCRIBE IN PARTICLE DATA BOOK. +C CLP IS THE LAMBDA + FORM FACTOR COEFFICIENT +C CLN IS THE LAMBDA 0 FORM FACTOR COEFFICIENT +C EEP IS E'pion +C GP IS THE F+(t) FORM FACTOR (t=AM*AM+SM1-2.D0*AM*E1S) +C H IS EPS(t)=F-(t)/F+(t) WHERE F- IS CALCULATED FROM F0 +C Amax is the maximum of this density (taken from Corsika by D. Heck) +C N is the decay channel : +C 1 - K -> Pi0 + e + Nu +C 2 - K -> Pi0 + Mu + Nu +C 3 - K0 -> Pi + e + Nu +C 4 - K0 -> Pi + Mu + Nu +C ----------------------------------------------- + DIMENSION CLP(4),CLN(4),Amax(4) + DATA CLP/0.0276,0.031,0.0288,0.034/ + DATA CLN/0.0,0.006,0.,0.025/ + DATA Amax/1.28e-2,1.194e-2,1.31e-2,1.241e-2/ + + SM1=RM1*RM1 + SM2=RM2*RM2 + EEP=0.5D0*(AM*AM+SM1-SM2)/AM-E1S + GP=1.+CLP(N)*(AM*AM+SM1-2.*AM*E1S)/SM1 + H=(AM*AM-SM1)/SM1*(CLN(N)-CLP(N))/GP + FML=GP*GP*(AM*(2.*E2S*E3S-AM*EEP)+ + *SM2*(0.25*EEP-E3S)+H*SM2*(E3S-0.5*EEP)+ + *0.25*H*H*SM2*EEP) + FML=FML/Amax(N) + RETURN + END +C ----------------------------------------------- + FUNCTION FMU(X) +C ----------------------------------------------- +C PROBABILITY DISTRI. FOR ELECTRON ENERGY FROM MUON DECAY : +C MU -> 2NU + E. DESCRIBE IN PARTICLE DATA BOOK. +C (SIMPLIFY DIFFERENTIAL DECAY RATE INTEGRATED) +C X REDUCED ENERGY OF PARTICLE +C ----------------------------------------------- + + FMU=2.*(3.-2.*X)*X*X + + RETURN + END diff --git a/modules/epos/epos-dro-lhc.f b/modules/epos/epos-dro-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..bfaf491d5d05bcc6fe0b7982757d26ff44720c28 --- /dev/null +++ b/modules/epos/epos-dro-lhc.f @@ -0,0 +1,2642 @@ +c---------------------------------------------------------------------- + subroutine ahydro +c---------------------------------------------------------------------- + include 'epos.inc' + common/geom/rmproj,rmtarg,bmax,bkmx + common/cranphi/ranphi + ntry=0 + 1 ntry=ntry+1 + if(ntry.eq.100)stop'in ahydro: infine loop (080719) ' + nevt=0 + nptl=0 + rmproj=1.19*maproj**(1./3.)-1.61*maproj**(-1./3.)+fctrmx*.54 + rmtarg=1.19*matarg**(1./3.)-1.61*matarg**(-1./3.)+fctrmx*.54 + b1=bminim + b2=min(rmproj+rmtarg,bmaxim) + bimevt=sqrt(b1**2+(b2**2-b1**2)*rangen()) + phievt=0 + ranphi=0 + call InitializeHyperbola !does not affect results but necessary + call HydroFO(ier) + if(ier.eq.1)goto1 + do n=1,nptl + iorptl(n)=0 + jorptl(n)=0 + istptl(n)=0 + ifrptl(1,n)=0 + ifrptl(2,n)=0 + tivptl(1,n)=xorptl(4,n) + call idtau(idptl(n),pptl(4,n),pptl(5,n),taugm) + r=rangen() + tivptl(2,n)=tivptl(1,n)+taugm*(-alog(r)) + radptl(n)=0. + dezptl(n)=0. + itsptl(n)=0 + rinptl(n)=0 + enddo + end + +c---------------------------------------------------------------------- + subroutine amicro(iret) +c---------------------------------------------------------------------- +c microcanonical decay of cluster specified via keu...ket, tecm, volu +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + double precision seedp + data ncntmi/0/ + save ncntmi + call utpri('amicro',ish,ishini,4) + ncntmi=ncntmi+1 + + if(ncntmi.eq.1)then + call ranfgt(seedp) !not to change the seed ... + if(hydt.ne.'---')then + call HydroTable2(0) + call DefineParticles + else + call ManiParticles(93,0) + endif + call ranfst(seedp) ! ... after this initialization + endif + + iret=0 + nevt=0 + nptl=0 +c dez=0.5e-4 + call InitializeHyperbola !does not affect results but necessary + +c 50 continue + call GraCan + energ=0 + do i=1,np + energ=energ+pcm(4,i) + enddo + !print*,'+++++',energ,tecm,tecm/volu +ccc if(abs(energ-tecm).gt.0.1) goto50 !uncomment for energy conservation + + do n=1,np + nptl=nptl+1 + if(nptl.gt.mxptl)call utstop('StaHadShort: mxptl too small&') + idptl(nptl)=ident(n) + do j=1,4 + pptl(j,nptl)=pcm(j,n) + xorptl(j,nptl)=0 + enddo + pptl(5,nptl)=amass(n) + ityptl(nptl)=19 + enddo + + do n=1,nptl + iorptl(n)=0 + jorptl(n)=0 + istptl(n)=0 + ifrptl(1,n)=0 + ifrptl(2,n)=0 + tivptl(1,n)=0 + call idtau(idptl(n),pptl(4,n),pptl(5,n),taugm) + r=rangen() + tivptl(2,n)=tivptl(1,n)+taugm*(-alog(r)) + radptl(n)=0. + itsptl(n)=0 + rinptl(n)=-9999 + enddo + + call utprix('amicro',ish,ishini,4) + return + end + +c----------------------------------------------------------------------- + subroutine GraCan +c----------------------------------------------------------------------- + ! decays cluster specified via tfo and volu using + ! hadron gas (ioclude=4) or recombination (ioclude=5) + ! pcm(5,n) is the usual energy (ioclude=4) + ! or the effective energy, based on quark mass sum (ioclude=5) + ! so for the flow boost use this energy + !---------------------------------------------------------------- + include 'epos.inc' + include 'epos.inchy' + common/copt/istat + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + parameter (mspez=54) + common/cspez1/nspez,ispez(mspez),aspez(2,mspez),gspez(mspez) + common/cspez2/kspez,jspez(mspez) + common/cspez3/fuga(mspez) + common/cspez4/ffstat(2,0:mspez+2) /ctfo/tfo + real u(3) + io3=ioclude-3 + if(io3.lt.1.or.io3.gt.2)stop'in GraCan: wrong ioclude (140808) ' + yie= volu * ffstat(io3,nspez) * ffstat(io3,mspez+2) + np=yie + if(rangen().le.yie-np)np=np+1 + do n=1,np + r=rangen()*yie + i=0 + do while(yie*ffstat(io3,i)/ffstat(io3,nspez).lt.r) + i=i+1 + enddo + ident(n)=ispez(i) + amass(n)=aspez(1,i) + fug=fuga(i) + js=jspez(i) + x=RanBoseFermi(aspez(io3,i),fug,js,tfo,istat) + p=x*tfo + e=sqrt(amass(n)**2+p**2) + ex=sqrt(aspez(io3,i)**2+p**2) + u(3)=2.*rangen()-1. + phi=2.*pi*rangen() + u(1)=sqrt(1.-u(3)**2)*cos(phi) + u(2)=sqrt(1.-u(3)**2)*sin(phi) + pcm(1,n)=p*u(1) + pcm(2,n)=p*u(2) + pcm(3,n)=p*u(3) + pcm(4,n)=e + pcm(5,n)=ex + enddo + end + +c---------------------------------------------------------------------- + subroutine HydroTable2(ichk) +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.inchy' + parameter (mspez=54) + common/cspez1/nspez,ispez(mspez),aspez(2,mspez),gspez(mspez) + common/cspez2/kspez,jspez(mspez) /cstep/netastep /crapi/delrapi + common/ctempcrit/tempcrit,epscrit + character tabname*550 + + if(hydt.eq.'---')stop'in HydroTable2. no table found (150808) ' + write(tabname,'(a)')fnnx(1:nfnnx)//'epos.ini'//hydt//' ' + call HydroTable(ichk,tabname) + epscri(3)=epscrit + kspez=1 + nspez=54 + end + +c------------------------------------------------------------------------------ + subroutine HydroTable(ichk,tabname) ! 13 Aug 08 (same as gyx.f except inc) +c------------------------------------------------------------------------------ + include 'epos.inc' + include 'epos.inchy' + character txtdum*40, tabname*550 + common/ctempcrit/tempcrit,epscrit/ctfo/tfo + nchar=index(tabname,' ')-1 + write(*,'(a,$)') + * ' reading table '//tabname(1:nchar)//' ...' + open(unit=3,file=tabname(1:nchar),status='old' + * ,err=99) + read(3,'(a)')txtdum + read(3,*)maprojx,matargx,engyx,epscrit,tempcrit + tfo=tempcrit + if(ichk.eq.1)then + if(maprojx.ne.maproj)stop'HydroTable: maprojx.ne.maproj. ' + if(matargx.ne.matarg)stop'HydroTable: matargx.ne.matarg. ' + if(engyx.ne.engy)stop'HydroTable: engyx.ne.engy. ' + endif + read(3,*)ncenthy,netahy,ntauhy,nphihy,nradhy + if(ncenthx.lt.ncenthy)stop'HydroTable: ncenthx too small. ' + if(netahx.lt.netahy) stop'HydroTable: netahx too small. ' + if(ntauhx.lt.ntauhy) stop'HydroTable: ntauhx too small. ' + if(nphihx.lt.nphihy) stop'HydroTable: nphihx too small. ' + if(nradhx.lt.nradhy) stop'HydroTable: nradhx too small. ' + read(3,*)(ntauhoc(ncent),ncent=1,ncenthy) + read(3,*)(centhy(ncent),ncent=1,ncenthy) + * ,(etahy(neta), neta= 1,netahy) + * ,(phihy(nphi), nphi= 1,nphihy) + * ,(radhy(nrad), nrad= 1,nradhy) + read(3,*)((tauhoc(ncent,ntau),ncent=1,ncenthy), ntau=1,ntauhy) + read(3,*)((((epsii(ncent,neta,nphi,nrad),ncent=1,ncenthy) + * ,neta=1,netahy),nphi=1,nphihy),nrad=1,nradhy) + read(3,*)meos,meosmu + read(3,*)((eos(i,m),i=1,3),m=1,meos) + * ,((eosmu(i,m),i=1,17),m=1,meosmu) + read(3,*)mcenty + read(3,*)(bcenty(m),m=1,mcenty),(pcenty(m),m=1,mcenty) + read(3,*)nbimp + read(3,*)(bimpar(1,m),m=1,nbimp),(bimpar(2,m),m=1,nbimp) + read(3,*)((((rar(ncent,neta,ntau,nphi),ncent=1,ncenthy) + * ,neta=1,netahy),ntau=1,ntauhy),nphi=1,nphihy) + read(3,*)(((((var(i,ncent,neta,ntau,nphi),i=1,3),ncent=1,ncenthy) + * ,neta=1,netahy),ntau=1,ntauhy),nphi=1,nphihy) + close(3) + do ntau=1,ntauhx + tauhy(ntau)=tauhoc(1,ntau) + enddo + do ncent=2,ncenthy + do ntau=1,ntauhoc(ncent) + if(abs(tauhoc(ncent,ntau)-tauhy(ntau)).gt.1e-4) + * stop'in HydroTable: different tau grids. ' + enddo + enddo + print*,' done' + return + 99 print*,'HydroTable: error opening hydro table' + print*,' file=',tabname(1:nchar) + stop'070817' + end + +c---------------------------------------------------------------------------------- + subroutine SymmTab(ncent1,ncent2) ! 13 Aug 08 (same as gyx.f except inc) +c---------------------------------------------------------------------------------- + include 'epos.inchy' + common/cderivs/ + . ddrdtau(ncenthx,-netahx+1:netahx-1,ntauhx,nphihx) + . ,ddrdphi(ncenthx,-netahx+1:netahx-1,ntauhx,nphihx) + . ,ddrdeta(ncenthx,-netahx+1:netahx-1,ntauhx,nphihx) + common/cgmma/gaa(ncenthx,-netahx+1:netahx-1,ntauhx,nphihx) + + !.............................................. + write(*,'(a,$)')' making symmetric tables ...' + !'''''''''''''''''''''''''''''''''''''''''''''' + + do ncent=ncent1,ncent2 + do meta=1-netahy,netahy-1 + do ntau=1,ntauhx + do nphi=1,nphihy + waa(ncent,meta,ntau,nphi)=0 + raa(ncent,meta,ntau,nphi)=0 + vaa(1,ncent,meta,ntau,nphi)=0 + vaa(2,ncent,meta,ntau,nphi)=0 + vaa(3,ncent,meta,ntau,nphi)=0 + ddrdphi(ncent,meta,ntau,nphi)=0 + ddrdtau(ncent,meta,ntau,nphi)=0 + ddrdeta(ncent,meta,ntau,nphi)=0 + gaa(ncent,meta,ntau,nphi)=0 + enddo + enddo + enddo + enddo + + do ncent=ncent1,ncent2 + ntauho=ntauhoc(ncent) + + do neta=1,netahy + meta=neta-1 + zetahy(meta)=etahy(neta) + zetahy(-meta)=-etahy(neta) + enddo + if(mod(nphihy,2).ne.1)stop'in Symm (2103200820) ' + do neta=1,netahy + meta=neta-1 + do ntau=1,ntauho + do nphi=1,nphihy + !------------------------- + ! symmetry: eta -> -eta ; x -> -x ; y -> y + ! or eta -> -eta ; r -> r ; phi -> pi-phi + ! vtg -> -vtg + ! v3 -> -v3 + ! drdphi -> -drdphi + ! drdeta -> -drdeta + !------------------------- + nphimed=nphihy/2+1 + if(nphi.le.nphimed)then + jphi=nphimed+1-nphi + else + jphi=nphihy-(nphi-nphimed) + endif + if(meta.ne.0)then + raa( ncent, meta,ntau,nphi)= rar( ncent,neta,ntau,nphi) + vaa(1,ncent, meta,ntau,nphi)= var(1,ncent,neta,ntau,nphi) + vaa(2,ncent, meta,ntau,nphi)= var(2,ncent,neta,ntau,nphi) + vaa(3,ncent, meta,ntau,nphi)= var(3,ncent,neta,ntau,nphi) + raa( ncent,-meta,ntau,nphi)= rar( ncent,neta,ntau,jphi) + vaa(1,ncent,-meta,ntau,nphi)= var(1,ncent,neta,ntau,jphi) + vaa(2,ncent,-meta,ntau,nphi)=-var(2,ncent,neta,ntau,jphi) + vaa(3,ncent,-meta,ntau,nphi)=-var(3,ncent,neta,ntau,jphi) + else + raa(ncent, meta,ntau,nphi)= + . 0.5*(rar(ncent,neta,ntau,nphi)+rar(ncent,neta,ntau,jphi)) + vaa(1,ncent,meta,ntau,nphi)= + . 0.5*(var(1,ncent,neta,ntau,nphi)+var(1,ncent,neta,ntau,jphi)) + vaa(2,ncent, meta,ntau,nphi)= + . 0.5*(var(2,ncent,neta,ntau,nphi)-var(2,ncent,neta,ntau,jphi)) + vaa(3,ncent, meta,ntau,nphi)= + . 0.5*(var(3,ncent,neta,ntau,nphi)-var(3,ncent,neta,ntau,jphi)) + endif + enddo + enddo + enddo + + do meta=1-netahy,netahy-1 + do nphi=1,nphihy + n=ntauho + do while(raa(ncent,meta,n,nphi).eq.0.0.and.n.gt.2) + n=n-1 + enddo + n=n+1 + n=min(n,ntauho) + ntauhec(ncent,meta,nphi)=n + enddo + enddo + + dphi=phihy(2)-phihy(1) + dtau=tauhy(2)-tauhy(1) + deta=etahy(2)-etahy(1) + do meta=1-netahy,netahy-1 + mem=meta-1 + mem=max(mem,1-netahy) + mep=meta+1 + mep=min(mep,netahy-1) + do nphi=1,nphihy + npp=nphi+1 + npp=min(npp,nphihy) + npm=nphi-1 + npm=max(npm,1) + do ntau=1,ntauhec(ncent,meta,nphi) + ntm=ntau-1 + ntm=max(ntm,1) + ntp=ntau+1 + ntp=min(ntp,ntauhec(ncent,meta,nphi)) + ddrdphi(ncent,meta,ntau,nphi)=(raa(ncent,meta,ntau,npp ) + . -raa(ncent,meta,ntau,npm )) / ((npp-npm)*dphi) + ddrdtau(ncent,meta,ntau,nphi)=(raa(ncent,meta,ntp ,nphi) + . -raa(ncent,meta,ntm ,nphi)) / ((ntp-ntm)*dtau) + ddrdeta(ncent,meta,ntau,nphi)=(raa(ncent,mep ,ntau,nphi) + . -raa(ncent,mem ,ntau,nphi)) / ((mep-mem)*deta) + enddo + enddo + enddo + + do meta=1-netahy,netahy-1 + do nphi=1,nphihy + do ntau=1,ntauhec(ncent,meta,nphi) + vv=sqrt(vaa(1,ncent,meta,ntau,nphi)**2 + . +vaa(2,ncent, meta,ntau,nphi)**2 + . +vaa(3,ncent, meta,ntau,nphi)**2) + gaa(ncent,meta,ntau,nphi)=1./sqrt((1-vv)*(1+vv)) + enddo + enddo + enddo + + do meta=1-netahy,netahy-1 + do nphi=1,nphihy +c phi=phihy(nphi) + do ntau=1,ntauhec(ncent,meta,nphi) + tau=tauhy(ntau) + rad=raa(ncent,meta,ntau,nphi) + vrd=vaa(1,ncent,meta,ntau,nphi) + vtg=vaa(2,ncent,meta,ntau,nphi) + v3=vaa(3,ncent,meta,ntau,nphi) + vv=sqrt(vrd**2+vtg**2+v3**2) + gm=1./sqrt((1-vv)*(1+vv)) + dVs= - ddrdtau(ncent,meta,ntau,nphi) * tau * rad *gm + . + rad * tau *gm*vrd + . + ddrdphi(ncent,meta,ntau,nphi) * tau *gm*vtg + . - ddrdeta(ncent,meta,ntau,nphi) * rad *gm*v3 + waa(ncent,meta,ntau,nphi)=abs(dVs) + enddo !tau + enddo !phi + enddo !neta + + enddo !ncent + + print*,' done' + + end + +c-------------------------------------------------------------------------------------- + subroutine DefineParticles ! 14 Aug 08 (same as gyx.f except inc) +c-------------------------------------------------------------------------------------- + include 'epos.inc' + include 'epos.inchy' + common/copt/istat + parameter (mspez=54) + common/cspez1/nspez,ispez(mspez),aspez(2,mspez),gspez(mspez) + common/cspez2/kspez,jspez(mspez) + common/cspez3/fuga(mspez) + common/cspez4/ffstat(2,0:mspez+2) /ctfo/tfo + parameter (nlag=15) + real xlag(nlag),wlag(nlag) +c parameter (klax=5) + common/cspez7/klass(mspez) + data klass/ + * 0, 1, 1, 2, 2, 4*0 + *, 9*0 + *, 8*0 + *, 8*0 + *,10*0 + *,10*0/ + data ispez/ + * 110, 120, -120, 130, -130, 230, -230, 220, 330 + *, 111, 121, -121, 131, -131, 231, -231, 221, 331 + *, 1120,-1120, 1220,-1220, 1130,-1130, 2130,-2130 + *, 1230,-1230, 2230,-2230, 1330,-1330, 2330,-2330 + *, 1111,-1111, 1121,-1121, 1221,-1221, 2221,-2221, 1131,-1131 + *, 1231,-1231, 2231,-2231, 1331,-1331, 2331,-2331, 3331,-3331 / + data jspez/ + * -1,-1,-1,-1,-1,-1,-1,-1,-1,-1,-1,-1,-1,-1,-1,-1,-1,-1 , 36*1/ + data gspez/ + * 9*1. + *, 9*3. + *, 8*2. + *, 8*2. + *,10*4. + *,10*4./ + data (aspez(1,m),m=1,mspez)/ + * 1.349766E-01 !pi 0 + *,2* 1.3957018E-01 !pi + + *,2* 4.93677E-01 !K + + *,2* 4.97648E-01 !K 0 + *, 5.4751E-01 !eta 0 + *, 9.5778E-01 !eta'(958) 0 + *,3* 7.755E-01 !rho(770) 0 + *,2* 8.9166E-01 !K*(892) + + *,2* 8.9600E-01 !K*(892) 0 + *, 7.8265E-01 !omega(782) 0 + *, 1.019460E+00 !phi(1020) 0 + *,2* 9.3827203E-01 !p + + *,2* 9.3956536E-01 !n 0 + *,2* 1.18937E+00 !Sigma + + *,2* 1.115683E+00 !Lambda 0 + *,2* 1.192642E+00 !Sigma 0 + *,2* 1.197449E+00 !Sigma - + *,2* 1.31483E+00 !Xi 0 + *,2* 1.32131E+00 !Xi - + *,8* 1.2320E+00 !Delta(1232) - + *,2* 1.3828E+00 !Sigma(1385) + + *,2* 1.3837E+00 !Sigma(1385) 0 + *,2* 1.3872E+00 !Sigma(1385) - + *,2* 1.53180E+00 !Xi(1530) 0 + *,2* 1.5350E+00 !Xi(1530) - + *,2* 1.67245E+00 !Omega - + */ +c data (aspez(1,m),m=1,mspez)/ +c * 0.13496, 2* 0.13957, 2* 0.49367, 2* 0.49767, 0.54880,0.95760 +c *, 3* 0.77000, 2* 0.88810, 2* 0.89220, 0.78260, 1.01960 +c *, 2* 0.93828, 2* 0.93957, 2* 1.18940, 2* 1.11560 +c *, 2* 1.19250, 2* 1.19740, 2* 1.31490, 2* 1.32130 +c *, 8* 1.23200, 2* 1.38230, 2* 1.38200, 2* 1.38750 +c *, 2* 1.53180, 2* 1.53500, 2* 1.67220 / + parameter (nquark=3) + real amaq(0:nquark) + data amaq /0., 0.337, 0.337, 0.486/ + do m=1,mspez + id=ispez(m) + call idflav(id,i1,i2,i3,jspin,index) + amx=amaq(abs(i1))+amaq(abs(i2))+amaq(abs(i3)) + aspez(2,m)=amx + enddo + + write(*,'(a,$)')' DefineParticles ...' + + istat=1 !0=Boltzmann, 1=Bose/Fermi + pi=3.1415927 + hbar=0.197327 + + call gaulag(xlag,wlag,nlag,0.) + do n=1,nlag + wlag(n)=wlag(n)*exp(xlag(n)) + enddo + + !write(*,'(4x,a,$)')'fuga:' + do m=kspez,nspez + id=ispez(m) + chem=0 + if(meosmu.gt.0)then + ihi=idxHiranoTable(id) + if(ihi.gt.0)then + k=1 + do while(eosmu(1,k).gt.tfo) + k=k+1 + enddo + f=(tfo-eosmu(1,k))/(eosmu(1,k-1)-eosmu(1,k)) + chem=eosmu(ihi,k)*(1-f) + eosmu(ihi,k-1)*f + endif + endif + fuga(m)=exp(chem/tfo) + !if(m.lt.6)write(*,'(i5,a,f6.2,$)')id,':',fuga(m) + enddo + + !write(*,'(/25x,a,$)')'yie:' + facphase=1./(2*pi*hbar)**3 + do m=0,kspez-1 + ffstat(1,m)=0 + ffstat(2,m)=0 + enddo + eesum=0 + hhsum=0 + do m=kspez,nspez + id=ispez(m) + am=aspez(1,m) + amx=aspez(2,m) + esum=0 + fsum=0 + gsum=0 + hsum=0 + do n=1,nlag + x=xlag(n) ! p/tfo + e=sqrt(am**2+x**2*tfo**2) + w=exp(-sqrt(am**2/tfo**2+x**2)) * fuga(m) + fsum=fsum+wlag(n)*x**2*w /(1+istat*jspez(m)*w) + esum=esum+wlag(n)*x**2*w /(1+istat*jspez(m)*w) *e + wx=exp(-sqrt(amx**2/tfo**2+x**2)) !???? * fuga(m) + gsum=gsum+wlag(n)*x**2*wx /(1+istat*jspez(m)*wx) + hsum=hsum+wlag(n)*x**2*wx /(1+istat*jspez(m)*wx) *e + enddo + esum=esum * facphase * gspez(m) * 4 * pi * tfo**2 * tfo + fsum=fsum * facphase * gspez(m) * 4 * pi * tfo**2 * tfo + gsum=gsum * facphase * gspez(m) * 4 * pi * tfo**2 * tfo + hsum=hsum * facphase * gspez(m) * 4 * pi * tfo**2 * tfo + ffstat(1,m)=ffstat(1,m-1)+fsum + ffstat(2,m)=ffstat(2,m-1)+gsum + eesum=eesum+esum + hhsum=hhsum+hsum + !if(m.lt.6)write(*,'(i5,a,f8.5,$)')id,':',fsum + enddo + ffstat(1,mspez+1)=eesum + ffstat(1,mspez+2)=1 + ffstat(2,mspez+1)=hhsum + ffstat(2,mspez+2)=eesum/hhsum + + print*,' E/V=',eesum,' Ereco/V=',hhsum,' done' + !do n=1,nlag + !print*,n,xlag(n),wlag(n) + !enddo + end + +c-------------------------------------------------------------------------------------- + subroutine RestFrameFO(nsimu,bimp + . ,jcent,ier,iprint,ianl,isto) ! 14 Aug 08 (same as gyx.f except inc) +c-------------------------------------------------------------------------------------- + include 'epos.inc' + include 'epos.inchy' + common/copt/istat + parameter (mspez=54,klax=5) + common/cspez1/nspez,ispez(mspez),aspez(2,mspez),gspez(mspez) + common/cspez2/kspez,jspez(mspez) /cho/netaho + common/cpro/probdi(20,100),dprob,mxprob + common/crap/nraphi,jfac /cstep/netastep + common/cspez3/fuga(mspez) + common/cspez4/ffstat(2,0:mspez+2) /ctfo/tfo + real u(3),q(4),waii(2),wbii(2),wcii(2) + real wrii(2),wwii(2),wxii(2),wyii(2),wzii(2) + parameter(numiv=100,rapmax=5,rapmin=-rapmax,ptvmax=2) + common/cana1/rapeta(klax,-netahx+1:netahx-1,numiv) + common/cana1b/rapar(klax,numiv),v2rapar(klax,numiv) + common/cana1c/phaar(klax,numiv,numiv) + common/cana1d/sapar(klax,numiv),v2sapar(klax,numiv) + common/cana1e/ptvar(klax,numiv),ptwar(klax,numiv) + common/cspez7/klass(mspez) + common/cderivs/ + . ddrdtau(ncenthx,-netahx+1:netahx-1,ntauhx,nphihx) + . ,ddrdphi(ncenthx,-netahx+1:netahx-1,ntauhx,nphihx) + . ,ddrdeta(ncenthx,-netahx+1:netahx-1,ntauhx,nphihx) + ier=1 + if(bimp.gt.centhy(ncenthy)+0.5)return + ier=0 + pi=3.1415927 +c hbar=0.197327 + delrax= 2*rapmax / numiv + delptv= ptvmax / numiv + do i=1,100 + probdi(jcent,i)=0 + enddo + mxprob=jcent + dprob=0.1 + ncent=2 + do while(ncent.lt.ncenthy.and.centhy(ncent).lt.bimp) + ncent=ncent+1 + enddo + n1=ncent-1 + n2=ncent + frac=(bimp-centhy(n1))/(centhy(n2)-centhy(n1)) + g1=1-frac + g2=frac + ntauho=max(ntauhoc(n1),ntauhoc(n2)) + + if(iprint.eq.1)then + print*,'++++++++',ncent, bimp, centhy(n1),centhy(n2),g1,g2 + print*,'++++++++',ntauho,netaho,jfac*netastep,nsimu + write(*,'(a,$)')' Rest Frame freeze out ... ' + endif + + dphi=phihy(2)-phihy(1) + dtau=tauhy(2)-tauhy(1) +c deta=etahy(2)-etahy(1) + dleta=(etahy(2)-etahy(1))/jfac + dall=dphi*dtau*dleta*0.125 + do nphi=1,nphihy + if(iprint.eq.1.and. + .mod(nphihy+1-nphi,10).eq.0)write(*,'(i3,$)')(nphihy+1-nphi)/10 + phi=phihy(nphi) + fphi=2 + if(nphi.eq.1.or.nphi.eq.nphihy)fphi=1 + do ntau=1,ntauho + tau=tauhy(ntau) + ftau=2 + if(ntau.eq.1.or.ntau.eq.ntauho)ftau=1 + do meta=-netaho+netastep,netaho,netastep + do ii=1,2 + if(ii.eq.1)then + mt=meta-netastep + else !if(ii.eq.2) + mt=meta + endif + wwii(ii)=g1*waa(n1,mt,ntau,nphi) +g2*waa(n2,mt,ntau,nphi) + wwii(ii)=max(0.,wwii(ii)) + wxii(ii)=g1*vaa(1,n1,mt,ntau,nphi) +g2*vaa(1,n2,mt,ntau,nphi) + wyii(ii)=g1*vaa(2,n1,mt,ntau,nphi) +g2*vaa(2,n2,mt,ntau,nphi) + wzii(ii)=g1*vaa(3,n1,mt,ntau,nphi) +g2*vaa(3,n2,mt,ntau,nphi) + wrii(ii)=g1*raa(n1,mt,ntau,nphi) +g2*raa(n2,mt,ntau,nphi) + waii(ii)=g1*ddrdtau(n1,mt,ntau,nphi)+g2*ddrdtau(n2,mt,ntau,nphi) + wbii(ii)=g1*ddrdphi(n1,mt,ntau,nphi)+g2*ddrdphi(n2,mt,ntau,nphi) + wcii(ii)=g1*ddrdeta(n1,mt,ntau,nphi)+g2*ddrdeta(n2,mt,ntau,nphi) + enddo + jmax=jfac*netastep + do j=0,jmax + f=2 + if(j.eq.0.or.j.eq.jmax)f=1 + fall=fphi*ftau*f + dVs=wwii(1)+j/float(jmax)*(wwii(2)-wwii(1)) + dVs=dVs*dall*fall + vr=wxii(1)+j/float(jmax)*(wxii(2)-wxii(1)) + vt=wyii(1)+j/float(jmax)*(wyii(2)-wyii(1)) + v3=wzii(1)+j/float(jmax)*(wzii(2)-wzii(1)) + v1=vr*cos(phi)+vt*sin(phi) + v2=vr*sin(phi)-vt*cos(phi) + gmx=max(1e-8, 1.-vr*vr-vt*vt-v3*v3) + gm=1./sqrt(gmx) + rad=wrii(1)+j/float(jmax)*(wrii(2)-wrii(1)) + ieta=(meta-netastep)*jfac+j + eta=ieta*dleta + finc=10 + volu=abs(dVs)*finc + io3=ioclude-3 + if(io3.lt.1.or.io3.gt.2) + . stop'in RestFrameFO: wrong ioclude (150808) ' + yie= volu * ffstat(io3,nspez) * ffstat(io3,mspez+2) + do nsim=1,nsimu + np=yie + if(rangen().le.yie-np)np=np+1 + if(np.gt.0)then + do n=1,np + r=rangen()*yie + i=0 + do while(yie*ffstat(io3,i)/ffstat(io3,nspez).lt.r) + i=i+1 + enddo + kss=klass(i) + id=ispez(i) + am=aspez(1,i) + fug=fuga(i) + js=jspez(i) + x=RanBoseFermi(aspez(io3,i),fug,js,tfo,istat) + p=x*tfo + e=sqrt(p**2+aspez(1,i)**2) + ex=sqrt(p**2+aspez(io3,i)**2) + !print*,id,e + u(3)=2.*rangen()-1. + angle=2.*pi*rangen() + u(1)=sqrt(1.-u(3)**2)*cos(angle) + u(2)=sqrt(1.-u(3)**2)*sin(angle) + q(1)=p*u(1) + q(2)=p*u(2) + q(3)=p*u(3) + q(4)=ex + call utlob3(-1, v1*gm , v2*gm , v3*gm , gm ,1e0 + . , q(1), q(2), q(3), q(4)) + w1=FOFactor(wrii(1),waii(1),wbii(1),wcii(1),tau,phi,q) + w2=FOFactor(wrii(2),waii(2),wbii(2),wcii(2),tau,phi,q) + fof=w1+j/float(jmax)*(w2-w1) + fof=fof*dall*fall + probab=fof/volu/e + ij=1+probab/dprob + if(ij.ge.1.and.ij.le.100) + . probdi(jcent,ij)=probdi(jcent,ij)+1 + if(rangen().le.probab)then !accept + if(io3.eq.2)q(4)=e + rap=eta + 0.5*log((q(4)+q(3))/(q(4)-q(3))) + pt2=q(1)**2+q(2)**2 + ptr=sqrt(pt2) + pha=sign(1.,q(2))*acos(q(1)/ptr) + if(pha.lt.0.)pha=pha+2*pi + if(ianl.eq.1)then !~~~~~~~~~~~~~~~~~~~~~~~~~~ + pz=sqrt(am**2+ptr**2)*sinh(rap) + pz2p=pz/sqrt(pz**2+ptr**2) + nrap=1+(rap-rapmin)/delrax + npha=1+pha/(2*pi/numiv) + sap=0.501 + if(pz2p.le.-1.)then + nsap=0 + elseif(pz2p.ge.1.)then + nsap=numiv+1 + else + sap=0.5*log((1+pz2p)/(1-pz2p)) + nsap=1+(sap-rapmin)/delrax + endif + nptv=1+ptr/delptv + if(nrap.ge.1.and.nrap.le.numiv.and.kss.gt.0)then + rapeta(kss,meta,nrap)=rapeta(kss,meta,nrap)+1 + rapar(kss,nrap)=rapar(kss,nrap)+1 + if(pt2.gt.0.) + . v2rapar(kss,nrap)=v2rapar(kss,nrap) + . +(q(1)**2-q(2)**2)/pt2 + if(npha.ge.1.and.npha.le.numiv)then + phaar(kss,nrap,npha)=phaar(kss,nrap,npha)+1 + endif + endif + if(nsap.ge.1.and.nsap.le.numiv.and.kss.gt.0)then + sapar(kss,nsap)=sapar(kss,nsap)+1 + if(pt2.gt.0.) + . v2sapar(kss,nsap)=v2sapar(kss,nsap) + . +(q(1)**2-q(2)**2)/pt2 + endif + if(nptv.ge.1.and.nptv.le.numiv.and.kss.gt.0 + . .and.abs(rap).le.0.5)then + ptvar(kss,nptv)=ptvar(kss,nptv)+1 + endif + if(nptv.ge.1.and.nptv.le.numiv.and.kss.gt.0 + . .and.abs(sap).le.0.5)then + ptwar(kss,nptv)=ptwar(kss,nptv)+1 + endif + endif !~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ + if(isto.eq.1) + . call FOStore(id,ptr,pha,am,rap,rad,phi,tau,eta) + endif + enddo !np + endif !np.gt.0 + enddo !nsim + enddo !j + + enddo !meta + enddo !ntau + enddo !nphi + + if(iprint.eq.1)print*,' done' + end + +c-------------------------------------------------------------------------------------- + subroutine FOStore(id,ptr,pha,am,rap,rad,phi,tau,eta) +c-------------------------------------------------------------------------------------- + include 'epos.inc' + include 'epos.inchy' + common/cranphi/ranphi + data ncntfoa/0/ + save ncntfoa + ncntfoa=ncntfoa+1 +c if(ncntfoa.eq.1)nptlb=nptl + phinull=phievt+ranphi + nptl=nptl+1 + if(nptl.gt.mxptl) + . call utstop('FOStore: mxptl too small&') + idptl(nptl)=id + pptl(1,nptl)=ptr*cos(pha+phinull) + pptl(2,nptl)=ptr*sin(pha+phinull) + pptl(3,nptl)=sqrt(am**2+ptr**2)*sinh(rap) + pptl(4,nptl)=sqrt(am**2+ptr**2)*cosh(rap) + pptl(5,nptl)=am + ityptl(nptl)=60 + xorptl(1,nptl)=rad*cos(phi+phinull) + xorptl(2,nptl)=rad*sin(phi+phinull) + xorptl(3,nptl)=tau*sinh(eta) + xorptl(4,nptl)=tau*cosh(eta) + end + +c-------------------------------------------------------------------------------------- + function FOFactor(wr,wa,wb,wc,tau,phi,q) ! 13 Aug 08 (same as gyx.f) +c-------------------------------------------------------------------------------------- + real q(4) + rad=wr + qrd= cos(phi)*q(1)+sin(phi)*q(2) + qtg= sin(phi)*q(1)-cos(phi)*q(2) + fof= - wa * tau * rad *q(4) + . + rad * tau *qrd + . + wb * tau *qtg + . - wc * rad *q(3) + FOFactor=fof + end + +c--------------------------------------------------------------------------------- + function RanBoseFermi(am,fug,js,tfo,istat) ! 13 Aug 08 (same as gyx.f) +c--------------------------------------------------------------------------------- +c generates randomly x=p/tfo according to Bose/Fermi +c------------------------------------------------------------------------------ + 1 x=RanTherm(am/tfo) + if(istat.eq.0)goto2 !Boltznann + p=x*tfo + e=sqrt(p**2+am**2) + w=exp(-e/tfo)*fug + if(js.eq.-1)then !bosons + w0=exp(-am/tfo)*fug + pacc=(1.-w0)/(1.-w) + elseif(js.eq.1)then !fermions + pacc=1./(1.+w) + else + stop'in RanBoseFermi: unknown statistics (080726) ' + endif + !print*,'+++++',am,js,pacc + if(rangen().gt.pacc)goto1 + 2 RanBoseFermi=x + end + +c------------------------------------------------------------------------------ + function RanTherm(a) ! 13 Aug 08 (same as gyx.f) +c------------------------------------------------------------------------------ +c generates a random number according to f(x) ~ x**2*exp(-sqrt(x*2+a**2)) +c in the interval from zero to infinity +c------------------------------------------------------------------------------ + !ntry=0 + 1 i=2 + if(rangen().le.a**3/(a**3+3*a**2+6*a+6))i=1 + !ntry=ntry+1 + if(i.eq.1)then + x=a*rangen()**(1./3.) + if(rangen().gt.exp(a-sqrt(x**2+a**2)))goto1 + elseif(i.eq.2)then + !f(z)~a**2+2*a*z+z**2)*exp(-z) from zero to infty + r=rangen() + if(r.lt.a**2/(a**2+2*a+2))then + z=-log(rangen()) + elseif(r.lt.(a**2+2*a)/(a**2+2*a+2))then + z=-log(rangen())-log(rangen()) + else + z=-log(rangen())-log(rangen())-log(rangen()) + endif + x=a+z + if(rangen().gt.exp(x-sqrt(x**2+a**2)))goto1 + endif + RanTherm=x + !ia=a*100 + !print*,ia,' ',ntry,' ',x + end + +c--------------------------------------------------------------------------------- + subroutine DefineRapScale ! 13 Aug 08 (same as gyx.f except inc) +c--------------------------------------------------------------------------------- + include 'epos.inchy' + common/crap/nraphi,jfac /cho/netaho /cstep/netastep /crapi/delrapi + deta=etahy(2)-etahy(1) + write(*,'(a,$)')' DefineRapScale ...' + jfac=1 + delrap=deta + do while(delrap.gt.delrapi) + jfac=jfac+1 + delrap=deta/jfac + enddo + write(*,'(f7.2,i3,f7.2,5x,$)')deta,jfac,delrap + nraphi=5 + rapmn=-delrap*nraphi + do while(rapmn.gt.-2.) + nraphi=nraphi+1 + if(nraphi.gt.nraphx)stop'(1539070608) ' + rapmn=-delrap*nraphi + enddo + netaho=netahy-1 + do while(mod(netaho,netastep).ne.0) + netaho=netaho-1 + enddo + !print*,'$$$$$$ nraphi,rapmn,netaho:',nraphi,rapmn,netaho + print*,' done' + end + +c---------------------------------------------------------------------- + subroutine HydroFO(ier) +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.inchy' + common/cen/ncentr + parameter (klax=5) + parameter(numiv=100)!,rapmax=5,rapmin=-rapmax) + common/cana1b/rapar(klax,numiv),v2rapar(klax,numiv) + common/cana1d/sapar(klax,numiv),v2sapar(klax,numiv) + common/cstep/netastep /crapi/delrapi + double precision seedp + + data icntcf /0/ + save icntcf + icntcf=icntcf+1 + if(icntcf.eq.1)then + call ranfgt(seedp) !not to change the seed ... + do n=1,klax + do nu=1,numiv + rapar(n,nu)=0 + v2rapar(n,nu)=0 + sapar(n,nu)=0 + v2sapar(n,nu)=0 + enddo + enddo + netastep=1 + delrapi=0.2 + call HydroTable2(0) + call SymmTab(1,ncenthy) + call DefineParticles + call DefineRapScale + call ranfst(seedp) ! ... after this initialization + endif + if(iappl.eq.9)then + call CheckBimp(ier) + if(ier.eq.1)return + call GetNpart + endif + call RestFrameFO(1,bimevt,1,ier,0,1,1) + end + +c---------------------------------------------------------------------- + subroutine xEnergy +c---------------------------------------------------------------------- + include 'epos.inc' + parameter (mspez=54) + common/cspez4/ffstat(2,0:mspez+2) + common/ccsum/eesum,hhsum + eesum=ffstat(1,mspez+1) + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i3)') '! energy ' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a)') ' openhisto htyp pgs xmod lin ymod lin ' + write(ifhi,'(a)') ' array 2' + write(ifhi,'(2e11.3)')eesum*volu,0.005 + write(ifhi,'(a)') ' endarray closehisto plot 0' + end + +c---------------------------------------------------------------------- + subroutine GetNpart +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.inchy' + mcent=2 + do while(mcent.lt.mcenty.and.bcenty(mcent).lt.bimevt) + mcent=mcent+1 + enddo + m1=mcent-1 + m2=mcent + hrac=(bimevt-bcenty(m1))/(bcenty(m2)-bcenty(m1)) + h1=1-hrac + h2=hrac + npartic=h1*pcenty(m1)+h2*pcenty(m2) + npjevt=npartic/2 + ntgevt=npartic-npjevt + !print*,'++++++++' + !. ,mcent, bimevt, bcenty(m1),bcenty(m2),h1,h2,npartic + end + +c---------------------------------------------------------------------- + subroutine CheckBimp(ier) +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.inchy' + data icntcb /0/ + save icntcb, wref,bref + icntcb=icntcb+1 + if(icntcb.eq.1)then + nmax=0 + wmax=0 + do n=1,nbimp + if(bimpar(2,n).gt.wmax)then + wmax=bimpar(2,n) + nmax=n + endif + enddo + nref=nmax*0.75 + bref=bimpar(1,nref) + wref=bimpar(2,nref) + endif + ier=0 + if(bimevt.lt.bref)then + q=1 + else + w=wref/bref*bimevt + n=2 + do while(n.lt.nbimp.and.bimpar(1,n).lt.bimevt) + n=n+1 + enddo + n1=n-1 + n2=n + frac=(bimevt-bimpar(1,n1))/(bimpar(1,n2)-bimpar(1,n1)) + g1=1-frac + g2=frac + wx=g1*bimpar(2,n1)+g2*bimpar(2,n2) + wx=max(0.,wx) + q=wx/w + endif + if(rangen().gt.q)ier=1 + !if(ier.eq.0)print*,'+++++',bimevt,q + + end + +c---------------------------------------------------------------------- + subroutine xCoopFryPt(kss) +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(numiv=100,ptvmax=2,klax=5) + common/cana1e/ptvar(klax,numiv),ptwar(klax,numiv) + delptv= ptvmax / numiv + pi=3.1415927 + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i3)') '! pt ' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a)') 'openhisto htyp lin xmod lin ymod log ' + write(ifhi,'(a,f7.2)') 'xrange 0 2 ' + write(ifhi,'(a)') 'txt "xaxis p?t!"' + write(ifhi,'(a)') 'txt "yaxis dn / 2[p] p?t! dp?t!"' + write(ifhi,'(a)') 'array 2' + do n=1,numiv + x=(n-0.5)*delptv + y=ptvar(kss,n)/float(nevent)/delptv/2./pi/x + write(ifhi,'(2e14.6)')x,y + enddo + write(ifhi,'(a)') 'endarray closehisto plot 0' +c write(ifhi,'(a)') 'openhisto htyp lin xmod lin ymod lin ' +c write(ifhi,'(a,f7.2)') 'xrange 0 2 ' +c write(ifhi,'(a)') 'array 2' +c do n=1,numiv +c x=(n-0.5)*delptv +c y=0 +c if(ptwar(kss,n).gt.0.)y=ptwar(kss,n)/float(nevent)/delptv/2./pi/x +c write(ifhi,'(2e14.6)')x,y +c enddo +c write(ifhi,'(a)') 'endarray closehisto plot 0' + end + +c---------------------------------------------------------------------- + subroutine xCoopFryRap(kss) +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(numiv=100,rapmax=5,rapmin=-rapmax,klax=5) + common/cana1b/rapar(klax,numiv),v2rapar(klax,numiv) + common/cana1d/sapar(klax,numiv),v2sapar(klax,numiv) + delrax= 2*rapmax / numiv + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i3)') '! rapidity distribution ' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a)') ' openhisto htyp lin xmod lin ymod lin ' + write(ifhi,'(a)') ' xrange -5 5' + write(ifhi,'(a)') ' txt "xaxis y "' + write(ifhi,'(a)') ' txt "yaxis dn/dy "' + write(ifhi,'(a)') ' array 2' + do n=1,numiv + x=rapmin+(n-0.5)*delrax + y=rapar(kss,n)/float(nevent)/delrax + write(ifhi,'(2e11.3)')x,y + enddo + write(ifhi,'(a)') ' endarray closehisto plot 0' +c write(ifhi,'(a)') ' openhisto htyp lin xmod lin ymod lin ' +c write(ifhi,'(a)') ' xrange -5 5' +c write(ifhi,'(a)') ' txt "xaxis [c] "' +c write(ifhi,'(a)') ' txt "yaxis dn/d[c]"' +c write(ifhi,'(a)') ' array 2' +c do n=1,numiv +c x=rapmin+(n-0.5)*delrax +c y=sapar(kss,n)/float(nevent)/delrax +c write(ifhi,'(2e11.3)')x,y +c enddo +c write(ifhi,'(a)') ' endarray closehisto plot 0' + end + +c---------------------------------------------------------------------- + subroutine xCoopFryV2(kss) +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(numiv=100,rapmax=5,rapmin=-rapmax,klax=5) + common/cana1b/rapar(klax,numiv),v2rapar(klax,numiv) + common/cana1d/sapar(klax,numiv),v2sapar(klax,numiv) + delrax= 2*rapmax / numiv + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i3)') '! v2 ' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a)') ' openhisto htyp lin xmod lin ymod lin ' + write(ifhi,'(a,f7.2)') ' xrange -5 5 yrange 0 auto' + write(ifhi,'(a)') ' txt "xaxis y "' + write(ifhi,'(a)') ' txt "yaxis v?2!"' + write(ifhi,'(a)') ' array 2' + do n=1,numiv + x=rapmin+(n-0.5)*delrax + y=0 + if(rapar(kss,n).gt.0.)y=v2rapar(kss,n)/rapar(kss,n) + write(ifhi,'(2e11.3)')x,y + enddo + write(ifhi,'(a)') ' endarray closehisto plot 0' +c write(ifhi,'(a)') ' openhisto htyp lin xmod lin ymod lin ' +c write(ifhi,'(a,f7.2)') ' xrange -5 5 yrange 0 auto' +c write(ifhi,'(a)') ' txt "xaxis [c]"' +c write(ifhi,'(a)') ' txt "yaxis v?2!"' +c write(ifhi,'(a)') ' array 2' +c do n=1,numiv +c x=rapmin+(n-0.5)*delrax +c y=0 +c if(sapar(kss,n).gt.0.)y=v2sapar(kss,n)/sapar(kss,n) +c write(ifhi,'(2e11.3)')x,y +c enddo +c write(ifhi,'(a)') ' endarray closehisto plot 0' + end + +c---------------------------------------------------------------------- + subroutine DropletDecay(ip,iret) +c---------------------------------------------------------------------- + ! statistical hadronization with imposed flow + ! (to be distiguished from real hydro flow as in StaHadDF) + !--------------------------------------------------------------- + include 'epos.inc' + include 'epos.inchy' + common/cxyzt/xptl(mxptl),yptl(mxptl),zptl(mxptl),tptl(mxptl) + *,optl(mxptl),uptl(mxptl),sptl(mxptl),rptl(mxptl,3) + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + common/citer/iter,itermx + integer jc(nflav,2) + double precision p(5),c(5)!,yyrmax + parameter(maxit=50000) + common/count/nacc,nrej,naccit(maxit),nptot,npit(maxit) + dimension uu(4),pe(5),pa(5) + common/ylong/ylong(maxp) + common/vradi/vradi(maxp),vtang(maxp),phifop(maxp),radfop(maxp) + . ,taufop(maxp) + common/xxxspecsy/ndrop(-4:4,-4:4,-4:4) + common/cdelzet/delzet,delsgr /cvocell/vocell + common/cen/ncentr /ctauhu/ntauhu(ncenthx,1-netahx:netahx-1) + common/cranphi/ranphi /ctfo/tfo + double precision seedp + !data vv2 /0./ nvv2 /0/ vv3 /0./ + !save vv2,nvv2,vv3 + data icntsta /0/ + save icntsta + icntsta=icntsta+1 + if(ioclude.eq.1)stop'ioclude.eq.1 no longer supported. ' + if(ioclude.eq.2)stop'ioclude.eq.2 no longer supported. ' + + call utpri('DropletDecay',ish,ishini,4) + + if(ish.ge.3)then + write(ifch,140) + 140 format(/' ----------------------------------'/ + * ' droplet decay'/ + * ' ----------------------------------') + write(ifch,*)'droplet:' + call alist('&',ip,ip) + endif + call ManiParticles(1,1) !store parameters, to be restored at the end + + if(icntsta.eq.1)then + call ranfgt(seedp) !not to change the seed ... + call ManiParticles(92,0) + !redefine parameters, for this subroutine; for the moment same parameters + ! for remnants and droplets, this could easily be changed + call ManiParticles(1,2) !store local parameters + call ranfst(seedp) ! ... after this initialization + else + call ManiParticles(-1,2) !restore local parameters + endif + + iret=0 + do j=1,5 + c(j)=pptl(j,ip) + enddo + + call idquac(ip,nqi,nsi,nai,jc) + keu=jc(1,1)-jc(1,2) + ked=jc(2,1)-jc(2,2) + kes=jc(3,1)-jc(3,2) + kec=jc(4,1)-jc(4,2) + keb=jc(5,1)-jc(5,2) + ket=jc(6,1)-jc(6,2) + !print*,'droplet uds=',keu,ked,kes,' E=',pptl(5,ip) + + !~~~~~define masses~~~~~~~~~~~~~~~~ + amin=utamnu(keu,ked,kes,kec,keb,ket,5) + aumin=amuseg+yrmaxi + ipo=ip + if(ityptl(ip).eq.60)ipo=iorptl(ip) + tecmor=pptl(5,ipo) + tecm=pptl(5,ip) + tecmxx=tecm + + if(iappl.eq.4.or.iorsdf.ne.3 + &.or.ityptl(ip).eq.40.or.ityptl(ip).eq.50)then !not for droplets from remnants + yrmax=0 + else + yrmax=yrmaxi !define in ainit + endif + + + !~~~~~redefine energy in case of imposed radial flow~~~~~~~~~~~~~~~~ + fradfli=1. + if(yrmax.gt.1e-5)fradfli=fradflii !define in ainit + if(tecm*fradfli.lt.amin.and.tecm.gt.0.)fradfli=1.1*amin/tecm !if flow too large, do something anyway (saturation of flow) + if(yrmax.gt.1e-5.and.tecmor.gt.aumin + &.and.tecm*fradfli.gt.amin) then + tecm=tecm*fradfli + else + yrmax=0. + fradfli=1. + endif + + !~~~~~redefine energy in case of long coll flow + if(iappl.eq.4.or.iorsdf.ne.3 + &.or.ityptl(ip).eq.40.or.ityptl(ip).eq.50)then !not for droplets from remnants + yco=0 + else + if(ylongmx.lt.0.)then + yco=delzet * 1.75 + else + yco=ylongmx + endif + endif + tecmx=tecm + if(yco.gt.0..and.tecmor.gt.aumin) then + tecm=tecm/sinh(yco)*yco + else + yco=0. + endif + !print*,'========= cluster energy: ',pptl(5,ip),tecmx,tecm + + !~~~~~define volu~~~~~~~~~~~~~~~~ + volu=tecm/epscri(3) + + !~~~~~~~~~decay~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ + ibarini=(keu+ked+kes+kec+keb+ket)/3 !for baryon number conservation + niter=0 + 4 niter=niter+1 + call GraCan + energ=0 + ibaryon=ibarini + do i=1,np + energ=energ+pcm(4,i) + if(abs(ident(i)).gt.1000)ibaryon=ibaryon-sign(1,ident(i)) + enddo + !print*,'++4+++',energ,tecm,tecm/volu,ibaryon + if((abs(energ-tecm).gt.0.1.or.ibaryon.ne.0) + & .and.niter.le.maxit) goto 4 !comment for energy non-conservation + if(niter.gt.maxit)then + iret=1 + goto1000 + endif + + !~~~~~~~~~~long coll flow -> particles~~~~~~~~~~~~~~~~ + tecmxxx=tecm + if(yco.gt.0.) then + errlim=0.0001 + tecm=tecmx + niter=0 + 611 energ=0. + niter=niter+1 + do i=1,np + ylong(i)=(2*rangen()-1)*yco + uu(3)=sinh(ylong(i)) + uu(4)=cosh(ylong(i)) + energ=energ+uu(4)*pcm(4,i)+uu(3)*pcm(3,i) + enddo + if(abs(energ-tecm).gt.0.1)then + goto 611 + elseif(niter.ge.1000)then + if(ish.ge.1)write(ifch,*)'Long Flow failed:' + & ,energ,tecm + yco=0 + tecm=tecmxxx + goto 400 + endif + !print*,'===== energy after flow boosts',energ,' soll: ',tecm + do j=1,4 + pe(j)=0. + enddo + do i=1,np + uu(1)= 0 + uu(2)= 0 + uu(3)= sinh(ylong(i)) + uu(4)= cosh(ylong(i)) + call utlob3(-1,uu(1),uu(2),uu(3),uu(4),1e0 + * , pcm(1,i), pcm(2,i), pcm(3,i), pcm(4,i)) + do j=1,4 + pe(j)=pe(j)+pcm(j,i) + enddo + enddo + pe(5)=sqrt(pe(4)**2-pe(3)**2-pe(2)**2-pe(1)**2) + !write(6,'(a,5e11.3)')'flow boosts',pe + do j=1,4 + pa(j)=0. + enddo + do i=1,np + call utlob3(1,pe(1),pe(2),pe(3),pe(4),pe(5) + * , pcm(1,i), pcm(2,i), pcm(3,i), pcm(4,i)) + do j=1,4 + pa(j)=pa(j)+pcm(j,i) + enddo + enddo + pa(5)=sqrt(pa(4)**2-pa(3)**2-pa(2)**2-pa(1)**2) + !write(6,'(a,5e11.3)')' cms boost ',pa + esoll=tecm + scal=1. + do ipass=1,200 + sum=0. + do j=1,np + do k=1,3 + pcm(k,j)=scal*pcm(k,j) + enddo + pcm(4,j)=sqrt(pcm(1,j)**2+pcm(2,j)**2+pcm(3,j)**2 + * +amass(j)**2) + sum=sum+pcm(4,j) + enddo + scal=esoll/sum + !write(6,*)'ipass,scal,e,esoll:' + ! $ ,ipass,scal,sum,esoll + if(abs(scal-1.).le.errlim) goto301 + enddo + 301 continue + do j=1,4 + pa(j)=0. + enddo + do i=1,np + do j=1,4 + pa(j)=pa(j)+pcm(j,i) + enddo + enddo + pa(5)=sqrt(pa(4)**2-pa(3)**2-pa(2)**2-pa(1)**2) + !write(6,'(a,5e11.3)')' rescaling ',pa + endif + 400 continue + + !~~~~~~~~~~radial flow -> particles~~~~~~~~~~~~~~~~~~ + if(fradfli.lt.1.) then + errlim=0.0001 + tecm=tecmxx + phinull=phievt+ranphi + do n=1,np + vradi(n)=tanh(sqrt(rangen())*yrmax) + vtang(n)=0. + phifop(n)=rangen()*2*pi + radfop(n)=0. + taufop(n)=0. + enddo + energ=0. + do n=1,np + co=cos(phifop(n)+phinull) + si=sin(phifop(n)+phinull) + v1=vradi(n)*co+vtang(n)*si + v2=vradi(n)*si-vtang(n)*co + v3=0 + a=1.-v1*v1-v2*v2-v3*v3 + if(a.le.0.)stop'in DropletDecay (20032008) ' + gm=1./sqrt(a) + + uu(1)=v1*gm + uu(2)=v2*gm + uu(3)=v3*gm + uu(4)=gm + call utlob3(-1,uu(1),uu(2),uu(3),uu(4),1e0 + * , pcm(1,n), pcm(2,n), pcm(3,n), pcm(5,n)) + energ=energ+sqrt(amass(n)**2 + * +pcm(1,n)**2+pcm(2,n)**2+pcm(3,n)**2) + enddo + esoll=tecm + !print*,tecm,energ + iiscale=1 + if(iiscale.eq.1)then + scal=1. + do ipass=1,200 + sum=0. + do j=1,np + do k=1,3 + pcm(k,j)=scal*pcm(k,j) + enddo + pcm(4,j)=sqrt(pcm(1,j)**2+pcm(2,j)**2+pcm(3,j)**2 + * +amass(j)**2) + sum=sum+pcm(4,j) + enddo + scal=esoll/sum + if(abs(scal-1.).le.errlim) goto300 + enddo + 300 continue + endif + else + phinull=0. + do n=1,np + vradi(n)=0. + vtang(n)=0. + phifop(n)=0. + radfop(n)=0. + taufop(n)=0. + enddo + endif + !~~~~~~~~~~~~~~~ + + nptlb=nptl + do n=1,np + nptl=nptl+1 + if(nptl.gt.mxptl) + . call utstop('DropletDecay: mxptl too small&') + idptl(nptl)=ident(n) + do j=1,4 + p(j)=pcm(j,n) + enddo + p(5)=amass(n) + call utlob2(-1,c(1),c(2),c(3),c(4),c(5),p(1),p(2),p(3),p(4),10) + do j=1,5 + pptl(j,nptl)=p(j) + enddo + if(fradfli.lt.1.) then + ityptl(nptl)=60 + elseif(ityptl(ip).eq.40.or.ityptl(ip).eq.50)then + ityptl(nptl)=ityptl(ip)+1 + else + ityptl(nptl)=19 + endif + if(ityptl(ip).eq.60)then + if(ityptl(nptl).eq.60)then + ipo=iorptl(ip) + phi=phifop(n) + tau=taufop(n) + r=radfop(n) + !---add r-randomness + !dr=5 + !do while(dr.lt.-2.or.dr.gt.2.) + ! dr=sqrt(3.)*(rangen()+rangen()+rangen()+rangen()-2) + !enddo + !r=r+dr + !--------- + zeta=0.5*log((p(4)+p(3))/(p(4)-p(3))) + !deleta=etahy(2)-etahy(1) + !zeta=zetaor-0.5*delzet+delzet*rangen() + z=tau*sinh(zeta) + t=tau*cosh(zeta) + xorptl(1,nptl)=r*cos(phi+phinull) + xorptl(2,nptl)=r*sin(phi+phinull) + xorptl(3,nptl)=z + xorptl(4,nptl)=t + else + xorptl(1,nptl)=xorptl(1,ip) + xorptl(2,nptl)=xorptl(2,ip) + xorptl(3,nptl)=xorptl(3,ip) + xorptl(4,nptl)=xorptl(4,ip) + endif + endif + enddo + if(ish.ge.3)then + write(ifch,*)'decay products:' + call alist('&',nptlb+1,nptl) + if(ish.ge.5)then + write(ifch,*)'momentum sum:' + do kk=1,5 + pptl(kk,nptl+1)=0 + do ii=nptlb+1,nptl + pptl(kk,nptl+1)=pptl(kk,nptl+1)+pptl(kk,ii) + enddo + pptl(kk,nptl+2)=c(kk) + enddo + call alist('&',nptl+1,nptl+2) + endif + endif + + 1000 continue + call ManiParticles(-1,1) + call utprix('DropletDecay',ish,ishini,4) + end + +c-------------------------------------------------------------------- + subroutine ManiParticles(isens,isto) +c-------------------------------------------------------------------- + ! isens=1 -> store, isens=-1 -> restore, isens=9... -> redefine + !----------------------------------------------------------- + include 'epos.inc' + include 'epos.inchy' + parameter (mspez=54,msto=2) + common/cspez1/nspez,ispez(mspez),aspez(2,mspez),gspez(mspez) + common/cspez2/kspez,jspez(mspez) + common/cspez3/fuga(mspez) + common/cspez4/ffstat(2,0:mspez+2) + common/ctfo/tfo + common/sp1/ffstatSave(2,0:mspez+2,msto),fugaSave(mspez,msto) + common/sp2/iocludeSave(msto),kspezSave(msto),nspezSave(msto) + common/sp3/tfoSave(msto),meosmuSave(msto),epscri3Save(msto) + if(isens.eq.1)then !~~~~~~~~~~~~~~store~~~~~~~~~~~~~~ + iocludeSave(isto)=ioclude + kspezSave(isto)=kspez + nspezSave(isto)=nspez + if(kspez.gt.0)then + do m=kspez,nspez + ffstatSave(1,m,isto)=ffstat(1,m) + ffstatSave(2,m,isto)=ffstat(2,m) + fugaSave(m,isto)=fuga(m) + enddo + endif + do i=1,2 + do j=1,2 + ffstatSave(i,mspez+j,isto)=ffstat(i,mspez+j) + enddo + enddo + tfoSave(isto)=tfo + meosmuSave(isto)=meosmu + epscri3Save(isto)=epscri(3) + elseif(isens.eq.-1)then !~~~~~~~~~~~~~~restore~~~~~~~~~~~~~~ + ioclude=iocludeSave(isto) + kspez=kspezSave(isto) + nspez=nspezSave(isto) + if(kspez.gt.0)then + do m=kspez,nspez + ffstat(1,m)=ffstatSave(1,m,isto) + ffstat(2,m)=ffstatSave(2,m,isto) + fuga(m)=fugaSave(m,isto) + enddo + endif + do i=1,2 + do j=1,2 + ffstat(i,mspez+j)=ffstatSave(i,mspez+j,isto) + enddo + enddo + tfo=tfoSave(isto) + meosmu=meosmuSave(isto) + epscri(3)=epscri3Save(isto) + elseif(isens.eq.92)then !~~~~~~~~~~~~~~redefine set2~~~~~~~~~~~~~~ + !used for remnant and droplet decay --- may be modified!!! + ioclude=5 !choice of hadronization (4 or 5) + kspez=1 !choice of + nspez=54 ! particles + tfo=0.130 !freeze out temperature used in this routine + meosmu=0 !no chemical potentials used in this routine + epscri(3)=0.0765 !should be consitent with tfo see EoS table below + call DefineParticles + elseif(isens.eq.93)then !~~~~~~~~~~~~~~redefine set3~~~~~~~~~~~~~ + !used for application micro + kspez=1 !choice of + nspez=54 ! particles + tfo=0.130 !freeze out temperature used in this routine + meosmu=0 !no chemical potentials used in this routine + epscri(3)=0.0765 !should be consitent with tfo see EoS table below + call DefineParticles + endif + !--------------------------! + ! epscri(3) ! tfo ! + !--------------------------! + ! 0.045 ! 0.11954 ! + ! 0.050 ! 0.12157 ! + ! 0.055 ! 0.12327 ! + ! 0.060 ! 0.12496 ! + ! 0.065 ! 0.12665 ! + ! 0.070 ! 0.12801 ! + ! 0.075 ! 0.1297 ! + ! 0.080 ! 0.13072 ! + ! 0.085 ! 0.13207 ! + ! 0.090 ! 0.13343 ! + ! 0.095 ! 0.13444 ! + ! 0.100 ! 0.13546 ! + ! 0.105 ! 0.13648 ! + ! 0.110 ! 0.13749 ! + ! 0.115 ! 0.13851 ! + ! 0.120 ! 0.13952 ! + ! 0.125 ! 0.1402 ! + !--------------------------! + end + +c------------------------------------------------------------------------------ + subroutine xSpaceTime +c------------------------------------------------------------------------------ + include 'epos.inc' + if(iSpaceTime.eq.1.and.ioclude.gt.1)then + call xCoreCorona(0,0) + do m=0,4,2 + do meta=-m,m,max(1,2*m) + call xFoMass(meta) + call xFoRadius(meta) + call xFoRadVelocity(meta) + call xFoTanVelocity(meta) + enddo + enddo + do m=0,4,2 + do meta=-m,m,max(1,2*m) + call xFreezeOutTauX(meta) + enddo + enddo + call xFeff + !call xFreezeOutTauEta + !call xFreezeOutTZ + call xEos + elseif(iSpaceTime.eq.1)then + call xCoreCorona(0,0) + !stop'bjinta: space-time plots require ioclude>1. ' + endif + end + +c------------------------------------------------------------------------------ + subroutine xEos +c------------------------------------------------------------------------------ + include'epos.inc' + include'epos.inchy' + common/latt/temp(14),press(14),epsi(14) + call Lattice + + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i3)') '! eos 1 ' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a)') ' openhisto htyp lin xmod lin ymod lin ' + write(ifhi,'(a)') ' xrange 0. 3. yrange 0 auto' + write(ifhi,'(a)') ' txt "xaxis [e] (GeV/fm^3!)"' + write(ifhi,'(a)') ' txt "yaxis p([e]) (GeV/fm^3!)"' + write(ifhi,'(a)') ' array 2' + do m=1,meos + if(eos(1,m).le.3.)write(ifhi,'(2e11.3)')eos(1,m),eos(2,m) + enddo + write(ifhi,'(a)') ' endarray closehisto plot 0-' + write(ifhi,'(a)') ' openhisto htyp poc ' + write(ifhi,'(a)') ' array 2' + do m=2,13 + if(epsi(m).le.3.)write(ifhi,'(2e11.3)')epsi(m),press(m) + enddo + write(ifhi,'(a)') 'endarray closehisto plot 0' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i3)') '! eos 2 ' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a)') ' openhisto htyp lin xmod lin ymod lin ' + write(ifhi,'(a)') ' xrange 0. 3. yrange 0 auto' + write(ifhi,'(a)') ' txt "xaxis [e] (GeV/fm^3!)"' + write(ifhi,'(a)') ' txt "yaxis T([e]) (GeV)"' + write(ifhi,'(a)') ' array 2' + do m=1,meos + if(eos(1,m).le.3.)write(ifhi,'(2e11.3)')eos(1,m),eos(3,m) + enddo + write(ifhi,'(a)') ' endarray closehisto plot 0-' + write(ifhi,'(a)') ' openhisto htyp poc ' + write(ifhi,'(a)') ' array 2' + do m=2,13 + if(epsi(m).le.3.)write(ifhi,'(2e11.3)')epsi(m),temp(m) + enddo + write(ifhi,'(a)') 'endarray closehisto plot 0' + !write(ifhi,'(a)') '!##################################' + !write(ifhi,'(a,i3)') '! eosmu ' + !write(ifhi,'(a)') '!##################################' + !write(ifhi,'(a)') ' openhisto htyp lin xmod lin ymod lin ' + !write(ifhi,'(a)') ' xrange 0. 0.2 yrange 0 auto' + !write(ifhi,'(a)') ' txt "xaxis T (GeV)"' + !write(ifhi,'(a)') ' txt "yaxis [m]?[p]!(T) (GeV)"' + !write(ifhi,'(a)') ' array 2' + !do m=1,meosmu + ! if(eos(1,m).le.3.)write(ifhi,'(2e11.3)')eosmu(1,m),eosmu(2,m) + !enddo + !write(ifhi,'(a)') 'endarray closehisto plot 0' + end + +c------------------------------------------------------------------------------ + subroutine Lattice +c------------------------------------------------------------------------------ + parameter (hc=0.1973,Tc=0.170/hc) + common/latt/temp(14),press(14),epsi(14) + real t2tc(14),p2T4(14),e2T4(14) + ! T/Tc no units + data t2tc /0.80,0.87,0.96,1.02,1.07,1.14,1.20,1.28 + * ,1.35,1.52,1.70,1.90,2.24,2.55/ + ! p/T^4, no units + data p2T4 /0.05,0.15,0.39,0.60,0.86,1.12,1.40,1.66 + * ,1.91,2.32,2.65,2.89,3.19,3.41/ + do i=1,14 + temp(i)=t2tc(i)*Tc*hc ! in GeV + press(i)=p2T4(i)*(t2tc(i)*Tc)**4*hc ! in GeV/fm^3 + enddo + do i=2,13 + f1=p2T4(i-1)*(t2tc(i-1)*Tc)**4 + f2=p2T4(i )*(t2tc(i )*Tc)**4 + f3=p2T4(i+1)*(t2tc(i+1)*Tc)**4 + a=(t2tc(i )*Tc - t2tc(i-1)*Tc) + b=(t2tc(i+1)*Tc - t2tc(i )*Tc) + s=(f2-f1)/a*b/(a+b) + (f3-f2)/b*a/(a+b) + s2T3=s / (t2tc(i)*Tc)**3 + e2T4(i)= s2T3 - p2T4(i) + epsi(i)=e2T4(i)*(t2tc(i)*Tc)**4*hc ! in GeV/fm^3 + enddo + end + +c------------------------------------------------------------------------------ + subroutine xFreezeOutTauX(meta) +c------------------------------------------------------------------------------ + include 'epos.inc' + include 'epos.inchy' + common/cxyzt/xptl(mxptl),yptl(mxptl),zptl(mxptl),tptl(mxptl) + *,optl(mxptl),uptl(mxptl),sptl(mxptl),rptl(mxptl,3) + common/cen/ncentr /ctauhu/ntauhu(ncenthx,1-netahx:netahx-1) + !.......................................................................... + nhis=1 + npl=0 + nplx=0 + deleta=etahy(2)-etahy(1) + eta1=zetahy(meta)-deleta/2 + eta2=zetahy(meta)+deleta/2 + etaav=zetahy(meta) + taumax=tauhoc(ncentr,ntauhu(ncentr,meta))+4 + do n=1,nptl + if(ityptl(n).eq.60 + * .and.istptl(n).ne.12.and.istptl(n).ne.11)then + if(istptl(iorptl(n)).eq.11)then + tau=0 + tau2=xorptl(4,n)**2-xorptl(3,n)**2 + if(tau2.gt.0.)tau=sqrt(tau2) + if(tau.lt.taumax)then + rap= + * .5*alog((xorptl(4,n)+xorptl(3,n))/(xorptl(4,n)-xorptl(3,n))) + if(rap.ge.eta1.and.rap.le.eta2)then + if(abs(xorptl(2,n)).le.2)then + npl=npl+1 + nplx=nplx+1 + if(npl.eq.1)then + if(nplx.gt.1) + * write(ifhi,'(a)') ' endarray closehisto plot 0-' + write(ifhi,'(a)') '!-------------------------------' + write(ifhi,'(a)') '! tau-x ' + write(ifhi,'(a)') '!-------------------------------' + write(ifhi,'(a)') '!newpage' + write(ifhi,'(a,i1)') 'openhisto name t-r-0-',nhis + write(ifhi,'(a)') 'htyp prl xmod lin ymod lin' + write(ifhi,'(a)') 'xrange -10 10' + write(ifhi,'(a,f5.1)') 'yrange 0 ',taumax + write(ifhi,'(a)') 'txt "xaxis x (fm)"' + write(ifhi,'(a)') 'txt "yaxis [t] (fm/c)"' + write(ifhi,'(a,f4.1,a)')'text 0.35 0.90 "[c]=',etaav,'"' + write(ifhi,'(a)') 'text 0.02 0.9 """B#y"B#"L#2fm""' + write(ifhi,'(a,f4.1,a)')'text 0.65 0.9 "',centhy(ncentr),'fm"' + write(ifhi,'(a)') 'array 2' + endif + write(ifhi,'(2e11.3)')xorptl(1,n),tau + if(npl.eq.1000)then + nhis=nhis+1 + npl=0 + endif + endif + endif + endif + endif + endif + enddo + if(nplx.gt.0)write(ifhi,'(a)') ' endarray closehisto plot 0-' + !.......................................................................... + nhis=1 + npl=0 + nplx=0 + npli=20 + do n=1,nptl + if(dezptl(n).lt.1e3.and.n.le.maxfra + * .and.(istptl(n).eq.0.or.istptl(n).eq.1))then + rap=1e10 + xp=tptl(n)+zptl(n) + xm=tptl(n)-zptl(n) + if(xp.gt.0.0.and.xm.gt.0.0)rap=.5*alog(xp/xm) + if(rap.ge.-0.5.and.rap.le.0.5)then + if(abs(xorptl(2,n)).le.2)then + npl=npl+npli + nplx=nplx+1 + if(npl.eq.npli)then + if(nplx.gt.1) + * write(ifhi,'(a)') ' endarray closehisto plot 0-' + write(ifhi,'(a)') '!-------------------------------' + write(ifhi,'(a)') '! tau-x corona ' + write(ifhi,'(a)') '!-------------------------------' + write(ifhi,'(a,i1)') 'openhisto name t-r-0-cor-',nhis + write(ifhi,'(a)') 'htyp pgl ' + write(ifhi,'(a)') 'array 2' + endif + x=xorptl(1,n) + y=xorptl(2,n) + z=xorptl(3,n) + t=xorptl(4,n) + tau=0 + tau2=t**2-z**2 + if(tau2.gt.0.)tau=sqrt(tau2) + if(abs(y).le.2) + . write(ifhi,'(2e11.3)')x,tau + dt=0.1 + do k=1,npli-1 + x=x+pptl(1,n)/pptl(4,n)*dt + y=y+pptl(2,n)/pptl(4,n)*dt + z=z+pptl(3,n)/pptl(4,n)*dt + t=t+dt + tau=0 + tau2=t**2-z**2 + if(tau2.gt.0.)tau=sqrt(tau2) + if(abs(y).le.2) + . write(ifhi,'(2e11.3)')x,tau + enddo + if(npl.eq.1000)then + nhis=nhis+1 + npl=0 + endif + endif + endif + endif + enddo + write(ifhi,'(a)') ' endarray closehisto plot 0' + !.......................................................................... + end + +c------------------------------------------------------------------------------ + subroutine xFeff +c------------------------------------------------------------------------------ + include 'epos.inc' + include 'epos.inchy' + common/cen/ncentr + write(ifhi,'(a)') '!-------------------------------' + write(ifhi,'(a)') '! feff ' + write(ifhi,'(a)') '!-------------------------------' + write(ifhi,'(a)') '!newpage' + write(ifhi,'(a)') 'openhisto name feff' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'xrange -6 6' + write(ifhi,'(a)') 'yrange 0 1.2' + write(ifhi,'(a)') 'txt "xaxis [c] "' + write(ifhi,'(a)') 'txt "yaxis f?eff!"' + write(ifhi,'(a,f4.1,a)') 'text 0.65 0.9 "',centhy(ncentr),'fm"' + write(ifhi,'(a)') 'array 2' + do meta=-netahy+1,netahy-1 + neta=abs(meta)+1 + eta=etahy(neta) + if(meta.lt.0)eta=-eta + write(ifhi,'(2e11.3)') eta,feff(ncentr,meta) + enddo + write(ifhi,'(a)') ' endarray closehisto plot 0' + end + +c------------------------------------------------------------------------------ + subroutine xFreezeOutTauEta +c------------------------------------------------------------------------------ + include 'epos.inc' + include 'epos.inchy' + common/cxyzt/xptl(mxptl),yptl(mxptl),zptl(mxptl),tptl(mxptl) + *,optl(mxptl),uptl(mxptl),sptl(mxptl),rptl(mxptl,3) + common/cen/ncentr /ctauhu/ntauhu(ncenthx,1-netahx:netahx-1) + taumax=tauhoc(ncentr,ntauhu(ncentr,0))+4 + !.......................................................................... + nhis=1 + npl=0 + do n=1,nptl + if(ityptl(n).eq.60 + * .and.istptl(n).ne.12.and.istptl(n).ne.11)then + if(istptl(iorptl(n)).eq.11)then + tau=0 + tau2=xorptl(4,n)**2-xorptl(3,n)**2 + if(tau2.gt.0.)tau=sqrt(tau2) + if(tau.lt.taumax)then + npl=npl+1 + if(npl.eq.1)then + write(ifhi,'(a)') '!-------------------------------' + write(ifhi,'(a)') '! tau-eta ' + write(ifhi,'(a)') '!-------------------------------' + write(ifhi,'(a)') '!newpage' + write(ifhi,'(a,i1)') 'openhisto name t-eta-',nhis + write(ifhi,'(a)') 'htyp prl xmod lin ymod lin' + write(ifhi,'(a)') 'xrange -4 4' + write(ifhi,'(a,f5.1)') 'yrange 0 ',taumax + write(ifhi,'(a)') 'txt "xaxis [c] "' + write(ifhi,'(a)') 'txt "yaxis [t] (fm/c)"' + write(ifhi,'(a,f4.1,a)')'text 0.65 0.9 "',centhy(ncentr),'fm"' + write(ifhi,'(a)') 'array 2' + endif + eta= + * .5*alog((xorptl(4,n)+xorptl(3,n))/(xorptl(4,n)-xorptl(3,n))) + write(ifhi,'(2e11.3)') eta,tau + if(npl.eq.1000)then + write(ifhi,'(a)') ' endarray closehisto plot 0-' + nhis=nhis+1 + npl=0 + endif + endif + endif + endif + enddo + if(npl.ne.0)write(ifhi,'(a)') ' endarray closehisto plot 0' + if(npl.eq.0)stop'xFreezeOutTZ: no particles!!!!! ' + end + +c------------------------------------------------------------------------------ + subroutine xFreezeOutTZ +c------------------------------------------------------------------------------ + include 'epos.inc' + include 'epos.inchy' + common/cxyzt/xptl(mxptl),yptl(mxptl),zptl(mxptl),tptl(mxptl) + *,optl(mxptl),uptl(mxptl),sptl(mxptl),rptl(mxptl,3) + common/cen/ncentr + !.......................................................................... + nhis=1 + npl=0 + do n=1,nptl + if(ityptl(n).eq.60 + * .and.istptl(n).ne.12.and.istptl(n).ne.11)then + if(istptl(iorptl(n)).eq.11)then + npl=npl+1 + if(npl.eq.1)then + write(ifhi,'(a)') '!-------------------------------' + write(ifhi,'(a)') '! t-z ' + write(ifhi,'(a)') '!-------------------------------' + write(ifhi,'(a)') '!newpage' + write(ifhi,'(a,i1)') 'openhisto name t-z-',nhis + write(ifhi,'(a)') 'htyp prl xmod lin ymod lin' + write(ifhi,'(a)') 'xrange -25 25' + write(ifhi,'(a)') 'yrange 0 25 ' + write(ifhi,'(a)') 'txt "xaxis z (fm)"' + write(ifhi,'(a)') 'txt "yaxis t (fm/c)"' + write(ifhi,'(a,f4.1,a)')'text 0.70 0.22 "',centhy(ncentr),'fm"' + write(ifhi,'(a)') 'array 2' + endif + write(ifhi,'(2e11.3)') xorptl(3,n),xorptl(4,n) + if(npl.eq.1000)then + write(ifhi,'(a)') ' endarray closehisto plot 0-' + nhis=nhis+1 + npl=0 + endif + endif + endif + enddo + if(npl.ne.0)write(ifhi,'(a)') ' endarray closehisto plot 0' + if(npl.eq.0)stop'xFreezeOutTZ: no particles!!!!! ' + end + +c------------------------------------------------------------------------------ + subroutine xFoMass(meta) +c------------------------------------------------------------------------------ + include 'epos.inc' + include 'epos.inchy' + common/cen/ncentr /ctauhu/ntauhu(ncenthx,1-netahx:netahx-1) + taumax=tauhoc(ncentr,ntauhu(ncentr,meta))+2 +c netahyxx=netahy + write(ifhi,'(a)') '!----------------------------------------' + write(ifhi,'(a,i3)') '! hydro freeze out rate ' + write(ifhi,'(a)') '!----------------------------------------' + write(ifhi,'(a)') '!newpage' + do ii=1,3 + if(ii.eq.1)nphi=2 + if(ii.eq.2)nphi=1+nphihy/4 + if(ii.eq.3)nphi=1+nphihy/2 + write(ifhi,'(a,3i1)')'openhisto htyp lin name w-',meta,nphi,ii + if(ii.eq.1)then !---------------------- + write(ifhi,'(a,f4.1)')'xmod lin xrange 0. ',taumax + write(ifhi,'(a)') 'txt "xaxis [t] (fm/c)"' + write(ifhi,'(a)') 'ymod lin yrange auto auto ' + write(ifhi,'(a,f4.1,a)')'text 0.1 0.9 " [c]=',zetahy(meta),'"' + write(ifhi,'(a)')'txt "yaxis w "' + write(ifhi,'(a,f4.1,a)')'text 0.65 0.9 "',centhy(ncentr),'fm"' + endif !------------------------------- + write(ifhi,'(a)')'array 2' + deltau=tauhoc(ncentr,2)-tauhoc(ncentr,1) + do ntau=2,ntauhu(ncentr,meta) + dy=waa(ncentr,meta,ntau,nphi) + write(ifhi,'(2e13.5)')tauhoc(ncentr,ntau)-deltau/2,dy + enddo + write(ifhi,'(a)') 'endarray closehisto ' + if(ii.ne.3)write(ifhi,'(a)') 'plot 0-' + if(ii.eq.3)write(ifhi,'(a)') 'plot 0' + enddo + end + +c------------------------------------------------------------------------------ + subroutine xFoRadius(meta) +c------------------------------------------------------------------------------ + include 'epos.inc' + include 'epos.inchy' + common/cen/ncentr /ctauhu/ntauhu(ncenthx,1-netahx:netahx-1) + taumax=tauhoc(ncentr,ntauhu(ncentr,meta))+2 +c netahyxx=netahy + write(ifhi,'(a)') '!----------------------------------------' + write(ifhi,'(a,i3)') '! hydro freeze out radius ' + write(ifhi,'(a)') '!----------------------------------------' + write(ifhi,'(a)') '!newpage' + do ii=1,3 + if(ii.eq.1)nphi=2 + if(ii.eq.2)nphi=1+nphihy/4 + if(ii.eq.3)nphi=1+nphihy/2 + write(ifhi,'(a,3i1)')'openhisto htyp lin name r-',meta,nphi,ii + if(ii.eq.1)then !---------------------- + write(ifhi,'(a,f4.1)')'xmod lin xrange 0. ',taumax + write(ifhi,'(a)')'txt "xaxis [t] (fm/c)"' + write(ifhi,'(a)') 'ymod lin yrange auto auto ' + write(ifhi,'(a,f4.1,a)')'text 0.1 0.9 " [c]=',zetahy(meta),'"' + write(ifhi,'(a)')'txt "yaxis r (fm) "' + write(ifhi,'(a,f4.1,a)')'text 0.65 0.9 "',centhy(ncentr),'fm"' + endif !------------------------------- + write(ifhi,'(a)')'array 2' + do ntau=2,ntauhu(ncentr,meta) + write(ifhi,'(2e13.5)')tauhoc(ncentr,ntau) + . ,raa(ncentr,meta,ntau,nphi) + enddo + write(ifhi,'(a)') 'endarray closehisto ' + if(ii.ne.3)write(ifhi,'(a)') 'plot 0-' + if(ii.eq.3)write(ifhi,'(a)') 'plot 0' + enddo + end + +c------------------------------------------------------------------------------ + subroutine xFoRadVelocity(meta) +c------------------------------------------------------------------------------ + include 'epos.inc' + include 'epos.inchy' + common/cen/ncentr /ctauhu/ntauhu(ncenthx,1-netahx:netahx-1) + taumax=tauhoc(ncentr,ntauhu(ncentr,meta))+2 +c netahyxx=netahy + write(ifhi,'(a)') '!----------------------------------------' + write(ifhi,'(a,i3)') '! hydro freeze out rad velocity ' + write(ifhi,'(a)') '!----------------------------------------' + write(ifhi,'(a)') '!newpage' + do ii=1,3 + if(ii.eq.1)nphi=2 + if(ii.eq.2)nphi=1+nphihy/4 + if(ii.eq.3)nphi=1+nphihy/2 + write(ifhi,'(a,3i1)')'openhisto htyp lin name y-',meta,nphi,ii + if(ii.eq.1)then !---------------------- + write(ifhi,'(a,f4.1)')'xmod lin xrange 0. ',taumax + write(ifhi,'(a)')'txt "xaxis [t] (fm/c)"' + write(ifhi,'(a)') 'ymod lin yrange auto auto ' + write(ifhi,'(a,f4.1,a)')'text 0.1 0.9 " [c]=',zetahy(meta),'"' + write(ifhi,'(a)')'txt "yaxis v?rad! "' + write(ifhi,'(a,f4.1,a)')'text 0.65 0.9 "',centhy(ncentr),'fm"' + endif !------------------------------- + write(ifhi,'(a)')'array 2' + do ntau=2,ntauhu(ncentr,meta) + write(ifhi,'(2e13.5)')tauhoc(ncentr,ntau) + . ,vaa(1,ncentr,meta,ntau,nphi) + enddo + write(ifhi,'(a)') 'endarray closehisto ' + if(ii.ne.3)write(ifhi,'(a)') 'plot 0-' + if(ii.eq.3)write(ifhi,'(a)') 'plot 0' + enddo + end +c------------------------------------------------------------------------------ + subroutine xFoTanVelocity(meta) +c------------------------------------------------------------------------------ + include 'epos.inc' + include 'epos.inchy' + common/cen/ncentr /ctauhu/ntauhu(ncenthx,1-netahx:netahx-1) + taumax=tauhoc(ncentr,ntauhu(ncentr,meta))+2 +c netahyxx=netahy + write(ifhi,'(a)') '!----------------------------------------' + write(ifhi,'(a,i3)') '! hydro freeze out tang velocity ' + write(ifhi,'(a)') '!----------------------------------------' + write(ifhi,'(a)') '!newpage' + do ii=1,4 + if(ii.eq.1)nphi=2 + if(ii.eq.2)nphi=1+nphihy/8 + if(ii.eq.3)nphi=1+nphihy/8*3 + if(ii.eq.4)nphi=1+nphihy/2 + write(ifhi,'(a,3i1)')'openhisto htyp lin name y-',meta,nphi,ii + if(ii.eq.1)then !---------------------- + write(ifhi,'(a,f4.1)')'xmod lin xrange 0. ',taumax + write(ifhi,'(a)')'txt "xaxis [t] (fm/c)"' + write(ifhi,'(a)') 'ymod lin yrange auto auto ' + write(ifhi,'(a,f4.1,a)')'text 0.1 0.9 " [c]=',zetahy(meta),'"' + write(ifhi,'(a)')'txt "yaxis v?tan! "' + write(ifhi,'(a,f4.1,a)')'text 0.65 0.9 "',centhy(ncentr),'fm"' + endif !------------------------------- + write(ifhi,'(a)')'array 2' + do ntau=2,ntauhu(ncentr,meta) + write(ifhi,'(2e13.5)')tauhoc(ncentr,ntau) + . ,vaa(2,ncentr,meta,ntau,nphi) + enddo + write(ifhi,'(a)') 'endarray closehisto ' + if(ii.ne.4)write(ifhi,'(a)') 'plot 0-' + if(ii.eq.4)write(ifhi,'(a)') 'plot 0' + enddo + end + +c----------------------------------------------------------------------- + subroutine xCoreCorona(iii,jjj) +c----------------------------------------------------------------------- +c space-time evolution of core and corona +c +c cluster ............ ist=11 ity=60 +c core particles ..... ist=0 ity=60 +c corona particles ... ist=0 ity/=60 +c +c iii=1: plot also binary collisions +c jjj>0: multiplicity trigger (useful for pp) +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.inchy' + common/cen/ncentr + common/cxyzt/xptl(mxptl),yptl(mxptl),zptl(mxptl),tptl(mxptl) + *,optl(mxptl),uptl(mxptl),sptl(mxptl),rptl(mxptl,3) + common/cdelzet/delzet,delsgr + parameter (myy=48,mrr=100) + real yy(myy),rr(mrr) + common/cranphi/ranphi + + phinll=phievt+ranphi + phi= phievt+ranphi + !print*,' EventPhi=',phievt,' RandomPhi=',ranphi + rapmax=6 + radmax=10 + r1=0.0 + if(maproj.gt.1)r1=radnuc(maproj) + r2=0.0 + if(matarg.gt.1)r2=radnuc(matarg) + if(maproj.eq.1.and.matarg.gt.1)r1=r2 + if(maproj.gt.1.and.matarg.eq.1)r2=r1 + a=7.8 + b=bimevt/2 +c n1=koievt + n2=0 + do k=1,koll + if(itpr(k).gt.0)n2=n2+1 + enddo +c n3=nglevt + + if(jjj.gt.0)then + multy1=0 + do i=maproj+matarg+1,nptl + if(istptl(i).eq.0)then + amt=pptl(5,i)**2+pptl(1,i)**2+pptl(2,i)**2 + rap=1000 + if(amt.gt.0..and.pptl(4,i).gt.0.)then + amt=sqrt(amt) + rap=sign(1.,pptl(3,i))*alog((pptl(4,i)+abs(pptl(3,i)))/amt) + endif + ch=0 + if(abs(idptl(i)).ge.100.and.abs(idptl(i)).lt.10000)then + call idchrg(idptl(i),ch) + if(abs(ch).gt.0.1.and.abs(rap).le.1.)multy1=multy1+1 + endif + endif + enddo + ih1=jjj/100 + ih2=mod(jjj,100) + if(0.5*multy1.lt.ih1.or.0.5*multy1.gt.ih2)return + endif + xmax=1+int(a*1.5) + + write(ifhi,'(a)') '!---------------------------------' + write(ifhi,'(a)') '! core particles ' + write(ifhi,'(a)') '!---------------------------------' + write(ifhi,'(a)') '!newpage' + write(ifhi,'(a)') 'openhisto name st1' + write(ifhi,'(a)') 'htyp prv xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-xmax,xmax + write(ifhi,'(a,2e11.3)')'yrange',-a,a + write(ifhi,'(a)') 'text 0.85 -0.25 " x (fm)"' + write(ifhi,'(a)') 'txt "yaxis y (fm)"' + write(ifhi,'(a)') 'text 0.05 0.90 "core"' + write(ifhi,'(a)') 'text 0.05 0.80 "corona"' + write(ifhi,'(a,f4.1,a)')'text 0.82 0.07 "[c]=0"' + write(ifhi,'(a,f4.1,a)')'text 0.65 0.9 "',centhy(ncentr),'fm"' + write(ifhi,'(a)') 'array 2' + ncore=0 + do i=1,nptl + if(abs(sptl(i)).lt.0.5*delsgr.and.istptl(i).eq.2)then + write(ifhi,'(2e11.3)')xptl(i)*cos(phi)+yptl(i)*sin(phi) + . , -xptl(i)*sin(phi)+yptl(i)*cos(phi) + ncore=ncore+1 + endif + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a)') '! corona particles ' + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a)') 'openhisto name st2' + write(ifhi,'(a)') 'htyp pgv xmod lin ymod lin' + write(ifhi,'(a)') 'array 2' + ncorona=0 + do i=1,nptl + if(abs(sptl(i)).lt.0.5*delsgr.and.istptl(i).eq.0 + . .and.ityptl(i).ne.60.and.ityptl(i).ne.19)then + write(ifhi,'(2e11.3)')xptl(i)*cos(phi)+yptl(i)*sin(phi) + . , -xptl(i)*sin(phi)+yptl(i)*cos(phi) + ncorona=ncorona+1 + endif + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + !print*,'b=',bimevt,' ncorona:ncore = ',ncorona,':',ncore + if(iii.eq.1)then + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a)') '! binary collisions ' + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a)') 'plot 0-' + write(ifhi,'(a)') 'openhisto name coo' + write(ifhi,'(a)') 'htyp pbl xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-xmax,xmax + write(ifhi,'(a,2e11.3)')'yrange',-a,a + write(ifhi,'(a)') 'array 2' + do k=1,koll + if(itpr(k).gt.0)then + write(ifhi,'(2e11.3)')coord(1,k)*cos(phi)+coord(2,k)*sin(phi) + * , -coord(1,k)*sin(phi)+coord(2,k)*cos(phi) + endif + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + endif + if(r1.ne.0.0)then + write(ifhi,'(a)') 'plot 0-' + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a)') '! hard spheres ' + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a)') 'openhisto name stc1 htyp lyu' + write(ifhi,'(a)') 'array 2' + do j=-50,50 + phi=j/50.*pi*0.55 + write(ifhi,'(2e11.3)')r1*cos(phi)-b,r1*sin(phi) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + endif + if(r2.ne.0.0)then + write(ifhi,'(a)') 'plot 0-' + write(ifhi,'(a)') 'openhisto name stc1 htyp lyu' + write(ifhi,'(a)') 'array 2' + do j=-50,50 + phi=j/50.*pi*0.55 + write(ifhi,'(2e11.3)')-r1*cos(phi)+b,r1*sin(phi) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + endif + + write(ifhi,'(a)') 'plot 0' + + !........................................................................................ + if(ioclude.le.1)return + !........................................................................................ + delrap=2*rapmax/float(myy) + do m=1,myy + yy(m)=0 + enddo + do n=1,nptl + if(dezptl(n).lt.1e3.and.n.le.maxfra.and.istptl(n).eq.2)then + routp=-sin(phinll)*xptl(n)+cos(phinll)*yptl(n) + rinp = cos(phinll)*xptl(n)+sin(phinll)*yptl(n) + if(abs(rinp).le.1.and.abs(routp).le.1.)then + rapx=dezptl(n) + eco=0 + amt=pptl(5,n)**2+pptl(1,n)**2+pptl(2,n)**2 + if(amt.gt.0..and.pptl(4,n)+abs(pptl(3,n)).gt.0.d0)then + amt=sqrt(amt) + rap=sign(1.,pptl(3,n))*alog((pptl(4,n)+abs(pptl(3,n)))/amt) + eco=amt*cosh(rap-rapx) + endif + m=(rapx+rapmax)/delrap+1 + if(m.gt.myy)m=myy + yy(m)=yy(m)+eco + endif + endif + enddo + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! core segment energy per d[c]dxdy ' + write(ifhi,'(a)')'! vs space-time rapidity rapx ' + write(ifhi,'(a)')'! (same as histogram rapx eco... in optns) ' + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)') '!newpage' + write(ifhi,'(a)') 'openhisto name rapx' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a,2f7.3)') 'xrange ',-rapmax,rapmax + write(ifhi,'(a)') 'yrange 0 auto ' + write(ifhi,'(a)') 'txt "title initial energy "' + write(ifhi,'(a,f4.1,a)')'text 0.05 0.70 "x=0"' + write(ifhi,'(a,f4.1,a)')'text 0.05 0.60 "y=0"' + write(ifhi,'(a,f4.1,a)')'text 0.65 0.9 "',centhy(ncentr),'fm"' + write(ifhi,'(a)') 'txt "xaxis space-time rapidity [c] "' + write(ifhi,'(a)') 'txt "yaxis dE/d[c]dxdy "' + write(ifhi,'(a)') 'array 2' + do m=1,myy + write(ifhi,'(2e11.3)')-rapmax+(m-0.5)*delrap, yy(m)/4./delrap + enddo + write(ifhi,'(a)') ' endarray closehisto plot 0-' + !........................................................................................ + delrap=2*rapmax/float(myy) + do m=1,myy + yy(m)=0 + enddo + do n=1,nptl + if(dezptl(n).lt.1e3.and.n.le.maxfra.and.istptl(n)/2.eq.0)then + routp=-sin(phinll)*xptl(n)+cos(phinll)*yptl(n) + rinp = cos(phinll)*xptl(n)+sin(phinll)*yptl(n) + if(abs(rinp).le.1.and.abs(routp).le.1.)then + rapx=dezptl(n) + eco=0 + amt=pptl(5,n)**2+pptl(1,n)**2+pptl(2,n)**2 + if(amt.gt.0..and.pptl(4,n)+abs(pptl(3,n)).gt.0.d0)then + amt=sqrt(amt) + rap=sign(1.,pptl(3,n))*alog((pptl(4,n)+abs(pptl(3,n)))/amt) + eco=amt*cosh(rap-rapx) + endif + m=(rapx+rapmax)/delrap+1 + if(m.ge.1.and.m.le.myy)yy(m)=yy(m)+eco + endif + endif + enddo + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! corona segment energy per d[c]dxdy ' + write(ifhi,'(a)')'! vs space-time rapidity rapx ' + write(ifhi,'(a)')'! (same as histogram rapx eco... in optns) ' + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)') 'openhisto name rapx' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a,2f7.3)') 'xrange ',-rapmax,rapmax + write(ifhi,'(a)') 'yrange 0 auto ' + write(ifhi,'(a)') 'txt "title initial energy "' + write(ifhi,'(a)') 'txt "xaxis space-time rapidity [c] "' + write(ifhi,'(a)') 'txt "yaxis dE/d[c]dxdy "' + write(ifhi,'(a)') 'array 2' + do m=1,myy + write(ifhi,'(2e11.3)')-rapmax+(m-0.5)*delrap, yy(m)/4./delrap + enddo + write(ifhi,'(a)') ' endarray closehisto plot 0-' + call xEiniEta(1) + write(ifhi,'(a)') 'plot 0' + !........................................................................................ + delrad=2*radmax/float(mrr) + do m=1,mrr + rr(m)=0 + enddo + do n=1,nptl + if(dezptl(n).lt.1e3.and.n.le.maxfra.and.istptl(n).eq.2)then + routp=-sin(phinll)*xptl(n)+cos(phinll)*yptl(n) + rinp = cos(phinll)*xptl(n)+sin(phinll)*yptl(n) + rapx=dezptl(n) + if(abs(rapx).le.1.and.abs(routp).le.1.)then + eco=0 + amt=pptl(5,n)**2+pptl(1,n)**2+pptl(2,n)**2 + if(amt.gt.0..and.pptl(4,n)+abs(pptl(3,n)).gt.0.d0)then + amt=sqrt(amt) + rap=sign(1.,pptl(3,n))*alog((pptl(4,n)+abs(pptl(3,n)))/amt) + eco=amt*cosh(rap-rapx) + endif + m=(rinp+radmax)/delrad+1 + if(m.gt.mrr)m=mrr + rr(m)=rr(m)+eco + endif + endif + enddo + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! core segment energy per d[c]dxdy vs x ' + write(ifhi,'(a)')'! (same as histogram rinp eco... in optns) ' + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)') '!newpage' + write(ifhi,'(a)') 'openhisto name rapx' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a,2f7.3)') 'xrange ',-radmax,radmax + write(ifhi,'(a)') 'yrange 0 auto ' + write(ifhi,'(a)') 'txt "title initial energy "' + write(ifhi,'(a,f4.1,a)')'text 0.05 0.70 "[c]=0"' + write(ifhi,'(a,f4.1,a)')'text 0.05 0.60 "y=0"' + write(ifhi,'(a,f4.1,a)')'text 0.65 0.9 "',centhy(ncentr),'fm"' + write(ifhi,'(a)') 'txt "xaxis x (fm)"' + write(ifhi,'(a)') 'txt "yaxis dE/d[c]dxdy "' + write(ifhi,'(a)') 'array 2' + do m=1,mrr + write(ifhi,'(2e11.3)')-radmax+(m-0.5)*delrad, rr(m)/4./delrad + enddo + write(ifhi,'(a)') ' endarray closehisto plot 0-' + !........................................................................................ + delrad=2*radmax/float(mrr) + do m=1,mrr + rr(m)=0 + enddo + do n=1,nptl + if(dezptl(n).lt.1e3.and.n.le.maxfra.and.istptl(n)/2.eq.0)then + routp=-sin(phinll)*xptl(n)+cos(phinll)*yptl(n) + rinp = cos(phinll)*xptl(n)+sin(phinll)*yptl(n) + rapx=dezptl(n) + if(abs(rapx).le.1.and.abs(routp).le.1.)then + eco=0 + amt=pptl(5,n)**2+pptl(1,n)**2+pptl(2,n)**2 + if(amt.gt.0..and.pptl(4,n)+abs(pptl(3,n)).gt.0.d0)then + amt=sqrt(amt) + rap=sign(1.,pptl(3,n))*alog((pptl(4,n)+abs(pptl(3,n)))/amt) + eco=amt*cosh(rap-rapx) + endif + m=(rinp+radmax)/delrad+1 + if(m.gt.mrr)m=mrr + rr(m)=rr(m)+eco + endif + endif + enddo + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! corona segment energy per d[c]dxdy vs x ' + write(ifhi,'(a)')'! (same as histogram rinp eco... in optns) ' + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)') 'openhisto name rapx' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'array 2' + do m=1,mrr + write(ifhi,'(2e11.3)')-radmax+(m-0.5)*delrad, rr(m)/4./delrad + enddo + write(ifhi,'(a)') ' endarray closehisto plot 0-' + call xEiniX(1) + write(ifhi,'(a)') 'plot 0' + !........................................................................................ + delrad=2*radmax/float(mrr) + do m=1,mrr + rr(m)=0 + enddo + do n=1,nptl + if(dezptl(n).lt.1e3.and.n.le.maxfra.and.istptl(n).eq.2)then + routp=-sin(phinll)*xptl(n)+cos(phinll)*yptl(n) + rinp = cos(phinll)*xptl(n)+sin(phinll)*yptl(n) + rapx=dezptl(n) + if(abs(rapx).le.1.and.abs(rinp).le.1.)then + eco=0 + amt=pptl(5,n)**2+pptl(1,n)**2+pptl(2,n)**2 + if(amt.gt.0..and.pptl(4,n)+abs(pptl(3,n)).gt.0.d0)then + amt=sqrt(amt) + rap=sign(1.,pptl(3,n))*alog((pptl(4,n)+abs(pptl(3,n)))/amt) + eco=amt*cosh(rap-rapx) + endif + m=(routp+radmax)/delrad+1 + if(m.gt.mrr)m=mrr + rr(m)=rr(m)+eco + endif + endif + enddo + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! core segment energy per d[c]dxdy vs y ' + write(ifhi,'(a)')'! (same as histogram routp eco... in optns) ' + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)') '!newpage' + write(ifhi,'(a)') 'openhisto name rout' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a,2f7.3)') 'xrange ',-radmax,radmax + write(ifhi,'(a)') 'yrange 0 auto ' + write(ifhi,'(a)') 'txt "title initial energy "' + write(ifhi,'(a,f4.1,a)')'text 0.05 0.70 "[c]=0"' + write(ifhi,'(a,f4.1,a)')'text 0.05 0.60 "x=0"' + write(ifhi,'(a,f4.1,a)')'text 0.65 0.9 "',centhy(ncentr),'fm"' + write(ifhi,'(a)') 'txt "xaxis y (fm)"' + write(ifhi,'(a)') 'txt "yaxis dE/d[c]dxdy "' + write(ifhi,'(a)') 'array 2' + do m=1,mrr + write(ifhi,'(2e11.3)')-radmax+(m-0.5)*delrad, rr(m)/4./delrad + enddo + write(ifhi,'(a)') ' endarray closehisto plot 0-' + !........................................................................................ + delrad=2*radmax/float(mrr) + do m=1,mrr + rr(m)=0 + enddo + do n=1,nptl + if(dezptl(n).lt.1e3.and.n.le.maxfra.and.istptl(n)/2.eq.0)then + routp=-sin(phinll)*xptl(n)+cos(phinll)*yptl(n) + rinp = cos(phinll)*xptl(n)+sin(phinll)*yptl(n) + rapx=dezptl(n) + if(abs(rapx).le.1.and.abs(rinp).le.1.)then + eco=0 + amt=pptl(5,n)**2+pptl(1,n)**2+pptl(2,n)**2 + if(amt.gt.0..and.pptl(4,n)+abs(pptl(3,n)).gt.0.d0)then + amt=sqrt(amt) + rap=sign(1.,pptl(3,n))*alog((pptl(4,n)+abs(pptl(3,n)))/amt) + eco=amt*cosh(rap-rapx) + endif + m=(routp+radmax)/delrad+1 + if(m.gt.mrr)m=mrr + rr(m)=rr(m)+eco + endif + endif + enddo + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! corona segment energy per d[c]dxdy vs y ' + write(ifhi,'(a)')'! (same as histogram routp eco... in optns) ' + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)') 'openhisto name rout' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'array 2' + do m=1,mrr + write(ifhi,'(2e11.3)')-radmax+(m-0.5)*delrad, rr(m)/4./delrad + enddo + write(ifhi,'(a)') ' endarray closehisto plot 0-' + call xEiniY(1) + write(ifhi,'(a)') 'plot 0' + + end + +c------------------------------------------------------------------------------ + subroutine xEini(ii) +c------------------------------------------------------------------------------ + include 'epos.inc' + include 'epos.inchy' + common/cen/ncentr + + entry xEiniX(ii) + write(ifhi,'(a)') '!----------------------------------------' + write(ifhi,'(a,i3)') '! hydro initial energy vs x ' + write(ifhi,'(a)') '!----------------------------------------' + write(ifhi,'(a)')'openhisto array 2' + do nr=nradhy,2,-1 + write(ifhi,'(2e13.5)') + . -radhy(nr),epsii(ncentr,ii,1,nr)*tauhoc(ncentr,1) + enddo + do nr=1,nradhy + write(ifhi,'(2e13.5)') + . radhy(nr),epsii(ncentr,ii,1,nr)*tauhoc(ncentr,1) + enddo + write(ifhi,'(a)') 'endarray closehisto ' + return + + entry xEiniY(ii) + write(ifhi,'(a)') '!----------------------------------------' + write(ifhi,'(a,i3)') '! hydro initial energy vs y ' + write(ifhi,'(a)') '!----------------------------------------' + write(ifhi,'(a)')'openhisto array 2' + do nr=nradhy,2,-1 + write(ifhi,'(2e13.5)') + . -radhy(nr),epsii(ncentr,ii,nphihy,nr)*tauhoc(ncentr,1) + enddo + do nr=1,nradhy + write(ifhi,'(2e13.5)') + . radhy(nr),epsii(ncentr,ii,nphihy,nr)*tauhoc(ncentr,1) + enddo + write(ifhi,'(a)') 'endarray closehisto ' + return + + entry xEiniEta(ii) + write(ifhi,'(a)') '!----------------------------------------' + write(ifhi,'(a,i3)') '! hydro initial energy vs y ' + write(ifhi,'(a)') '!----------------------------------------' + write(ifhi,'(a)')'openhisto array 2' + do neta=netahy,2,-1 + write(ifhi,'(2e13.5)') + . -etahy(neta),epsii(ncentr,neta,1,1)*tauhoc(ncentr,1) + enddo + do neta=1,netahy + write(ifhi,'(2e13.5)') + . etahy(neta),epsii(ncentr,neta,1,1)*tauhoc(ncentr,1) + enddo + write(ifhi,'(a)') 'endarray closehisto ' + return + + end + +c----------------------------------------------------------------------------- + integer function idxHiranoTable(id) +c----------------------------------------------------------------------------- + ida=abs(id) + ihi=0 + if(ida.eq.120.or.id.eq.110) ihi=2 !pion + if(id.eq.220) ihi=3 !eta + if(ida.eq.121.or.id.eq.111) ihi=4 !rho + if(id.eq.221) ihi=5 !omega + !if(id.eq.) ihi=6 !sigma + if(id.eq.330) ihi=7 !eta prime + !if(id.eq.) ihi=8 !f_0 + !if(id.eq.) ihi=9 !a_0 + if(id.eq.331) ihi=10 !phi + !if(id.eq.) ihi=11 !h_1 + if(ida.eq.130.or.ida.eq.230) ihi=12 !K + if(ida.eq.131.or.ida.eq.231) ihi=13 !K star + if(ida.eq.1120.or.ida.eq.1220)ihi=14 !N + if(ida.eq.1111.or.ida.eq.1121)ihi=15 !Delta + if(ida.eq.1221.or.ida.eq.2221)ihi=15 !Delta + if(ida.eq.2130) ihi=16 !Lambda + if(ida.eq.1130.or.ida.eq.1230)ihi=17 !Sigma + if(ida.eq.2230) ihi=17 !Sigma + idxHiranoTable=ihi + end + +c---------------------------------------------------------------------- + subroutine InitializeHyperbola +c---------------------------------------------------------------------- + include 'epos.inc' + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat + common /cttaus/ tpro,zpro,ttar,ztar,ttaus,detap,detat + ttaus=1 + ypjtl=6 + yhaha=3 + etapro=(ypjtl-yhaha)*etafac + etatar=-yhaha*etafac + detap=dble(etapro) + detat=dble(etatar) + tpro=dcosh(detap) + zpro=dsinh(detap) + ttar=dcosh(detat) + ztar=dsinh(detat) + end + +c---------------------------------------------------------------------- + integer function idGet() +c---------------------------------------------------------------------- + include 'epos.inc' + integer jc(nflav,2),ic(2) + if(ish.ge.5)write(ifch,'(a/6i4)') + *' keu ked kes kec keb ket:',keu,ked,kes,kec,keb,ket + do i=1,6 + jc(i,1)=0 + jc(i,2)=0 + enddo + if(keu.ge.0)jc(1,1)=keu + if(ked.ge.0)jc(2,1)=ked + if(kes.ge.0)jc(3,1)=kes + if(kec.ge.0)jc(4,1)=kec + if(keb.ge.0)jc(5,1)=keb + if(ket.ge.0)jc(6,1)=ket + if(keu.lt.0)jc(1,2)=-keu + if(ked.lt.0)jc(2,2)=-ked + if(kes.lt.0)jc(3,2)=-kes + if(kec.lt.0)jc(4,2)=-kec + if(keb.lt.0)jc(5,2)=-keb + if(ket.lt.0)jc(6,2)=-ket + if(ish.ge.5)write(ifch,'(a/6i4/6i4)')' jc:',jc + idr=0 + do nf=1,nflav + do ij=1,2 + if(jc(nf,ij).ge.10)idr=7*10**8 + enddo + enddo + if(idr/10**8.ne.7)then + call idenco(jc,ic,ireten) + if(ic(1).eq.0.and.ic(2).eq.0)then + ic(1)=100000 + ic(2)=100000 + endif + + idr=8*10**8+ic(1)*100+ic(2)/100 + if(ish.ge.5)write(ifch,'(a,i9)')' id:',idr + else + idr=idr + * +mod(jc(1,1)+jc(2,1)+jc(3,1)+jc(4,1),10**4)*10**4 + * +mod(jc(1,2)+jc(2,2)+jc(3,2)+jc(4,2),10**4) + call idtrbi(jc,ibptl(1,1),ibptl(2,1),ibptl(3,1),ibptl(4,1)) + endif + idGet=idr + end + diff --git a/modules/epos/epos-ems-lhc.f b/modules/epos/epos-ems-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..51faa2370709b199ee5578dc3d473484e1f259ce --- /dev/null +++ b/modules/epos/epos-ems-lhc.f @@ -0,0 +1,12556 @@ +c----------------------------------------------------------------------- + subroutine emsaa(iret) +c----------------------------------------------------------------------- +c energy-momentum sharing +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + common/cwzero/wzero,wzerox + double precision omega,omlog,oma,omb,wab,wba,wmatrix,wzero,nbar + *,wzerox,rrr,eps,xprem,xmrem,om1intgck + parameter(eps=1.d-30) + common/col3/ncol,kolpt +c logical modu + common/cems5/plc,s + double precision s,px,py,pomass,plc!,PhiExpo + common/ems6/ivp0,iap0,idp0,isp0,ivt0,iat0,idt0,ist0 + common/emsptl/nppr(npommx,kollmx),npproj(mamx),nptarg(mamx) + common/nucl3/phi,bimp + common/epoquasi/iquasi + logical vpom,difint + dimension ishuff(2*mamx,2),icp(2),ict(2),jcp(nflav,2),jct(nflav,2) + & ,nishuff(2) + call utpri('emsaa ',ish,ishini,4) + + irea=iret + + do j=1,2 + do i=1,nflav + jcp(i,j)=0 + jct(i,j)=0 + enddo + enddo + + iret=0 + iret2=0 + +c initialize +c ---------- + + call emsipt !initialize projectile and target + call emsigr !initialize grid + + + +c Metropolis + + if(iokoll.ne.1)then + + nSprmx=0 + do k=1,koll + nSprmx=nSprmx+nprmx(k) + enddo + + omlog=0 + nemsi=nemsi+1 + if(nemsi.le.4.and.iemsi1.eq.1)call xEmsI1(1,0,omlog) + if(ish.ge.6)write (ifch,*)'after xEmsI1' + if(nemsi.le.4.and.iemsi2.eq.1)call xEmsI2(1,0) + if(ish.ge.6)write (ifch,*)'after xEmsI2' + if(ish.ge.6)call XPrint('Before Markov:&') + + +c Markov +c ------ + + if(ish.ge.4)write(ifch,*)'Markov Process' + kint=int(max(15.,2.*engy**0.2)) + if(koll.gt.50)kint=3*kint/int(log(float(koll))) + kmcmx=nSprmx*kint !50*kint !100*kint + + + do kmc=1,kmcmx !-----> start Metropolis + + knprmx=0 + rrr=dble(rangen()) + do ik=1,koll + knprmx=knprmx+nprmx(ik) + if(rrr.le.dble(knprmx)/dble(nSprmx))then ! k-th pair + k=ik + goto 10 + endif + enddo + 10 continue + + ip=iproj(k) + it=itarg(k) + n=1+int(rangen()*float(nprmx(k))) ! n-th spot for k-th pair + nbar=dble(npr(0,k)) + if(idpr(n,k).eq.0)nbar=nbar-1d0 + + xprem=1.d0!xpp(ip)+xppr(n,k) !consistently, it should be 1. + xmrem=1.d0!xmt(it)+xmpr(n,k) + wzerox=(nbar+1d0) + wzero=wzerox / ( wzerox + & +om1intgck(k,xprem,xmrem)*gammaV(k) ) + + if(ish.ge.8)write(ifch,*)'wzero',k,n,wzero,wzerox,gammaV(k) + & ,om1intgck(k,xprem,xmrem) + if(ish.ge.1.and.100000*(kmc/100000).eq.kmc) + & write(ifmt,*)'kmc',kmc,kmcmx + + call StoCon(1,k,n) + call RemPom(k,n) + call ProPo(k,n) + call ProXY(k,n) + + call StoCon(2,k,n) + + if(idpr(n,k).eq.0.and.idx0.eq.0)then + accept=accept+1. + else + + omb=omega(n,k) + if(omb.le.0.d0)then + reject=reject+1. + call RemPom(k,n) + call StoCon(-1,k,n) + else + + wab=wmatrix(k,n) + if(ish.ge.8)write(ifch,*)'omb',omb,wab,k,n + if(wab.le.0.d0)then + write (ifmt,*)'wab,kmc',wab,omb,kmc,k,n,xpr(n,k),ypr(n,k) + & ,xppr(n,k),xmpr(n,k),xpp(ip),xmt(it),ip,it,idpr(n,k) + write(ifmt,'(a,i12,d25.15)')'ems,seedf',nrevt+1,seedc + iret=1 + goto 1000 + endif + call RemPom(k,n) + call StoCon(-1,k,n) + oma=omega(n,k) + wba=wmatrix(k,n) + if(oma.ge.0.d0.and.oma.le.eps*omb*wba/wab)then + accept=accept+1. + call RemPom(k,n) + call StoCon(-2,k,n) + omlog=omlog+dlog(omb) + goto 500 + elseif(oma.le.1.d-300.or.oma.ne.oma.or.omb.ne.omb)then + write (ifmt,*)'oma,kmc',oma,omb,kmc,k,n,xpr(n,k),ypr(n,k) + & ,xppr(n,k),xmpr(n,k),idpr(n,k),npr(1,k),xpp(ip),xmt(it),ip,it + write(ifmt,'(a,i12,d25.15)')'ems,seedf',nrevt+1,seedc + iret=1 + goto 1000 + endif + + z=sngl(omb/oma*wba/wab) + if(ish.ge.8)write(ifch,*)'z,oma',z,oma,wba,k,n + if(rangen().gt.z)then + reject=reject+1. + else + accept=accept+1. + call RemPom(k,n) + call StoCon(-2,k,n) + omlog=omlog-dlog(oma)+dlog(omb) + endif + + 500 continue + + endif + + endif + + if(nemsi.le.4)then + kplot=int(float(kmc)/float(kmcmx)*100.) + if(iemsi1.eq.1)call xEmsI1(1,kplot,omlog) + if(iemsi2.eq.1)call xEmsI2(1,kplot) + endif + + enddo !-----> end Metropolis + + + else + + n=1 + + do k=1,koll + + call ProPo(k,n) + call ProXY(k,n) + + enddo + + endif + +c --- Plot Pomeron b-distributions --- + + if(ish.ge.6)call XPrint('After Markov :&') + + if(iemsb.eq.1)then ! plot + do k=1,koll + call xEmsB(1,1,k) + if(nprt(k).gt.0)call xEmsB(1,2,k) + enddo + endif + + if(iemsbg.eq.1)then ! plot + call xEmsBg(3,0,0) + do k=1,koll + call xEmsBg(1,0,k) + if(nprt(k).gt.0)then + call xEmsBg(1,-1,k) + do n=1,nprmx(k) + if(idpr(n,k).ne.0)call xEmsBg(1,idpr(n,k),k) + enddo + endif + enddo + endif + +c --- Plot distr of pomeron number --- + + + if(iemspm.eq.1)then + do k=1,koll + call xEmsPm(1,k,nprt(k),nprmx(k)) + enddo + endif + + +c --- Count all interactions --- + + ncol=0 + ncolh=0 + do k=1,koll + if(nprt(k).gt.0)then + ncol=ncol+1 + if(isplit.eq.1)then + do n=1,nprmx(k) + if(xpr(n,k).gt.xzcutpar(k))itpr(k)=1 !for nuclear splitting + enddo + endif + ip=iproj(k) + it=itarg(k) + kolp(ip)=kolp(ip)+nprt(k) !number of cut Pomerons + kolt(it)=kolt(it)+nprt(k) !on remnants + endif + enddo + +c --- Calculate Z (written to zzremn) + + + do ip=1,maproj + call CalcZZ(1,ip) + enddo + do it=1,matarg + call CalcZZ(-1,it) + enddo + +c -- Split Enhanced Pomerons and fix their nature --- + + if(isplit.eq.1.and.ncol.gt.0)then + + if (iLHC.eq.1)then !make random selection to avoid assymetry + + nishuff(1)=0 + nishuff(2)=0 + do ip=1,maproj + nishuff(1)=nishuff(1)+1 + ishuff(nishuff(1),1)=ip + enddo + do it=1,matarg + nishuff(2)=nishuff(2)+1 + ishuff(nishuff(2),2)=it + enddo + + do while(nishuff(1)+nishuff(2).gt.0) + +c random selection + if(nishuff(1).gt.0.and.nishuff(2).gt.0)then + ir=1+int(rangen()+0.5) + elseif(nishuff(1).gt.0)then + ir=1 + else + ir=2 + endif + + indx=1+int(rangen()*float(nishuff(ir))) + if(ir.eq.1)then + ip=ishuff(indx,ir) + if(lproj3(ip).ne.0.and.kolp(ip).eq.0)call ProNucSpl( 1,ip) + else + it=ishuff(indx,ir) + if(ltarg3(it).ne.0.and.kolt(it).eq.0)call ProNucSpl(-1,it) + endif + ishuff(indx,ir)=ishuff(nishuff(ir),ir) + nishuff(ir)=nishuff(ir)-1 + + enddo + + else + + do ip=1,maproj + if(lproj3(ip).ne.0.and.kolp(ip).eq.0)call ProNucSpl( 1,ip) + enddo + do it=1,matarg + if(ltarg3(it).ne.0.and.kolt(it).eq.0)call ProNucSpl(-1,it) + enddo + + endif + + if(ish.ge.6)call XPrint('After ProNucSpl:&') + + endif + +c -- Fix Pomeron type --- + + do k=1,koll + itpr(k)=0 + do n=1,nprmx(k) + if(idfpr(n,k).eq.0)call ProPoTy(k,n) + enddo + enddo + + + +c --- Fix Remnant Excitation + + do ip=1,maproj + if(lproj(ip).ne.0)then + call ProReEx( 1,ip) + if(iremn.ge.2)call UpdateFlav(ip,jcp,0) !reset jcpref to 0 + endif + enddo + do it=1,matarg + if(ltarg(it).ne.0)then + call ProReEx(-1,it) + if(iremn.ge.2)call UpdateFlav(it,jct,0) !reset jctref to 0 + endif + enddo + + +c --- LHC tune : remove unnecessary diffractive Pomerons + if(iLHC.eq.1)then + do k=1,koll + ip=iproj(k) + it=itarg(k) +c remove temporary diffractive Pomeron if at least on remnant excited +c ymean=0. + do n=1,nprmx(k) + if(idpr(n,k).eq.-1)then + idpr(n,k)=1 + if((iep(ip).gt.0.or.iet(it).gt.0) + & .and.xpr(n,k).le.xzcutpar(k))call VirPom(k,n,0) +c if(iep(ip).gt.0.or.iet(it).gt.0)then +c if(xpr(n,k).ge.xzcutpar(k))then +c call VirPom(k,n,0) +c else +c ymean=ymean+ypr(n,k) +c endif +c endif + endif + enddo +cc put excitation on the side of the pomeron +c if((ymean.gt.0..and.iet(it).gt.0).or. +c & (ymean.lt.0..and.iep(ip).gt.0))then +c ietmp=iep(ip) +c iep(ip)=iet(it) +c iet(it)=ietmp +c endif + enddo + endif + +c --- Count real interactions --- + + ncol=0 + do k=1,koll + if(nprt(k).gt.0)then !inelastic + ncol=ncol+1 + if(itpr(k).lt.0)then + itpr(k)=-1 + else + itpr(k)=1 !diffractive with Pomeron + endif + elseif(itpr(k).gt.0)then !diffractive + ncol=ncol+1 + call ProDiSc(k) + itpr(k)=2 + endif + enddo + if(ish.ge.5)write(ifch,*)'ncol:',ncol + + + +c --- fix all variables + + + if(ish.ge.4)write(ifch,*)'fix all variables' + + +c --- recalculate Zptn + + +c if(irzptn.eq.1)call recalcZPtn + + + typevt=0 !ela + if(maproj+matarg.eq.2)then !pp + if(itpr(1).ne.0)then + anintine=anintine+1. + if(itpr(1).gt.0)then + if(ionudi.eq.1 + & .or.iep(1).ne.0.or.iet(1).ne.0.or.itpr(1).eq.1)then + anintdiff=anintdiff+1. + if((iep(1).eq.0.and.iet(1).eq.2).or. + & (iet(1).eq.0.and.iep(1).eq.2))anintsdif=anintsdif+1. + if(iep(1).eq.0.and.iet(1).eq.2)typevt=-4 !SD tar + if(iet(1).eq.0.and.iep(1).eq.2)typevt=4 !SD pro + if(iep(1).eq.2.and.iet(1).eq.2)typevt=2 !DD + if(iep(1).eq.0.and.iet(1).eq.0)typevt=3 !CD + else + anintine=anintine-1. !diffractive without excitation = elastic + endif + else + typevt=1 !ND + endif + endif + else + aidif=0. + aidifp=0. + aidift=0. + aiine=0. + do k=1,koll + ip=iproj(k) + it=itarg(k) + if(aidif.ge.0..and.itpr(k).gt.0)then + aidifp=aidifp+iep(ip)+(2-itpr(k))*0.00001 + aidift=aidift+iet(it)+(2-itpr(k))*0.00001 + if(ionudi.eq.1)then !count all diff as inelastic (to compare to tabulated cs) + aidif=aidif+1. + endif + elseif(itpr(k).eq.-1)then + aiine=aiine+1. + aidif=-ainfin + endif + enddo + if(ionudi.eq.2)then + aidif=aidif+aidifp + else + aidif=aidif+aidifp+aidift + endif + if(aidif.gt.0.)then + anintdiff=anintdiff+1. + anintine=anintine+1. + if(aidifp.gt.0.5.and.aidift.le.0.5)then + anintsdif=anintsdif+1. + typevt=4 !SD pro + endif + if(aidifp.gt.0.5.and.aidift.gt.0.5)then + typevt=2 !DD + endif + if(ionudi.ne.2)then + if(aidifp.le.0.5.and.aidift.gt.0.5)then + anintsdif=anintsdif+1. + typevt=-4 !SD tar + elseif(typevt.le.0.5.and.aidifp.gt.0..and.aidift.gt.0.)then + typevt=3 !CD + endif + endif + elseif(aiine.gt.0.)then + anintine=anintine+1. + typevt=1 !ND + endif + endif + + if(ish.ge.6)call XPrint('After fixing:&') + + +c --- Plot MC pomeron number --- + + if(nemsi.le.4.and.irea.ge.0)then + if(iemsi1.eq.1)call xEmsI1(1,100,omlog) + if(iemsi2.eq.1)call xEmsI2(1,100) + if(iemsi1.eq.1.and.ncol.gt.0)call xEmsI1(2,0,omlog) + if(iemsi2.eq.1.and.ncol.gt.0)call xEmsI2(2,0) + if((iemsi1.eq.1.or.iemsi2.eq.1).and.ncol.eq.0)nemsi=nemsi-1 + endif + + if(iemsb.eq.1)then ! plot + do k=1,koll + if(itpr(k).eq.0)call xEmsB(1,3,k) !nothing + if(itpr(k).eq.-1)call xEmsB(1,4,k) !cut + if(itpr(k).gt.0)call xEmsB(1,5,k) !diffr + if(abs(itpr(k)).eq.1)call xEmsB(1,6,k) !cut+diffr cut + enddo + endif + + +c check for diffractive interaction without excitation + difint=.true. + ieptot=0 + if(maproj+matarg.eq.2)ieptot=1 !not used for pp + do k=1,koll + if(itpr(k).eq.2)then + ip=iproj(k) + it=itarg(k) + ieptot=ieptot+iep(ip) + if(ionudi.ne.2)ieptot=ieptot+iet(it) +c for CR, ionudi=1, count diffraction without excitation as inelastic (part of the xs) + if(ionudi.ne.1.and.iep(ip).eq.0.and.iet(it).eq.0)then + ncol=ncol-1 + itpr(k)=0 + kolp(ip)=kolp(ip)-1 + kolt(it)=kolt(it)-1 + endif + else + if(iLHC.eq.1.and.abs(itpr(k)).eq.1)then + difint=.false. + elseif(iLHC.eq.0)then !bug in CR version for ionudi=2 (difint=F always !) + difint=.false. + endif + endif + enddo + if(difint.and.ionudi.eq.2.and.ieptot.eq.0)then + ncol=0 !for ionudi=2 + iret=0 + goto 1000 !no projectile excitation = elastic + endif + + iquasi=0 + if(ncol.eq.0)goto 998 + if(difint.and.ieptot-1.le.0)then + iquasi=1 + if(ish.ge.2)write(ifch,*)'EPOS Quasi-elastic event' + goto 998 + endif + +c --- Treat Pomerons --------------------------------------- + + +c --- Check minimum mass --- + + do k=1,koll + ip=iproj(k) + it=itarg(k) + do n=1,nprmx(k) + if(xpr(n,k).lt.(cumpom/engy)**2)then + nnb=nbkpr(n,k) + nnv=nvpr(n,k) + if(nnv.ne.0)then + nbkpr(nnv,k)=0 !if bckp Pomeron + endif + if(nnb.ne.0)then + ivi=1 + call VirPom(k,nnb,ivi) !if hard backup exist + nbkpr(n,k)=0 !remove it + endif + ivi=2 + call VirPom(k,n,ivi) + elseif(itpr(k).eq.1.and.abs(idfpr(n,k)).eq.1)then +c diffractive cut Pomeron should not change remnant excitation + idfs=sign(1,idfpr(n,k)) + if(iep(ip).eq.0.and.iet(it).eq.0)then + idfpr(n,k)=idfs*4 !not linked to both proj and targ + elseif(iep(ip).eq.0)then + idfpr(n,k)=idfs*3 !linked to targ + iet(it)=1 !target excitation is inelastic type + elseif(iet(it).eq.0)then + idfpr(n,k)=idfs*2 !linked to proj + iep(ip)=1 !projectile excitation is inelastic type + endif + endif + enddo + enddo + +c --- Set String End Type and Pt + + do k=1,koll + ip=iproj(k) + it=itarg(k) + do n=1,nprmx(k) + + if(idpr(n,k).gt.0)then + + ntry=0 + vpom=.false. + ivpi=ivp(ip) + ivti=ivt(it) + idpi=idp(ip) + idti=idt(it) + do i=1,2 + icp(i)=icproj(i,ip) + ict(i)=ictarg(i,it) + enddo + if(iremn.ge.2)then !save jcpref and jctref into jcp and jct + call UpdateFlav(ip,jcp,1) + call UpdateFlav(it,jct,2) + endif + + 100 ntry=ntry+1 + iret=0 + if(ntry.ge.200)vpom=.true. + if(ntry.gt.1)then + if(ish.ge.4)write(ifch,*)'Try again setting string ends for k,n' + & ,k,n,ntry + ivp(ip)=ivpi + ivt(it)=ivti + idp(ip)=idpi + idt(it)=idti + do i=1,2 + icproj(i,ip)=icp(i) + ictarg(i,it)=ict(i) + enddo + if(iremn.ge.2)then !restore jcpref and jctref from jcp and jct + call UpdateFlav(ip,jcp,-1) + call UpdateFlav(it,jct,-2) + endif + call RmPt(k,n) + endif + + if(nvpr(n,k).eq.0)call ProSeTy(k,n) !Not for backup Pomeron + call ProSePt(k,n,iret) + if(iret.eq.1)then + if(vpom)then + ivi=13 + call VirPom(k,n,ivi) + else + goto 100 + endif + endif + +c enddo +c enddo + +c --- Check Pomeron mass + +c do k=1,koll +c do n=1,nprmx(k) + if(idpr(n,k).ne.0.and.ivpr(n,k).ne.0)then + px=xxp1pr(n,k)+xxp2pr(n,k)+xxm1pr(n,k)+xxm2pr(n,k) + py=xyp1pr(n,k)+xyp2pr(n,k)+xym1pr(n,k)+xym2pr(n,k) + pomass=xpr(n,k)*s-px*px-py*py + if(pomass.lt.amprmn(idhpr(n,k)))then + nnv=nvpr(n,k) + nnb=nbkpr(n,k) + idfpom=iabs(idfpr(n,k)) + if(vpom)then + ivi=3 + call VirPom(k,n,ivi) !call RmPt(k,n) + if(nnv.ne.0)then !bckp Pomeron + nbkpr(nnv,k)=0 + endif + if(nnb.ne.0)then !big Pomeron with bckp one + ivpr(nnb,k)=1 + nvpr(nnb,k)=0 + idfpr(nnb,k)=idfpom + npr(1,k)=npr(1,k)+1 + npr(3,k)=npr(3,k)-1 + endif + else + goto 100 + endif + endif + endif +c enddo +c enddo + +c --- Define String ends for "backup" Pomerons --- + +c do k=1,koll +c do n=1,nprmx(k) +c if(nvpr(n,k).ne.0)call ProSeX(k,n,iret) +c if(iret.eq.1)then +c if(vpom)then +c nn=nvpr(n,k) +c ivi=7 +c call VirPom(k,n,ivi) +c nbkpr(nn,k)=0 +c else +c goto 100 +c endif +c endif + iret=0 + iret2=0 +c enddo +c enddo + +c --- Define String ends for "normal" Pomerons --- + +c do k=1,koll +c do n=1,nprmx(k) + if(nvpr(n,k).eq.0)call ProSeX(k,n,iret) !Not for backup Pomeron + if(iret.eq.1)then + if(vpom)then + ivi=12 + call VirPom(k,n,ivi) + else + goto 100 + endif + endif + iret=0 + iret2=0 + + endif + + enddo + enddo + + +c --- Write --- + + 998 call emszz + if(ncol.eq.0)then + iret=0 + goto 1000 + endif + + + do k=1,koll + if(abs(itpr(k)).eq.1)call emswrpom(k,iproj(k),maproj+itarg(k)) + enddo + + +c --- Treat hard Pomeron + + ncolh=0 + do k=1,koll + ncolhp=0 + do n=1,nprmx(k) + if(idpr(n,k).eq.3)then + if(ishpom.eq.1)then + call psahot(k,n,iret) + if(iret.eq.0)ncolhp=ncolhp+1 + if(iret.eq.1)then + if(nbkpr(n,k).ne.0)then + nn=nbkpr(n,k) + call ProSeTy(k,nn) + call ProSeX(k,nn,iret2) + if(iret2.eq.1)then + ivi=15 + call VirPom(k,nn,ivi) + if(ivi.lt.0)then + jerr(7)=jerr(7)+1 + iret=1 + goto 1000 + endif + istptl(nppr(nn,k))=32 + nbkpr(n,k)=0 + else + ivpr(nn,k)=1 + nvpr(nn,k)=0 + idfpr(nn,k)=idfpr(n,k) + npr(1,k)=npr(1,k)+1 + npr(3,k)=npr(3,k)-1 + ansff=ansff+1 !counters + anshf=anshf-1 + endif + endif + ivi=16 + call VirPom(k,n,ivi) + if(ivi.lt.0)then + jerr(7)=jerr(7)+1 + iret=1 + goto 1000 + endif + istptl(nppr(n,k))=32 + elseif(nbkpr(n,k).ne.0)then + nn=nbkpr(n,k) + ivi=17 + call VirPom(k,nn,ivi) + if(ivi.lt.0)then + jerr(7)=jerr(7)+1 + iret=1 + goto 1000 + endif + istptl(nppr(nn,k))=32 + nbkpr(n,k)=0 + endif + iret=0 + else + istptl(nppr(n,k))=32 + if(nbkpr(n,k).ne.0)then + nn=nbkpr(n,k) + istptl(nppr(nn,k))=32 + endif + endif + endif + enddo + if(ncolhp.gt.0)ncolh=ncolh+1 !count hard binary collisions + enddo + kohevt=ncolh !update number of hard collisions + + if(iLHC.eq.0.and.iremn.ge.2)then +c --- Add valence quark to jcpref and jctref for soft string ends --- + do ip=1,maproj + if(iep(ip).ne.-1)then + call UpdateFlav(ip,jcp,10) + do nnn=1,nrflav + jcpval(nnn,1,ip)=jcp(nnn,1) + enddo + do nnn=1,nrflav + jcpval(nnn,2,ip)=jcp(nnn,2) + enddo + else + icp(1)=icproj(1,ip) + icp(2)=icproj(2,ip) + call iddeco(icp,jcp) + do nnn=1,nrflav + jcpval(nnn,1,ip)=jcp(nnn,1) + enddo + do nnn=1,nrflav + jcpval(nnn,2,ip)=jcp(nnn,2) + enddo + endif + enddo + do it=1,matarg + if(iet(it).ne.-1)then + call UpdateFlav(it,jct,20) + do nnn=1,nrflav + jctval(nnn,1,it)=jct(nnn,1) + enddo + do nnn=1,nrflav + jctval(nnn,2,it)=jct(nnn,2) + enddo + else + ict(1)=ictarg(1,it) + ict(2)=ictarg(2,it) + call iddeco(ict,jct) + do nnn=1,nrflav + jctval(nnn,1,it)=jct(nnn,1) + enddo + do nnn=1,nrflav + jctval(nnn,2,it)=jct(nnn,2) + enddo + endif + enddo + endif + +c --- Treat "normal" soft Pomerons --- + + do k=1,koll + do n=1,nprmx(k) + if(nvpr(n,k).eq.0)then + if(isopom.eq.1)then + call ProSeF(k,n,iret) + if(iret.eq.1)then + ivi=18 + call VirPom(k,n,ivi) + if(ivi.lt.0)then + jerr(7)=jerr(7)+1 + iret=1 + goto 1000 + endif + istptl(nppr(n,k))=32 + endif + iret=0 + else + istptl(nppr(n,k))=32 + endif + endif + enddo + enddo + + + +c --- Treat Remnants ----------------------------------------- + +c --- Fix Pion Exchange in diffractive remnants + + do ip=1,maproj + if(iep(ip).eq.2)call ProReEx( 2,ip) + enddo + do it=1,matarg + if(iet(it).eq.2)call ProReEx( -2,it) + enddo + +c --- Diffractive Pt and check Pomeron status + + iret=1 + do k=1,koll + call ProDiPt(k,1,iret) + enddo + if(iret.ne.0)then + jerr(8)=jerr(8)+1 + ivi=99 + if(ish.ge.2)then + write(ifch,*)'All Pomeron lost, redo event !' + write(ifmt,*)'All Pomeron lost, redo event !' + endif + iret=1 + goto 1000 + endif + + if(iLHC.eq.1.and.iremn.ge.2)then +c --- Add valence quark to jcpref and jctref for soft string ends --- + do ip=1,maproj + if(iep(ip).ne.-1)then + call UpdateFlav(ip,jcp,10) + do nnn=1,nrflav + jcpval(nnn,1,ip)=jcp(nnn,1) + enddo + do nnn=1,nrflav + jcpval(nnn,2,ip)=jcp(nnn,2) + enddo + else + icp(1)=icproj(1,ip) + icp(2)=icproj(2,ip) + call iddeco(icp,jcp) + do nnn=1,nrflav + jcpval(nnn,1,ip)=jcp(nnn,1) + enddo + do nnn=1,nrflav + jcpval(nnn,2,ip)=jcp(nnn,2) + enddo + endif + enddo + do it=1,matarg + if(iet(it).ne.-1)then + call UpdateFlav(it,jct,20) + do nnn=1,nrflav + jctval(nnn,1,it)=jct(nnn,1) + enddo + do nnn=1,nrflav + jctval(nnn,2,it)=jct(nnn,2) + enddo + else + ict(1)=ictarg(1,it) + ict(2)=ictarg(2,it) + call iddeco(ict,jct) + do nnn=1,nrflav + jctval(nnn,1,it)=jct(nnn,1) + enddo + do nnn=1,nrflav + jctval(nnn,2,it)=jct(nnn,2) + enddo + endif + enddo + endif + + do ip=1,maproj +c Here and later "kolp(ip).ne.0" replaced by "iep(ip).ne.-1" to count +c projectile and target nucleons which are counted in paires but are not used +c in collision (no diffractive or inelastic interaction) as slow particles +c at the end. Then we can use them in ProRem to give mass to all other nucleons +c and avoid energy conservation violation that utrescl can not treat +c (and it gives a reasonnable number of grey particles even if distributions +c are not really reproduced). +c if(kolp(ip).ne.0)call ProCop(ip,ip) + if(iep(ip).ne.-1)call ProCop(ip,ip) + enddo + do it=1,matarg + if(iet(it).ne.-1)call ProCot(it,maproj+it) +c if(kolt(it).ne.0)call ProCot(it,maproj+it) + enddo + + +c ---- Remnant Masses (ProReM) + + + if(ish.ge.6)call XPrint('Before ProReM:&') + ntry=0 + iret=0 + call StoRe(1) !Store Remnant configuration + 123 ntry=ntry+1 + nishuff(1)=0 + nishuff(2)=0 + do ip=1,maproj + if(iep(ip).eq.0)then + nishuff(1)=nishuff(1)+1 + ishuff(nishuff(1),1)=ip !positive for non excited projectile + elseif(iep(ip).gt.0)then + nishuff(2)=nishuff(2)+1 + ishuff(nishuff(2),2)=ip !positive for excited projectile + endif + enddo + do it=1,matarg + if(iet(it).eq.0)then + nishuff(1)=nishuff(1)+1 + ishuff(nishuff(1),1)=-it !negative for non excited target + elseif(iet(it).gt.0)then + nishuff(2)=nishuff(2)+1 + ishuff(nishuff(2),2)=-it !negative for excited target + endif + enddo + +c do ir=1,2 !first set mass of non excited remnant +cc do ir=2,1,-1 !first set mass of excited remnant + +c do while(nishuff(ir).gt.0) + do while(nishuff(1)+nishuff(2).gt.0) + +c random selection + if(nishuff(1).gt.0.and.nishuff(2).gt.0)then + ir=1+int(rangen()+0.5) + elseif(nishuff(1).gt.0)then + ir=1 + else + ir=2 + endif + + indx=1+int(rangen()*float(nishuff(ir))) + if(ishuff(indx,ir).gt.0)then + ip=ishuff(indx,ir) + call ProReM( 1,ip,iret) + else + it=-ishuff(indx,ir) + call ProReM(-1,it,iret) + endif + if(ish.ge.10)call XPrint('In ProReM:&') + + if(iret.eq.1)then + !---------------------------------------- + !If there is a problem, try again shuffle (30 times), + !if it doesn't work, for pp, try 10 times with the same type + !of event and if doesn't work redo event; + !for pA redo event ; and for AB (with A or B >10) + !continue with some ghosts ... + !---------------------------------------- + if(ntry.lt.30)then + if(ish.ge.3)write(ifch,*)'shuffle, try again',ntry + call StoRe(-1) !Restore Remnant configuration + iret=0 + goto 123 + elseif(ntry.gt.30.or.maproj.le.20.or.matarg.le.20)then + if(ish.ge.2)write(ifch,*)'ProRem, redo event ! ntry=',ntry + if(ish.ge.1)write(ifmt,*)'ProRem, redo event ! ntry=',ntry + iret=1 + goto 1000 + else + if(ish.ge.3)write(ifch,*)'shuffle, try again forcing ...' + call StoRe(-1) !Restore Remnant configuration + iret=10 + goto 123 + endif + endif + + ishuff(indx,ir)=ishuff(nishuff(ir),ir) + nishuff(ir)=nishuff(ir)-1 + + enddo +c enddo + +c --- Correction for Diffractive Pt (from Ralph but seems to be less good for NA49) + +c do k=1,koll +c call ProDiPt(k,2,idum) +c enddo + + + iret=0 + if(ish.ge.6)call XPrint('After ProReM:&') + + +c --- Write Z into zpaptl for connected strings + + + do ip=1,maproj + if(kolp(ip).ne.0)call WriteZZ(1,ip) + enddo + do it=1,matarg + if(kolt(it).ne.0)call WriteZZ(-1,it) + enddo + + +c --- Write Remnants + + + do ip=1,maproj +c if(kolp(ip).ne.0)call emswrp(ip,ip) + if(iep(ip).ne.-1)call emswrp(ip,ip) + enddo + + do it=1,matarg +c if(kolt(it).ne.0)call emswrt(it,maproj+it) + if(iet(it).ne.-1)call emswrt(it,maproj+it) + enddo + + +c --- Remnant Flavors (ProReF) + + + do ip=1,maproj + call ProReF(1,ip,iret) + if(iret.ne.0)goto 1000 + enddo + do it=1,matarg + call ProReF(-1,it,iret) + if(iret.ne.0)goto 1000 + enddo + + +c plot +c ---- + + if(iemspx.eq.1)then + do ko=1,koll + if(nprt(ko).gt.0)then + do np=1,nprmx(ko) + if(idpr(np,ko).gt.0)then + call xEmsPx(1,sngl(xpr(np,ko)),sngl(ypr(np,ko)),nprt(ko)) + endif + enddo + endif + enddo + endif + + if(iemspbx.eq.1)then + do k=1,koll + if(nprt(k).gt.0)then + do n=1,nprmx(k) + if(idpr(n,k).eq.3)then + je1=min(1,nemispr(1,n,k)) + je2=min(1,nemispr(2,n,k)) + jex=1+je1+2*je2 + if(itpr(k).eq.-1)then + call xEmsP2(1,1+idhpr(n,k),jex + * ,sngl(xppr(n,k)) + * ,sngl(xmpr(n,k)) + * ,sngl(xpprbor(n,k)),sngl(xmprbor(n,k)) + * ,ptprboo(1,n,k),ptprboo(2,n,k) ) + else !diffractive hard pomeron + call xEmsP2(1,0,jex + * ,sngl(xppr(n,k)) + * ,sngl(xmpr(n,k)) + * ,sngl(xpprbor(n,k)),sngl(xmprbor(n,k)) + * ,ptprboo(1,n,k),ptprboo(2,n,k) ) + endif + endif + enddo + endif + enddo + endif + + + if(iemsse.eq.1)then + do ko=1,koll + if(nprt(ko).gt.0)then + do np=1,nprmx(ko) + if(idpr(np,ko).gt.0)then + ptp1=sngl(xxp1pr(np,ko)**2+xyp1pr(np,ko)**2) + ptp2=sngl(xxp2pr(np,ko)**2+xyp2pr(np,ko)**2) + ptm1=sngl(xxm1pr(np,ko)**2+xym1pr(np,ko)**2) + ptm2=sngl(xxm2pr(np,ko)**2+xym2pr(np,ko)**2) + call xEmsSe(1,sngl(xp1pr(np,ko)),ptp1,1,1) + call xEmsSe(1,sngl(xp2pr(np,ko)),ptp2,1,1) + call xEmsSe(1,sngl(xm1pr(np,ko)),ptm1,-1,1) + call xEmsSe(1,sngl(xm2pr(np,ko)),ptm2,-1,1) + call xEmsSe(1,sngl(xp1pr(np,ko)),sngl(xm1pr(np,ko)),1,2) + call xEmsSe(1,sngl(xm2pr(np,ko)),sngl(xp2pr(np,ko)),1,2) + endif + enddo + endif + enddo + endif + + if(iemsdr.eq.1)then + do i=maproj+matarg+1,nptl + if(istptl(iorptl(i)).eq.41)then + xpdr=(pptl(4,i)+pptl(3,i))/sngl(plc) + xmdr=(pptl(4,i)-pptl(3,i))/sngl(plc) + if(ityptl(i).eq.41)call xEmsDr(1,xpdr,xmdr,1) + if(ityptl(i).eq.51)call xEmsDr(1,xpdr,xmdr,2) + if(ityptl(i).eq.42)call xEmsDr(1,xpdr,xmdr,3) + if(ityptl(i).eq.52)call xEmsDr(1,xpdr,xmdr,4) + endif + enddo + endif + + if(iemsrx.eq.1)then + do i=1,maproj + if(kolp(i).gt.0)call xEmsRx(1,1,sngl(xpp(i)),sngl(xmp(i))) + enddo + do j=1,matarg + if(kolt(j).gt.0)call xEmsRx(1,2,sngl(xmt(j)),sngl(xpt(j))) + enddo + endif + + if(ixbDens.eq.1)call xbDens(1) + +c exit +c ---- + + 1000 continue +c write(*,*)'emsaa-iret',iret + if(ish.ge.2.and.iret.ne.0)write(ifch,*)'iret not 0 (ems)=> redo' + & ,iret,ivi + call utprix('emsaa ',ish,ishini,4) + return + end + + +c---------------------------------------------------------------------- + subroutine StoCon(mode,k,n) +c---------------------------------------------------------------------- +c store or restore configuration +c mode = 1 (store) or -1 (restore) +c k = collision index +c n = pomeron index +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + + ip=iproj(k) + it=itarg(k) + + if(mode.eq.1)then + + do i=0,3 + nprx0(i)=npr(i,k) + enddo + nprtx0=nprt(k) + idx0=idpr(n,k) + xxpr0=xpr(n,k) + yx0=ypr(n,k) + xxppr0=xppr(n,k) + xxmpr0=xmpr(n,k) + nppx0=npp(ip) + nptx0=npt(it) + xppx0=xpp(ip) + xppstx0=xppmx(ip) + xmpstx0=xppmn(ip) + xmtx0=xmt(it) + xptstx0=xmtmx(it) + xmtstx0=xmtmn(it) + + elseif(mode.eq.2)then + + do i=0,3 + nprx(i)=npr(i,k) + enddo + nprtx=nprt(k) + idx=idpr(n,k) + xxpr=xpr(n,k) + yx=ypr(n,k) + xxppr=xppr(n,k) + xxmpr=xmpr(n,k) + nppx=npp(ip) + nptx=npt(it) + xppx=xpp(ip) + xppstx=xppmx(ip) + xmpstx=xppmn(ip) + xmtx=xmt(it) + xptstx=xmtmx(it) + xmtstx=xmtmn(it) + + elseif(mode.eq.-1)then + + do i=0,3 + npr(i,k)=nprx0(i) + enddo + nprt(k)=nprtx0 + idpr(n,k)=idx0 + xpr(n,k)=xxpr0 + ypr(n,k)=yx0 + xppr(n,k)=xxppr0 + xmpr(n,k)=xxmpr0 + npp(ip)=nppx0 + npt(it)=nptx0 + xpp(ip)=xppx0 + xppmx(ip)=xppstx0 + xppmn(ip)=xmpstx0 + xmt(it)=xmtx0 + xmtmx(it)=xptstx0 + xmtmn(it)=xmtstx0 + + elseif(mode.eq.-2)then + + do i=0,3 + npr(i,k)=nprx(i) + enddo + nprt(k)=nprtx + idpr(n,k)=idx + xpr(n,k)=xxpr + ypr(n,k)=yx + xppr(n,k)=xxppr + xmpr(n,k)=xxmpr + npp(ip)=nppx + npt(it)=nptx + xpp(ip)=xppx + xppmx(ip)=xppstx + xppmn(ip)=xmpstx + xmt(it)=xmtx + xmtmx(it)=xptstx + xmtmn(it)=xmtstx + + else + call utstop('mode should integer from -2 to 2 (without 0)&') + endif + return + end + +c------------------------------------------------------------------------- + subroutine RemPom(k,n) +c------------------------------------------------------------------------- +c remove pomeron +c------------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + + ip=iproj(k) + it=itarg(k) + npr(idpr(n,k),k)=npr(idpr(n,k),k)-1 !nr of pomerons + nprt(k)=npr(1,k)+npr(3,k) + if(idpr(n,k).gt.0)then + npp(ip)=npp(ip)-1 !nr of pomerons per proj + npt(it)=npt(it)-1 !nr of pomerons per targ + idpr(n,k)=0 + xpp(ip)=xpp(ip)+xppr(n,k) + xmt(it)=xmt(it)+xmpr(n,k) + xpr(n,k)=0.d0 + ypr(n,k)=0.d0 + xppr(n,k)=0.d0 + xmpr(n,k)=0.d0 + + + + endif + + end + +c------------------------------------------------------------------------- + subroutine ProPo(k,n) +c------------------------------------------------------------------------- +c propose pomeron type = idpr(n,k +c------------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + double precision wzero,wzerox + common/cwzero/wzero,wzerox + + ip=iproj(k) + it=itarg(k) + + idpr(n,k)=0 + + if(dble(rangen()).gt.wzero)then + idpr(n,k)=1 + + +c nbr of pomerons per proj + npp(ip)=npp(ip)+1 +c nbr of pomerons per targ + npt(it)=npt(it)+1 + + endif + + npr(idpr(n,k),k)=npr(idpr(n,k),k)+1 !nr of pomerons + nprt(k)=npr(1,k)+npr(3,k) + + + end + + +c------------------------------------------------------------------------- + subroutine ProXY(k,n) +c------------------------------------------------------------------------- +c propose pomeron x,y +c------------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + include 'epos.incems' + include 'epos.incsem' + double precision xp,xm,om1xprk,om1xmrk,anip,anit,eps + &,xprem,xmrem,xprm,xmrm + parameter (eps=1.d-30) + + + ip=iproj(k) + it=itarg(k) + + + xpr(n,k)=0.d0 + ypr(n,k)=0.d0 + + if(idpr(n,k).ne.0)then + xprem=xpp(ip) + xmrem=xmt(it) +c because of fom, it's not symetric any more if we choose always xp first +c and then xm ... so choose it randomly. + if(rangen().lt.0.5)then + xp=om1xprk(k,xprem,xminDf,1) + xmrm=xmrem + xprm=xminDf + xm=om1xmrk(k,xp,xprm,xmrm,1) + else + xm=om1xprk(k,xmrem,xminDf,-1) + xmrm=xminDf + xprm=xprem + xp=om1xmrk(k,xm,xmrm,xprm,-1) + endif + xpr(n,k)=xp*xm + ypr(n,k)=0.d0 + if(xm.gt.eps.and.xp.gt.eps)then + ypr(n,k)=0.5D0*dlog(xp/xm) + xppr(n,k)=xp + xmpr(n,k)=xm + else + if(ish.ge.1)write(ifmt,*)'Warning in ProXY ',xp,xm + npr(idpr(n,k),k)=npr(idpr(n,k),k)-1 + idpr(n,k)=0 + npr(idpr(n,k),k)=npr(idpr(n,k),k)+1 + xpr(n,k)=0.d0 + ypr(n,k)=0.d0 + xppr(n,k)=0.d0 + xmpr(n,k)=0.d0 + nprt(k)=npr(1,k)+npr(3,k) + npp(ip)=npp(ip)-1 !nr of pomerons per proj + npt(it)=npt(it)-1 !nr of pomerons per targ + endif + +c Update xp and xm of remnant, and change the limit to have big enought mass. + + anip=dble(npp(ip)) + anit=dble(npt(it)) + xpp(ip)=xpp(ip)-xppr(n,k) + xppmn(ip)=min(1.d0,anip*xpmn(ip)/xmpmx(ip)) + xmt(it)=xmt(it)-xmpr(n,k) + xmtmn(it)=min(1.d0,anit*xtmn(it)/xptmx(it)) + + endif + + end + +c------------------------------------------------------------------------- + double precision function wmatrix(k,n) +c------------------------------------------------------------------------- +c proposal matrix w(a->b), considering pomeron type, x, y +c------------------------------------------------------------------------- + + include 'epos.incems' + double precision wzero,wzerox,Womegak,xprem,xmrem,om1intgck + common/cwzero/wzero,wzerox + + +c ip=iproj(k) +c it=itarg(k) + + if(idpr(n,k).eq.0)then + wmatrix=wzero + else + xprem=1.d0!xpp(ip)+xppr(n,k) + xmrem=1.d0!xmt(it)+xmpr(n,k) + wmatrix=(1d0-wzero)/om1intgck(k,xprem,xmrem) + * *Womegak(xppr(n,k),xmpr(n,k),xprem,xmrem,k) + endif + + + end + +c------------------------------------------------------------------------- + double precision function omega(n,k) +c------------------------------------------------------------------------- +c calculates partial omega for spot (k,n) +c------------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + common/cwzero/wzero,wzerox + double precision wzero,wzerox,eps + parameter(eps=1.d-15) + double precision PhiExpoK,omGamk,xp,xm,fom + double precision plc,s + common/cems5/plc,s + common/nucl3/phi,bimp + + omega=0.d0 + + ip=iproj(k) + it=itarg(k) + + if(xpp(ip).lt.xppmn(ip)+eps.or.xpp(ip).gt.1.d0+eps)goto 1001 + if(xmt(it).lt.xmtmn(it)+eps.or.xmt(it).gt.1.d0+eps)goto 1001 + + omega=xpp(ip)**dble(alplea(iclpro)) + & *xmt(it)**dble(alplea(icltar)) + +c ztg=0 +c zpj=0 +c nctg=0 +c ncpj=0 +c zsame=nprt(k) +c if(idpr(n,k).gt.0)then +c if(nprt(k).le.0)stop'omega: nprt(k) should be positive !!!! ' +c zsame=zsame-1 +c endif +c nlpop=nint(zsame) +c nlpot=nint(zsame) +c bglaub2=sigine/10./pi !10= fm^2 -> mb +c bglaub=sqrt(bglaub2) +c b2x=epscrp*epscrp*bglaub2 +c b2=bk(k)**2 +c ztgx=epscrw*exp(-b2/2./b2x)*fscra(engy/egyscr) +c zpjx=epscrw*exp(-b2/2./b2x)*fscra(engy/egyscr) +c +c if(koll.gt.1)then +c do li=1,lproj(ip) +c kk=kproj(ip,li) +c if(kk.ne.k)then +c b2=bk(kk)**2 +c if(b2.le.bglaub2)nctg=nctg+1 +c ztg=ztg+epscrw*exp(-b2/2./b2x)*fscro(engy/egyscr) +c nlpop=nlpop+nprt(kk) +c endif +c enddo +c do li=1,ltarg(it) +c kk=ktarg(it,li) +c if(kk.ne.k)then +c b2=bk(kk)**2 +c if(b2.le.bglaub2)ncpj=ncpj+1 +c zpj=zpj+epscrw*exp(-b2/2./b2x)*fscro(engy/egyscr) +c nlpot=nlpot+nprt(kk) +c endif +c enddo +c endif + ! zpjx+zpj is equal to zparpro(k) + ! ztgx+ztg is equal to zpartar(k) + zprj=zparpro(k) !zsame+zpj + ztgt=zpartar(k) !zsame+ztg +c if(npp(ip).gt.nfctrl)stop'nfctrl too small (1) ' +c if(npt(it).gt.nfctrl)stop'nfctrl too small (2) ' + if(idpr(n,k).eq.0)then + omega=omega*wzerox + else + xp=xppr(n,k) + xm=xmpr(n,k) +c !------------------------------------------------------------------------- +c ! fom : part of Phi regularization; Phi -> Phi^(n) (n = number of Poms) +c ! Phi^(0) relevant for Xsect unchanged, apart of (maybe) normalization (Z) +c !------------------------------------------------------------------------- + omega=omega*omGamk(k,xp,xm)*gammaV(k)*fom(zprj,xm,bk(k)) + & *fom(ztgt,xp,bk(k)) + endif + + omega=omega*PhiExpoK(k,xpp(ip),xmt(it)) + + + if(omega.le.0.d0)goto 1001 + + if(koll.gt.1)then + do li=1,lproj(ip) + kk=kproj(ip,li) + if(itarg(kk).ne.it)then + ipl=iproj(kk) + itl=itarg(kk) + omega=omega*PhiExpoK(kk,xpp(ipl),xmt(itl)) + if(omega.le.0.d0)goto 1001 + endif + enddo + do li=1,ltarg(it) + kk=ktarg(it,li) + if(iproj(kk).ne.ip)then + ipl=iproj(kk) + itl=itarg(kk) + omega=omega*PhiExpoK(kk,xpp(ipl),xmt(itl)) + if(omega.le.0.d0)goto 1001 + endif + enddo + endif + + if(omega.lt.1.d-100)then + if(ish.ge.6)write(*,*)'omega-exit',omega + omega=0.d0 + elseif(omega.gt.1.d100)then + if(ish.ge.6)write(*,*)'omega-exit',omega + omega=0.d0 + endif + + return + + 1001 continue + + omega=0.d0 + return + + end + +c------------------------------------------------------------------------- + double precision function fom(z,x,b) +c------------------------------------------------------------------------- + include 'epos.inc' + double precision x,u,w,z0 + !---------------------------------------------------------------- + ! part of Phi regularization; Phi -> Phi^(n) (n = number of Poms) + ! Phi^(0) relevant for Xsect unchanged + !---------------------------------------------------------------- + fom=1d0 + if(z.gt.0..and.alpfomi.gt.0.)then + z0=dble(alpfomi) + u=dble(z**gamfom) +c u=z0*dble(z/z0)**2. + w=u/z0*exp(-dble(b*b/delD(1,iclpro,icltar))) +c w=10.d0*u + !--------------------------------------------------- + !e=exp(-0.05*u) !analytic function with e(0)=1 + !fom=((1-u)+(u+w)*sqrt(x**2+((u-1+e)/(u+w))**2)) + ! fom(z=0)=1 fom(x=0)=e fom(x=1)~w + !--------------------------------------------------- + fom=1.d0+w*x**betfom + !--------------------------------------------------- + endif + end + +c------------------------------------------------------------------------- + subroutine ProNucSpl(ir,ii) +c------------------------------------------------------------------------- +c propose nuclear splitting +c for proj (iep) if ir=1 or target (iet) if ir=-1 +c If remnant full of parton, force excitation to mimic fan diagram connections +c------------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + double precision alp,eps,xrr,zfrac(kollmx),zsum,xk,proba,xp,xm,xr0 + &,drangen,omGamk,PomInt!,PomIncPExact,PomIncMExact + integer knopp(kollmx) + parameter(eps=1.d-10) + + + if(ir.eq.1)then !proj + + ip=ii + zzz=zzremn(ip,1)!excite more if many nucleon connected or if in nucleus + if(ish.ge.4)write(ifch,*)'ProNucSpl proj:',ip,zzz + r=rangen() + if(r.gt.exp(-min(50.,zrminc*zzz)))then + iep(ip)=5 + if(kolp(ip).eq.0)then + if(1.d0-xpp(ip).gt.eps)stop'ProNucSpl: should not happen (2)' + alp=1.d0/(1.d0+dble(alplea(iclpro))) + ncon=0 + zsum=0d0 + do l=1,lproj3(ip) + kp=kproj3(ip,l) + it=itarg(kp) + if(kolt(it).gt.0)then + do m=1,ltarg3(it) + kt=ktarg3(it,m) + if(itpr(kt).gt.0)then + do n=1,nprmx(kt) + if(xpr(n,kt).gt.xzcutpar(kt))then + ncon=ncon+1 + knopp(ncon)=kt + zfrac(ncon)=dble(zparpro(kt)) + zsum=zsum+zfrac(ncon) + endif + enddo + endif + enddo + endif + enddo + if(ish.ge.4)write(ifch,*)'ProNucSpl zsum:',zsum,ncon + if(zsum.gt.0d0)then + xr0=xpp(ip)-drangen(xpp(ip))**alp + xrr=xr0 + if(ish.ge.6)write(ifch,*)'xrr:',xrr + do nc=1,ncon + k=knopp(nc) + xk=zfrac(nc)/zsum*xr0 + if(ish.ge.6)write(ifch,*)'xk:',nc,k,xk + ipp=iproj(k) + itt=itarg(k) + do n=1,nprmx(k) + if(xpr(n,k).gt.xzcutpar(k))then + xp=xppr(n,k)+xk + if(xp.lt.1d0)then +c accept xp with probability GFF/PomIncExact + PomInt=PomInck(k) + if(PomInt.gt.0d0)then + proba=omGamk(k,xp,xmpr(n,k)) + & *xrr**dble(alplea(iclpro)) + & *xpp(ipp)**dble(alplea(iclpro)) + & *xmt(itt)**dble(alplea(icltar)) + & /PomInt + if(drangen(proba).lt.proba)then !accept xp for pair k + xppr(n,k)=xp + xpr(n,k)=xppr(n,k)*xmpr(n,k) + ypr(n,k)=0.5D0*log(xppr(n,k)/xmpr(n,k)) + xpp(ip)=xpp(ip)-xk + knucnt(1,k)=knucnt(1,k)+1 !store info of momentum transfer + irnuc(knucnt(1,k),1,k)=ip !in case of virpom later + npnuc(knucnt(1,k),1,k)=n + xxnuc(knucnt(1,k),1,k)=xk + if(ish.ge.6)write(ifch,*)'Transfer:' + & ,knucnt(1,k),k,n,xk,ip + goto 10 + endif + endif + endif + endif + enddo + xrr=xrr-xk + 10 continue + enddo + if(xrr.lt.eps)then + iep(ip)=0 !excitation not possible + zzremn(ip,1)=0. + endif + if(ish.ge.4)write(ifch,*)'ProNucSpl out:',iep(ip),xrr + else + iep(ip)=0 + zzremn(ip,1)=0. + if(ish.ge.4)write(ifch,*)'ProNucSpl out:',iep(ip) + endif + else + if(ish.ge.4)write(ifch,*)'ProNucSpl out:',iep(ip) + endif + else + iep(ip)=0 + endif + + + elseif(ir.eq.-1)then !targ + + it=ii + zzz=zzremn(it,2)!excite more if many nucleon connected or if in nucleus + if(ish.ge.4)write(ifch,*)'ProNucSpl targ:',it,zzz + r=rangen() + if(r.gt.exp(-min(50.,zrminc*zzz)))then + iet(it)=5 + if(kolt(it).eq.0)then + if(1.d0-xmt(it).gt.eps)stop'ProNucSpl: should not happen (4)' + alp=1.d0/(1.d0+dble(alplea(icltar))) + ncon=0 + zsum=0d0 + do l=1,ltarg3(it) + kt=ktarg3(it,l) + ip=iproj(kt) + if(kolp(ip).gt.0)then + do m=1,lproj3(ip) + kp=kproj(ip,m) + if(itpr(kp).gt.0)then + do n=1,nprmx(kp) + if(xpr(n,kp).gt.xzcutpar(kp))then + ncon=ncon+1 + knopp(ncon)=kp + zfrac(ncon)=dble(zpartar(kp)) + zsum=zsum+zfrac(ncon) + endif + enddo + endif + enddo + endif + enddo + if(ish.ge.4)write(ifch,*)'ProNucSpl zsum:',zsum,ncon + if(zsum.gt.0d0)then + xr0=xmt(it)-drangen(xmt(it))**alp + xrr=xr0 + if(ish.ge.6)write(ifch,*)'xrr:',xrr + do nc=1,ncon + k=knopp(nc) + xk=zfrac(nc)/zsum*xr0 + if(ish.ge.6)write(ifch,*)'xk:',nc,k,xk + ipp=iproj(k) + itt=itarg(k) + do n=1,nprmx(k) + if(xpr(n,k).gt.xzcutpar(k))then + xm=xmpr(n,k)+xk + if(xm.lt.1d0)then +c accept xp with probability GFF/PomIncExact + PomInt=PomInck(k) + if(PomInt.gt.0d0)then + proba=omGamk(k,xppr(n,k),xm) + & *xpp(ipp)**dble(alplea(iclpro)) + & *xmt(itt)**dble(alplea(icltar)) + & *xrr**dble(alplea(icltar)) + & / PomInt + if(drangen(proba).lt.proba)then !accept xp for pair k + xmpr(n,k)=xm + xpr(n,k)=xppr(n,k)*xmpr(n,k) + ypr(n,k)=0.5D0*log(xppr(n,k)/xmpr(n,k)) + xmt(it)=xmt(it)-xk + knucnt(2,k)=knucnt(2,k)+1 !store info of momentum transfer + irnuc(knucnt(2,k),2,k)=it !in case of virpom later + npnuc(knucnt(2,k),2,k)=n + xxnuc(knucnt(2,k),2,k)=xk + if(ish.ge.6)write(ifch,*)'Transfer:' + & ,knucnt(2,k),k,n,xk,it + goto 20 + endif + endif + endif + endif + enddo + xrr=xrr-xk + 20 continue + enddo + if(xrr.lt.eps)then + iet(it)=0 !excitation not possible + zzremn(it,2)=0. + endif + if(ish.ge.4)write(ifch,*)'ProNucSpl out:',iet(it),xrr + else + iet(it)=0 + zzremn(it,2)=0. + if(ish.ge.4)write(ifch,*)'ProNucSpl out:',iet(it) + endif + else + if(ish.ge.4)write(ifch,*)'ProNucSpl out:',iet(it) + endif + else + iet(it)=0 + endif + endif + + end + +c------------------------------------------------------------------------- + subroutine ProPoTy(k,n) +c------------------------------------------------------------------------- +c propose pomeron type +c------------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + common/cems5/plc,s + double precision s,plc + double precision ww,w0,w1,w2,w3,w4,w5,w(0:7),aks,eps,zdiff + *,xh,yp!,xp,xm + parameter(eps=1.d-10) + logical cont + dimension nnn(3),kkk(3) + + if(idpr(n,k).eq.0)return + ip=iproj(k) + it=itarg(k) + if(ish.ge.4)write(ifch,*)'ProPoTy:k,n,idpr,x',k,n,ip,it,nprt(k) + * ,idpr(n,k),xpr(n,k) + if(idpr(n,k).ne.1)call utstop('ProPoTy: should not happen&') + + cont=.true. + do i=1,3 + nnn(i)=0 + kkk(i)=0 + enddo + + idfpr(n,k)=1 + xh=xpr(n,k) + yp=ypr(n,k) +c xp=xppr(n,k) +c xm=xmpr(n,k) + nnn(3)=n + kkk(3)=k + + if(iep(ip).ne.5)iep(ip)=-1 + if(iet(it).ne.5)iet(it)=-1 + + + idpr(n,k)=1 + + w0=0.d0 + w1=0.d0 + w2=0.d0 + w3=0.d0 + w4=0.d0 + w5=0.d0 + + call WomTy(w,xh,yp,k) + + + if(w(0).gt.0.d0)w0=w(0) + if(w(1).gt.0.d0)w1=w(1) + if(iremn.ge.2)then + if(w(2).gt.0.d0)then !q-g + if(ivp(ip).gt.0)then + w2=w(2) + else + w1=w1+w(2) + endif + endif + if(w(3).gt.0.d0)then !g-q + if(ivt(it).gt.0)then + w3=w(3) + else + w1=w1+w(3) + endif + endif + if(w(4).gt.0.d0)then !q-q + if(ivp(ip)*ivt(it).gt.0)then + w4=w(4) + else + w1=w1+w(4) + endif + endif + else + if(w(2).gt.0.d0)w2=w(2) + if(w(3).gt.0.d0)w3=w(3) + if(w(4).gt.0.d0)w4=w(4) + endif + if(w(5).gt.0.d0)w5=w(5) + + ww=w0+w1+w2+w3+w4+w5 + if(ish.ge.4)write(ifch,*)'ProPoTy:ww,ww_i' + * ,ww,w0/ww*100.d0,w1/ww*100.d0,w2/ww*100.d0 + * ,w3/ww*100.d0,w4/ww*100.d0,w5/ww*100.d0 + + + aks=dble(rangen())*ww + + if(ww.lt.eps.or.aks.le.w0)then !soft pomeron + + itpr(k)=-2*npommx !Pair is not diffractive + if(ish.ge.5)write(ifch,*)'ProPoTy:idpr',idpr(n,k) + + elseif(aks.ge.ww-w5)then !diffractive interaction + + itpr(k)=itpr(k)+2 +c the probability to have a real diffractive Pomeron increase with Z and hard P +c zdiff=exp(-min(50.d0,dble(zdfinc*(zparpro(k)+zpartar(k)))*w1)) + zdiff=1d0/sqrt(1d0+dble(zdfinc*(zparpro(k)+zpartar(k)))*w1) +c print *,xpr(n,k),zdiff,w1!,zdiff2 + if(ish.ge.5)write(ifch,*)'ProPoTy:itpr',itpr(k),zdiff + if(xpr(n,k).gt.xzcutpar(k).and.rangen().gt.zdiff)then +c if(rangen().gt.zdiff)then +c High mass diffraction : Keep pomeron and choose between soft and semi-hard + aks=dble(rangen())*(w0+w1) + if(aks.gt.w0)then + idpr(n,k)=3 + npr(3,k)=npr(3,k)+1 + npr(1,k)=npr(1,k)-1 + bhpr(n,k)=bk(k) + idhpr(n,k)=0 +c elseif(iLHC.eq.1)then +c idpr(n,k)=-1 + endif + else + if(iLHC.eq.1)then !LHC tune +c keep soft Pomeron for later + idpr(n,k)=-1 + else !original CR +c Low mass diffraction : no pomeron +c restore x from nuclear splitting + if(knucnt(1,k).gt.0)then + do nuc=1,knucnt(1,k) + if(npnuc(nuc,1,k).eq.n)then + ipp=irnuc(nuc,1,k) + xpp(ipp)=xpp(ipp)+xxnuc(nuc,1,k) + if(xpp(ipp)-1d0.ge.-1d-10)iep(ipp)=0 + xppr(n,k)=xppr(n,k)-xxnuc(nuc,1,k) + xpr(n,k)=xppr(n,k)*xmpr(n,k) + ypr(n,k)=0.5D0*log(xppr(n,k)/xmpr(n,k)) + npnuc(nuc,1,k)=0 !to be sure not to use it again + endif + enddo + endif + if(knucnt(2,k).gt.0)then + do nuc=1,knucnt(2,k) + if(npnuc(nuc,2,k).eq.n)then + itt=irnuc(nuc,2,k) + xmt(itt)=xmt(itt)+xxnuc(nuc,2,k) + if(xmt(itt)-1d0.ge.-1d-10)iet(itt)=0 + xmpr(n,k)=xmpr(n,k)-xxnuc(nuc,2,k) + xpr(n,k)=xppr(n,k)*xmpr(n,k) + ypr(n,k)=0.5D0*log(xppr(n,k)/xmpr(n,k)) + npnuc(nuc,2,k)=0 !to be sure not to use it again + endif + enddo + endif + call RemPom(k,n) + idfpr(n,k)=0 + npr(0,k)=npr(0,k)+1 !nr of empty cells + kolp(ip)=kolp(ip)-1 !suppress diffractive collision from the remnant + kolt(it)=kolt(it)-1 !it will be restored if the pair is diffractive + if(ish.ge.6)write(ifch,*)'ProPoTy:idpr',idpr(n,k) + endif + + endif + + else + + itpr(k)=-2*npommx !Pair is not diffractive + idpr(n,k)=3 + if(ish.ge.5)write(ifch,*)'ProPoTy:idpr',idpr(n,k) + npr(3,k)=npr(3,k)+1 + npr(1,k)=npr(1,k)-1 + bhpr(n,k)=bk(k) + + aks=aks-w0 + if(aks.le.w1)then !gg-pomeron + idhpr(n,k)=0 + elseif(aks.le.w1+w2)then !qg-pomeron + idhpr(n,k)=1 + ivp(ip)=ivp(ip)-1 + elseif(aks.le.w1+w2+w3)then !gq-pomeron + idhpr(n,k)=2 + ivt(it)=ivt(it)-1 + elseif(aks.le.w1+w2+w3+w4)then !qq-pomeron + idhpr(n,k)=3 + ivp(ip)=ivp(ip)-1 + ivt(it)=ivt(it)-1 + else + call utstop('ems-unknown pomeron&') + endif + if(ish.ge.6)write(ifch,*)'ProPoTy:idhpr',idhpr(n,k) + & ,' |',ip,ivp(ip),' |',it,ivt(it) + + endif + + if(idfpr(n,k).eq.1)then + antot=antot+1 + antotf=antotf+1 + if(abs(idpr(n,k)).eq.1)then + ansf=ansf+1 + ansff=ansff+1 + endif + if(idpr(n,k).eq.3)then + ansh=ansh+1 + anshf=anshf+1 + endif + endif + + do i=3,1,-1 + + if(nnn(i).ne.0.and.kkk(i).ne.0.and.cont)then + + if(idpr(nnn(i),kkk(i)).eq.3)then + + !Backup soft Pomeron if sh not possible later + + kb=kkk(i) + nb=nnn(i) + ip=iproj(kb) + it=itarg(kb) + do nn=1,nprmx(kb) + if(idpr(nn,kb).eq.0)then !empty spot + nbkpr(nb,kb)=nn + nvpr(nn,kb)=nb + idpr(nn,kb)=1 + ivpr(nn,kb)=2 + xpr(nn,kb)=xpr(nb,kb) + ypr(nn,kb)=ypr(nb,kb) + xppr(nn,kb)=xppr(nb,kb) + xmpr(nn,kb)=xmpr(nb,kb) + idfpr(nn,kb)=-idfpr(nb,kb) + bhpr(nn,kb)=bhpr(nb,kb) + idp1pr(nn,kb)=0 + idp2pr(nn,kb)=0 + idm1pr(nn,kb)=0 + idm2pr(nn,kb)=0 + xm1pr(nn,kb)=0.d0 + xp1pr(nn,kb)=0.d0 + xm2pr(nn,kb)=0.d0 + xp2pr(nn,kb)=0.d0 + xxm1pr(nn,kb)=0.d0 + xym1pr(nn,kb)=0.d0 + xxp1pr(nn,kb)=0.d0 + xyp1pr(nn,kb)=0.d0 + xxm2pr(nn,kb)=0.d0 + xym2pr(nn,kb)=0.d0 + xxp2pr(nn,kb)=0.d0 + xyp2pr(nn,kb)=0.d0 + goto 10 + endif + enddo + if(ish.ge.2)write(ifmt,*)'no empty lattice site, backup lost' + + 10 continue + endif + endif + enddo + + return + end + +c------------------------------------------------------------------------- + subroutine ProDiSc(k) +c------------------------------------------------------------------------- +c propose diffractive scattering +c------------------------------------------------------------------------- + + include 'epos.incems' + + ip=iproj(k) + it=itarg(k) + kolp(ip)=kolp(ip)+itpr(k)/2 !number of diffractive Pomerons + kolt(it)=kolt(it)+itpr(k)/2 !on remnants + + + end + +c------------------------------------------------------------------------- + subroutine ProReEx(ir,ii) +c------------------------------------------------------------------------- +c propose remnant excitation +c for proj (iep) if ir=1 or target (iet) if ir=-1: +c 0 = no, 1 = inel excitation, 2 = diffr excitation +c fixed before : 5 = excit due to split without connection +c fixed after : 3 = large excitation due to # quark > 3 +c 6 = active spectator (get small pt and used for mass) +c propose "pion exchange" process for diffractive remnant excitation +c for proj (iep) if ir=2 or target (iet) if ir=-2: +c 4 = diffr excitation but with fixed minimum excited mass +c------------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + include 'epos.incpar' + + + if(ir.eq.1)then !proj + + ip=ii + mine=0 + mdif=0 + do l=1,lproj(ip) + kp=kproj(ip,l) + if(itpr(kp).lt.0)mine=1 + if(itpr(kp).gt.0)mdif=1 + enddo + r=rangen() + if(mine.eq.1)then !inelastic + if(iremn.eq.1)then +c increase excitation probability with number of close enough nucleons + if(r.lt.1.-(1.-rexndi(iclpro))**(kolp(ip) + & *(1.+rexres(iclpro)*log(max(1.,float(lproj(ip)))))))then + iep(ip)=1 + else + iep(ip)=0 + endif + elseif(iremn.ne.0)then +c increase of inelastic remnant excitation in pA needed for Barton + if(r.lt.1.-(1.-rexndi(iclpro)) + & **(1.+rexres(iclpro)*float(lproj(ip)-1)))then + iep(ip)=1 + else + iep(ip)=0 + endif + else!if(iremn.ne.2)then + if(r.lt.rexndi(iclpro))then + iep(ip)=1 + else + iep(ip)=0 + endif + endif + elseif(mdif.eq.1)then !diffr + if(iremn.eq.1)then +c increase excitation probability with number of close enough nucleons + if(r.lt.1.-(1.-rexdif(iclpro))**(kolp(ip) + & *(1.+rexres(iclpro)*log(max(1.,float(lproj(ip)))))))then + iep(ip)=2 + else + iep(ip)=0 + endif + elseif(iremn.ne.0)then +c increase of diffractive remnant excitation in pA needed for Barton + if(r.lt.1.-(1.-rexdif(iclpro)) + & **(1.+rexres(iclpro)*float(lproj(ip)-1)))then + iep(ip)=2 + else + iep(ip)=0 + endif + else + if(r.lt.1.-(1.-rexdif(iclpro)))then + iep(ip)=2 + else + iep(ip)=0 + endif + endif + elseif(iep(ip).ne.5)then +c for non-excited spectators + iep(ip)=0 + endif + + elseif(ir.eq.-1)then !targ + + it=ii + mine=0 + mdif=0 + do l=1,ltarg(it) + kt=ktarg(it,l) + if(itpr(kt).lt.0)mine=1 + if(itpr(kt).gt.0)mdif=1 + enddo + r=rangen() + if(mine.eq.1)then !inelastic + if(iremn.eq.1)then + if(r.lt.1.-(1.-rexndi(icltar))**(kolt(it) + & *(1.+rexres(icltar)*log(max(1.,float(ltarg(it)))))))then + iet(it)=1 + else + iet(it)=0 + endif + elseif(iremn.ne.0)then +c increase of inelastic remnant excitation in pA needed for Barton + if(r.lt.1.-(1.-rexndi(icltar)) + & **(1.+rexres(icltar)*float(ltarg(it)-1)))then + iet(it)=1 + else + iet(it)=0 + endif + else + if(r.lt.rexndi(icltar))then + iet(it)=1 + else + iet(it)=0 + endif + endif + elseif(mdif.eq.1)then !diffr + if(iremn.eq.1)then + if(r.lt.1.-(1.-rexdif(icltar))**(kolt(it) + & *(1.+rexres(icltar)*log(max(1.,float(ltarg(it)))))))then + iet(it)=2 + else + iet(it)=0 + endif + elseif(iremn.ne.0)then +c increase of diffractive remnant excitation in pA needed for Barton anb xsection + if(r.lt.1.-(1.-rexdif(icltar)) + & **(1.+rexres(icltar)*float(ltarg(it)-1)))then + iet(it)=2 + else + iet(it)=0 + endif + else + if(r.lt.1.-(1.-rexdif(icltar)))then + iet(it)=2 + else + iet(it)=0 + endif + endif + elseif(iet(it).ne.5)then + iet(it)=0 + endif + + elseif(ir.eq.2)then !proj diff excitation + +c minimum mass excitation + ip=ii + r=rangen() +c if(r.lt.rexpdif(iclpro))iep(ip)=4 + if(r.lt.rexpdif(iclpro) + & **(1.+rexres(iclpro)*float(lproj(ip)-1)))iep(ip)=4 + + elseif(ir.eq.-2)then !targ diff excitation + +cminimum mass excitation + it=ii + r=rangen() +c if(r.lt.rexpdif(icltar))iet(it)=4 + if(r.lt.rexpdif(icltar) + & **(1.+rexres(icltar)*float(ltarg(it)-1)))iet(it)=4 + + endif + + end + + +c------------------------------------------------------------------------- + subroutine ProDiPt(k,iqq,iret) +c------------------------------------------------------------------------- +c propose transverse momentum for diffractive interaction +c iqq=1 : fix pt for non diffractive pair (and check if all pairs are still valid) +c iqq=2 : diffractive pt with mass dependence +c------------------------------------------------------------------------- + + include 'epos.incems' + include 'epos.incsem' + include 'epos.inc' + double precision xxe(kollmx),xye(kollmx),pt2,am0,am1,am2!,p5sqpr,p5sqtg + double precision plc,s,xxpnew,xypnew,xxtnew,xytnew,rannorm + common/cems5/plc,s + common/emsptl/nppr(npommx,kollmx),npproj(mamx),nptarg(mamx) + save xxe,xye + + ip=iproj(k) + it=itarg(k) + pt=0. + phi=0. + + +c generate p_t for diffractive + if(iqq.eq.1)then + + if(ptdiff.gt.0.)then + if(itpr(k).eq.2)then + pt=ranpt()*ptdiff/(1.+0.02*max(0.,sngl(log(s)))) + elseif(itpr(k).eq.0)then !pt for non-wounded nucleon (usefull in ProRem to avoid problem in utrescl) + if(iLHC.eq.1)then + pt = sngl(RANNORM(0.088D0,0.044D0)) !limited by some data like sal.optns + else + ptnw=0.005 + pt=ranptd()*ptnw + endif + if(kolp(ip).eq.0.and.iep(ip).le.0)iep(ip)=6 !active spectators + if(kolt(it).eq.0.and.iet(it).le.0)iet(it)=6 + else + xxe(k)=0d0 + xye(k)=0d0 + goto 10 + endif + phi=2.*pi*rangen() + xxe(k)=dble(pt*cos(phi)) + xye(k)=dble(pt*sin(phi)) + else + xxe(k)=0d0 + xye(k)=0d0 + endif + +c update remnant p_t + + 10 xxp(ip)=xxp(ip)-xxe(k) + xyp(ip)=xyp(ip)-xye(k) + xxt(it)=xxt(it)+xxe(k) + xyt(it)=xyt(it)+xye(k) + + if(ish.ge.8)write(ifch,'(a,i5,3i4,4g13.5)') + & 'ProDiPt',k,ip,it,itpr(k),pt,phi,xxe(k),xye(k) + + if(itpr(k).ne.0.and.itpr(k).ne.3)iret=0 +!to simulate the fact that originally we had a Pomeron +c if(koll.le.2)then +c call StoCon(-k,k,1) !to fixe mass of corresponding remnants +c xpp(ip)=xpp(ip)-xppr(1,k) +c xpt(it)=xpt(it)+xppr(1,k) +c xmt(it)=xmt(it)-xmpr(1,k) +c xmp(ip)=xmp(ip)+xmpr(1,k) +c idpr(1,k)=0 +c xpr(1,k)=0.d0 +c ypr(1,k)=0.d0 +c xppr(1,k)=0.d0 +c xmpr(1,k)=0.d0 +c endif +c p5sqpr=xpp(ip)*xmp(ip)*s-dble(amproj*amproj) +c p5sqtg=xpt(it)*xmt(it)*s-dble(amtarg*amtarg) +c phi=2.*pi*rangen() +c ntry=0 +c 20 ntry=ntry+1 +c pt=ranptcut(ptsems)*ptsend**2 +c if(ntry.lt.100.and.(p5sqpr-dble(pt*pt).lt.0.d0 +c & .or.p5sqtg-dble(pt*pt).lt.0.d0))then +c goto 20 +c else +c pt=ranptcut(ptsems)*ptsendi +c endif +c xxe(k)=dble(pt*cos(phi)) +c xye(k)=dble(pt*sin(phi)) +c xxp(ip)=xxp(ip)-xxe(k) +c xyp(ip)=xyp(ip)-xye(k) +c xxt(it)=xxt(it)+xxe(k) +c xyt(it)=xyt(it)+xye(k) +c endif + + elseif(itpr(k).eq.2.and.ptdiff.ne.0.)then + + pt2=xxe(k)*xxe(k)+xye(k)*xye(k) + if(pt2.gt.0d0)then + am0=dble(amproj**2*amtarg**2) + am1=max(dble(amproj**2),xpp(ip)*xmp(ip)*s + & -xxp(ip)*xxp(ip)-xyp(ip)*xyp(ip)) + am2=max(dble(amtarg**2),xpt(it)*xmt(it)*s + & -xxp(it)*xxp(it)-xyp(it)*xyp(it)) + ptd=ptdiff/(1.+0.02*max(0.,sngl(log(s*am0/am1/am2)))) !0.02 comes from data (Z. Phys. C 67, 227-237, 1995) +c ad=pi/4./ptd**2 +c r=rangen() + pt=ranpt()*ptd !sqrt(-alog(r)/ad) + else + return + endif + if(ish.ge.8)write(ifch,'(a,i5,2i4,5g13.5)') + & 'ProDiPt',k,ip,it,pt,sqrt(pt2),ptd,am1,am2 +c suppress the pt given with iqq=1 and give a new one taking into account the mass (iqq=2) with the same angle phi + pt=pt/sqrt(pt2) + xxe(k)=xxe(k)*pt + xye(k)=xye(k)*pt + +c update remnant p_t if enough energy available + xxpnew=xxp(ip)-xxe(k) + xypnew=xyp(ip)-xye(k) + xxtnew=xxt(it)+xxe(k) + xytnew=xyt(it)+xye(k) + if((iep(ip).eq.0.or. + & xpp(ip)*xmp(ip)*s-xxpnew*xxpnew-xypnew*xypnew + & .gt.1.3d0*dble(pptl(5,npproj(ip)))**2) + &.and.(iet(it).eq.0.or. + & xpt(it)*xmt(it)*s-xxtnew*xxtnew-xytnew*xytnew + & .gt.1.3d0*dble(pptl(5,nptarg(it)))**2))then + xxp(ip)=xxp(ip)-xxe(k) + xyp(ip)=xyp(ip)-xye(k) + xxt(it)=xxt(it)+xxe(k) + xyt(it)=xyt(it)+xye(k) + endif + + endif + + end + +c------------------------------------------------------------------------- + subroutine ProSePt(k,n,iret) +c------------------------------------------------------------------------- +c propose transverse momentum for string ends +c------------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + common/cems5/plc,s + double precision s,plc + double precision x1p,x2p,x1t,x2t + + if(ivpr(n,k).eq.2)return !Backup Pomeron + + ip=iproj(k) + it=itarg(k) + amk0=1. ! included in ptsend !(qmass(1)+qmass(2)+qmass(3))/3. !mass for mt distribution + + ptsecut=ptsecu !cut for gaussian distribution (center around 0.4) + +c generate p_t for string ends (proj) + iret=0 + ntry=0 + 10 ntry=ntry+1 + xxp1pr(n,k)=0d0 + xyp1pr(n,k)=0d0 + xxp2pr(n,k)=0d0 + xyp2pr(n,k)=0d0 + xxm1pr(n,k)=0d0 + xym1pr(n,k)=0d0 + xxm2pr(n,k)=0d0 + xym2pr(n,k)=0d0 + x1p=0d0 + x2p=0d0 + x1t=0d0 + x2t=0d0 + pt=0. + phi=0. + if(ntry.gt.100)then + iret=1 + goto 1000 !no pt + endif +c +c !---proj----- + ptsef=ptsend + if(iep(ip).eq.0)ptsef=ptsendi + ptsendx = ptsems + ptsendy = ptsendx + if(iLHC.eq.0)ptsendy = ptsendx*2 + + ipt=1 + +c 2 step pt : first give pt between remnant and Pomeron and then between +c string ends on the same side. + if(iLHC.eq.-1)ipt=2 + + do ii=1,ipt + + if(idp1pr(n,k).gt.0)then + if(ii.eq.1)then + if(idp1pr(n,k).eq.4.or.idp1pr(n,k).eq.5)then !diquarks + amk1=amk0*ptsendy+qmass(0) !mass for mt distribution with bounding energy for diquark + else + amk1=amk0*ptsendx + endif +c if(iep(ip).eq.0)amk1=0. + if(iep(ip).eq.0)then + pt=ranptd()*ptsef + else + pt=ranptcut(ptsecut)*ptsef +c pt=ranptd()*ptsef + pt=pt+amk1 + endif +c pt=ranptcut(ptsecut)*ptsef +c pt=pt+amk1 +c pt=ranptd()*ptsef +c pt=sqrt(pt*pt+amk1*amk1) + else + pt=ranpt()*ptfraqq + endif + phi=2.*pi*rangen() + xxp1pr(n,k)=xxp1pr(n,k)+dble(pt*cos(phi)) + xyp1pr(n,k)=xyp1pr(n,k)+dble(pt*sin(phi)) + else + xxp1pr(n,k)=0d0 + xyp1pr(n,k)=0d0 + endif + if(idp2pr(n,k).gt.0)then + if(ii.eq.1)then + if(idp2pr(n,k).eq.4.or.idp2pr(n,k).eq.5)then + amk1=amk0*ptsendy+qmass(0) !mass for mt distribution with bounding energy for diquark + else + amk1=amk0*ptsendx + endif +c if(iep(ip).eq.0)amk1=0. + if(iep(ip).eq.0)then + pt=ranptd()*ptsef + else + pt=ranptcut(ptsecut)*ptsef +c pt=ranptd()*ptsef + pt=pt+amk1 + endif +c pt=ranptcut(ptsecut)*ptsef +c pt=pt+amk1 +c pt=ranptd()*ptsef +c pt=sqrt(pt*pt+amk1*amk1) + phi=2.*pi*rangen() + else !use pt and phi from other string ends + pt=-pt + endif + xxp2pr(n,k)=xxp2pr(n,k)+dble(pt*cos(phi)) + xyp2pr(n,k)=xyp2pr(n,k)+dble(pt*sin(phi)) + else + xxp2pr(n,k)=0d0 + xyp2pr(n,k)=0d0 + endif +c generate p_t for string ends (targ) + + +c !---targ----- + ptsef=ptsend + if(iet(it).eq.0)ptsef=ptsendi + ptsendx = ptsems + ptsendy = ptsendx + if(iLHC.eq.0)ptsendy = ptsendx*2. + + if(idm1pr(n,k).gt.0)then + if(ii.eq.1)then + if(idm1pr(n,k).eq.4.or.idm1pr(n,k).eq.5)then + amk1=amk0*ptsendy+qmass(0) !mass for mt distribution with bounding energy for diquark + else + amk1=amk0*ptsendx + endif +c if(iet(it).eq.0)amk1=0. + if(iet(it).eq.0)then + pt=ranptd()*ptsef + else + pt=ranptcut(ptsecut)*ptsef +c pt=ranptd()*ptsef + pt=pt+amk1 + endif +c pt=ranptcut(ptsecut)*ptsef +c pt=pt+amk1 +c pt=ranptd()*ptsef +c pt=sqrt(pt*pt+amk1*amk1) + else + pt=ranpt()*ptfraqq + endif + phi=2.*pi*rangen() + xxm1pr(n,k)=xxm1pr(n,k)+dble(pt*cos(phi)) + xym1pr(n,k)=xym1pr(n,k)+dble(pt*sin(phi)) + else + xxm1pr(n,k)=0d0 + xym1pr(n,k)=0d0 + endif + if(idm2pr(n,k).gt.0)then + if(ii.eq.1)then + if(idm2pr(n,k).eq.4.or.idm2pr(n,k).eq.5)then + amk1=amk0*ptsendy+qmass(0) !mass for mt distribution with bounding energy for diquark + else + amk1=amk0*ptsendx + endif +c if(iet(it).eq.0)amk1=0. + if(iet(it).eq.0)then + pt=ranptd()*ptsef + else + pt=ranptcut(ptsecut)*ptsef +c pt=ranptd()*ptsef + pt=pt+amk1 + endif +c pt=ranptcut(ptsecut)*ptsef +c pt=pt+amk1 +c pt=ranptd()*ptsef +c pt=sqrt(pt*pt+amk1*amk1) + phi=2.*pi*rangen() + else !use pt and phi from other string ends + pt=-pt + endif + xxm2pr(n,k)=xxm2pr(n,k)+dble(pt*cos(phi)) + xym2pr(n,k)=xym2pr(n,k)+dble(pt*sin(phi)) + else + xxm2pr(n,k)=0d0 + xym2pr(n,k)=0d0 + endif + + if(ii.eq.1)then !balance pt bwteen string ends and remnant + + x1p=xxp(ip)-xxp1pr(n,k)-xxp2pr(n,k) + x2p=xyp(ip)-xyp1pr(n,k)-xyp2pr(n,k) + x1t=xxt(it)-xxm1pr(n,k)-xxm2pr(n,k) + x2t=xyt(it)-xym1pr(n,k)-xym2pr(n,k) + + if(iLHC.eq.1)then !check energy + if(x1p**2+x2p**2+2.*amproj**2.ge.xpp(ip)*s)goto 10 + if(x1t**2+x2t**2+2.*amtarg**2.ge.xmt(it)*s)goto 10 + endif + + endif + + if(ish.ge.8)write(ifch,*) 'ProSePt',ii,n,k + * ,sqrt(xxp1pr(n,k)**2+xyp1pr(n,k)**2) + * ,sqrt(xxp2pr(n,k)**2+xyp2pr(n,k)**2) + * ,sqrt(xxm1pr(n,k)**2+xym1pr(n,k)**2) + * ,sqrt(xxm2pr(n,k)**2+xym2pr(n,k)**2) + + enddo + + +c update remnant p_t (pomeron) + xxp(ip)=x1p + xyp(ip)=x2p + xxt(it)=x1t + xyt(it)=x2t + +c update backup soft pomeron p_t if exist + + 1000 if(nbkpr(n,k).ne.0)then + nn=nbkpr(n,k) + xxp1pr(nn,k)=xxp1pr(n,k) + xyp1pr(nn,k)=xyp1pr(n,k) + xxp2pr(nn,k)=xxp2pr(n,k) + xyp2pr(nn,k)=xyp2pr(n,k) + xxm1pr(nn,k)=xxm1pr(n,k) + xym1pr(nn,k)=xym1pr(n,k) + xxm2pr(nn,k)=xxm2pr(n,k) + xym2pr(nn,k)=xym2pr(n,k) + endif + + if(ish.ge.6)then + write(ifch,*) 'ProSePt' + write(ifch,'(4i14/4d14.3/4d14.3/)') + * idp1pr(n,k),idp2pr(n,k),idm1pr(n,k),idm2pr(n,k) + *,xxp1pr(n,k),xxp2pr(n,k),xxm1pr(n,k),xxm2pr(n,k) + *,xyp1pr(n,k),xyp2pr(n,k),xym1pr(n,k),xym2pr(n,k) + endif + + end + +c----------------------------------------------------------------------- + subroutine ProSeX(k,n,iret) +c----------------------------------------------------------------------- +c calculates x of string ends +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + common/cems5/plc,s + double precision s,plc + common/cems10/a(0:ntypmx),b(0:ntypmx),d(0:ntypmx) + double precision a,b,d + *,xp,xm,ap1,ap2,am1,am2,aamin1,aamin2,u + *,xmn1,xmn2 + + iret=0 + + if(abs(itpr(k)).ne.1)return + if(idpr(n,k).ne.1.or.ivpr(n,k).eq.0)return + + if(idp1pr(n,k).eq.0.and.idp2pr(n,k).eq.0 + * .and.idm1pr(n,k).eq.0.and.idm2pr(n,k).eq.0) + *call utstop('no Pomeron in ProSex&') + + xp=xppr(n,k) + xm=xmpr(n,k) + ap1=a(idp1pr(n,k)) + ap2=a(idp2pr(n,k)) + am1=a(idm1pr(n,k)) + am2=a(idm2pr(n,k)) + aamin1=ammn(idp1pr(n,k)+idm2pr(n,k)) + aamin2=ammn(idp2pr(n,k)+idm1pr(n,k)) + xmn1=(aamin1**2+(xxp1pr(n,k)+xxm2pr(n,k))**2 + & +(xyp1pr(n,k)+xym2pr(n,k))**2)/s + xmn2=(aamin2**2+(xxp2pr(n,k)+xxm1pr(n,k))**2 + & +(xyp2pr(n,k)+xym1pr(n,k))**2)/s + + ntry=0 + 999 ntry=ntry+1 + if(ntry.gt.100)then + iret=1 + if(ish.ge.5)write(ifch,*)'Problem in ProSex(k,n)',k,n + return + endif + + 1 u=dble(rangen())**(1d0/(1d0+ap1)) + if(dble(rangen()).gt.(1d0-u)**ap2)goto1 + xp1pr(n,k)=u*xp + xp2pr(n,k)=(1-u)*xp + 2 u=dble(rangen())**(1d0/(1d0+am1)) + if(dble(rangen()).gt.(1d0-u)**am2)goto2 + xm1pr(n,k)=u*xm + xm2pr(n,k)=(1-u)*xm + + if(xp1pr(n,k)*xm2pr(n,k).lt.xmn1)then + goto 999 +c fc=xp1pr(n,k)*xm2pr(n,k)/xmn1 !avoid virpom +c if(fc.eq.0.)goto 999 +c xp1pr(n,k)=xp1pr(n,k)/sqrt(fc) +c xm2pr(n,k)=xm2pr(n,k)/sqrt(fc) + endif + if(xp2pr(n,k)*xm1pr(n,k).lt.xmn2)then + goto 999 +c fc=xp2pr(n,k)*xm1pr(n,k)/xmn2 !avoid virpom +c if(fc.eq.0.)goto 999 +c xp2pr(n,k)=xp2pr(n,k)/sqrt(fc) +c xm1pr(n,k)=xm1pr(n,k)/sqrt(fc) + endif + + if(ish.ge.6)then + write(ifch,*) 'ProSeX' + write(ifch,'(2d28.3,i8)') xp,xm,ntry + write(ifch,'(4d14.3)')xp1pr(n,k),xp2pr(n,k),xm1pr(n,k),xm2pr(n,k) + write(ifch,'(4d14.3/)')xp1pr(n,k)*xm2pr(n,k) + * ,xp2pr(n,k)*xm1pr(n,k), xmn1, xmn2 + endif + + end +c------------------------------------------------------------------------- + subroutine RmPt(k,n) +c------------------------------------------------------------------------- +c remove pt from pomeron +c------------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + ip=iproj(k) + it=itarg(k) + xxp(ip)=xxp(ip)+xxp1pr(n,k)+xxp2pr(n,k) + xyp(ip)=xyp(ip)+xyp1pr(n,k)+xyp2pr(n,k) + xxt(it)=xxt(it)+xxm1pr(n,k)+xxm2pr(n,k) + xyt(it)=xyt(it)+xym1pr(n,k)+xym2pr(n,k) + xp1pr(n,k)=0d0 + xp2pr(n,k)=0d0 + xm1pr(n,k)=0d0 + xm2pr(n,k)=0d0 + xxm1pr(n,k)=0d0 + xym1pr(n,k)=0d0 + xxp1pr(n,k)=0d0 + xyp1pr(n,k)=0d0 + xxm2pr(n,k)=0d0 + xym2pr(n,k)=0d0 + xxp2pr(n,k)=0d0 + xyp2pr(n,k)=0d0 + idp1pr(n,k)=0 + idm2pr(n,k)=0 + idp2pr(n,k)=0 + idm1pr(n,k)=0 + end + +c------------------------------------------------------------------------- + subroutine VirPom(k,n,id) +c------------------------------------------------------------------------- +c create virtual pomeron +c virtual pomeron: ivpr(n,k)=0, otherwise ivpr(n,k)=1 +c------------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + common/col3/ncol,kolpt + common/emsptl/nppr(npommx,kollmx),npproj(mamx),nptarg(mamx) + double precision plc,s + common/cems5/plc,s + integer jcp(nflav,2),jct(nflav,2) +c data nvir/0/ +c save nvir + + call utpri('VirPom',ish,ishini,3) + + if(idpr(n,k).eq.0)return + + ip=iproj(k) + it=itarg(k) + + nnv=nvpr(n,k) + nnb=nbkpr(n,k) + +c nvir=nvir+1 +c print *,' ',id,' ',nvir + + if(ish.ge.3)then + write(ifch,*)"virpom ",id," (n,k)",n,k,nnb,nnv,nppr(n,k),itpr(k) + & ,nprt(k),idpr(n,k),npr(1,k),npr(3,k) + if(ish.ge.5)write(ifch,*)"remnant in",xpp(ip),xmt(it) + endif + + if(nnv.ne.0)then + nn=nnv + kk=k + if(idpr(nn,kk).eq.0)then + nvpr(n,k)=0 + endif + endif + + if(nnb.ne.0)then + nn=nnb + kk=k + if(idpr(nn,kk).eq.0)then + nbkpr(n,k)=0 + endif + endif + + + if(nbkpr(n,k).eq.0.and.nvpr(n,k).eq.0)then !normal Pomeron + + npr(0,k)=npr(0,k)+1 + npp(ip)=npp(ip)-1 + npt(it)=npt(it)-1 + npr(idpr(n,k),k)=npr(idpr(n,k),k)-1 + nprt(k)=npr(1,k)+npr(3,k) + antotf=antotf-1 + if(idpr(n,k).eq.1)ansff=ansff-1 + if(idpr(n,k).eq.3)anshf=anshf-1 + kolp(ip)=kolp(ip)-1 + kolt(it)=kolt(it)-1 + xxp(ip)=xxp(ip)+xxp1pr(n,k)+xxp2pr(n,k) + xyp(ip)=xyp(ip)+xyp1pr(n,k)+xyp2pr(n,k) + xxt(it)=xxt(it)+xxm1pr(n,k)+xxm2pr(n,k) + xyt(it)=xyt(it)+xym1pr(n,k)+xym2pr(n,k) + +c restore x from nuclear splitting + if(knucnt(1,k).gt.0)then + do nuc=1,knucnt(1,k) + if(npnuc(nuc,1,k).eq.n)then + ipp=irnuc(nuc,1,k) + xpp(ipp)=xpp(ipp)+xxnuc(nuc,1,k) + if(xpp(ipp).ge.1d0)iep(ipp)=0 + xppr(n,k)=xppr(n,k)-xxnuc(nuc,1,k) + xpr(n,k)=xppr(n,k)*xmpr(n,k) + ypr(n,k)=0.5D0*log(xppr(n,k)/xmpr(n,k)) + npnuc(nuc,1,k)=0 !to be sure not to use it again + endif + enddo + endif + if(knucnt(2,k).gt.0)then + do nuc=1,knucnt(2,k) + if(npnuc(nuc,2,k).eq.n)then + itt=irnuc(nuc,2,k) + xmt(itt)=xmt(itt)+xxnuc(nuc,2,k) + if(xmt(itt).ge.1d0)iet(itt)=0 + xmpr(n,k)=xmpr(n,k)-xxnuc(nuc,2,k) + xpr(n,k)=xppr(n,k)*xmpr(n,k) + ypr(n,k)=0.5D0*log(xppr(n,k)/xmpr(n,k)) + npnuc(nuc,2,k)=0 !to be sure not to use it again + endif + enddo + endif + + xpp(ip)=xpp(ip)+xppr(n,k) + xmt(it)=xmt(it)+xmpr(n,k) + + + if(abs(itpr(k)).eq.1.and.nprt(k).eq.0)then !no more Pomeron on this pair + if(itpr(k).gt.0)then + itpr(k)=2 !this pair is diffractive + if(id.gt.0.and.iep(ip).eq.0.and.iet(it).eq.0)itpr(k)=3 !this pair is empty now + else + itpr(k)=3 !this pair is empty now + endif + endif + + endif + + istring=idp1pr(n,k)+idp2pr(n,k)+idm1pr(n,k)+idm2pr(n,k) + if(istring.ne.0.and.iremn.ge.2)then + if(ish.ge.7)write(ifch,*)"restore flavor:",istring + + if(idp1pr(n,k).eq.2)ivp(ip)=ivp(ip)+1 !update number of valence quark + if(idm1pr(n,k).eq.2)ivt(it)=ivt(it)+1 + if(idp2pr(n,k).eq.2)ivp(ip)=ivp(ip)+1 + if(idm2pr(n,k).eq.2)ivt(it)=ivt(it)+1 + if(idp1pr(n,k).eq.5)idp(ip)=idp(ip)+1 !update number of valence diquark + if(idm1pr(n,k).eq.5)idt(it)=idt(it)+1 + if(idp2pr(n,k).eq.5)idp(ip)=idp(ip)+1 + if(idm2pr(n,k).eq.5)idt(it)=idt(it)+1 + if(iLHC.eq.1)then + if(idp1pr(n,k).eq.4)idp(ip)=idp(ip)-1 !update number of diquark + if(idm1pr(n,k).eq.4)idt(it)=idt(it)-1 + if(idp2pr(n,k).eq.4)idp(ip)=idp(ip)-1 + if(idm2pr(n,k).eq.4)idt(it)=idt(it)-1 + endif + + if(iremn.eq.3)then !virtual Pomeron (remove unnecessary flavors for string ends) + do j=1,2 + do i=1,nrflav + jcp(i,j)=jcpref(i,j,ip) + jct(i,j)=jctref(i,j,it) + enddo + do i=nrflav+1,nflav + jcp(i,j)=0 + jct(i,j)=0 + enddo + enddo + if(ish.ge.7)write(ifch,*)"in:",jcp,' |',jct + iret=0 + +c Projectile diquark-antidiquark pair + iaq=nint(1.5+sign(0.5,float(idproj))) + iq=3-iaq + if(idp1pr(n,k).eq.4)then !diquark +c first quark + idum=idrafl(iclpro,jcp,iaq,'v',0,iret) !pick anti-quark + ntry=0 + do while (jcp(idum,iq).eq.0.and.ntry.lt.100)!look for the corresponding quark + ntry=ntry+1 + idum=idrafl(iclpro,jcp,iaq,'v',0,iret) + enddo + if(ntry.lt.100)then !if OK, then remove the pair and pick a second quark + call idsufl3(idum,1,jcp) + call idsufl3(idum,2,jcp) + if(jcp(idum,1)-jcpval(idum,1,ip).lt.0) !check valence quark number + & jcpval(idum,1,ip)=jcpval(idum,1,ip)-1 + if(jcp(idum,2)-jcpval(idum,2,ip).lt.0) + & jcpval(idum,2,ip)=jcpval(idum,2,ip)-1 + +c second quark + idum=idrafl(iclpro,jcp,iaq,'v',0,iret) + ntry2=0 + do while (jcp(idum,iq).eq.0.and.ntry2.lt.100)!look for the corresponding antiquark + ntry2=ntry2+1 + idum=idrafl(iclpro,jcp,iaq,'v',0,iret) + enddo + if(ntry2.lt.100)then !if OK, then remove the pair + call idsufl3(idum,1,jcp) + call idsufl3(idum,2,jcp) + if(jcp(idum,1)-jcpval(idum,1,ip).lt.0) + & jcpval(idum,1,ip)=jcpval(idum,1,ip)-1 + if(jcp(idum,2)-jcpval(idum,2,ip).lt.0) + & jcpval(idum,2,ip)=jcpval(idum,2,ip)-1 + else !if not (because quarks already used by other valid string), then redo event to avoid problem in flavor conservation + if(id.ge.15)then + id=-1 + return + else + call utstop("Virpom:should not happen (2) !&") + endif + endif + else !if no pair has be found (because quarks already used by other valid string), then redo event to avoid problem in flavor conservation + if(id.ge.15)then + id=-1 + return + else + call utstop("Virpom:should not happen (3) !&") + endif + endif + +c Projectile quark-antiquark pair + else + idum=idrafl(iclpro,jcp,iaq,'v',0,iret) !pick anti-quark + ntry=0 + do while (jcp(idum,iq).eq.0.and.ntry.lt.100) !look for the corresponding quark + ntry=ntry+1 + idum=idrafl(iclpro,jcp,iaq,'v',0,iret) + enddo + if(ntry.lt.100)then !if OK, then remove the pair + call idsufl3(idum,1,jcp) + call idsufl3(idum,2,jcp) + if(jcp(idum,1)-jcpval(idum,1,ip).lt.0) + & jcpval(idum,1,ip)=jcpval(idum,1,ip)-1 + if(jcp(idum,2)-jcpval(idum,2,ip).lt.0) + & jcpval(idum,2,ip)=jcpval(idum,2,ip)-1 + else !if not (because quarks already used by other valid string),then redo event to avoid problem in flavor conservation + if(id.ge.15)then + id=-1 + return + else + call utstop("Virpom:should not happen (4) !&") + endif + endif + endif + +c Target diquark-antidiquark pair + iaq=nint(1.5+sign(0.5,float(idtarg))) + iq=3-iaq + if(idm1pr(n,k).eq.4)then !diquark +c first quark + idum=idrafl(icltar,jct,iaq,'v',0,iret) + ntry=0 + do while (jct(idum,iq).eq.0.and.ntry.lt.100) + ntry=ntry+1 + idum=idrafl(icltar,jct,iaq,'v',0,iret) + enddo + if(ntry.lt.100)then + call idsufl3(idum,1,jct) + call idsufl3(idum,2,jct) + if(jct(idum,1)-jctval(idum,1,it).lt.0) + & jctval(idum,1,it)=jctval(idum,1,it)-1 + if(jct(idum,2)-jctval(idum,2,it).lt.0) + & jctval(idum,2,it)=jctval(idum,2,it)-1 +c second quark + idum=idrafl(icltar,jct,1,'v',0,iret) + ntry2=0 + do while (jct(idum,2).eq.0.and.ntry2.lt.100) + ntry2=ntry2+1 + idum=idrafl(icltar,jct,1,'v',0,iret) + enddo + if(ntry2.lt.100)then + call idsufl3(idum,1,jct) + call idsufl3(idum,2,jct) + if(jct(idum,1)-jctval(idum,1,it).lt.0) + & jctval(idum,1,it)=jctval(idum,1,it)-1 + if(jct(idum,2)-jctval(idum,2,it).lt.0) + & jctval(idum,2,it)=jctval(idum,2,it)-1 + else + if(id.ge.15)then + id=-1 + return + else + call utstop("Virpom:should not happen (5) !&") + endif + endif + else + if(id.ge.15)then + id=-1 + return + else + call utstop("Virpom:should not happen (6) !&") + endif + endif + +c Target quark-antiquark pair + else + idum=idrafl(icltar,jct,1,'v',0,iret) + ntry=0 + do while (jct(idum,2).eq.0.and.ntry.lt.100) + ntry=ntry+1 + idum=idrafl(icltar,jct,1,'v',0,iret) + enddo + if(ntry.lt.100)then + call idsufl3(idum,1,jct) + call idsufl3(idum,2,jct) + if(jct(idum,1)-jctval(idum,1,it).lt.0) + & jctval(idum,1,it)=jctval(idum,1,it)-1 + if(jct(idum,2)-jctval(idum,2,it).lt.0) + & jctval(idum,2,it)=jctval(idum,2,it)-1 + else + if(id.ge.15)then + id=-1 + return + else + call utstop("Virpom:should not happen (7) !&") + endif + endif + endif + + if(ish.ge.7)write(ifch,*)"out:",jcp,' |',jct + do j=1,2 + do i=1,nrflav + jcpref(i,j,ip)=jcp(i,j) + jctref(i,j,it)=jct(i,j) + enddo + enddo + + endif + endif + + + ivpr(n,k)=0 + nbkpr(n,k)=0 + nvpr(n,k)=0 + idpr(n,k)=0 + idfpr(n,k)=0 + xpr(n,k)=0d0 + ypr(n,k)=0d0 + xppr(n,k)=0d0 + xmpr(n,k)=0d0 + idp1pr(n,k)=0 + idp2pr(n,k)=0 + idm1pr(n,k)=0 + idm2pr(n,k)=0 + xm1pr(n,k)=0d0 + xp1pr(n,k)=0d0 + xm2pr(n,k)=0d0 + xp2pr(n,k)=0d0 + xxm1pr(n,k)=0d0 + xym1pr(n,k)=0d0 + xxp1pr(n,k)=0d0 + xyp1pr(n,k)=0d0 + xxm2pr(n,k)=0d0 + xym2pr(n,k)=0d0 + xxp2pr(n,k)=0d0 + xyp2pr(n,k)=0d0 + + if(ish.ge.5)write(ifch,*)"remnant out",xpp(ip),xmt(it),itpr(k) + + call utprix('VirPom',ish,ishini,3) + + end + +c----------------------------------------------------------------------- + subroutine StoRe(imod) +c----------------------------------------------------------------------- +c Store Remnant configuration (imod=1) before shuffle to restore the +c initial configuration (imod=-1) in case of problem. +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + + if(imod.eq.1)then + +c initialize projectile + + do i=1,maproj + iepst(i)=iep(i) + xppst(i)=xpp(i) + xmpst(i)=xmp(i) + xposst(i)=xpos(i) + enddo + +c initialize target + + do j=1,matarg + ietst(j)=iet(j) + xmtst(j)=xmt(j) + xptst(j)=xpt(j) + xtosst(j)=xtos(j) + enddo + + elseif(imod.eq.-1)then + +c restore projectile + + do i=1,maproj + iep(i)=iepst(i) + xpp(i)=xppst(i) + xmp(i)=xmpst(i) + xpos(i)=xposst(i) + enddo + +c restore target + + do j=1,matarg + iet(j)=ietst(j) + xmt(j)=xmtst(j) + xpt(j)=xptst(j) + xtos(j)=xtosst(j) + enddo + + else + + call utstop('Do not know what to do in StoRe.&') + + endif + + return + end + +c----------------------------------------------------------------------- + subroutine UpdateFlav(ir,jc,mod) +c----------------------------------------------------------------------- +C Add valence quark to sea quarks in projectile jcpref (mod=10) or target +c jctref (mod=20) for soft string ends (mod=0 reset jcrpref and +c jctref to 0). +c For mod=1 or 2, save jcref into jc. +c For mod=-1 or -2, put jc into jcref. +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + dimension ic(2),jc(nflav,2),jc2(nflav,2) + + if(mod.eq.0)then + do j=1,2 + do i=1,nrflav + jcpref(i,j,ir)=0 + jctref(i,j,ir)=0 + enddo + enddo + elseif(mod.eq.-1)then + do j=1,2 + do i=1,nrflav + jcpref(i,j,ir)=jc(i,j) + enddo + enddo + elseif(mod.eq.-2)then + do j=1,2 + do i=1,nrflav + jctref(i,j,ir)=jc(i,j) + enddo + enddo + elseif(mod.eq.1)then + do j=1,2 + do i=1,nrflav + jc(i,j)=jcpref(i,j,ir) + enddo + enddo + elseif(mod.eq.2)then + do j=1,2 + do i=1,nrflav + jc(i,j)=jctref(i,j,ir) + enddo + enddo + elseif(mod.eq.10)then + ic(1)=icproj(1,ir) + ic(2)=icproj(2,ir) + call iddeco(ic,jc) + itest=0 + do j=1,2 + do i=1,nrflav + jcpref(i,j,ir)=jcpref(i,j,ir)+jc(i,j) + enddo + enddo + +c cancel quark and antiquarks to avoid to much remnant excitation + do i=1,nrflav + + if(iLHC.eq.1)then + + if(jcpref(i,1,ir).ge.jcpref(i,2,ir))then + jcpref(i,1,ir)=jcpref(i,1,ir)-jcpref(i,2,ir) + jcpref(i,2,ir)=0 +c update valence quarks (cancel first sea quarks) + if(jcpref(i,1,ir)-jc(i,1).lt.0)jc(i,1)=jcpref(i,1,ir) + jc(i,2)=0 + else + jcpref(i,2,ir)=jcpref(i,2,ir)-jcpref(i,1,ir) + jcpref(i,1,ir)=0 +c update valence quarks (cancel first sea quarks) + if(jcpref(i,2,ir)-jc(i,2).lt.0)jc(i,2)=jcpref(i,2,ir) + jc(i,1)=0 + endif + + endif + + do j=1,2 + itest=itest+jcpref(i,j,ir) + jc2(i,j)=jcpref(i,j,ir) + enddo + enddo + if(itest.eq.0)then !do not leave empty remnant + idum=idrafl(iclpro,jc2,1,'r',3,iretso) !create q-qb + do j=1,2 + do i=1,nrflav + jcpref(i,j,ir)=jc2(i,j) + enddo + enddo + endif + if(ish.ge.6)write(ifch,'(a,i3,a,1x,4i3,3x,4i3)') + & 'jcpref(',ir,') ini:',((jcpref(i,j,ir),i=1,nflavems),j=1,2) + elseif(mod.eq.20)then + ic(1)=ictarg(1,ir) + ic(2)=ictarg(2,ir) + call iddeco(ic,jc) + itest=0 + do j=1,2 + do i=1,nrflav + jctref(i,j,ir)=jctref(i,j,ir)+jc(i,j) + enddo + enddo + + do i=1,nrflav + + if(iLHC.eq.1)then + +c cancel quark and antiquarks to avoid to much remnant excitation + if(jctref(i,1,ir).ge.jctref(i,2,ir))then + jctref(i,1,ir)=jctref(i,1,ir)-jctref(i,2,ir) + jctref(i,2,ir)=0 +c update valence quarks (cancel first sea quarks) + if(jctref(i,1,ir)-jc(i,1).lt.0)jc(i,1)=jctref(i,1,ir) + jc(i,2)=0 + else + jctref(i,2,ir)=jctref(i,2,ir)-jctref(i,1,ir) + jctref(i,1,ir)=0 +c update valence quarks (cancel first sea quarks) + if(jctref(i,2,ir)-jc(i,2).lt.0)jc(i,2)=jctref(i,2,ir) + jc(i,1)=0 + endif + + endif + + do j=1,2 + itest=itest+jctref(i,j,ir) + jc2(i,j)=jctref(i,j,ir) + enddo + enddo + if(itest.eq.0)then !do not leave empty remnant + idum=idrafl(icltar,jc2,1,'r',3,iretso) !create q-qb + do j=1,2 + do i=1,nrflav + jctref(i,j,ir)=jc2(i,j) + enddo + enddo + endif + if(ish.ge.6)write(ifch,'(a,i3,a,1x,4i3,3x,4i3)') + & 'jctref(',ir,') ini:',((jctref(i,j,ir),i=1,nflavems),j=1,2) + else + stop'mod not recognized in UpdateFlav' + endif + end + +c----------------------------------------------------------------------- + subroutine CalcZZ(ir,m) +c----------------------------------------------------------------------- +C Calculates zz for remnant m for proj (ir=1) or target (ir=-1) +c writes it to zzremn(m, 1 or 2) +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incpar' + if(isplit.eq.1)then + if(ir.eq.1)then + zz=0. + if(lproj3(m).ge.1)then + do l=1,lproj3(m) + kpair=kproj3(m,l) + zpar=zparpro(kpair) + zz=zz+min(zpar,epscrx) + enddo + endif + zzremn(m,1)=zz + elseif(ir.eq.-1)then + zz=0 + if(ltarg3(m).ge.1)then + do l=1,ltarg3(m) + kpair=ktarg3(m,l) + zpar=zpartar(kpair) + zz=zz+min(zpar,epscrx) + enddo + endif + zzremn(m,2)=zz + else + stop'CalcZZ: invalid option. ' + endif + else + if(ir.eq.1) zzremn(m,1)=0 + if(ir.eq.-1)zzremn(m,2)=0 + endif + end + +c----------------------------------------------------------------------- + subroutine WriteZZ(ir,irem) +c----------------------------------------------------------------------- +c Write Z into zpaptl(K) for connected strings +c K is the index for the string end +c on the corresponding remnant side +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + common/emsptl/nppr(npommx,kollmx),npproj(mamx),nptarg(mamx) + common/cems5/plc,s + double precision s,plc + + if(ir.eq.1)then + jrem=1 + elseif(ir.eq.-1)then + jrem=2 + else + jrem=0 + call utstop("Wrong ir in WriteZZ !&") + endif + + do li=1,lremn(irem,jrem) + kkk=kremn(irem,li,jrem) +c ip=iproj(kkk) +c it=itarg(kkk) + amtot=0. + do n=1,nprmx(kkk) + if(idpr(n,kkk).ne.0)amtot=amtot+sngl(xpr(n,kkk)*s) + enddo + amtot=sqrt(amtot) + do n=1,nprmx(kkk) + if(idpr(n,kkk).ne.0)then + npom=nppr(n,kkk) +c write(ifch,*)'remn',irem,' (',jrem,' ) pom',npom +c & ,' ',zzremn(irem,jrem) + ie=0 + is1=0 + if(ifrptl(1,npom).gt.0)then + do is=ifrptl(1,npom),ifrptl(2,npom) + if(ie.eq.0)is1=is + if(idptl(is).ne.9)ie=ie+1 + if(ie.eq.2)then + is2=is + ie=0 + if(ir.eq. 1)then +c Z for remnant ip (low if alone and high in nucleus) + zpaptl(1,is1)=zzremn(irem,jrem) +c sum of Z of remnant itt linked to ip (high if connected to many other remn) + zpaptl(2,is1)=amtot !float(nprt(kkk)) !float(lproj(ip)) +c zpaptl(2,is1)=0. +c if(lproj(ip).ge.1)then +c do l=1,lproj(ip) +c kpair=kproj(ip,l) +c itt=itarg(kpair) +c zpaptl(2,is1)=zpaptl(2,is1)+zzremn(itt,2) +c enddo +c endif + endif + if(ir.eq.-1)then +c Z for remnant it (low if alone and high in nucleus) + zpaptl(1,is2)=zzremn(irem,jrem) +c sum of Z of remnant ipp linked to it (high if connected to many other remn) + zpaptl(2,is2)=float(nprt(kkk)) !float(ltarg(it)) +c zpaptl(2,is2)=0. +c if(ltarg(it).ge.1)then +c do l=1,ltarg(it) +c kpair=ktarg(it,l) +c ipp=iproj(kpair) +c zpaptl(2,is2)=zpaptl(2,is2)+zzremn(ipp,1) +c enddo +c endif + endif +c do isi=is1,is2 +c write(ifch,*)' ',isi,idptl(isi),zpaptl(1,isi),zpaptl(2,isi) +c enddo + endif + enddo + endif + endif + enddo + enddo + + end + +c----------------------------------------------------------------------- + subroutine ProReM(ir,irem,iret) +c----------------------------------------------------------------------- +c propose remnant mass of remnant irem in case of proj (ir=1) +c or target (ir=-1) +c (-> xmp, xpt) +c iret : input : if iret=10 force to give mass even if no more energy, +c when input not 10 : output = error if 1 +c Energy is taken only from the other side nucleon which are close enough +c to form a pair even if that pair was not used for a collision. +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + double precision rr,xxx,xmin,xmax,msmin,xmmin,xpt2rem,xtest0,xtmp + double precision at,alp,xi,xii,eps,sx,xmin0,xtest(mamx),fxtest + parameter(eps=1.d-20) + common/cemsr5/at(0:1,0:5) + double precision plc,s,p5sq,aremn,aremnex,xxmax,drangen!,xmdrmax + common/cems5/plc,s + integer icrmn(2),jc(nflav,2) + logical cont,force,drop,excited + character cremn*4 + dimension k2j(mamx) + + call utpri('ProReM',ish,ishini,5) + + if(iret.eq.10)then + force=.true. + else + iret=0 + force=.false. + endif + ntrymx=50 + do j=1,2 + do i=1,nflav + jc(i,j)=0 + enddo + enddo + +c uncomment the following two lines to force the excitation + +ccc force=.true. !<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<< +ccc ntrymx=1 !<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<< + +c initial definitions + + ntry=0 + iremo1=0 + jremo=0 + if(ir.eq.1)then + cremn='targ' + jrem=1 + jremo=2 + masso=lproj(irem) !number of target nucleon linked to irem + do k=1,masso + k2j(k)=itarg(kproj(irem,k)) + xme(k2j(k))=0.d0 + enddo + icrmn(1)=icremn(1,irem,jrem) + if(icrmn(1).eq.999999)then !more than 9 quark : use jcpref + do j=1,2 + do i=1,nrflav + jc(i,j)=jcpref(i,j,irem) + enddo + enddo + else + icrmn(2)=icremn(2,irem,jrem) + call iddeco(icrmn,jc) + endif + amremn=amproj + !idx=isign(iabs(idproj)/10*10+1,idproj) + !call idmass(idx,amremn) + iremo1=itarg(1) + msmin=dble(amremn*amremn) + zz=1. + if(iez(irem,jrem).eq.3.or.iez(irem,jrem).eq.5) + & zz=zz+zzremn(irem,1)*zmsinc + elseif(ir.eq.-1)then + cremn='proj' + jrem=2 + jremo=1 + masso=ltarg(irem) !number of projectile nucleon linked to irem + do k=1,masso + k2j(k)=iproj(ktarg(irem,k)) + xme(k2j(k))=0.d0 + enddo + icrmn(1)=icremn(1,irem,jrem) + if(icrmn(1).eq.999999)then !more than 9 quark : use jctref + do j=1,2 + do i=1,nrflav + jc(i,j)=jctref(i,j,irem) + enddo + enddo + else + icrmn(2)=icremn(2,irem,jrem) + call iddeco(icrmn,jc) + endif + amremn=amtarg + !idx=isign(iabs(idtarg)/10*10+1,idtarg) + !call idmass(idx,amremn) + iremo1=iproj(1) + msmin=dble(amremn*amremn) + zz=1. + if(iez(irem,jrem).eq.3.or.iez(irem,jrem).eq.5) + & zz=zz+zzremn(irem,2)*zmsinc + endif + drop=.false. + if(iremn.ge.2.and.(iez(irem,jrem).eq.3.or.iez(irem,jrem).eq.5)) + & drop=.true. + excited=.false. + if(iez(irem,jrem).gt.0.and.iez(irem,jrem).ne.6) + & excited=.true. + +c for spectators only low mass and few partners, so do not care about energy + if(iez(irem,jrem).eq.6)force=.true. + +c defs + + sx=s*xpz(irem,jrem) + xpt2rem=xxz(irem,jrem)**2d0+xyz(irem,jrem)**2d0 + +c fremnux (+) and not fremnux2 (-) which gives a mass too low in case of gethadron where q and aq do not cancel + + + if(excited)then + aremn=dble(max(amremn,fremnux(jc))) +c if(iremn.eq.2.and.iez(irem,jrem).eq.3) !droplet +c & aremn=dble(max(amremn,fremnux(jc))) + if(iremn.ge.2)then + aremnex=aremn+amemn(idz(irem,jrem),iez(irem,jrem)) +c if(drop)aremnex=aremnex*zz + else + aremnex=aremn+amemn(idz(irem,jrem),iez(irem,jrem)) + endif + elseif(iLHC.eq.1)then !minimum mass for spectators should be as low as possible + aremn=amremn + aremnex=dble(max(amremn,fremnux2(jc))) + else !minimum mass for spectators should be as low as possible + aremn=dble(max(amremn,fremnux2(jc))) + aremnex=aremn + endif + + + if(ish.ge.8)write(ifch,10)ir,irem,masso,icrmn,iez(irem,jrem),force + & ,amremn,fremnux(jc),aremn,aremnex + & ,xpz(irem,jrem),xpt2rem,sx + 10 format('prorem : ',i3,2i4,2i7,i2,L2,/ + & ,' mass :',4g13.5,/ + & ,' x,pt,sx :',3g13.5) +c ntry + + 1 ntry=ntry+1 + if(ntry.gt.ntrymx)then + if(ish.ge.5)then + call utmsg('ProReM') + write(ifch,*)'Remnant mass assignment not possible (ntry)' + & ,ir,irem + if(force)write(ifch,*)'Ignore p4 conservation' + call utmsgf + endif + if(.not.force)then + iret=1 + goto 1000 + else +c not enough energy availabe : force last mass and check + goto 900 + endif + endif + +c check + + if(xpz(irem,jrem).le.0.d0)then + write(ifch,*)'ProRem ipp',xpz(irem,jrem) + & ,jrem,irem,lremn(irem,jrem) + do li=1,lremn(irem,jrem) + kkk=kremn(irem,li,jrem) + write(ifch,*)'kkk',kkk + enddo + call XPrint('ProRem :&') + call utstop('Big problem in ProRem !&') + endif + +c xtest = xminus-max, corresponding mostly to a remnant mass 0.2 + + xtest0=0.d0 + fxtest=0.4d0*(1d0+drangen(xxx)) !1.d0 !0.3d0 + do k=1,masso + j=k2j(k) + cont=.false. +ctp if(xmz(j,jremo).gt.eps.and.iez(j,jrem).gt.0)then !xmz(,jremo)=xplus +ctp060824 if(xmz(j,jremo).gt.eps.and.iez(j,jrem).ge.0)then !xmz(,jremo)=xplus +c if(iez(j,jremo).gt.0.or.koll.eq.1)then !xmz(,jremo)=xplus + if(xmz(j,jremo).gt.eps)then !xmz(,jremo)=xplus + cont=.true. + xmmin=xzos(j,jremo)/xmz(j,jremo) + else + xmmin=xzos(j,jremo) + endif + xtest(j)=xpz(j,jremo)-xmmin !maximal momentum available +!this term is very important for non excited remnants in pp, it changes the xf +! distribution of proton and the multiplicity at low energy. Fxtest should not +! be to close to 0. otherwise it makes a step in xf distribution of p at +! 1-fxtest but if fxtest=1, multiplicity at low energy is too high ... +! but better (and smoother) with exponential decrease). + if(.not.cont)then + if(xtest(j).gt.0d0)then + xtest(j)=min(xtest(j),fxtest/xpz(irem,jrem)) + else + xtest(j)=min(1.d0,fxtest/xpz(irem,jrem)) + endif + endif +c else +c xtest(j)=0.01d0 !maximal momentum available for non exited state +c endif + xtest0=max(xtest0,xtest(j)) +c print *,iep(1),iet(1),iez(irem,jrem),xtest(j),xpz(j,jremo),xmmin +c & ,xzos(j,jremo),xmz(j,jremo) + enddo +ctp060824 if(.not.cont)xtest=min(1.d0,0.2d0/xpz(irem,jrem)) + + + +c determine xminus + +c xmin0=1.05*(aremn**2d0+xxz(irem,jrem)**2d0+xyz(irem,jrem)**2d0)/sx +c xmin=1.1*(aremnex**2d0+xxz(irem,jrem)**2d0+xyz(irem,jrem)**2d0)/sx + xmin0=1.1d0*(aremn**2d0+xpt2rem)/sx + if(iLHC.eq.1.and.xmin0.ge.1.d0)xmin0=min(xmin0,0.9d0) + if(ish.ge.1.and.xmin0.ge.1d0) + & write(ifch,*)"Warning in ProReM with xmin0 !" + + if(iez(irem,jrem).eq.4)then !pion exchange, minim should not change + xmin=dble(xmindiff)*(aremnex**2d0+xpt2rem)/sx + else + xmin=dble(xminremn)*(aremnex**2d0+xpt2rem)/sx + endif +c xmax=min(1.d6/s,xtest0) !to avoid ultra high mass remnants + xmax=xtest0 +c for diffractive remnant, mass should never exceed 5% of the proj or targ energy +c if(iez(irem,jrem).eq.1)then +c xmax=min(xmax,max(dble(xminremn),xmin)) +c elseif(iez(irem,jrem).eq.2)then +c xmax=min(xmax,max(dble(xmindiff),xmin)) +c endif +c if(iez(irem,jrem).eq.1.or.iez(irem,jrem).eq.3)then +c xtmp=max(dble(min(1.,xminremn*float(maproj+matarg-1))),xmin) +c & *drangen(xmin) + xtmp=1.d0 + if(excited)then + if(iez(irem,jrem).eq.2)then +c xtmp=max(min(1d0,dble(xmindiff)),xmin)!*drangen(xmin) + xtmp=min(1d0,dble(xmxrem)*dble(masso) + & *drangen(xmin)**0.05) +c xtmp=dble(xmindiff) + elseif(iez(irem,jrem).eq.1)then + xtmp=min(1d0,dble(xmxrem)*dble(masso) + & *drangen(xmin)**0.05) +c xtmp=dble(xminremn) + elseif(drop)then !3 or 5 +c xtmp=max(dble(min(1.,xminremn*float(maproj+matarg-1))),xmin) +c & *drangen(xmin) + xtmp=min(1d0,dble(xmxrem)*zz*dble(masso) + & *drangen(xmin)**0.05) +c xtmp=dble(xminremn) + endif + endif + xmax=min(xmax,max(xtmp,xmin)) + if(ish.ge.8)write(ifch,*)'ntry',ntry,xmin,xmax,xtmp + * ,xmax*dble(masso),xmin0,excited + if(koll.eq.1)xmax=min(xmax,xpz(iremo1,jremo)) + xxmax=xmax*dble(masso)-eps + if(iLHC.eq.1)xxmax=min(1d0-eps,xxmax) !check energy limit + if(xmin.ge.xxmax)then + xmax=xxmax + xmin=xmin0 + if(xmin0.ge.xmax-eps)then + if(.not.force)then + iret=1 + elseif(excited)then + xmz(irem,jrem)=min(1.-xpz(irem,jrem), + & xmin0+0.5d0*(1d0-xmin0)*drangen(xmin)) !random not to form a peak + else + xxx=(aremn**2d0+xpt2rem)/sx + xmz(irem,jrem)=xxx +c xmin0=max(0.5d0,(1d0-((amzmn(idz(irem,jremo),jremo) +c & +6d0*drangen(xxx))**2+xpt2rem)/sx))*xxx + if(iLHC.eq.1)then !LHC tune (more reasonnable xsi distribution) +c xmin0=(1d0-xmin**0.3)*xxx + xmin0=max(0.35d0*(1d0+drangen(xxx)) + & ,1d0-((amzmn(idz(irem,jremo),jremo) + & +engy**drangen(xxx))**2+xpt2rem)/sx)*xxx + else !original CR version + xmin0=max(0.35d0*(1d0+drangen(xxx)) + & ,1d0-((amzmn(idz(irem,jremo),jremo) + & +sqrt(engy)*drangen(xxx)**0.5)**2+xpt2rem)/sx)*xxx + endif + endif + goto 1000 + endif + elseif(xmin.ge.xmax)then + xmax=1d0 + endif + rr=dble(rangen()) + alp=0. + xxx=0.d0 + if(excited)then +c xmin=xmin-xpt2rem/sx !no pt +c xmax=xmax-xpt2rem/sx !no pt + alp=at(idz(irem,jrem),iez(irem,jrem))/dble(zz) + + if(dabs(alp-1.d0).lt.eps)then + xxx=xmax**rr*xmin**(1d0-rr) + else + xxx=(rr*xmax**(1d0-alp)+(1d0-rr)*xmin**(1d0-alp)) + & **(1d0/(1d0-alp)) + endif +c xxx=xxx+xpt2rem/sx !no pt +!smooth distribution + if(iez(irem,jrem).eq.4)xmin=xmin0 + xmin0=xmin+(1d0-exp(-2d0*drangen(xxx)**2))*(xxx-xmin) + else + if(masso.eq.1)ntry=ntrymx !xxx is fixed so 1 try is enough +c xmin=dble(amremn)**2d0/sx !no pt +c xxx=xmin+xpt2rem/sx !no pt + xmin=(dble(aremn)**2d0+xpt2rem)/sx + xxx=xmin + if(xmin.gt.xmax+eps)then + if(ish.ge.6)write(ifch,*)'xmin>xmax for proj not possible (2)' + & ,ir,irem + if(.not.force)then + iret=1 + else + xmz(irem,jrem)=xxx + endif + goto 1000 + endif +c to have a nice diffractive peak, do not allow too much fluctuation +c this function is more or less a fit of the diffractive peak +c (pp100, ep-forward (ZEUS), NA49, pipp100, taking into account the +c contribution of inelastic remnants) + if(iLHC.eq.1)then !LHC tune (more reasonnable xsi distribution) +c xmin0=(1d0-xmin**0.3)*xxx + xmin0=max(0.35d0*(1d0+drangen(xxx)) + & ,1d0-((amzmn(idz(irem,jremo),jremo) + & +engy**drangen(xxx))**2+xpt2rem)/sx)*xxx + else !original CR version + xmin0=max(0.35d0*(1d0+drangen(xxx)) + & ,1d0-((amzmn(idz(irem,jremo),jremo) + & +sqrt(engy)*drangen(xxx)**0.5)**2+xpt2rem)/sx)*xxx + endif + +c write(*,*)'->',xmin0/xxx,sx,log10(1d0-xmin0/xxx) +c &,1d0-((amzmn(idz(irem,jremo),jremo) +c &+5d0*exp(-0.5d0*drangen(xxx)**2))**2+xpt2rem)/sx +c xmin0=dble(0.9+0.09*rangen())*xxx + endif + if(ish.ge.8)write(ifch,*)'alp',alp,xmin,xxx,xmax,zz + msmin=xmin*sx +c msmin=xmin*sx+xpt2rem !no pt + +c partition xminus between nucleons of the other side + + xii=1d0 + ii=masso + kk=int(rangen()*float(ii))+1 ! choose ramdomly a nucleon to start + + do while(ii.gt.0) + + iro=k2j(kk) + cont=iez(iro,jremo).lt.0.or.xme(iro).lt.-0.99d0 + do while(cont) + kk=kk+1 + if(kk.gt.masso)kk=kk-masso + iro=k2j(kk) + ii=ii-1 + if(ii.lt.1)then + ntry=ntrymx + goto 1 + endif + cont=iez(iro,jremo).lt.0.or.xme(iro).lt.-0.99d0 + enddo + + if(ii-1.gt.0)then + xi=xii*dble(rangen())**(1.d0/dble(ii-1)) + else + xi=0d0 + endif + xme(iro)=xxx*(xii-xi) + + xmmin=xzos(iro,jremo) + if(xmz(iro,jremo).gt.eps)then + xmmin=xmmin/xmz(iro,jremo) + elseif(koll.eq.1.and.xtest(iro).gt.eps)then + xmmin=xmmin/min(xpz(irem,jrem),xtest(iro)) + elseif(xtest(iro).gt.eps)then + xmmin=xmmin/xtest(iro) + endif + if((xpz(iro,jremo)-xme(iro)).lt.xmmin)then + if(ish.ge.8)write(ifch,*)' skip ',cremn,' ',ii,masso,ntry + & ,iro,xme(iro),xpz(iro,jremo)-xme(iro),xmmin + xme(iro)=-1.d0 + if(ii.le.1)goto 1 + else + xii=xi + if(ish.ge.8)write(ifch,*)' ok ',cremn,' ',ii,masso,ntry + & ,iro,xme(iro),xme(iro)/xxx + endif + kk=kk+1 + if(kk.gt.masso)kk=kk-masso + ii=ii-1 + + enddo + +c check xmz(irem,jrem) + + 900 xmz(irem,jrem)=xxx + + p5sq=xpz(irem,jrem)*xmz(irem,jrem)*s + if(ish.ge.8)write(ifch,*)'final mass',irem,p5sq,msmin + &,xpz(irem,jrem),xmz(irem,jrem),force + if(p5sq-msmin.lt.-1d-10)then + if(ish.ge.5)then + call utmsg('ProReM') + write(ifch,*)'Remnant mass assignment not possible (M<Mmin)!' + & ,ir,irem + if(force)write(ifch,*)'Ignore p4 conservation' + call utmsgf + endif + if(.not.force)then + iret=1 + elseif(xpz(irem,jrem).gt.0.d0)then + xmz(irem,jrem)=min(1.-xpz(irem,jrem), + & xmin+0.5d0*(1d0-xmin)*drangen(xmin)) !random not to form a peak + endif + goto 1000 + endif + +c subtract xme + + do k=1,masso + iro=k2j(k) + if(xme(iro).gt.0.d0)then + xpz(iro,jremo)=xpz(iro,jremo)-xme(iro) !xpz(,jremo)=xminus + endif + enddo + + 1000 continue + if(iret.ne.1)xzos(irem,jrem)=xmin0*xpz(irem,jrem) + + call utprix('ProReM',ish,ishini,5) + + end + +c----------------------------------------------------------------------- + subroutine ProSeTy(k,n) +c----------------------------------------------------------------------- +c creates proposal for string ends, idp., idm. +c updates quark counters +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + + common/ems6/ivp0,iap0,idp0,isp0,ivt0,iat0,idt0,ist0 + double precision pes,xfqp,xfqt !so01 + parameter(eps=1.e-6) + common/ems9/xfqp(0:9),xfqt(0:9) + common/emsx3/pes(0:3,0:6) + integer jcp(nflav,2),jct(nflav,2) + & ,jcpi(nflavems,2),jcti(nflavems,2) + logical go + + if(idpr(n,k).eq.2)stop'no Reggeons any more' + + iret=0 + ip=iproj(k) + it=itarg(k) + if(iremn.ge.3)then + do j=1,2 + do i=1,nrflav + jcp(i,j)=jcpref(i,j,ip) + jct(i,j)=jctref(i,j,it) + enddo + do i=nrflav+1,nflav + jcp(i,j)=0 + jct(i,j)=0 + enddo + enddo + endif + + idp1pr(n,k)=0 + idm1pr(n,k)=0 + idp2pr(n,k)=0 + idm2pr(n,k)=0 + idsppr(n,k)=0 + idstpr(n,k)=0 + pssp=0. + pvsp=0. + pvap=0. + pddp=0. + psvvp=0. + paasp=0. + psst=0. + pvst=0. + pvat=0. + pddt=0. + psvvt=0. + paast=0. + + if(iLHC.eq.1)then + +c for hard Pomeron, define which string ends are connected to valence quark +c treat gluon has soft string ends (including diquarks but can not be +c a "soft" valence like in soft Pomerons) later + if(idpr(n,k).eq.3)then + go=.false. + if(ivp0.eq.iap0.and.rangen().lt.0.5)go=.true. !meson + idsppr(n,k)=5 + if(idhpr(n,k).eq.3.or.idhpr(n,k).eq.1)then + if(iremn.ge.2)ivp(ip)=ivp(ip)-1 + if(iap0.eq.0.or.go)then !baryon + idp1pr(n,k)=2 + else !antibaryon + idp2pr(n,k)=2 + endif + endif + idstpr(n,k)=5 + if(idhpr(n,k).eq.3.or.idhpr(n,k).eq.2)then + if(iremn.ge.2)ivt(it)=ivp(it)-1 + if(iat0.eq.0)then !baryon + idm1pr(n,k)=2 + else !antibaryon + idm2pr(n,k)=2 + endif + endif + endif + + if(idpr(n,k).ne.0)then + +c projectile + + if(idfpr(n,k).eq.1.or.idfpr(n,k).eq.2)then + + ntry=0 + ivpi=ivp(ip) + idpi=idp(ip) + idspi=idsppr(n,k) + if(iremn.eq.3)then + do j=1,2 + do i=1,nrflav + jcpi(i,j)=jcp(i,j) + enddo + enddo + endif + 1 ntry=ntry+1 + if(ntry.gt.10)call utstop('something goes wrong in sr ProSeTy&') + ivp(ip)=ivpi + idp(ip)=idpi + idsppr(n,k)=idspi + if(iremn.eq.3)then + do j=1,2 + do i=1,nrflav + jcp(i,j)=jcpi(i,j) + enddo + enddo + endif + pss=wgtval+wgtsea + if(pss.gt.0.)then + pss=wgtsea/pss + else + pss=0. + endif + if(iremn.ge.2)then + if(iap0.eq.0)then + pvs=0. + if(ivp(ip).ne.0.and.idpr(n,k).ne.3)pvs=1.-pss + pva=0. + psvv=0. + if(idp(ip).ne.0.and.idp2pr(n,k).ne.2)psvv=wgtqqq(iclpro) + paas=0. + elseif(ivp0.eq.0)then + pva=0. + if(ivp(ip).ne.0.and.idpr(n,k).ne.3)pva=1.-pss + pvs=0. + psvv=0. + paas=0. + if(idp(ip).ne.0.and.idp1pr(n,k).ne.2)paas=wgtqqq(iclpro) + else !for meson, no soft string with valence quark (we do not know whether the quark or the antiquark will be used by hard string) + pvs=0. + pva=0. +c diquark or antidiquark can be created once in meson remnant + psvv=0. + paas=0. + if(1+idp(ip).ne.0)then + if(idp2pr(n,k).ne.2)psvv=wgtqqq(iclpro) + if(idp1pr(n,k).ne.2)paas=wgtqqq(iclpro) + endif + endif + pdd=wgtdiq/(1.+float(abs(idp(ip)))) +c if(idpr(n,k).eq.3)then +c pdd=0. +c psvv=0. +c paas=0. +c endif + elseif(iremn.ne.0)then + pvs=0. + pva=0. + psvv=0. + paas=0. + if(idp2pr(n,k).ne.2)psvv=wgtqqq(iclpro) + if(idp1pr(n,k).ne.2)paas=wgtqqq(iclpro) + pdd=wgtdiq/(1.+float(abs(idp(ip)))) + else + pvs=0. + pva=0. + psvv=0. + paas=0. + pdd=wgtdiq/(1.+float(abs(idp(ip)))) + endif + if(idp1pr(n,k).eq.2)then !with valence quark only 1 SE available + psd=pdd + pds=0. + pdd=0. + elseif(idp2pr(n,k).eq.2)then !with valence antiquark only 1 SE available + pds=pdd + psd=0. + pdd=0. + else + psd=pdd + pds=pdd + pdd=pdd**2 + endif + su=1.-min(1.,pdd+psd+pds) !diquark probability + pss=(1.-min(1.,pvs+pva))*su !no more valence quark: take from sea + pvs=pvs*su + pva=pva*su + su=1.-min(1.,psvv+paas) !stopping probability + pss=pss*su + pvs=pvs*su + pva=pva*su + psd=psd*su + pds=pds*su + pdd=pdd*su + su=pss+pvs+pva+pdd+psd+pds+psvv+paas + pssp = pss /su + pvsp = pvs /su + pvap = pva /su + psdp = psd /su + pdsp = pds /su + pddp = pdd /su + psvvp= psvv/su + paasp= paas/su + r=rangen() + if(r.gt.(pssp+pvsp+pvap+psdp+pdsp+psvvp+paasp) + & .and.pddp.gt.eps)then + if(idp1pr(n,k).ne.2)idp1pr(n,k)=4 + if(idp2pr(n,k).ne.2)idp2pr(n,k)=4 + idsppr(n,k)=idsppr(n,k)+4 + if(iremn.ge.2)idp(ip)=idp(ip)+2 + if(iremn.eq.3)then !add diquark flavor to jcpref for ProSeF later (sea quark) + idum=idrafl(iclpro,jcp,1,'s',3,iret) + idum=idrafl(iclpro,jcp,1,'d',3,iret) + idum=idrafl(iclpro,jcp,1,'s',3,iret) + idum=idrafl(iclpro,jcp,1,'d',3,iret) + endif + elseif(r.gt.(pssp+pvsp+pvap+psdp+psvvp+paasp).and.pdsp.gt.eps)then + if(idp1pr(n,k).ne.2)idp1pr(n,k)=4 + if(idp2pr(n,k).ne.2)idp2pr(n,k)=1 + idsppr(n,k)=idsppr(n,k)+4 + if(iremn.ge.2)idp(ip)=idp(ip)+1 + if(iremn.eq.3)then !add diquark flavor to jcpref for ProSeF later (sea quark) + idum=idrafl(iclpro,jcp,1,'s',3,iret) + idum=idrafl(iclpro,jcp,1,'d',3,iret) + endif + elseif(r.gt.(pssp+pvsp+pvap+psvvp+paasp).and.psdp.gt.eps)then + if(idp1pr(n,k).ne.2)idp1pr(n,k)=1 + if(idp2pr(n,k).ne.2)idp2pr(n,k)=4 + idsppr(n,k)=idsppr(n,k)+4 + if(iremn.ge.2)idp(ip)=idp(ip)+1 + if(iremn.eq.3)then !add diquark flavor to jcpref for ProSeF later (sea quark) + idum=idrafl(iclpro,jcp,1,'s',3,iret) + idum=idrafl(iclpro,jcp,1,'d',3,iret) + endif + elseif(r.gt.(pssp+pvsp+pvap+psvvp).and.paasp.gt.eps)then + if(idp1pr(n,k).ne.2)idp1pr(n,k)=5 + if(idp2pr(n,k).ne.2)idp2pr(n,k)=1 + idsppr(n,k)=idsppr(n,k)+5 + if(iremn.ge.2)idp(ip)=idp(ip)-1 + if(iremn.eq.3)idum=idrafl(iclpro,jcp,1,'s',3,iret) !add flavor to jcpref for ProSeF later (sea quark) (only a q-aq pair because we replace diquark by q-aq (baryon "decay" or "stopping") + elseif(r.gt.(pssp+pvsp+pvap+pddp).and.psvvp.gt.eps)then + if(idp1pr(n,k).ne.2)idp1pr(n,k)=1 + if(idp2pr(n,k).ne.2)idp2pr(n,k)=5 + idsppr(n,k)=idsppr(n,k)+5 + if(iremn.ge.2)idp(ip)=idp(ip)-1 + if(iremn.eq.3)idum=idrafl(iclpro,jcp,1,'s',3,iret) !add flavor to jcpref for ProSeF later (sea quark) (only a q-aq pair because we replace diquark by q-aq (baryon "decay" or "stopping") + elseif(r.gt.(pssp+pvsp).and.pvap.gt.eps)then + if(idp1pr(n,k).ne.2)idp1pr(n,k)=1 + if(idp2pr(n,k).ne.2)idp2pr(n,k)=2 + idsppr(n,k)=idsppr(n,k)+2 + if(iremn.ge.2)ivp(ip)=ivp(ip)-1 + if(iremn.eq.3)idum=idrafl(iclpro,jcp,1,'s',3,iret) !add flavor to jcpref for ProSeF later (sea quark) + elseif(r.gt.pssp.and.pvsp.gt.eps)then + if(idp1pr(n,k).ne.2)idp1pr(n,k)=2 + if(idp2pr(n,k).ne.2)idp2pr(n,k)=1 + idsppr(n,k)=idsppr(n,k)+2 + if(iremn.ge.2)ivp(ip)=ivp(ip)-1 + if(iremn.eq.3)idum=idrafl(iclpro,jcp,2,'s',3,iret) !add flavor to jcpref for ProSeF later (sea quark) + elseif(pssp.gt.eps)then + if(idp1pr(n,k).ne.2)idp1pr(n,k)=1 + if(idp2pr(n,k).ne.2)idp2pr(n,k)=1 + idsppr(n,k)=idsppr(n,k)+1 + if(iremn.eq.3)idum=idrafl(iclpro,jcp,1,'s',3,iret) !add flavor to jcpref for ProSeF later (sea quark) + else + goto 1 + endif + + else + idp1pr(n,k)=1 + idp2pr(n,k)=1 + idsppr(n,k)=0 + endif + + +c target + + if(idfpr(n,k).eq.1.or.idfpr(n,k).eq.3)then + + + ntry=0 + ivti=ivt(it) + idti=idt(it) + idsti=idstpr(n,k) + if(iremn.eq.3)then + do j=1,2 + do i=1,nrflav + jcti(i,j)=jct(i,j) + enddo + enddo + endif + 2 ntry=ntry+1 + if(ntry.gt.10)call utstop('something goes wrong in sr ProSeTy&') + ivt(it)=ivti + idt(it)=idti + idstpr(n,k)=idsti + if(iremn.eq.3)then + do j=1,2 + do i=1,nrflav + jct(i,j)=jcti(i,j) + enddo + enddo + endif + pss=wgtval+wgtsea + if(pss.gt.0.)then + pss=wgtsea/pss + else + pss=0. + endif + if(iremn.ge.2)then + if(iat0.eq.0)then + pvs=0. + if(ivt(it).ne.0.and.idpr(n,k).ne.3)pvs=1.-pss + pva=0. + psvv=0. + if(idt(it).ne.0.and.idm2pr(n,k).ne.2)psvv=wgtqqq(icltar) + paas=0. + elseif(ivt0.eq.0)then + pva=0. + if(ivt(it).ne.0.and.idpr(n,k).ne.3)pva=1.-pss + pvs=0. + psvv=0. + paas=0. + if(idt(it).ne.0.and.idm1pr(n,k).ne.2)paas=wgtqqq(icltar) + else !for meson, no soft string with valence quark (we do not know whether the quark or the antiquark will be used by hard string) + pvs=0. + pva=0. +c diquark or antidiquark can be created once in meson remnant + psvv=0. + paas=0. + if(1+idt(it).ne.0)then + if(idm2pr(n,k).ne.2)psvv=wgtqqq(icltar) + if(idm1pr(n,k).ne.2)paas=wgtqqq(icltar) + endif + endif + pdd=wgtdiq/(1.+float(abs(idt(it)))) +c if(idpr(n,k).eq.3)then +c pdd=0. +c psvv=0. +c paas=0. +c endif + elseif(iremn.ne.0)then + pvs=0. + pva=0. + psvv=0. + paas=0. + if(idm2pr(n,k).ne.2)psvv=wgtqqq(icltar) + if(idm1pr(n,k).ne.2)paas=wgtqqq(icltar) + pdd=wgtdiq/(1.+float(abs(idt(it)))) + else + pvs=0. + pva=0. + psvv=0. + paas=0. + pdd=wgtdiq/(1.+float(abs(idt(it)))) + endif + if(idm1pr(n,k).eq.2)then !with valence quark only 1 SE available + psd=pdd + pds=0. + pdd=0. + elseif(idm2pr(n,k).eq.2)then !with valence antiquark only 1 SE available + pds=pdd + psd=0. + pdd=0. + else + psd=pdd + pds=pdd + pdd=pdd**2 + endif + su=1.-min(1.,pdd+pds+psd) !diquark probability + pss=(1.-min(1.,pvs+pva))*su !no more valence quark: take from sea + pvs=pvs*su + pva=pva*su + su=1.-min(1.,psvv+paas) !stopping probability + pss=pss*su + pvs=pvs*su + pva=pva*su + pds=pds*su + psd=psd*su + pdd=pdd*su + su=pss+pvs+pva+pdd+psd+pds+psvv+paas + psst = pss /su + pvst = pvs /su + pvat = pva /su + psdt = psd /su + pdst = pds /su + pddt = pdd /su + psvvt= psvv/su + paast= paas/su + r=rangen() + if(r.gt.(psst+pvst+pvat+psdt+pdst+psvvt+paast) + & .and.pddt.gt.eps)then + if(idm1pr(n,k).ne.2)idm1pr(n,k)=4 + if(idm2pr(n,k).ne.2)idm2pr(n,k)=4 + idstpr(n,k)=idstpr(n,k)+4 + if(iremn.ge.2)idt(it)=idt(it)+2 + if(iremn.eq.3)then !add diquark flavor to jctref for ProSeF later (sea quark) + idum=idrafl(icltar,jct,1,'s',3,iret) + idum=idrafl(icltar,jct,1,'d',3,iret) + idum=idrafl(icltar,jct,1,'s',3,iret) + idum=idrafl(icltar,jct,1,'d',3,iret) + endif + elseif(r.gt.(psst+pvst+pvat+psdt+psvvt+paast).and.pdst.gt.eps)then + if(idm1pr(n,k).ne.2)idm1pr(n,k)=4 + if(idm2pr(n,k).ne.2)idm2pr(n,k)=1 + idstpr(n,k)=idstpr(n,k)+4 + if(iremn.ge.2)idt(it)=idt(it)+1 + if(iremn.eq.3)then !add diquark flavor to jctref for ProSeF later (sea quark) + idum=idrafl(icltar,jct,1,'s',3,iret) + idum=idrafl(icltar,jct,1,'d',3,iret) + endif + elseif(r.gt.(psst+pvst+pvat+psvvt+paast).and.psdt.gt.eps)then + if(idm1pr(n,k).ne.2)idm1pr(n,k)=1 + if(idm2pr(n,k).ne.2)idm2pr(n,k)=4 + idstpr(n,k)=idstpr(n,k)+4 + if(iremn.ge.2)idt(it)=idt(it)+1 + if(iremn.eq.3)then !add diquark flavor to jctref for ProSeF later (sea quark) + idum=idrafl(icltar,jct,1,'s',3,iret) + idum=idrafl(icltar,jct,1,'d',3,iret) + endif + elseif(r.gt.(psst+pvst+pvat+psvvt).and.paast.gt.eps)then + if(idm1pr(n,k).ne.2)idm1pr(n,k)=5 + if(idm2pr(n,k).ne.2)idm2pr(n,k)=1 + idstpr(n,k)=idstpr(n,k)+5 + if(iremn.ge.2)idt(it)=idt(it)-1 + if(iremn.eq.3)idum=idrafl(icltar,jct,1,'s',3,iret) !add flavor to jcpref for ProSeF later (sea quark) (only a q-aq pair because we replace diquark by q-aq (baryon "decay" or "stopping") + elseif(r.gt.(psst+pvst+pvat+pddt).and.psvvt.gt.eps)then + if(idm1pr(n,k).ne.2)idm1pr(n,k)=1 + if(idm2pr(n,k).ne.2)idm2pr(n,k)=5 + idstpr(n,k)=idstpr(n,k)+5 + if(iremn.ge.2)idt(it)=idt(it)-1 + if(iremn.eq.3)idum=idrafl(icltar,jct,1,'s',3,iret) !add flavor to jcpref for ProSeF later (sea quark) (only a q-aq pair because we replace diquark by q-aq (baryon "decay" or "stopping") + elseif(r.gt.(psst+pvst).and.pvat.gt.eps)then + if(idm1pr(n,k).ne.2)idm1pr(n,k)=1 + if(idm2pr(n,k).ne.2)idm2pr(n,k)=2 + idstpr(n,k)=idstpr(n,k)+2 + if(iremn.ge.2)ivt(it)=ivt(it)-1 + if(iremn.eq.3)idum=idrafl(icltar,jct,1,'s',3,iret) !add flavor to jctref for ProSeF later (sea quark) + elseif(r.gt.psst.and.pvst.gt.eps)then + if(idm1pr(n,k).ne.2)idm1pr(n,k)=2 + if(idm2pr(n,k).ne.2)idm2pr(n,k)=1 + idstpr(n,k)=idstpr(n,k)+2 + if(iremn.ge.2)ivt(it)=ivt(it)-1 + if(iremn.eq.3)idum=idrafl(icltar,jct,2,'s',3,iret) !add flavor to jctref for ProSeF later (sea quark) + elseif(psst.gt.eps)then + if(idm1pr(n,k).ne.2)idm1pr(n,k)=1 + if(idm2pr(n,k).ne.2)idm2pr(n,k)=1 + idstpr(n,k)=idstpr(n,k)+1 + if(iremn.eq.3)idum=idrafl(icltar,jct,1,'s',3,iret) !add flavor to jctref for ProSeF later (sea quark) + else + goto 2 + endif + + else + idm1pr(n,k)=1 + idm2pr(n,k)=1 + idstpr(n,k)=0 + endif + + else + + idp1pr(n,k)=0 + idm2pr(n,k)=0 + idp2pr(n,k)=0 + idm1pr(n,k)=0 + + endif + + else !iLHC + + if(idpr(n,k).eq.3)then + pssp=0. + pvsp=0. + pvap=0. + pddp=0. + psvvp=0. + paasp=0. + psst=0. + pvst=0. + pvat=0. + pddt=0. + psvvt=0. + paast=0. + if(idhpr(n,k).eq.3)then !so01 + idp1pr(n,k)=2 + idp2pr(n,k)=8 + idm1pr(n,k)=2 + idm2pr(n,k)=8 + elseif(idhpr(n,k).eq.2)then + idp1pr(n,k)=1 + idp2pr(n,k)=1 + idm1pr(n,k)=2 + idm2pr(n,k)=8 + elseif(idhpr(n,k).eq.1)then + idp1pr(n,k)=2 + idp2pr(n,k)=8 + idm1pr(n,k)=1 + idm2pr(n,k)=1 + elseif(idhpr(n,k).eq.0)then + idp1pr(n,k)=1 + idp2pr(n,k)=1 + idm1pr(n,k)=1 + idm2pr(n,k)=1 + else + call utstop('ProSeTy-idhpr????&') + endif + if(iremn.eq.3)then !add flavor to jcpref and jctref for psahot and ProSeF later (sea quark) + idum=idrafl(iclpro,jcp,1,'s',3,iret) + idum=idrafl(icltar,jct,1,'s',3,iret) + endif + + + elseif(idpr(n,k).eq.1)then + +c projectile + + if(idfpr(n,k).eq.1.or.idfpr(n,k).eq.2)then + + ntry=0 + ivpi=ivp(ip) + idpi=idp(ip) + if(iremn.eq.3)then + do j=1,2 + do i=1,nrflav + jcpi(i,j)=jcp(i,j) + enddo + enddo + endif + 3 ntry=ntry+1 + if(ntry.gt.10)call utstop('something goes wrong in sr ProSeTy&') + ivp(ip)=ivpi + idp(ip)=idpi + if(iremn.eq.3)then + do j=1,2 + do i=1,nrflav + jcp(i,j)=jcpi(i,j) + enddo + enddo + endif + pss=wgtval+wgtsea + if(pss.gt.0.)then + pss=wgtsea/pss + else + pss=0. + endif + if(iremn.ge.2)then + if(iap0.eq.0)then + pvs=0. + if(ivp(ip).ne.0)pvs=1.-pss + pva=0. + psvv=0. + if(idp(ip).ne.0)psvv=wgtqqq(iclpro) + paas=0. + elseif(ivp0.eq.0)then + pva=0. + if(ivp(ip).ne.0)pva=1.-pss + pvs=0. + psvv=0. + paas=0. + if(idp(ip).ne.0)paas=wgtqqq(iclpro) + else !for meson, no soft string with valence quark (we do not know whether the quark or the antiquark will be used by hard string) + pvs=0. + pva=0. +c diquark or antidiquark can be created once in meson remnant + psvv=0. + paas=0. + if(1+idp(ip).ne.0)then + psvv=wgtqqq(iclpro) + paas=wgtqqq(iclpro) + endif + endif + pdd=wgtdiq + elseif(iremn.ne.0)then + pvs=0. + pva=0. + psvv=wgtqqq(iclpro) + paas=wgtqqq(iclpro) + pdd=wgtdiq + else + pvs=0. + pva=0. + psvv=0. + paas=0. + pdd=wgtdiq + endif + su=1.-min(1.,pdd) !diquark probability + pss=(1.-min(1.,pvs+pva))*su !no more valence quark: take from sea + pvs=pvs*su + pva=pva*su + su=1.-min(1.,psvv+paas) !stopping probability + pdd=pdd*su + pss=pss*su + pvs=pvs*su + pva=pva*su + su=pss+pvs+pva+pdd+psvv+paas + pssp = pss /su + pvsp = pvs /su + pvap = pva /su + pddp = pdd /su + psvvp= psvv/su + paasp= paas/su + r=rangen() + if(r.gt.(pssp+pvsp+pvap+pddp+psvvp).and.paasp.gt.eps)then + idp1pr(n,k)=5 + idp2pr(n,k)=1 + idsppr(n,k)=6 + if(iremn.ge.2)idp(ip)=idp(ip)-1 + if(iremn.eq.3)idum=idrafl(iclpro,jcp,1,'s',3,iret) !add flavor to jcpref for ProSeF later (sea quark) (only a q-aq pair because we replace diquark by q-aq (baryon "decay" or "stopping") + elseif(r.gt.(pssp+pvsp+pvap+pddp).and.psvvp.gt.eps)then + idp1pr(n,k)=1 + idp2pr(n,k)=5 + idsppr(n,k)=5 + if(iremn.ge.2)idp(ip)=idp(ip)-1 + if(iremn.eq.3)idum=idrafl(iclpro,jcp,1,'s',3,iret) !add flavor to jcpref for ProSeF later (sea quark) (only a q-aq pair because we replace diquark by q-aq (baryon "decay" or "stopping") + elseif(r.gt.(pssp+pvsp+pvap).and.pddp.gt.eps)then + idp1pr(n,k)=4 + idp2pr(n,k)=4 + idsppr(n,k)=4 + if(iremn.eq.3)then !add diquark flavor to jcpref for ProSeF later (sea quark) + idum=idrafl(iclpro,jcp,1,'s',3,iret) + idum=idrafl(iclpro,jcp,1,'d',3,iret) + endif + elseif(r.gt.(pssp+pvsp).and.pvap.gt.eps)then + idp1pr(n,k)=1 + idp2pr(n,k)=2 + idsppr(n,k)=3 + if(iremn.ge.2)ivp(ip)=ivp(ip)-1 + if(iremn.eq.3)idum=idrafl(iclpro,jcp,1,'s',3,iret) !add flavor to jcpref for ProSeF later (sea quark) + elseif(r.gt.pssp.and.pvsp.gt.eps)then + idp1pr(n,k)=2 + idp2pr(n,k)=1 + idsppr(n,k)=2 + if(iremn.ge.2)ivp(ip)=ivp(ip)-1 + if(iremn.eq.3)idum=idrafl(iclpro,jcp,2,'s',3,iret) !add flavor to jcpref for ProSeF later (sea quark) + elseif(pssp.gt.eps)then + idp1pr(n,k)=1 + idp2pr(n,k)=1 + idsppr(n,k)=1 + if(iremn.eq.3)idum=idrafl(iclpro,jcp,1,'s',3,iret) !add flavor to jcpref for ProSeF later (sea quark) + else + goto 3 + endif + + else + idp1pr(n,k)=1 + idp2pr(n,k)=1 + idsppr(n,k)=0 + endif + + +c target + + if(idfpr(n,k).eq.1.or.idfpr(n,k).eq.3)then + + + ntry=0 + ivti=ivt(it) + idti=idt(it) + if(iremn.eq.3)then + do j=1,2 + do i=1,nrflav + jcti(i,j)=jct(i,j) + enddo + enddo + endif + 4 ntry=ntry+1 + if(ntry.gt.10)call utstop('something goes wrong in sr ProSeTy&') + ivt(it)=ivti + idt(it)=idti + if(iremn.eq.3)then + do j=1,2 + do i=1,nrflav + jct(i,j)=jcti(i,j) + enddo + enddo + endif + pss=wgtval+wgtsea + if(pss.gt.0.)then + pss=wgtsea/pss + else + pss=0. + endif + if(iremn.ge.2)then + if(iat0.eq.0)then + pvs=0. + if(ivt(it).ne.0)pvs=1.-pss + pva=0. + psvv=0. + if(idt(it).ne.0)psvv=wgtqqq(icltar) + paas=0. + elseif(ivt0.eq.0)then + pva=0. + if(ivt(it).ne.0)pva=1.-pss + pvs=0. + psvv=0. + paas=0. + if(idt(it).ne.0)paas=wgtqqq(icltar) + else !for meson, no soft string with valence quark (we do not know whether the quark or the antiquark will be used by hard string) + pvs=0. + pva=0. + psvv=0. + paas=0. +c diquark or antidiquark can be created once in meson remnant + if(1+idt(it).ne.0)then + psvv=wgtqqq(icltar) + paas=wgtqqq(icltar) + endif + endif + pdd=wgtdiq + elseif(iremn.ne.0)then + pvs=0. + pva=0. + psvv=wgtqqq(icltar) + paas=wgtqqq(icltar) + pdd=wgtdiq + else + pvs=0. + pva=0. + psvv=0. + paas=0. + pdd=wgtdiq + endif +c no more valence quark: take from sea + su=1.-min(1.,pdd) !diquark probability + pss=(1.-min(1.,pvs+pva))*su !no more valence quark: take from sea + pvs=pvs*su + pva=pva*su + su=1.-min(1.,psvv+paas) !stopping probability + pdd=pdd*su + pss=pss*su + pvs=pvs*su + pva=pva*su + su=pss+pvs+pva+pdd+psvv+paas + psst = pss /su + pvst = pvs /su + pvat = pva /su + pddt = pdd /su + psvvt= psvv/su + paast= paas/su + r=rangen() + if(r.gt.(psst+pvst+pvat+pddt+psvvt).and.paast.gt.eps)then + idm1pr(n,k)=5 + idm2pr(n,k)=1 + idstpr(n,k)=6 + if(iremn.ge.2)idt(it)=idt(it)-1 + if(iremn.eq.3)idum=idrafl(icltar,jct,1,'s',3,iret) !add flavor to jcpref for ProSeF later (sea quark) (only a q-aq pair because we replace diquark by q-aq (baryon "decay" or "stopping") + elseif(r.gt.(psst+pvst+pvat+pddt).and.psvvt.gt.eps)then + idm1pr(n,k)=1 + idm2pr(n,k)=5 + idstpr(n,k)=5 + if(iremn.ge.2)idt(it)=idt(it)-1 + if(iremn.eq.3)idum=idrafl(icltar,jct,1,'s',3,iret) !add flavor to jcpref for ProSeF later (sea quark) (only a q-aq pair because we replace diquark by q-aq (baryon "decay" or "stopping") + elseif(r.gt.(psst+pvst+pvat).and.pddt.gt.eps)then + idm1pr(n,k)=4 + idm2pr(n,k)=4 + idstpr(n,k)=4 + if(iremn.eq.3)then !add diquark flavor to jctref for ProSeF later (sea quark) + idum=idrafl(icltar,jct,1,'s',3,iret) + idum=idrafl(icltar,jct,1,'d',3,iret) + endif + elseif(r.gt.(psst+pvst).and.pvat.gt.eps)then + idm1pr(n,k)=1 + idm2pr(n,k)=2 + idstpr(n,k)=3 + if(iremn.ge.2)ivt(it)=ivt(it)-1 + if(iremn.eq.3)idum=idrafl(icltar,jct,1,'s',3,iret) !add flavor to jctref for ProSeF later (sea quark) + elseif(r.gt.psst.and.pvst.gt.eps)then + idm1pr(n,k)=2 + idm2pr(n,k)=1 + idstpr(n,k)=2 + if(iremn.ge.2)ivt(it)=ivt(it)-1 + if(iremn.eq.3)idum=idrafl(icltar,jct,2,'s',3,iret) !add flavor to jctref for ProSeF later (sea quark) + elseif(psst.gt.eps)then + idm1pr(n,k)=1 + idm2pr(n,k)=1 + idstpr(n,k)=1 + if(iremn.eq.3)idum=idrafl(icltar,jct,1,'s',3,iret) !add flavor to jctref for ProSeF later (sea quark) + else + goto 4 + endif + + else + idm1pr(n,k)=1 + idm2pr(n,k)=1 + idstpr(n,k)=0 + endif + + elseif(idpr(n,k).eq.0)then + + idp1pr(n,k)=0 + idm2pr(n,k)=0 + idp2pr(n,k)=0 + idm1pr(n,k)=0 + + endif + + endif + + if(ish.ge.6)then + write(ifch,'(a,2(6(f4.2,1x),2x),$)')'ProSeTy ', + * pssp,pvsp,pvap,pddp,psvvp,paasp, psst,pvst,pvat,pddt,psvvt,paast + write(ifch,'(2x,3i3,2x,2(i2,1x,2i2,1x,i2,i3,2x))')idpr(n,k),n,k + * ,idsppr(n,k),idp1pr(n,k),idp2pr(n,k),ivp(ip),idp(ip) + * ,idstpr(n,k),idm1pr(n,k),idm2pr(n,k),ivt(it),idt(it) + endif + + if(iremn.eq.3)then + do j=1,2 + do i=1,nrflav + jcpref(i,j,ip)=jcp(i,j) + jctref(i,j,it)=jct(i,j) + enddo + enddo + if(ish.ge.6)then + write(ifch,'(a,i3,a,1x,4i3,3x,4i3)')'jcpref(',ip,'):',jcp + write(ifch,'(a,i3,a,1x,4i3,3x,4i3)')'jctref(',it,'):',jct + endif + endif + + return + end + +c----------------------------------------------------------------------- + subroutine ProSeF(k,n,iret) +c----------------------------------------------------------------------- +c starting from string properties as already determined in EMS, +c one determines string end flavors +c by checking compatibility with remnant masses. +c strings are written to /cems/ and then to /cptl/ +c remnant ic is updated (icproj,ictarg) +c------------------------------------------------------------------------ + + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + + double precision plc,s,pstg,pend + common/cems5/plc,s + common/cems/pstg(5,2),pend(4,4),idend(4) + common/emsptl/nppr(npommx,kollmx),npproj(mamx),nptarg(mamx) + integer icp(2),ict(2),ic(2),icp1(2),icp2(2),icm1(2),icm2(2) + integer jcp(nflav,2),jct(nflav,2),jcpv(nflav,2),jctv(nflav,2) + integer jcp1(nflav,2),jcp2(nflav,2),jcm1(nflav,2),jcm2(nflav,2) + common/col3/ncol,kolpt /cfacmss/facmss /cts/its + + +c entry +c ----- + + iret=0 + + if(ncol.eq.0)return + if(abs(itpr(k)).ne.1)return + + ip=iproj(k) + it=itarg(k) + + if(idpr(n,k).eq.0.or.ivpr(n,k).eq.0)return + if(idpr(n,k).eq.2)stop'Reggeon' + if(idpr(n,k).eq.3)return + call utpri('ProSeF',ish,ishini,5) + if(ish.ge.5)then + write(ifch,*)'soft Pomeron' + write(ifch,*)'k:',k,' n:',n,' ip:',ip,' it:',it + endif + np=nppr(n,k) + +c string ends + + pend(1,1)=xxp1pr(n,k) + pend(2,1)=xyp1pr(n,k) + pend(3,1)=xp1pr(n,k)*plc/2d0 + pend(4,1)=dsqrt(pend(1,1)**2+pend(2,1)**2+pend(3,1)**2) + pend(1,2)=xxp2pr(n,k) + pend(2,2)=xyp2pr(n,k) + pend(3,2)=xp2pr(n,k)*plc/2d0 + pend(4,2)=dsqrt(pend(1,2)**2+pend(2,2)**2+pend(3,2)**2) + pend(1,4)=xxm1pr(n,k) + pend(2,4)=xym1pr(n,k) + pend(3,4)=-xm1pr(n,k)*plc/2d0 + pend(4,4)=dsqrt(pend(1,4)**2+pend(2,4)**2+pend(3,4)**2) + pend(1,3)=xxm2pr(n,k) + pend(2,3)=xym2pr(n,k) + pend(3,3)=-xm2pr(n,k)*plc/2d0 + pend(4,3)=dsqrt(pend(1,3)**2+pend(2,3)**2+pend(3,3)**2) + +c strings + + pstg(1,1)=xxp1pr(n,k)+xxm2pr(n,k) + pstg(2,1)=xyp1pr(n,k)+xym2pr(n,k) + pstg(3,1)=(xp1pr(n,k)-xm2pr(n,k))*plc/2d0 + pstg(4,1)=(xp1pr(n,k)+xm2pr(n,k))*plc/2d0 + pstg(5,1)=dsqrt((pstg(4,1)-pstg(3,1))*(pstg(4,1)+pstg(3,1)) + & -pstg(1,1)**2-pstg(2,1)**2) + pstg(1,2)=xxp2pr(n,k)+xxm1pr(n,k) + pstg(2,2)=xyp2pr(n,k)+xym1pr(n,k) + pstg(3,2)=(xp2pr(n,k)-xm1pr(n,k))*plc/2d0 + pstg(4,2)=(xp2pr(n,k)+xm1pr(n,k))*plc/2d0 + pstg(5,2)=dsqrt((pstg(4,2)-pstg(3,2))*(pstg(4,2)+pstg(3,2)) + & -pstg(2,2)**2-pstg(1,2)**2) + +c initialize + + ntry=0 + 777 ntry=ntry+1 + if(ntry.gt.100)goto1001 + + if(iremn.ge.2)then !uses precalculated flavors + do i=1,2 + icp(i)=icproj(i,ip) + ict(i)=ictarg(i,it) + enddo + if(iLHC.eq.1)then + call iddeco(icp,jcpv) + call iddeco(ict,jctv) + endif + do j=1,2 + do i=1,nrflav + jcp(i,j)=jcpref(i,j,ip) + jct(i,j)=jctref(i,j,it) + if(iLHC.eq.0)then + jcpv(i,j)=jcpval(i,j,ip) + jctv(i,j)=jctval(i,j,it) + endif + enddo + do i=nrflav+1,nflav + jcp(i,j)=0 + jct(i,j)=0 + jcpv(i,j)=0 + jctv(i,j)=0 + enddo + enddo + else + do i=1,2 + icp(i)=icproj(i,ip) + ict(i)=ictarg(i,it) + enddo + call iddeco(icp,jcp) + call iddeco(ict,jct) + do j=1,2 + do i=1,nflav + jcpv(i,j)=0 + jctv(i,j)=0 + enddo + enddo + endif + do i=1,2 + icp1(i)=0 + icp2(i)=0 + icm1(i)=0 + icm2(i)=0 + do j=1,nflav + jcp1(j,i)=0 + jcp2(j,i)=0 + jcm1(j,i)=0 + jcm2(j,i)=0 + enddo + enddo + idpj0=idtr2(icp) + idtg0=idtr2(ict) + do j=1,4 + idend(j)=0 + enddo + + if(ish.ge.7)then + write(ifch,'(a,3x,6i3,3x,6i3,i9)')' proj: ' + * ,jcp,idpj0 + write(ifch,'(a,6i3,3x,6i3)')' proj val: ',jcpv + endif + if(ish.ge.7)then + write(ifch,'(a,3x,6i3,3x,6i3,i9)')' targ: ' + * ,jct,idtg0 + write(ifch,'(a,6i3,3x,6i3)')' targ val: ',jctv + endif + +c determine string flavors + + call fstrfl(jcp,jct,jcpv,jctv,icp1,icp2,icm1,icm2 + * ,idp1pr(n,k),idp2pr(n,k),idm1pr(n,k),idm2pr(n,k) + * ,idsppr(n,k),idstpr(n,k),iret) + if(iret.ne.0)goto 1002 + +c check mass string 1 + + ic(1)=icp1(1)+icm2(1) + ic(2)=icp1(2)+icm2(2) + if(ic(1).gt.0.or.ic(2).gt.0)then + am=sngl(pstg(5,1)) + call iddeco(icp1,jcp1) + call iddeco(icm2,jcm2) + ammns=utamnx(jcp1,jcm2) + if(ish.ge.7)write(ifch,'(a,2i7,2e12.3)') + * ' string 1 - ic,mass,min.mass:',ic,am,ammns + if(am.lt.ammns*facmss)then + goto 777 !avoid virpom + endif + if(iLHC.eq.1)then + idend(1)=idtra(icp1,0,0,0) + idend(3)=idtra(icm2,0,0,0) + else + idend(1)=idtra(icp1,0,0,3) + idend(3)=idtra(icm2,0,0,3) + endif + if(ish.ge.7)write(ifch,'(a,2i6)') ' string 1 - SE-ids:' + * ,idend(1),idend(3) + endif + +c check mass string 2 + + ic(1)=icp2(1)+icm1(1) + ic(2)=icp2(2)+icm1(2) + if(ic(1).gt.0.or.ic(2).gt.0)then + am=sngl(pstg(5,2)) + call iddeco(icp2,jcp2) + call iddeco(icm1,jcm1) + ammns=utamnx(jcp2,jcm1) + if(ish.ge.7)write(ifch,'(a,2i7,2e12.3)') + * ' string 2 - ic,mass,min.mass:',ic,am,ammns + if(am.lt.ammns*facmss)then + goto 777 !avoid virpom + endif + if(iLHC.eq.1)then + idend(2)=idtra(icp2,0,0,0) + idend(4)=idtra(icm1,0,0,0) + else + idend(2)=idtra(icp2,0,0,3) + idend(4)=idtra(icm1,0,0,3) + endif + if(ish.ge.7)write(ifch,'(a,2i6)') ' string 2 - SE-ids:' + * ,idend(2),idend(4) + endif + + if(ish.ge.5)then + write(ifch,'(a,i10)')' pom: ' + * ,idptl(np) + write(ifch,'(a,2i5)')' str 1: ' + * ,idend(1),idend(3) + write(ifch,'(a,2i5)')' str 2: ' + * ,idend(2),idend(4) + endif + +c update remnant ic + +c determine icp,ict +c Similar process for hard pomeron in epos-rsh !!!! + + if(iremn.ge.2)then !uses precalculated flavors + + do j=1,2 + do i=1,nrflav + jcpref(i,j,ip)=jcp(i,j) + jctref(i,j,it)=jct(i,j) + if(iLHC.eq.0)then + jcpval(i,j,ip)=jcpv(i,j) + jctval(i,j,it)=jctv(i,j) + endif + enddo + enddo + if(iLHC.eq.1)then + call idenco(jcpv,icp,iret) + if(iret.ne.0)goto 1002 + call idenco(jctv,ict,iret) + if(iret.ne.0)goto 1002 + do i=1,2 + icproj(i,ip)=icp(i) + ictarg(i,it)=ict(i) + enddo + endif + if(ish.ge.5)then + write(ifch,'(a,6i3,3x,6i3)')' proj: ',jcp + write(ifch,'(a,6i3,3x,6i3)')' proj val: ',jcpv + write(ifch,'(a,6i3,3x,6i3)')' targ: ',jct + write(ifch,'(a,6i3,3x,6i3)')' targ val: ',jctv + endif + + else + + call idenco(jcp,icp,iret) + if(iret.ne.0)goto 1002 + call idenco(jct,ict,iret) + if(iret.ne.0)goto 1002 + do i=1,2 + icproj(i,ip)=icp(i) + ictarg(i,it)=ict(i) + enddo + if(ish.ge.5)then + write(ifch,'(a,2i7,1x,a)')' proj: ' + * ,(icp(l),l=1,2) + write(ifch,'(a,2i7,1x,a)')' targ: ' + * ,(ict(l),l=1,2) + endif + + endif + +c write strings to /cptl/ + + its=idp1pr(n,k)+idm2pr(n,k) + call fstrwr(1,1,3,k,n) + its=idp2pr(n,k)+idm1pr(n,k) + call fstrwr(2,2,4,k,n) + +c exit +c ---- + +1000 continue + call utprix('ProSeF',ish,ishini,5) + return + + 1002 jerr(1)=jerr(1)+1 ! > 9 quarks per flavor attempted. + 1001 iret=1 + if(ish.ge.5)write(ifch,'(a)')'Problem in ProSeF ... ' + goto 1000 + + end + +c----------------------------------------------------------------------- + subroutine fstrfl(jcp,jct,jcpv,jctv,icp1,icp2,icm1,icm2 + * ,idp1,idp2,idm1,idm2,idsp,idst,iret) +c----------------------------------------------------------------------- +c knowing the string end types (idp1,idp2,idm1,idm2) +c and remnant flavors (icp,ict) +c and remnant link of the string (idsp and idst) +c for LHC (idsp/t=100 with one idp/idm=2 means that the valence quark +c to use is define in the corresponding icp/icm +c (using just 1 to 6 for flavor identification (no diquark))) +c one determines quark flavors of string ends (icp1,icp2,icm1,icm2) +c and updates remnant flavors (icp,ict) +c iret=0 ok +c iret=1 problem, more than 9 quarks per flavor attempted +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + integer icp1(2),icp2(2),icm1(2),icm2(2) + integer jcp(nflav,2),jct(nflav,2) + & ,jcpi(nflavems,2),jcti(nflavems,2) + integer iq(2,4),jcpv(nflav,2),jctv(nflav,2) + character m +c data neuz/0/proz/0/dtaz/0/ +c save neuz,proz,dtaz + + call utpri('fstrfl',ish,ishini,7) + +c entry +c ----- + + idum=0 + iret=0 + iret1=0 + iret2=0 + iret3=0 + iret4=0 + + if(idp1.eq.8)stop'fstrfl: fragm quarks not used any more' + if(idp2.eq.8)stop'fstrfl: fragm quarks not used any more' + if(idm1.eq.8)stop'fstrfl: fragm quarks not used any more' + if(idm2.eq.8)stop'fstrfl: fragm quarks not used any more' + +c determine flavors of string ends (u,d,s) + + if(ish.ge.7)then + write(ifch,'(a,3x,2i3)')' string 1, SE types:',idp1,idm2 + write(ifch,'(a,3x,2i3)')' string 2, SE types:',idp2,idm1 + endif + +c empty + + if(idp1.eq.0)then + iq(1,1)=0 + iq(2,1)=0 + endif + if(idp2.eq.0)then + iq(1,2)=0 + iq(2,2)=0 + endif + if(idm1.eq.0)then + iq(1,4)=0 + iq(2,4)=0 + endif + if(idm2.eq.0)then + iq(1,3)=0 + iq(2,3)=0 + endif + do j=1,2 + do n=1,nrflav + jcpi(n,j)=jcp(n,j) + jcti(n,j)=jct(n,j) + enddo + enddo + +c Projectile + + if(idsp.eq.0.or.iremn.eq.0)then +c give the same flavor to quark and antiquark not to change remnant flavor + + if(idp1.eq.4)then +c diquarks, code 4 + iq(1,1)=idrafl(iclpro,jcp,1,'d',0,iret) + iq(2,1)=idrafl(iclpro,jcp,1,'d',0,iret) + iq(1,2)=iq(1,1) + iq(2,2)=iq(2,1) + else +c sea quarks, code 1 + iq(1,1)=idrafl(iclpro,jcp,1,'s',0,iret) + iq(2,1)=0 + iq(1,2)=iq(1,1) + iq(2,2)=0 + endif + + elseif(iremn.ge.2)then +c count valence quarks properly + +c valence quarks + + if(idp1.eq.2)then + + if(iLHC.eq.1)then + if(idsp.eq.100)then + iq(1,1)=icp1(1) !flavor of hard quark already defined + else + iq(1,1)=idrafl(iclpro,jcpv,1,'v',0,idum) + endif + if(iq(1,1).gt.0)then !if still exist, update jcp and jcpv + call idsufl3(iq(1,1),1,jcpv) + else ! if not, use jcp directly and sea + iq(1,1)=idrafl(iclpro,jcp,1,'s',1,idum) + endif + else + + iq(1,1)=idrafl(iclpro,jcpv,1,'v',0,idum) + if(iq(1,1).gt.0)then !if still exist, update jcp and jcpv + call idsufl3(iq(1,1),1,jcpv) + call idsufl3(iq(1,1),1,jcp) + else ! if not, use jcp directly + iq(1,1)=idrafl(iclpro,jcp,1,'v',1,idum) + endif + + endif + + iq(2,1)=0 + endif + + if(idp2.eq.2)then + + if(iLHC.eq.1)then + if(idsp.eq.100)then + iq(1,2)=icp2(2) !flavor of hard antiquark already defined + else + iq(1,2)=idrafl(iclpro,jcpv,2,'v',0,idum) + endif + if(iq(1,2).gt.0)then !if still exist, update jcp and jcpv + call idsufl3(iq(1,2),2,jcpv) + else ! if not, use jcp directly and sea + iq(1,2)=idrafl(iclpro,jcp,2,'s',1,idum) + endif + else + + iq(1,2)=idrafl(iclpro,jcpv,2,'v',0,idum) + if(iq(1,2).gt.0)then !if still exist, update jcp and jcpv + call idsufl3(iq(1,2),2,jcpv) + call idsufl3(iq(1,2),2,jcp) + else ! if not, use jcp directly + iq(1,2)=idrafl(iclpro,jcp,2,'v',1,idum) + endif + endif + iq(2,2)=0 + endif + +c sea quarks + m='v' !iremn=3 + + if(idp1.eq.1)then + if(iremn.eq.2)m='s' + j=1 !quark + i=idrafl(iclpro,jcp,j,m,1,idum) + iq(1,1)=i + if(iLHC.eq.0.and.jcp(i,j)-jcpv(i,j).lt.0)jcpv(i,j)=jcpv(i,j)-1 + iq(2,1)=0 + elseif(idp1.ge.4)then + if(iremn.eq.2)m='d' + j=2 !anti-diquark + i=idrafl(iclpro,jcp,j,m,1,idum) + iq(1,1)=i + if(iLHC.eq.0.and.jcp(i,j)-jcpv(i,j).lt.0)jcpv(i,j)=jcpv(i,j)-1 + i=idrafl(iclpro,jcp,j,m,1,idum) + iq(2,1)=i + if(iLHC.eq.0.and.jcp(i,j)-jcpv(i,j).lt.0)jcpv(i,j)=jcpv(i,j)-1 + endif + if(idp2.eq.1)then + if(iremn.eq.2)m='s' + j=2 !antiquark + i=idrafl(iclpro,jcp,j,m,1,idum) + iq(1,2)=i + if(iLHC.eq.0.and.jcp(i,j)-jcpv(i,j).lt.0)jcpv(i,j)=jcpv(i,j)-1 + iq(2,2)=0 + elseif(idp2.ge.4)then + if(iremn.eq.2)m='d' + j=1 !diquark + i=idrafl(iclpro,jcp,j,m,1,idum) + iq(1,2)=i + if(iLHC.eq.0.and.jcp(i,j)-jcpv(i,j).lt.0)jcpv(i,j)=jcpv(i,j)-1 + i=idrafl(iclpro,jcp,j,m,1,idum) + iq(2,2)=i + if(iLHC.eq.0.and.jcp(i,j)-jcpv(i,j).lt.0)jcpv(i,j)=jcpv(i,j)-1 + endif + + elseif(iremn.ne.0)then +c free remant content + +c valence quarks + + if(idp1.eq.2)then + if(iLHC.eq.1.and.idsp.eq.100)then + iq(1,1)=icp1(1) !flavor of hard quark already defined + else + iq(1,1)=idrafl(iclpro,jcp,1,'v',1,iret) + endif + iq(2,1)=0 + endif + if(idp2.eq.2)then + if(iLHC.eq.1.and.idsp.eq.100)then + iq(1,2)=icp2(1) !flavor of hard antiquark already defined + else + iq(1,2)=idrafl(iclpro,jcp,2,'v',1,iret) + endif + iq(2,2)=0 + endif + +c sea quarks + + if(idp1.eq.1)then + iq(1,1)=idrafl(iclpro,jcp,1,'s',1,iret1) + iq(2,1)=0 + endif + if(idp2.eq.1)then + iq(1,2)=idrafl(iclpro,jcp,2,'s',1,iret2) + iq(2,2)=0 + endif + +c diquarks, code 4 + + if(idp1.eq.4.or.idp2.eq.4)then + iq(1,1)=idrafl(iclpro,jcp,2,'d',1,iret1) + iq(2,1)=idrafl(iclpro,jcp,2,'d',1,iret1) + iq(1,2)=idrafl(iclpro,jcp,1,'d',1,iret2) + iq(2,2)=idrafl(iclpro,jcp,1,'d',1,iret2) + endif + +c diquarks, code 5 (former valence, but actually sea) + + if(idp1.eq.5)then + iq(1,1)=idrafl(iclpro,jcp,2,'d',1,iret1) + iq(2,1)=idrafl(iclpro,jcp,2,'d',1,iret1) + endif + if(idp2.eq.5)then + iq(1,2)=idrafl(iclpro,jcp,1,'d',1,iret2) + iq(2,2)=idrafl(iclpro,jcp,1,'d',1,iret2) + endif + + + if(iret.ne.0)goto 1000 + + + +c in case of saturated remnants, use the same flavor for quark and anti-quark +c at string-end + if(iret1.ne.0.or.iret2.ne.0)then + do j=1,2 + do n=1,nrflav + jcp(n,j)=jcpi(n,j) + enddo + enddo + if(idp1.gt.idp2.or.(idp1.eq.idp2.and.rangen().gt.0.5))then + iq(1,2)=iq(1,1) + iq(2,2)=iq(2,1) + else + iq(1,1)=iq(1,2) + iq(2,1)=iq(2,2) + endif + endif + + endif + +c Target + + if(idst.eq.0.or.iremn.eq.0)then +c give the same flavor to quark and antiquark not to change remnant flavor + + + if(idm1.eq.4)then +c diquarks, code 4 + iq(1,4)=idrafl(icltar,jct,1,'d',0,iret) + iq(2,4)=idrafl(icltar,jct,1,'d',0,iret) + iq(1,3)=iq(1,4) + iq(2,3)=iq(2,4) + else +c sea quarks,code 1 + iq(1,4)=idrafl(icltar,jct,1,'s',0,iret) + iq(2,4)=0 + iq(1,3)=iq(1,4) + iq(2,3)=0 + endif + + elseif(iremn.ge.2)then +c count valence quarks properly + +c valence quarks + + if(idm1.eq.2)then + + if(iLHC.eq.1)then + if(idst.eq.100)then + iq(1,4)=icm1(1) !flavor of hard quark already defined + else + iq(1,4)=idrafl(icltar,jctv,1,'v',0,idum) + endif + if(iq(1,4).gt.0)then !if still exist, update jct and jctv + call idsufl3(iq(1,4),1,jctv) + else ! if not, use jct directly + iq(1,4)=idrafl(icltar,jct,1,'s',1,idum) + endif + else + + iq(1,4)=idrafl(icltar,jctv,1,'v',0,idum) + if(iq(1,4).gt.0)then !if still exist, update jct and jctv + call idsufl3(iq(1,4),1,jctv) + call idsufl3(iq(1,4),1,jct) + else ! if not, use jct directly + iq(1,4)=idrafl(icltar,jct,1,'v',1,idum) + endif + + endif + + iq(2,4)=0 + endif + if(idm2.eq.2)then + + if(iLHC.eq.1)then + if(idst.eq.100)then + iq(1,3)=icm2(2) !flavor of hard antiquark already defined + else + iq(1,3)=idrafl(icltar,jctv,2,'v',0,idum) + endif + if(iq(1,3).gt.0)then !if still exist, update jct and jctv + call idsufl3(iq(1,3),2,jctv) + else ! if not, use jct directly + iq(1,3)=idrafl(icltar,jct,2,'s',1,idum) + endif + else + + iq(1,3)=idrafl(icltar,jctv,2,'v',0,idum) + if(iq(1,3).gt.0)then !if still exist, update jct and jctv + call idsufl3(iq(1,3),2,jctv) + call idsufl3(iq(1,3),2,jct) + else ! if not, use jct directly + iq(1,3)=idrafl(icltar,jct,2,'v',1,idum) + endif + endif + iq(2,3)=0 + endif + +c sea quarks + m='v' !iremn=3 + + if(idm1.eq.1)then + if(iremn.eq.2)m='s' + j=1 !quark + i=idrafl(icltar,jct,j,m,1,idum) + iq(1,4)=i + if(iLHC.eq.0.and.jct(i,j)-jctv(i,j).lt.0)jctv(i,j)=jctv(i,j)-1 + iq(2,4)=0 + elseif(idm1.ge.4)then + if(iremn.eq.2)m='d' + j=2 !anti-diquark + i=idrafl(icltar,jct,j,m,1,idum) + iq(1,4)=i + if(iLHC.eq.0.and.jct(i,j)-jctv(i,j).lt.0)jctv(i,j)=jctv(i,j)-1 + i=idrafl(icltar,jct,j,m,1,idum) + iq(2,4)=i + if(iLHC.eq.0.and.jct(i,j)-jctv(i,j).lt.0)jctv(i,j)=jctv(i,j)-1 + endif + if(idm2.eq.1)then + if(iremn.eq.2)m='s' + j=2 !antiquark + i=idrafl(icltar,jct,j,m,1,idum) + iq(1,3)=i + if(iLHC.eq.0.and.jct(i,j)-jctv(i,j).lt.0)jctv(i,j)=jctv(i,j)-1 + iq(2,3)=0 + elseif(idm2.ge.4)then + if(iremn.eq.2)m='d' + j=1 !diquark + i=idrafl(icltar,jct,j,m,1,idum) + iq(1,3)=i + if(iLHC.eq.0.and.jct(i,j)-jctv(i,j).lt.0)jctv(i,j)=jctv(i,j)-1 + i=idrafl(icltar,jct,j,m,1,idum) + iq(2,3)=i + if(iLHC.eq.0.and.jct(i,j)-jctv(i,j).lt.0)jctv(i,j)=jctv(i,j)-1 + endif + + elseif(iremn.ne.0)then + +c valence quarks + + if(idm1.eq.2)then + if(iLHC.eq.1.and.idst.eq.100)then + iq(1,4)=icm1(1) !flavor of hard quark already defined + else + iq(1,4)=idrafl(icltar,jct,1,'v',1,iret) + endif + iq(2,4)=0 + endif + if(idm2.eq.2)then + if(iLHC.eq.1.and.idst.eq.100)then + iq(1,3)=icm2(1) !flavor of hard antiquark already defined + else + iq(1,3)=idrafl(icltar,jct,2,'v',1,iret) + endif + iq(2,3)=0 + endif + +c sea quarks + + if(idm1.eq.1)then + iq(1,4)=idrafl(icltar,jct,1,'s',1,iret4) + iq(2,4)=0 + endif + if(idm2.eq.1)then + iq(1,3)=idrafl(icltar,jct,2,'s',1,iret3) + iq(2,3)=0 + endif + +c diquarks, code 4 + + if(idm1.eq.4.or.idm2.eq.4)then + iq(1,4)=idrafl(icltar,jct,2,'d',1,iret3) + iq(2,4)=idrafl(icltar,jct,2,'d',1,iret3) + iq(1,3)=idrafl(icltar,jct,1,'d',1,iret4) + iq(2,3)=idrafl(icltar,jct,1,'d',1,iret4) + endif + +c diquarks, code 5 (former valence, but actually sea) + + if(idm1.eq.5)then + iq(1,4)=idrafl(icltar,jct,2,'d',1,iret4) + iq(2,4)=idrafl(icltar,jct,2,'d',1,iret4) + endif + if(idm2.eq.5)then + iq(1,3)=idrafl(icltar,jct,1,'d',1,iret3) + iq(2,3)=idrafl(icltar,jct,1,'d',1,iret3) + endif + + + if(iret.ne.0)goto 1000 + + + +c in case of saturated remnants, use the same flavor for quark and anti-quark +c at string-end + + if(iret3.ne.0.or.iret4.ne.0)then + do j=1,2 + do n=1,nrflav + jct(n,j)=jcti(n,j) + enddo + enddo + if(idm1.gt.idm2.or.(idm1.eq.idm2.and.rangen().gt.0.5))then + iq(1,4)=iq(1,3) + iq(2,4)=iq(2,3) + else + iq(1,3)=iq(1,4) + iq(2,3)=iq(2,4) + endif + endif + + endif + + ifla=iq(1,1) + iflb=iq(2,1) + iflc=iq(1,3) + ifld=iq(2,3) + if(ish.ge.7)write(ifch,'(a,2i5,4x,2i5)') + *' string 1, string ends:',ifla,iflb,iflc,ifld + + if(ifla.gt.0)then + if(iflb.eq.0)then + icp1(1)=10**(6-ifla) + icp1(2)=0 + else + icp1(1)=0 + icp1(2)=10**(6-ifla) + icp1(2)=icp1(2)+10**(6-iflb) + endif + endif + + if(iflc.gt.0)then + if(ifld.eq.0)then + icm2(1)=0 + icm2(2)=10**(6-iflc) + else + icm2(1)=10**(6-iflc) + icm2(1)=icm2(1)+10**(6-ifld) + icm2(2)=0 + endif + endif + + ifla=iq(1,4) + iflb=iq(2,4) + iflc=iq(1,2) + ifld=iq(2,2) + if(ish.ge.7)write(ifch,'(a,2i5,4x,2i5)') + *' string 2, string ends:',ifla,iflb,iflc,ifld + + if(ifla.gt.0)then + if(iflb.eq.0)then + icm1(1)=10**(6-ifla) + icm1(2)=0 + else + icm1(1)=0 + icm1(2)=10**(6-ifla) + icm1(2)=icm1(2)+10**(6-iflb) + endif + endif + + if(iflc.gt.0)then + if(ifld.eq.0)then + icp2(1)=0 + icp2(2)=10**(6-iflc) + else + icp2(1)=10**(6-iflc) + icp2(1)=icp2(1)+10**(6-ifld) + icp2(2)=0 + endif + endif + + if(ish.ge.7)then + write(ifch,'(a,2i7,4x,2i7)') + * ' SE-forw:',icp1(1),icp1(2),icp2(1),icp2(2) + write(ifch,'(a,2i7,4x,2i7)') + * ' SE-back:',icm1(1),icm1(2),icm2(1),icm2(2) + write(ifch,'(a,3x,6i3,3x,6i3)')' proj:',jcp + write(ifch,'(a,3x,6i3,3x,6i3)')' proj val:',jcpv + write(ifch,'(a,3x,6i3,3x,6i3)')' targ:',jct + write(ifch,'(a,3x,6i3,3x,6i3)')' targ val:',jctv + endif + +c exit +c ---- + +1000 continue + call utprix('fstrfl',ish,ishini,7) + return + end + + +cc----------------------------------------------------------------------- +c subroutine fremfl(icp,ict,iret) +cc----------------------------------------------------------------------- +cc checks projectile and target flavor (icp,ict) +cc in case of reggeon exchange they do not correspond to hadrons. +cc one transfers therefore flavor from one side to the other in order +cc to have hadron flavor. +cc icp and ict are modified correspondingly +cc----------------------------------------------------------------------- +c include 'epos.inc' +c integer icp(2),ict(2),jcp(6,2),jct(6,2),kp(4),kt(4) +c +c call utpri('fremfl',ish,ishini,7) +c +cc entry +cc ----- +c +c iret=0 +c +c call iddeco(icp,jcp) +c call iddeco(ict,jct) +c +c iakp=0 +c iakt=0 +c ikp=0 +c ikt=0 +c do l=1,4 +c kp(l)=jcp(l,1)-jcp(l,2) +c kt(l)=jct(l,1)-jct(l,2) +c iakp=iakp+iabs(kp(l)) +c iakt=iakt+iabs(kt(l)) +c ikp=ikp+kp(l) +c ikt=ikt+kt(l) +c enddo +c if(ish.ge.7)write(ifch,*)'iak_p:',iakp,' ik_p:',ikp +c if(ish.ge.7)write(ifch,*)'iak_t:',iakt,' ik_t:',ikt +c +c if(iakp.eq.4)then +c if(ikp.eq.4.or.ikp.eq.-2)then +c ifl=idrafl(jcp,1,'v',iret) +c iqp=2 ! subtract quark +c iqt=1 ! add quark +c elseif(ikp.eq.-4.or.ikp.eq.2)then +c ifl=idrafl(jcp,2,'v',iret) +c iqp=1 ! subtract antiquark +c iqt=2 ! add antiquark +c else +c call utstop('fremfl&') +c endif +c elseif(iakt.eq.4)then +c if(ikt.eq.4.or.ikt.eq.-2)then +c ifl=idrafl(jct,1,'v',iret) +c iqp=1 ! add quark +c iqt=2 ! subtract quark +c elseif(ikt.eq.-4.or.ikt.eq.2)then +c ifl=idrafl(jct,2,'v',iret) +c iqp=2 ! add antiquark +c iqt=1 ! subtract antiquark +c else +c call utstop('fremfl&') +c endif +c elseif(iakp.eq.3)then +c if(ikp.gt.0)then +c ifl=idrafl(jcp,1,'v',iret) +c iqp=2 ! subtract quark +c iqt=1 ! add quark +c else +c ifl=idrafl(jcp,2,'v',iret) +c iqp=1 ! subtract antiquark +c iqt=2 ! add antiquark +c endif +c elseif(iakt.eq.3)then +c if(ikt.gt.0)then +c ifl=idrafl(jct,1,'v',iret) +c iqp=1 ! add quark +c iqt=2 ! subtract quark +c else +c ifl=idrafl(jct,2,'v',iret) +c iqp=2 ! add antiquark +c iqt=1 ! subtract antiquark +c endif +c elseif(iakp.eq.2)then +c if(ikp.gt.0)then +c ifl=idrafl(jct,1,'v',iret) +c iqp=1 ! add quark +c iqt=2 ! subtract quark +c else +c ifl=idrafl(jct,2,'v',iret) +c iqp=2 ! add antiquark +c iqt=1 ! subtract antiquark +c endif +c elseif(iakt.eq.2)then +c if(ikt.gt.0)then +c ifl=idrafl(jct,1,'v',iret) +c iqp=2 ! subtract quark +c iqt=1 ! add quark +c else +c ifl=idrafl(jct,2,'v',iret) +c iqp=1 ! subtract antiquark +c iqt=2 ! add antiquark +c endif +c elseif(iakp.eq.1)then +c if(ikp.gt.0)then +c ifl=idrafl(jcp,2,'v',iret) +c iqp=2 ! add antiquark +c iqt=1 ! subtract antiquark +c else +c ifl=idrafl(jcp,1,'v',iret) +c iqp=1 ! add quark +c iqt=2 ! subtract quark +c endif +c elseif(iakt.eq.1)then +c if(ikt.gt.0)then +c ifl=idrafl(jct,2,'v',iret) +c iqp=1 ! subtract antiquark +c iqt=2 ! add antiquark +c else +c ifl=idrafl(jct,1,'v',iret) +c iqp=2 ! subtract quark +c iqt=1 ! add quark +c endif +c else +c call utstop('fremfl: error&') +c endif +c +c if(ish.ge.7)write(ifch,*)'iq_p:',iqp,' iq_t:',iqt,' if:',ifl +c call uticpl(icp,ifl,iqp,iret) +c if(iret.ne.0)goto1000 +c call uticpl(ict,ifl,iqt,iret) +c if(iret.ne.0)goto1000 +c +cc exit +cc ---- +c +c1000 continue +c call utprix('fremfl',ish,ishini,7) +c return +c end +c +c----------------------------------------------------------------------- + subroutine fstrwr(j,ii,jj,k,n) +c----------------------------------------------------------------------- +c take pstg(5,j),pend(4,ii),idend(ii),pend(4,jj),idend(jj) (/cems/) +c and write it to /cptl/ +c----------------------------------------------------------------------- +c j: string 1 or 2 +c ii,jj: string end (1,2: proj; 3,4: targ) +c k: current collision +c n: current pomeron +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + + double precision pstg,pend,ptt3!,utpcmd + common/cems/pstg(5,2),pend(4,4),idend(4) + common/emsptl/nppr(npommx,kollmx),npproj(mamx),nptarg(mamx) + double precision pp(4) + common/cts/its + + call utpri('fstrwr',ish,ishini,7) + + if(idend(ii).ne.0.and.idend(jj).ne.0)then + +c string +c id1=abs(idend(ii)) +c id2=abs(idend(jj)) +c call idmass(id1,am1) +c call idmass(id2,am2) +c if(id1.gt.100)then +c am1=am1+qmass(0) +c endif +c if(id2.gt.100)then +c am2=am2+qmass(0) +c endif +c ptt3=utpcmd(pstg(5,j),dble(am1),dble(am2),iret) +c if(iret.ne.0.or.pstg(5,j)-dble(am1)-dble(am2).le.0d0)then +c ptt3=0.5d0*pstg(5,j) +c am1=0. +c am2=0. +c endif + am1=0. + am2=0. + ptt3=0.5d0*pstg(5,j) + + call utlob2(1,pstg(1,j),pstg(2,j),pstg(3,j),pstg(4,j),pstg(5,j) + * ,pend(1,ii),pend(2,ii),pend(3,ii),pend(4,ii),20) + pp(1)=0d0 + pp(2)=0d0 + pp(3)=ptt3!.5d0*pstg(5,j) + pp(4)=sqrt(ptt3*ptt3+dble(am1*am1))!.5d0*pstg(5,j) + call utrot2 + * (-1,pend(1,ii),pend(2,ii),pend(3,ii),pp(1),pp(2),pp(3)) + call utlob2(-1,pstg(1,j),pstg(2,j),pstg(3,j),pstg(4,j),pstg(5,j) + * ,pp(1),pp(2),pp(3),pp(4),21) + + npom=nppr(n,k) + if(ifrptl(1,npom).eq.0)ifrptl(1,npom)=nptl+1 + ifrptl(2,npom)=nptl+2 + istptl(npom)=31 + + nptl=nptl+1 + pptl(1,nptl)=sngl(pp(1)) + pptl(2,nptl)=sngl(pp(2)) + pptl(3,nptl)=sngl(pp(3)) + pptl(4,nptl)=sngl(pp(4)) + pptl(5,nptl)=am1 !0. + istptl(nptl)=20 + iorptl(nptl)=npom + jorptl(nptl)=0 + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + xorptl(1,nptl)=coord(1,k) + xorptl(2,nptl)=coord(2,k) + xorptl(3,nptl)=coord(3,k) + xorptl(4,nptl)=coord(4,k) + tivptl(1,nptl)=xorptl(4,nptl) + tivptl(2,nptl)=xorptl(4,nptl) + idptl(nptl)=idend(ii) + ityptl(nptl)=ityptl(npom)+j + itsptl(nptl)=its + rinptl(nptl)=-9999 + qsqptl(nptl)=pstg(4,j)**2 + zpaptl(1,nptl)=0. + zpaptl(2,nptl)=0. + + nptl=nptl+1 + do i=1,4 + pptl(i,nptl)=sngl(pstg(i,j))-pptl(i,nptl-1) + enddo + pptl(5,nptl)=am2!0. + + istptl(nptl)=20 + iorptl(nptl)=nppr(n,k) + jorptl(nptl)=0 + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + xorptl(1,nptl)=coord(1,k) + xorptl(2,nptl)=coord(2,k) + xorptl(3,nptl)=coord(3,k) + xorptl(4,nptl)=coord(4,k) + tivptl(1,nptl)=xorptl(4,nptl) + tivptl(2,nptl)=xorptl(4,nptl) + idptl(nptl)=idend(jj) + ityptl(nptl)=ityptl(npom)+j + itsptl(nptl)=its + rinptl(nptl)=-9999 + qsqptl(nptl)=pstg(4,j)**2 + zpaptl(1,nptl)=0. + zpaptl(2,nptl)=0. + + if(ish.ge.7)then + write(ifch,100)' kink:',(pptl(l,nptl-1),l=1,4),idptl(nptl-1) + write(ifch,100)' kink:',(pptl(l,nptl),l=1,4),idptl(nptl) + endif + + elseif(idend(ii).ne.0.and.idend(jj).eq.0)then + +c resonance + + npom=nppr(n,k) + if(ifrptl(1,npom).eq.0)ifrptl(1,npom)=nptl+1 + ifrptl(2,npom)=nptl+1 + istptl(npom)=31 + + nptl=nptl+1 + idptl(nptl)=idend(ii) + pptl(1,nptl)=sngl(pstg(1,j)) + pptl(2,nptl)=sngl(pstg(2,j)) + pptl(3,nptl)=sngl(pstg(3,j)) + pptl(4,nptl)=sngl(pstg(4,j)) + pptl(5,nptl)=sngl(pstg(5,j)) + istptl(nptl)=0 + iorptl(nptl)=npom + jorptl(nptl)=0 + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + xorptl(1,nptl)=coord(1,k) + xorptl(2,nptl)=coord(2,k) + xorptl(3,nptl)=coord(3,k) + xorptl(4,nptl)=coord(4,k) + tivptl(1,nptl)=coord(4,k) + call idtau(idptl(nptl),pptl(4,nptl),pptl(5,nptl),taugm) + tivptl(2,nptl)=tivptl(1,nptl)+taugm*(-alog(rangen())) + ityptl(nptl)=ityptl(npom)+2+j + itsptl(nptl)=its + rinptl(nptl)=-9999 + qsqptl(nptl)=0. + zpaptl(1,nptl)=0. + zpaptl(2,nptl)=0. + + if(ish.ge.7)then + write(ifch,100)' res:',(pptl(l,nptl),l=1,4),idptl(nptl) + endif + elseif(idend(ii).eq.0.and.idend(jj).eq.0)then + goto1000 + else + call utstop('error in fstrwr&') + endif + + 100 format(a,4e9.3,i5) + +1000 continue + call utprix('fstrwr',ish,ishini,7) + return + end + +c----------------------------------------------------------------------- + subroutine ProReF(ir,m,iretxx) +c----------------------------------------------------------------------- +c proposes flavor for remnant m for proj (ir=1) or target (ir=-1) +c and writes remnant into /cptl/ as string or hadron +c ityptl definitions: +c 51 41 ... rmn drop +c 52 42 ... rmn str inel +c 53 43 ... rmn str diff +c 54 44 ... rmn str inel with split (or after droplet or hadron split) +c 55 45 ... rmn res +c 56 46 ... rmn from split without connexion +c 57 47 ... rmn res active spectators +c 58 48 ... rmn res from diff +c 59 49 ... hadron split +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + + double precision plc,s ,ptt1,ptt2,ptt3 + common/cems5/plc,s + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat,zor,tor + common/cttaus/tpro,zpro,ttar,ztar,ttaus,detap,detat + common /cncl/xproj(mamx),yproj(mamx),zproj(mamx) + * ,xtarg(mamx),ytarg(mamx),ztarg(mamx) + double precision amasmin,amasini,xmdrmax,xmdrmin!,utpcmd + integer icf(2),icb(2) + integer jcf(nflav,2),jcval(nflav,2)!,jcdummy(nflav,2) + logical gdrop, ghadr,gproj + double precision ept(5),ep(4),aa(5),am2t,piq1,piq2,piq3 + common/emsptl/nppr(npommx,kollmx),npproj(mamx),nptarg(mamx) + common /ems12/iodiba,bidiba ! defaut iodiba=0. if iodiba=1, study H-Dibaryon + character c*1,c1*1,c2*1 + + call utpri('ProReF',ish,ishini,3) + + iretxx=0 + + if(ir.ne.1.and.ir.ne.-1)stop'ProReF: wrong ir' + + irmdropx=irmdrop + 55 idrop=0 + gdrop=.false. + ghadr=.false. + iret=0 + dens=0.0765 + do j=1,2 + do i=1,nflav + jcf(i,j)=0 + enddo + enddo + + flow=1. + if(ir.eq.1)then +c if(kolp(m).le.0)goto1000 + if(iep(m).le.-1)goto1000 + gproj=.true. + mm=npproj(m) + iept=iep(m) + zz=zzremn(m,1) + iclpt=iclpro + isopt=isoproj + if(iremn.ge.2)then !number of valence quarks still in proj + if(iLHC.gt.0)then + flow=1e10 !to force decay here + elseif((iept.eq.3.or.iept.eq.5).and.yrmaxi.gt.1.e-5)then + flow=1./fradflii**2 + endif + do nnn=1,nrflav + jcval(nnn,1)=jcpval(nnn,1,m) + jcval(nnn,2)=jcpval(nnn,2,m) + enddo + do nnn=nrflav+1,nflav + jcval(nnn,1)=0 + jcval(nnn,2)=0 + enddo + else + do nnn=1,nflav + jcval(nnn,1)=0 + enddo + do nnn=1,nflav + jcval(nnn,2)=0 + enddo + endif + elseif(ir.eq.-1)then +c if(kolt(m).le.0)goto1000 + if(iet(m).le.-1)goto1000 + gproj=.false. + mm=nptarg(m) + iept=iet(m) + zz=zzremn(m,2) + iclpt=icltar + isopt=isotarg + if(iremn.ge.2)then !number of valence quarks still in proj + if(iLHC.gt.0)then + flow=1e10 !to force decay here + elseif((iept.eq.3.or.iept.eq.5).and.yrmaxi.gt.1.e-5)then + flow=1./fradflii**2 + endif + do nnn=1,nrflav + jcval(nnn,1)=jctval(nnn,1,m) + jcval(nnn,2)=jctval(nnn,2,m) + enddo + do nnn=nrflav+1,nflav + jcval(nnn,1)=0 + jcval(nnn,2)=0 + enddo + else + do nnn=1,nflav + jcval(nnn,1)=0 + enddo + do nnn=1,nflav + jcval(nnn,2)=0 + enddo + endif + else + call utstop('ProReF: ir ???&') + endif + if(ish.ge.3) + &write(ifch,*)'remnant particle index:',mm,m,iclpt,isopt + + if(ish.ge.8)call alist('ProRef&',1,nptl) + antotre=antotre+1. + + mmini=mm + nptlini=nptl + minfra=min(minfra,nptlini) !for trigger condition + + do l=1,5 + ept(l)=dble(pptl(l,mm)) + enddo + + ifrptl(1,mm)=0 + ifrptl(2,mm)=0 + +c initialize forward and backward ic (to transform remnant into string) + + if(gproj)then + icf(1)=icproj(1,m) + icf(2)=icproj(2,m) + if(icf(1).eq.999999)then !more than 9 quark : use jcpref + do j=1,2 + do i=1,nrflav + jcf(i,j)=jcpref(i,j,m) + enddo + enddo + else + call iddeco(icf,jcf) + endif + else !gtarg + icf(1)=ictarg(1,m) + icf(2)=ictarg(2,m) + if(icf(1).eq.999999)then !more than 9 quark : use jctref + do j=1,2 + do i=1,nrflav + jcf(i,j)=jctref(i,j,m) + enddo + enddo + else + call iddeco(icf,jcf) + endif + endif + icb(1)=0 + icb(2)=0 + + call idquacjc(jcf,nqu,naq) +c use RemoveHadron if too many c quarks + if(nrflav.gt.3)then + nqc=jcf(4,1)+jcf(4,2) + if(nqu.lt.3.and.jcf(4,1).gt.1.or. + & naq.lt.3.and.jcf(4,2).gt.1.or. + & jcf(4,1)*jcf(4,2).gt.1 )nqc=4 + else + nqc=0 + endif + if(iremn.ge.2)then + ier=0 + ires=0 + id=idtra(icf,ier,ires,0) + if(ier.eq.0)then + call idspin(id,ispin,jspin,istra) + else + ispin=0 + jspin=0 + istra=0 + endif + endif + +c define masses + + amasmin=dble(fremnux(jcf))**2.d0 + if(ept(5).le.0.d0)then + ept(5)=dble(fremnux(jcf)*(1.+rangen())) + if(ish.ge.2)then + call utmsg('ProReF') + write(ifch,*)'zero remnant mass -> amasmin' + call utmsgf + endif + endif + am2t=sqrt(ept(1)**2+ept(2)**2+ept(5)**2) + if(iLHC.eq.1.and.ept(4).gt.am2t.and.(iept.eq.0.or.iept.eq.6))then + ept(3)=sign(sqrt((ept(4)+am2t)*(ept(4)-am2t)),ept(3)) + else + ept(4)=sqrt(ept(3)*ept(3)+ept(2)*ept(2)+ept(1)*ept(1) + & +ept(5)*ept(5)) + endif + am2t=(ept(4)+ept(3))*(ept(4)-ept(3))-(ept(1)**2+ept(2)**2) + if(ish.ge.2 + & .and.(am2t.lt.-1d0.or.abs(am2t-ept(5)*ept(5)).gt.ept(5)))then + write(ifch,*)'Precision problem in ProRef, p:', + & (ept(k),k=1,4),ept(5)*ept(5),am2t + endif + + if(ish.ge.3)then + if(gproj)then + write(ifch,'(a,5e11.3,2i7)')' proj:' + & ,(sngl(ept(k)) ,k=1,5),(icproj(k,m) ,k=1,2) + else !gtarg + write(ifch,'(a,5e11.3,2i7)')' targ:' + & ,(sngl(ept(k)) ,k=1,5),(ictarg(k,m),k=1,2) + endif + endif + + amasini=ept(5)*ept(5) + + xmdrmin=dble(fremnux(jcf)+amdrmin)**2 + xmdrmax=dble(fremnux(jcf)+amdrmax)**2 + + + if(ish.ge.4)write(ifch,*)'remnant masses:',am2t,amasini,amasmin + & ,xmdrmin,zz,iept + +c.............................exotic ................................... + +c if(amasini.gt.amasmin.and.irmdropx.eq.1)then + +c if(.not.((nqu.eq.3.and.naq.eq.0).or.(nqu.eq.0.and.naq.eq.3) + if((iept.eq.3.or.iept.eq.5.or. +c & (iept.eq.1.and.iremn.eq.3!.and.amasini.le.xmdrmin +c & .and.(jcf(4,1)+jcf(4,2).eq.0)).or. + & .not.((nqu.eq.3.and.naq.eq.0).or.(nqu.eq.0.and.naq.eq.3) + & .or.(nqu.eq.1.and.naq.eq.1))).and.nqc.le.3 + & .and.amasini.gt.amasmin.and.irmdropx.eq.1)then + +c if(( +c & .not.((nqu.eq.3.and.naq.eq.0).or.(nqu.eq.0.and.naq.eq.3) +c & .or.(nqu.eq.1.and.naq.eq.1)).or. +c & (iept.ne.0.and.iept.le.2.and.reminv/ept(5).gt.rangen())) +c & .and.amasini.gt.amasmin.and.irmdropx.eq.1)then + + !print*,'-------------------------------------------' !!! + !print*,jcf + !print*,icf,sqrt(amasini),sqrt(amasmin),sqrt(xmdrmin) !!! + !print*,nqu,naq !!! +c charm not possible in droplet + if(iremn.ge.2.or. + & (amasini.gt.xmdrmin.or.nqc.ne.0))then + if(iremn.eq.2)then + call getdropx(ir,iept,m,icf,jcf,jcval,zz,ept,aa + & ,gdrop,xmdrmax) + else + call getdroplet(ir,iept,icf,jcf,zz,ept,aa,gdrop,xmdrmax) + endif + !-------------------------------- + !emit a droplet, update the remnant string flavor and 5-momentum + ! input + ! ir ......... 1 projectile, -1 target remnant + ! ept ........ remnant 5-momentum + ! jcf ........ remnant jc + ! output + ! gdrop ... .true. = successful droplet emission + ! jcf, ept ....... droplet ic and 5-momentum + ! icf, a ......... remnant string jc and 5-momentum + ! .false. = unsuccessful + ! jcf, ept .... unchanged, + ! emits hadrons instead of droplet +c ! considered as droplet jc and 5-momentum + !------------------------------------- + endif + +c redefine energy and charm quarks in droplet + amasini=ept(5)*ept(5) + nqc=jcf(4,1)+jcf(4,2) +c use remove hadrons if droplet too heavy (should not happen) or charm + if(amasini.gt.1e4.or.nqc.ne.0)goto 500 + + !...........droplet + !also in case of unsuccessful drop emission, then remnant = droplet ! + idrop=1 + nptl=nptl+1 + t=xorptl(4,mm) + istptl(mm)=41 + ifrptl(1,mm)=nptl + ifrptl(2,mm)=nptl + tivptl(2,mm)=t +c Remnant radius to have eps=dens GeV/fm3 + radptl(nptl)=(3.*sngl(ept(5))/4./pi/dens)**0.3333 + dezptl(nptl)=0. + do l=1,5 + pptl(l,nptl)=sngl(ept(l)) + enddo + if(gdrop)then + idx=0 + else + if(iLHC.eq.1)then + idx=idtra(icf,0,0,0) + else + idx=idtra(icf,0,0,3) + endif + endif + if(abs(idx).gt.100)then + amx=sngl(ept(5)) + call idres(idx,amx,idrx,iadjx) + idx=idrx + else + idx=0 + endif + if(idx.eq.0)then + istptl(nptl)=10 + call idenct(jcf,idptl(nptl) + * ,ibptl(1,nptl),ibptl(2,nptl),ibptl(3,nptl),ibptl(4,nptl)) + if(gproj)then + ityptl(nptl)=40 + else !gtarg + ityptl(nptl)=50 + endif + else + istptl(nptl)=0 + idptl(nptl)=idx + pptl(5,nptl)=amx + pptl(4,nptl)=sqrt(amx*amx+pptl(1,nptl)*pptl(1,nptl) + & +pptl(2,nptl)*pptl(2,nptl)+pptl(3,nptl)*pptl(3,nptl)) + if(gproj)then + ityptl(nptl)=45 + if(iept.eq.6)ityptl(nptl)=47 + else !gtarg + ityptl(nptl)=55 + if(iept.eq.6)ityptl(nptl)=57 + endif + endif + iorptl(nptl)=mm + jorptl(nptl)=0 + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + xorptl(1,nptl)=xorptl(1,mm) + xorptl(2,nptl)=xorptl(2,mm) + xorptl(3,nptl)=xorptl(3,mm) + xorptl(4,nptl)=t + tivptl(1,nptl)=t + call idtau(idptl(nptl),pptl(4,nptl),pptl(5,nptl),taugm) + tivptl(2,nptl)=tivptl(1,nptl)+taugm*(-alog(rangen())) + do l=1,4 + ibptl(l,nptl)=0 + enddo + andropl=andropl+1 + if(ish.ge.3)write(ifch,*)'Proref,ept(5),id',ept(5),idptl(nptl) + !print*,nptl,idptl(nptl),sngl(ept(5)),pptl(5,nptl) !!! + + !..........remnant update + if(gdrop)then !drop emission: new remnant -> ept, icf + idrop=0 + do l=1,5 + ept(l)=aa(l) + enddo + call iddeco(icf,jcf) + call idquacjc(jcf,nqu,naq) + if(iret.eq.1)call utstop('Pb in ProRef in strg+drop process&') + !!! print*,'new remnant:',icf,ept(5) !!! + nptl=nptl+1 + t=xorptl(4,mm) + ifrptl(2,mm)=nptl + do l=1,5 + pptl(l,nptl)=sngl(ept(l)) + enddo + idptl(nptl)=idptl(mm) + istptl(nptl)=40 + iorptl(nptl)=mm + jorptl(nptl)=0 + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + xorptl(1,nptl)=xorptl(1,mm) + xorptl(2,nptl)=xorptl(2,mm) + xorptl(3,nptl)=xorptl(3,mm) + xorptl(4,nptl)=t + tivptl(1,nptl)=t + tivptl(2,nptl)=ainfin + if(gproj)then + ityptl(nptl)=40 + else !gtarg + ityptl(nptl)=50 + endif + do l=1,4 + ibptl(l,nptl)=0 + enddo + endif + + !........decay mini-droplet...... + mm=nptlini+1 + nptlb=nptl + if(iabs(idptl(mm)).gt.10**8)then + + iret=0 + if(iorsdf.ne.3.or.pptl(5,mm).gt.100. + & .or.amasini.le.amasmin*flow)then !decay here only if no fusion or large mass or mass too low for flow + + if(ish.ge.3)write(ifch,*)'Decay remnant droplet...' + if(nptlb.gt.mxptl-10)call utstop('ProRef: mxptl too small&') + + if(ifrade.gt.0.and.ispherio.eq.0)then + if(ioclude.eq.3.or.dble(pptl(5,mm)).lt.xmdrmin)then + call hnbaaa(mm,iret) + else + call DropletDecay(mm,iret)!Decay remn + iret=0 + endif + endif + if(iret.ne.1.and.nptl.ne.nptlb)then ! ---successful decay--- + istptl(mm)=istptl(mm)+1 + ifrptl(1,mm)=nptlb+1 + ifrptl(2,mm)=nptl + t=tivptl(2,mm) + x=xorptl(1,mm)+(t-xorptl(4,mm))*pptl(1,mm)/pptl(4,mm) + y=xorptl(2,mm)+(t-xorptl(4,mm))*pptl(2,mm)/pptl(4,mm) + z=xorptl(3,mm)+(t-xorptl(4,mm))*pptl(3,mm)/pptl(4,mm) + do 21 n=nptlb+1,nptl + iorptl(n)=mm + jorptl(n)=0 + istptl(n)=0 + ifrptl(1,n)=0 + ifrptl(2,n)=0 + radius=0.8*sqrt(rangen()) + phi=2*pi*rangen() + ti=t + zi=z + xorptl(1,n)=x + radius*cos(phi) + xorptl(2,n)=y + radius*sin(phi) + xorptl(3,n)=zi + xorptl(4,n)=ti + iioo=mm + zor=dble(xorptl(3,iioo)) + tor=dble(xorptl(4,iioo)) +c call idquac(iioo,nq,ndummy1,ndummy2,jcdummy) + r=rangen() + tauran=-taurea*alog(r) + call jtaix(n,tauran,zor,tor,zis,tis) + tivptl(1,n)=amax1(ti,tis) + call idtau(idptl(n),pptl(4,n),pptl(5,n),taugm) + r=rangen() + tivptl(2,n)=t+taugm*(-alog(r)) +c ityptl(n)=ityptl(n)+1 !already in hnbaaa + if(iept.eq.6)ityptl(n)=ityptl(n)+5 !6 + radptl(n)=0. + dezptl(n)=0. + itsptl(n)=0 + rinptl(nptl)=-9999 + 21 continue + if(iabs(idptl(nptlb+1)).le.6) then + call gakli2(0,0) + if(ish.ge.1)write (ifmt,*)'string from drop:nptlb+1,nptl:' + * ,nptlb+1,nptl + istptl(nptlb+1)=1 + do n=nptlb+2,nptl + istptl(n)=20 + zpaptl(1,n)=0. + zpaptl(2,n)=0. + enddo + call gakfra(0,iret) + call gakli2(0,0) + endif + jerr(4)=jerr(4)+1 + elseif(ifrade.gt.0.and.ispherio.eq.0)then ! Unsuccessful decay + jerr(5)=jerr(5)+1 + if(ish.ge.4)write(ifch,*) + * '***** Unsuccessful remnant cluster decay' + * ,' --> do RemoveHadrons instead.' + mm=mmini + nptl=nptlini + irmdropx=0 + goto 55 + endif + + endif + endif + + if(idrop.eq.1)goto 1000 + !successful drop decay, no additional string, nothing to do + + endif + +c............................................................... + + 500 mm=mmini + if(gdrop)mm=nptlini+2 + istptl(mm)=41 + ifrptl(1,mm)=nptl+1 + +c........................remove hadrons......................... + + if(.not.((nqu.eq.3.and.naq.eq.0).or.(nqu.eq.0.and.naq.eq.3) + & .or.(nqu.eq.1.and.naq.eq.1)))then + if(irmdropx.eq.irmdrop)then + jerr(6)=jerr(6)+1 + !call utmsg('ProReF') + !write(ifch,*)'***** condition for droplet treatment: ' + !write(ifch,*)'***** amasini.gt.amasmin.and.irmdropx.eq.1 = ' + !* ,amasini.gt.amasmin.and.irmdropx.eq.1 + !write(ifch,*)'***** amasini,amasmin,irmdropx:' + !* ,amasini,amasmin,irmdropx + !write(ifch,*)'***** nqu,naq:',nqu,naq + !write(ifch,*)'***** call RemoveHadrons' + !call utmsgf + endif + call RemoveHadrons(gproj,ghadr,m,mm,jcf,jcval,icf,ept,iret) + if(iret.ne.0)then + iretxx=1 + goto 1000 + endif + endif + +c........................ determine idr (0=string, else=resonance)....... + + if(icf(1).eq.0.and.icf(2).eq.0)then + id=110 + else + if(iLHC.eq.1)then + id=idtra(icf,0,0,0) + else + id=idtra(icf,0,0,3) + endif + endif + idr=0 + am=sngl(ept(5)) + call idres(id,am,idr,iadj) +c if(iabs(mod(idr,10)).le.2.and.idr.ne.0)then +c id=idr +c else +c idr=0 +c endif !ckeck on-shell mass (see uti) + if(iadj.ne.0.and.iept.gt.0.and.ept(5).gt.0.d0 + & .and.(dabs((ept(4)+ept(3))*(ept(4)-ept(3)) + $ -ept(2)**2-ept(1)**2-dble(am)**2).gt.0.3d0))idr=0 + + if(ish.ge.3)then + write(ifch,'(a,5e11.3)')' updt:',(sngl(ept(k)) ,k=1,5) + write(ifch,*)' icf: ',icf,' idr: ',idr,' iept: ',iept + endif + +c if(iept.eq.3)stop'ProReF: iept=3 ???' + +c...........................................string................... + if(iept.gt.0.and.iept.ne.6.and.idr.eq.0)then + + !... nqu of remainder string + + anstrg0=anstrg0+1 + if(gdrop)anstrg1=anstrg1+1 + + call iddeco(icf,jcf) + nqu=0 + nqv=0 + nav=0 + do l=1,nrflav + nqu=nqu+jcf(l,1)-jcf(l,2) + nqv=nqv+jcval(l,1)+jcval(l,2) + nav=nav+jcval(l,2) + enddo + +c if(zrminc.lt.0.)stop'ProReF: not supported any more. ' + + !......determine forward momentum ep + + + am1=0. + am2=0. + ptt1=0d0 + ptt2=0d0 + if(iLHC.eq.1)then + pt=ranptcut(1.)*ptfraqq + if(pt.lt.0.5d0*ept(5))then + phi=2.*pi*rangen() + ptt1=dble(pt*cos(phi)) + ptt2=dble(pt*sin(phi)) + endif + ptt3=dble(ir)*sqrt((0.5d0*ept(5))**2-ptt1*ptt1-ptt2*ptt2) + else + ptt3=dble(ir)*0.5d0*ept(5) + endif + + ep(1)=ptt1 + ep(2)=ptt2 + ep(3)=ptt3 +cc ep(4)=0.5d0*ept(5) + ep(4)=sqrt(ptt3*ptt3+ptt2*ptt2+ptt1*ptt1+dble(am1*am1)) + +c if(abs(ept(3)).le.ptsend)then +c phi=2.*pi*rangen() +c theta=2.*pi*rangen() +c ca=cos(theta) +c sa=sin(theta) +c call utroa2(dble(phi),dble(ca),dble(sa),0d0,ep(1),ep(2),ep(3)) +c endif + call utlob2(-1,ept(1),ept(2),ept(3),ept(4),ept(5) + * ,ep(1),ep(2),ep(3),ep(4),25) + + + xxx=min(1.,sngl(abs(ep(3)/ep(4)))) + qqs=sngl(ept(5)**2) + + !....determine forward and backward flavor icf, icb + + if(iremn.ge.2)then + xm3val=9. + xm2val=3. + xm1val=1. + ntryx=0 + 33 xx1=0. + xx2=0. + xx3=0. + del=1./(1.-alppar) + if(nqv.eq.3)then + xx1=min(1.,ranptcut(xm3val)) + xx2=min(1.,ranptcut(xm3val)) + xx3=min(1.,ranptcut(xm3val)) + elseif(nqv.eq.2)then + xx1=min(1.,ranptcut(xm2val)) + xx2=min(1.,ranptcut(xm2val)) + xx3=rangen()**del + elseif(nqv.eq.1)then + xx1=min(1.,ranptcut(xm1val)) + xx2=rangen()**del + xx3=rangen()**del + else + xx1=rangen()**del + xx2=rangen()**del + xx3=rangen()**del + endif + if(ntryx.lt.1000)then + if(xx1+xx2+xx3.gt.1)goto 33 + else + xx1=rangen() + xx2=rangen()*(1.-xx1) + xx3=rangen()*(1.-xx1-xx2) + endif + xx1=xxx*xx1 + xx2=xxx*xx2 + xx3=xxx*xx3 + piq1=0d0 + piq2=0d0 + piq3=0d0 + if(iept.eq.4)then + ireminv=0 !no inversion for very low mass diffraction + else +c inversion needed for inelatic remnant because of cascade (NA49) + ireminv=1 + endif + if(nqu.eq.3)then !---baryon--- + c="s" + if(nqv.ge.1)c="v" + iq1=idraflx(piq1,xx1,qqs,iclpt,jcf,jcval,1,isopt,c) + c="s" + if(nqv.ge.2)c="v" + iq2=idraflx(piq2,xx2,qqs,iclpt,jcf,jcval,1,isopt,c) + c="s" + if(nqv.ge.3)c="v" + iq3=idraflx(piq3,xx3,qqs,iclpt,jcf,jcval,1,isopt,c) +c rescale x to have heavier quark backward (neutron in ZEUS or lambda in NA49 not forward) +c if(iept.eq.2)then +c if(isopt.gt.0)then +c xx1=xx1/float(iq1) +c xx2=xx2/float(iq2) +c xx3=xx3/float(iq3) +c elseif(isopt.lt.0)then +c if(iq1.lt.3)then +c xx1=xx1/float(3-iq1) +c else +c xx1=xx1/float(iq1) +c endif +c if(iq2.lt.3)then +c xx2=xx2/float(3-iq2) +c else +c xx2=xx2/float(iq2) +c endif +c if(iq3.lt.3)then +c xx3=xx3/float(3-iq3) +c else +c xx3=xx3/float(iq3) +c endif +c endif +c endif + call neworderx(xx3,xx2,xx1,iq3,iq2,iq1) + if(xx2-xx3.gt.reminv*(xx1-xx2))ireminv=0 +c put always strange quarks in diquark (for lambda and cascade (NA49)) + if(iq3.ge.3.and.ireminv.eq.0)ireminv=1 !here inversion only in diffraction except for strange particles (lambda and cascade very central) +c if inversion for diffractive and inelastic +c if(iq1+iq2.lt.6.and.iq3.ge.3.and.ireminv.eq.0)then +c iqtmp=iq3 +c if(iq2.eq.3.or.(iq1.ne.3.and.rangen().gt.0.5))then +c iq3=iq1 +c iq1=iqtmp +c else +c iq3=iq2 +c iq2=iqtmp +c endif +c endif + if(ireminv.eq.0)then + call uticpl(icf,iq3,2,iret) ! antiquark + call uticpl(icb,iq3,1,iret) ! quark + else + call uticpl(icf,iq3,2,iret) ! antiquark + call uticpl(icb,iq3,1,iret) ! quark + call uticpl(icf,iq2,2,iret) ! antiquark + call uticpl(icb,iq2,1,iret) ! quark + endif + elseif(nqu.eq.-3)then !---antibaryon--- + c="s" + if(nqv.ge.1)c="v" + iq1=idraflx(piq1,xx1,qqs,iclpt,jcf,jcval,2,isopt,c) + c="s" + if(nqv.ge.2)c="v" + iq2=idraflx(piq2,xx2,qqs,iclpt,jcf,jcval,2,isopt,c) + c="s" + if(nqv.ge.3)c="v" + iq3=idraflx(piq3,xx3,qqs,iclpt,jcf,jcval,2,isopt,c) +c rescale x to have heavier quark backward (neutron in ZEUS or lambda in NA49 not forward) +c if(iept.eq.2)then +c if(isopt.gt.0)then +c xx1=xx1/float(iq1) +c xx2=xx2/float(iq2) +c xx3=xx3/float(iq3) +c elseif(isopt.lt.0)then +c if(iq1.lt.3)then +c xx1=xx1/float(3-iq1) +c else +c xx1=xx1/float(iq1) +c endif +c if(iq2.lt.3)then +c xx2=xx2/float(3-iq2) +c else +c xx2=xx2/float(iq2) +c endif +c if(iq3.lt.3)then +c xx3=xx3/float(3-iq3) +c else +c xx3=xx3/float(iq3) +c endif +c endif +c endif + call neworderx(xx3,xx2,xx1,iq3,iq2,iq1) + if(xx2-xx3.gt.reminv*(xx1-xx2))ireminv=0 +c put always strange quarks in diquark + if(iq3.ge.3.and.ireminv.eq.0)ireminv=1 +c if(iq1+iq2.lt.6.and.iq3.ge.3.and.ireminv.eq.0)then +c iqtmp=iq3 +c if(iq2.eq.3.or.(iq1.ne.3.and.rangen().gt.0.5))then +c iq3=iq1 +c iq1=iqtmp +c else +c iq3=iq2 +c iq2=iqtmp +c endif +c endif + if(ireminv.eq.0)then + call uticpl(icf,iq3,1,iret) ! quark + call uticpl(icb,iq3,2,iret) ! antiquark + else + call uticpl(icf,iq1,1,iret) ! quark + call uticpl(icb,iq1,2,iret) ! antiquark + call uticpl(icf,iq2,1,iret) ! quark + call uticpl(icb,iq2,2,iret) ! antiquark + endif + elseif(nqu.eq.0)then !---meson--- + xx3=0. !no third quark + iq3=0 + if(nqv.eq.2)then + c1="v" + c2="v" + j=min(2,1+int(0.5+rangen())) + elseif(nav.ne.0)then !valence antiquark + c1="v" + c2="s" + j=2 + elseif(nqv.ne.0)then !valence quark + c1="v" + c2="s" + j=1 + else !only sea quarks + c1="s" + c2="s" + j=min(2,1+int(0.5+rangen())) + endif + iq1=idraflx(piq1,xx1,qqs,iclpt,jcf,jcval,j,isopt,c1) + iq2=idraflx(piq2,xx2,qqs,iclpt,jcf,jcval,3-j,isopt,c2) + if(xx1.gt.xx2)ireminv=0 + if(ireminv.eq.1)then + call uticpl(icf,iq1,3-j,iret) ! subtract quark 1 forward + call uticpl(icb,iq1,j,iret) ! add quark 1 backward + else + call uticpl(icf,iq2,j,iret) ! subtract antiquark 2 forward + call uticpl(icb,iq2,3-j,iret) ! add antiquark 2 backward + endif + else + call utmsg('ProReF') + write(ifch,*)'***** neither baryon nor antibaryon nor meson.' + write(ifch,*)'***** number of net quarks:',nqu + write(ifmt,*)'ProReF: no hadron; ',nqu,' quarks --> redo' + iretxx=1 + goto 1000 + endif + if(ish.ge.3)write(ifch,'(a,2i3,3(i2,e13.6))')' inversion:',isopt + & ,ireminv,iq1,xx1,iq2,xx2,iq3,xx3 + else + ireminv=0 + if(iept.ne.0)then + if(rangen().lt.reminv)ireminv=1 + endif + if(nqu.eq.3)then !---baryon--- + iq=idrafl(iclpt,jcf,1,'v',1,iret) + call uticpl(icf,iq,2,iret) ! antiquark + call uticpl(icb,iq,1,iret) ! quark + if(ireminv.eq.1)then + iq=idrafl(iclpt,jcf,1,'v',1,iret) + call uticpl(icf,iq,2,iret) ! antiquark + call uticpl(icb,iq,1,iret) ! quark + endif + elseif(nqu.eq.-3)then !---antibaryon--- + iq=idrafl(iclpt,jcf,2,'v',1,iret) + call uticpl(icf,iq,1,iret) ! quark + call uticpl(icb,iq,2,iret) ! antiquark + if(ireminv.eq.1)then + iq=idrafl(iclpt,jcf,2,'v',1,iret) + call uticpl(icf,iq,1,iret) ! quark + call uticpl(icb,iq,2,iret) ! antiquark + endif + elseif(nqu.eq.0)then !---meson--- + iq1=idrafl(iclpt,jcf,1,'v',1,iret) + iq2=idrafl(iclpt,jcf,2,'v',1,iret) + if(rangen().gt.0.5)then + call uticpl(icf,iq1,2,iret) ! subtract quark + call uticpl(icb,iq1,1,iret) ! add quark + else + call uticpl(icf,iq2,1,iret) ! subtract antiquark + call uticpl(icb,iq2,2,iret) ! add antiquark + endif +c elseif(nqu.eq.0)then !---meson--- +c if(iept.ne.1.and.iept.ne.6.and.rangen().lt.0.5)then +c iq=idrafl(iclpt,jcf,1,'v',1,iret) +c call uticpl(icf,iq,2,iret) ! subtract quark +c call uticpl(icb,iq,1,iret) ! add quark +c else +cc put quark in forward direction always for inelastic +c iq=idrafl(iclpt,jcf,2,'v',1,iret) +c call uticpl(icf,iq,1,iret) ! subtract antiquark +c call uticpl(icb,iq,2,iret) ! add antiquark +c endif + else + if(ish.ge.1)then + call utmsg('ProReF') + write(ifch,*)'***** neither baryon nor antibaryon nor meson.' + write(ifch,*)'***** number of net quarks:',nqu + endif + write(ifmt,*)'ProReF: no hadron; ',nqu,' quarks --> redo' + iretxx=1 + goto1000 + endif + endif + + + !..... forward string end + + nptl=nptl+1 + if(nptl.gt.mxptl)call utstop('ProRef: mxptl too small&') + pptl(1,nptl)=sngl(ep(1)) + pptl(2,nptl)=sngl(ep(2)) + pptl(3,nptl)=sngl(ep(3)) + pptl(4,nptl)=sngl(ep(4)) + pptl(5,nptl)=am1 !0. + istptl(nptl)=20 + iorptl(nptl)=mm + if(.not.gdrop)istptl(mm)=41 + jorptl(nptl)=0 + if(.not.ghadr.and..not.gdrop)ifrptl(1,mm)=nptl + ifrptl(2,mm)=nptl + xorptl(1,nptl)=xorptl(1,mm) + xorptl(2,nptl)=xorptl(2,mm) + xorptl(3,nptl)=xorptl(3,mm) + xorptl(4,nptl)=xorptl(4,mm) + tivptl(1,nptl)=xorptl(4,nptl) + tivptl(2,nptl)=xorptl(4,nptl) + if(iLHC.eq.1)then + idptl(nptl)=idtra(icf,0,0,0) + else + idptl(nptl)=idtra(icf,0,0,3) + endif + if(gproj)then + if(iep(m).lt.1)stop'ProReF: iep(m)<1 ' + ityptl(nptl)=41+iep(m) ! =42 =43 =44 =46 =47 + if(iep(m).eq.4)ityptl(nptl)=42 + if(gdrop.and.iep(m).ne.6)ityptl(nptl)=44 + if(ghadr)ityptl(nptl)=44 + else !gtarg + if(iet(m).lt.1)stop'ProReF: iet(m)<1 ' + ityptl(nptl)=51+iet(m) !=52 =53 =54 =56 =57 + if(iet(m).eq.4)ityptl(nptl)=52 + if(gdrop.and.iet(m).ne.6)ityptl(nptl)=54 + if(ghadr)ityptl(nptl)=54 + endif + itsptl(nptl)=1 + qsqptl(nptl)=qqs + rinptl(nptl)=-9999 + !write(6,'(a,i9,$)')' ',idptl(nptl) !====================== + zpaptl(1,nptl)=zz + if(gproj)then + zpaptl(2,nptl)=float(lproj(m)) +c zpaptl(2,nptl)=0. +c if(lproj(m).ge.1)then +c do l=1,lproj(m) +c kpair=kproj(m,l) +c itt=itarg(kpair) +c zpaptl(2,nptl)=zpaptl(2,nptl)+zzremn(itt,2) +c enddo +c endif + else !gtarg + zpaptl(2,nptl)=float(ltarg(m)) +c zpaptl(2,nptl)=0. +c if(ltarg(m).ge.1)then +c do l=1,ltarg(m) +c kpair=ktarg(m,l) +c ipp=iproj(kpair) +c zpaptl(2,nptl)=zpaptl(2,nptl)+zzremn(ipp,1) +c enddo +c endif + endif + if(ish.ge.3)then + write(ifch,'(a,5e11.3,$)')' kink:',(pptl(k,nptl),k=1,5) + write(ifch,*)' id: ',idptl(nptl) + endif + !....... backward string end + + nptl=nptl+1 + if(nptl.gt.mxptl)call utstop('ProRef: mxptl too small&') + pptl2=0. + do i=1,3 + pptl(i,nptl)=sngl(ept(i)-ep(i)) + pptl2=pptl2+pptl(i,nptl)*pptl(i,nptl) + enddo + pptl(5,nptl)=am2 !0. + pptl2=pptl2+pptl(5,nptl)*pptl(5,nptl) + pptl(4,nptl)=sqrt(pptl2) + pptl2=sngl(ept(4)-ep(4)) + if(ish.ge.1.and.abs(pptl2-pptl(4,nptl)).gt.max(0.1, + & 0.1*abs(pptl2)))then + write(ifmt,*) + & 'Warning in ProRef: inconsistent backward string end energy !' + & ,pptl(4,nptl),pptl2,abs(pptl2-pptl(4,nptl)),am1,am2,ptt3,ep(4) + if(ish.ge.2)write(ifch,*) + & 'Warning in ProRef: inconsistent backward string end energy !' + & ,(pptl(kkk,nptl),kkk=1,4),pptl2,abs(pptl2-pptl(4,nptl)) + endif + istptl(nptl)=20 + iorptl(nptl)=mm + jorptl(nptl)=0 + ifrptl(2,mm)=nptl + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + xorptl(1,nptl)=xorptl(1,mm) + xorptl(2,nptl)=xorptl(2,mm) + xorptl(3,nptl)=xorptl(3,mm) + xorptl(4,nptl)=xorptl(4,mm) + tivptl(1,nptl)=xorptl(4,nptl) + tivptl(2,nptl)=xorptl(4,nptl) + if(iLHC.eq.1)then + idptl(nptl)=idtra(icb,0,0,0) + else + idptl(nptl)=idtra(icb,0,0,3) + endif + if(gproj)then + ityptl(nptl)=41+iep(m) ! =42 =43 =47 + if(iep(m).eq.4)ityptl(nptl)=42 + if(gdrop.and.iep(m).ne.6)ityptl(nptl)=44 + if(ghadr)ityptl(nptl)=44 + else !gtarg + ityptl(nptl)=51+iet(m) !=52 =53 =57 + if(iet(m).eq.4)ityptl(nptl)=52 + if(gdrop.and.iet(m).ne.6)ityptl(nptl)=54 + if(ghadr)ityptl(nptl)=54 + endif + itsptl(nptl)=1 + qsqptl(nptl)=qqs + rinptl(nptl)=-9999 + !write(6,'(a,i9)')' ',idptl(nptl) + zpaptl(1,nptl)=0. + zpaptl(2,nptl)=1. + if(ish.ge.3)then + write(ifch,'(a,5e11.3,$)')' kink:',(pptl(k,nptl),k=1,5) + write(ifch,*)' id: ',idptl(nptl) + endif + +c............................no string = resonance................... + else + + anreso0=anreso0+1 + if(gdrop)anreso1=anreso1+1 + + nptl=nptl+1 + if(idr.ne.0)id=idr + if(nptl.gt.mxptl)call utstop('ProRef: mxptl too small&') + if(iept.eq.0.or.iept.eq.6)call idmass(id,am) + idptl(nptl)=id + pptl(1,nptl)=sngl(ept(1)) + pptl(2,nptl)=sngl(ept(2)) + am2t=sqrt(ept(2)*ept(2)+ept(1)*ept(1)+dble(am*am)) + if(iLHC.eq.1.and.ept(4).gt.am2t)then !conserve value of E on not pz + pptl(4,nptl)=sngl(ept(4)) + pptl(3,nptl)=sngl(sign(sqrt((ept(4)+am2t)*(ept(4)-am2t)) + & ,ept(3))) + else + pptl(3,nptl)=sngl(ept(3)) + pptl(4,nptl)=sngl(sqrt(ept(3)*ept(3)+am2t)) + endif + pptl(5,nptl)=am + istptl(nptl)=0 + iorptl(nptl)=mm + if(.not.gdrop)istptl(mm)=41 + jorptl(nptl)=0 + if(.not.ghadr.and..not.gdrop)ifrptl(1,mm)=nptl + ifrptl(2,mm)=nptl + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + xorptl(1,nptl)=xorptl(1,mm) + xorptl(2,nptl)=xorptl(2,mm) + xorptl(3,nptl)=xorptl(3,mm) + xorptl(4,nptl)=xorptl(4,mm) + tivptl(1,nptl)=xorptl(4,nptl) + call idtau(idptl(nptl),pptl(4,nptl),pptl(5,nptl),taugm) + tivptl(2,nptl)=tivptl(1,nptl)+taugm*(-alog(rangen())) + if(gproj)then + ityptl(nptl)=45 + if(gdrop)then + ityptl(nptl)=46 + elseif(iept.eq.6)then + ityptl(nptl)=47 + elseif(iept.eq.2.or.iept.eq.4)then +c elseif(iept.eq.2)then + ityptl(nptl)=48 + elseif(ghadr)then + ityptl(nptl)=49 + else + mine=0 + mdif=0 + do l=1,lproj(m) + kp=kproj(m,l) + if(abs(itpr(kp)).eq.1)mine=1 + if(itpr(kp).eq.2)mdif=1 + enddo + if(mine.eq.0.and.mdif.eq.1)ityptl(nptl)=48 + endif + else !gtarg + ityptl(nptl)=55 + if(gdrop)then + ityptl(nptl)=56 + elseif(iept.eq.6)then + ityptl(nptl)=57 + elseif(iept.eq.2.or.iept.eq.4)then +c elseif(iept.eq.2)then + ityptl(nptl)=58 + elseif(ghadr)then + ityptl(nptl)=59 + else + mine=0 + mdif=0 + do l=1,lproj(m) + kp=kproj(m,l) + if(abs(itpr(kp)).eq.1)mine=1 + if(itpr(kp).eq.2)mdif=1 + enddo + if(mine.eq.0.and.mdif.eq.1)ityptl(nptl)=58 + endif + endif + itsptl(nptl)=0 + qsqptl(nptl)=0. + rinptl(nptl)=-9999 + + if(ish.ge.3)write(ifch,'(a,5e10.3,i7)')' nucl:' + * ,(pptl(i,nptl),i=1,5),idptl(nptl) + + endif +c....................................................................... +c print *,iep(1),iet(1),ityptl(nptl) + 1000 call utprix('ProReF',ish,ishini,3) +ctp060829 if(ityptl(nptl).gt.60)print*,ityptl(nptl) + return + + end + +c----------------------------------------------------------------------- + subroutine RemoveHadrons(gproj,ghadr,m,mm,jcf,jcv + & ,icf,ept,iret) +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + integer jcf(nflav,2),jcv(nflav,2),icf(2) + double precision aa(5),ept(5) + logical ghadr,gproj + common/ems6/ivp0,iap0,idp0,isp0,ivt0,iat0,idt0,ist0 + common /cncl/xproj(mamx),yproj(mamx),zproj(mamx) + * ,xtarg(mamx),ytarg(mamx),ztarg(mamx) + + iret=0 + + if(iremn.ge.2)then + if(gproj)then + idrf=idp(m) + else + idrf=idt(m) + endif + else + if(gproj)then + idrf=idp0 + else + idrf=idt0 + endif + endif + call idquacjc(jcf,nqu,naq) + if(nqu.eq.naq.and.(nqu.le.2.or.idrf.eq.0))then + nmes=nqu + nmes=nmes-1 !string is aq-q + nbar=0 + elseif(nqu.gt.naq)then + nmes=naq + nbar=(nqu-nmes)/3 !nbar baryons + if(nmes.eq.0.or.idrf.eq.1)then + nbar=nbar-1 !string is qq-q + else + nmes=nmes-1 !string is aq-q + endif + elseif(nqu.lt.naq)then + nmes=nqu + nbar=(naq-nmes)/3 !nbar antibaryons + if(nmes.eq.0.or.idrf.eq.1)then + nbar=nbar-1 !string is aqaq-aq + else + nmes=nmes-1 !string is aq-q + endif + else + nbar=nqu/3 + nmes=nqu-3*nbar + nbar=nbar+naq/3 + nbar=nbar-1 !string is qq-q or aqaq-aq + endif + if(ish.ge.5) + & write(ifch,*)'RemoveHadron part (nq,na,nb,nm,dq):' + & ,nqu,naq,nbar,nmes,idrf + if(nmes+nbar.gt.0)ghadr=.true. +c remove mesons + if(nmes.gt.0)then + do mes=1,nmes + !write(ifch,*)'remove meson',mes,' / ',nmes + call gethadron(1,idd,aa,jcf,jcv,ept,gproj,iret) + if(iret.ne.0)goto 1000 + nptl=nptl+1 + if(nptl.gt.mxptl) + & call utstop('RemoveHadrons: mxptl too small&') + idptl(nptl)=idd + do i=1,5 + pptl(i,nptl)=sngl(aa(i)) + enddo + iorptl(nptl)=mm + jorptl(nptl)=0 + if(mes.eq.1)then + ifrptl(1,mm)=nptl + ifrptl(2,mm)=nptl + else + ifrptl(2,mm)=nptl + endif + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + istptl(nptl)=0 + if(gproj)then + ityptl(nptl)=49 + xorptl(1,nptl)=xproj(m) + xorptl(2,nptl)=yproj(m) + xorptl(3,nptl)=zproj(m) + else !gtarg + ityptl(nptl)=59 + xorptl(1,nptl)=xtarg(m) + xorptl(2,nptl)=ytarg(m) + xorptl(3,nptl)=ztarg(m) + endif + xorptl(4,nptl)=xorptl(4,mm) + tivptl(1,nptl)=xorptl(4,nptl) + call idtau(idptl(nptl),pptl(4,nptl),pptl(5,nptl),taugm) + tivptl(2,nptl)=tivptl(1,nptl)+taugm*(-alog(rangen())) + qsqptl(nptl)=0. +c deleted: after abstracting a meson, +c check if the NEW remnant is a H-Dibaryon + enddo + endif +c remove (anti)baryons + call idquacjc(jcf,nqu,naq) + if(nbar.gt.0)then + do nb=1,nbar + !write(ifch,*)'remove baryon',nb,' / ',nbar + prq=float(nqu/3) + pra=float(naq/3) + psum=prq+pra + if(psum.gt.0.)then + if(rangen()*psum.le.prq)then !baryon + call gethadron(2,idd,aa,jcf,jcv,ept,gproj,iret) + nqu=nqu-3 + else !antibaryon + call gethadron(3,idd,aa,jcf,jcv,ept,gproj,iret) + naq=naq-3 + endif + else + iret=1 + endif + if(iret.ne.0)goto 1000 + nptl=nptl+1 + if(nptl.gt.mxptl) + & call utstop('RemoveHadron: mxptl too small&') + idptl(nptl)=idd + do i=1,5 + pptl(i,nptl)=sngl(aa(i)) + enddo + iorptl(nptl)=mm + jorptl(nptl)=0 + if(nmes.eq.0.and.nb.eq.1)then + ifrptl(1,mm)=nptl + ifrptl(2,mm)=nptl + else + ifrptl(2,mm)=nptl + endif + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + istptl(nptl)=0 + if(gproj)then + ityptl(nptl)=49 + xorptl(1,nptl)=xproj(m) + xorptl(2,nptl)=yproj(m) + xorptl(3,nptl)=zproj(m) + else !gtarg + ityptl(nptl)=59 + xorptl(1,nptl)=xtarg(m) + xorptl(2,nptl)=ytarg(m) + xorptl(3,nptl)=ztarg(m) + endif + xorptl(4,nptl)=xorptl(4,mm) + tivptl(1,nptl)=xorptl(4,nptl) + call idtau(idptl(nptl),pptl(4,nptl),pptl(5,nptl),taugm) + tivptl(2,nptl)=tivptl(1,nptl)+taugm*(-alog(rangen())) + qsqptl(nptl)=0. +c deleted: after abstracting a (anti)baryon, +c check if the NEW remnant is a H-Dibaryon + enddo + endif + call idenco(jcf,icf,iret) + + 1000 return + end + +c------------------------------------------------------------------ + subroutine gethadron(imb,idf,a,jc,jcv,ep,gproj,iret) +c------------------------------------------------------------------ +c goal: emit a hadron (imb= 1 meson, 2 baryon, 3 antibaryon) +c update the remnant flavor and 5-momentum +c +c idf ,a : hadron id and 5-momentum +c gproj : T projectile, F target remnant +c jc, ep : remnant flavor and 5-momentum +c iret : in case of error, keep correct momentum in remnant +c and lose the quarks of the (not) emitted hadron +c----------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + common/cems5/plc,s + double precision s,plc + double precision ep(5),a(5),re(5),p1(5) + integer jc(nflav,2),jcv(nflav,2),jcini(nflav,2),jcvini(nflav,2) + & ,ifh(3),ic(2) + common /ems12/iodiba,bidiba ! defaut iodiba=0. if iodiba=1, study H-Dibaryon + double precision ptm,qcm,u(3),utpcmd,ptt,phi,sxini,sxini0,strmas + & ,ampt2dro,ampt2str,p5sq,amasex,drangen,xmaxrm + logical gproj + + call utpri('gethad',ish,ishini,5) + + iret=0 + do i=1,5 + a(i)=0.d0 + re(i)=ep(i) + enddo + ic(1)=0 + ic(2)=0 + do j=1,2 + do i=1,nflav + jcini(i,j)=jc(i,j) + jcvini(i,j)=jcv(i,j) + enddo + enddo + + if(iremn.ge.2)then + if(ish.ge.5)then + write(ifch,*)'remnant flavor and 5-momentum:',jc + write(ifch,*)' ',jcv + write(ifch,*)'momentum :',ep,gproj,imb + endif + call idquacjc(jcvini,nqv,nav) + else + if(ish.ge.5) + & write(ifch,*)'remnant flavor and 5-momentum:',jc,ep,gproj + & ,imb + nqv=0 + nav=0 + endif + !write(*,'(/a,5f8.3)')'p before: ',ep + + if(gproj)then + iclpt=iclpro + else + iclpt=icltar + endif + +c boost remnant in rest frame + if(ish.ge.6) write (ifch,*) 'on-shell check' + do k=1,5 + p1(k)=ep(k) + enddo + p1(5)=(p1(4)-p1(3))*(p1(4)+p1(3))-p1(2)**2-p1(1)**2 + if(p1(5).gt.0d0.and.abs(p1(5)-ep(5)*ep(5)).lt.ep(5))then + p1(5)=sqrt(p1(5)) + else + if(ish.ge.1)write(ifch,*)'Precision problem in gethad, p:', + & (p1(k),k=1,5),ep(5)*ep(5) + p1(5)=0d0 + endif + +c initial limits + mamos=4 + ptm=p1(5) + sxini0=ptm*ptm + idf=0 +c redo + + nredo=0 + 777 continue + nredo=nredo+1 + if(nredo.gt.1)then !restore initial flavors + ic(1)=0 + ic(2)=0 + do j=1,2 + do i=1,nflav + jc(i,j)=jcini(i,j) + jcv(i,j)=jcvini(i,j) + enddo + enddo + if(iremn.ge.2)then + call idquacjc(jcvini,nqv,nav) + endif + if(ish.ge.7)write(ifch,*)'Restore flavor',idf,jc + idf=0 + if(ptm.eq.0.or.nredo.gt.20)then + if(ish.ge.4)write(ifch,*) + & 'Pb with hadron momentum in Gethad !' + iret=1 + endif + endif + +c get the id and mass of hadron, the remnant jc is updated + iret2=0 + if(imb.eq.1)then ! a meson + j=1 + if(nqv.gt.0)then + i=idraflz(jcv,j) + jc(i,j)=jc(i,j)-1 + nqv=nqv-1 + else + i=idrafl(iclpt,jc,j,'v',1,iret2) + if(iLHC.eq.1.and.iret2.ne.0)goto 77 + endif + ifq=i + j=2 + if(nav.gt.0)then + i=idraflz(jcv,j) + jc(i,j)=jc(i,j)-1 + nav=nav-1 + else + i=idrafl(iclpt,jc,j,'v',1,iret2) + if(iLHC.eq.1.and.iret2.ne.0)goto 77 + endif + ifa=i +c write(ifch,*)'ici',ifq,ifa,jc,'| ',jcv + ic(1)=10**(6-ifq) + ic(2)=10**(6-ifa) + ier=0 + idf=idtra(ic,ier,idum,0) + if(ier.ne.0)then + if(ifq.le.ifa)then + idf=ifq*100+ifa*10 + else + idf=-(ifq*10+ifa*100) + endif + endif + call idmass(idf,amss) + + elseif(imb.eq.2)then ! a baryon + j=1 + do ik=1,3 + if(nqv.gt.0)then + i=idraflz(jcv,j) + jc(i,j)=jc(i,j)-1 + nqv=nqv-1 + else + i=idrafl(iclpt,jc,j,'v',1,iret2) + if(iLHC.eq.1.and.iret2.ne.0)goto 77 + endif + ifh(ik)=i + ic(j)=ic(j)+10**(6-i) + enddo + ier=0 + idf=idtra(ic,ier,idum,0) + if(ier.ne.0)then + call neworder(ifh(1),ifh(2),ifh(3)) + idf=ifh(1)*1000+ifh(2)*100+ifh(3)*10 + if(ifh(1).ne.ifh(2).and.ifh(2).ne.ifh(3) + $ .and.ifh(1).ne.ifh(3)) idf=2130 + if(ifh(1).eq.ifh(2).and.ifh(2).eq.ifh(3))idf=idf+1 + endif + call idmass(idf,amss) + + elseif(imb.eq.3)then ! an antibaryon + j=2 + do ik=1,3 + if(nav.gt.0)then + i=idraflz(jcv,j) + jc(i,j)=jc(i,j)-1 + nav=nav-1 + else + i=idrafl(iclpt,jc,j,'v',1,iret2) + if(iLHC.eq.1.and.iret2.ne.0)goto 77 + endif + ifh(ik)=i + ic(j)=ic(j)+10**(6-i) + enddo + ier=0 + idf=idtra(ic,ier,idum,0) + if(ier.ne.0)then + call neworder(ifh(1),ifh(2),ifh(3)) + idf=ifh(1)*1000+ifh(2)*100+ifh(3)*10 + if(ifh(1).ne.ifh(2).and.ifh(2).ne.ifh(3) + $ .and.ifh(1).ne.ifh(3)) idf=2130 + if(ifh(1).eq.ifh(2).and.ifh(2).eq.ifh(3))idf=idf+1 + idf=-idf + endif + call idmass(idf,amss) + else + call utstop('This imb does not exist in gethad !&') + endif + + 77 if(iret2.ne.0)then + write(ifmt,*)'warning in gethadron: imb=',imb,' iclpt:',iclpt + write(ifmt,*)' jc: ',jc,' j: ',j,' (1=q,2=aq) --> redo' + call utmsg('gethad') + write(ifch,*)'Not enough quark ??? ... redo event !' + call utmsgf + iret=1 + goto 1000 + endif + +c fix pt + amasex=dble(amss) + strmas=dble(utamnz(jc,mamos)) + + ptt=dble(ranpt()*alpdro(2))**2 !pt+pl + if(iret.ne.0)ptt=min(ptt,sxini0) + if(ptt.gt.sxini0)goto 777 + sxini=sqrt(sxini0-ptt) + + + + a(5)=amasex + re(5)=sxini-a(5) + if(re(5).lt.strmas)then + call idquacjc(jc,nq,na) + if(nq+na.le.3)then + idtmp=idtra(ic,1,idum,0) + amtmp=0. + call idmass(idtmp,amtmp) + if(re(5).lt.amtmp)then + if(ish.ge.6)write(ifch,*) + & 'Pb with initial mass in Gethad, retry',idf + & ,amasex,re(5),strmas,sxini,ptm,ptt,amtmp,idtmp,ic,iret + if(iret.eq.0)then + goto 777 + else + if(ish.ge.6)write(ifch,*) + & 'Continue with minimal mass for remnant',re(5) + & ,amtmp + re(5)=amtmp + endif + else + strmas=amtmp + endif + endif + endif + + ampt2dro=amasex**2d0 + ampt2str=strmas**2d0 + +c two body decay + iret2=0 + if(iret.eq.1)then +c If energy to small, then produce a new particle adding the needed missing energy (limited energy violation to avoid stop and corrected in utrescl) + xmaxrm=a(5)*a(5)+re(5)*re(5) + if(ptm*ptm-xmaxrm.lt.0d0)then + ptm=1.1d0*sqrt(2.d0*abs(a(5))*abs(re(5))+xmaxrm) + p1(5)=ptm + p1(4)=sqrt(p1(3)*p1(3)+p1(2)*p1(2)+p1(1)*p1(1)+p1(5)*p1(5)) + endif + endif + if(ish.ge.6)write(ifch,*)'2 body decay',ptm,a(5),re(5),iret + qcm=utpcmd(ptm,a(5),re(5),iret2) + if(iret2.ne.0)then + if(iret.eq.0)then + goto 777 + else +c call utstop('Problem with qcm in gethadron !&') + if(ish.ge.1)then + call utmsg('gethad') + write(ifch,*)'Problem with qcm ... redo event !' + call utmsgf + endif + iret=1 + return + endif + endif + u(3)=2.d0*drangen(qcm)-1.d0 + phi=2.d0*dble(pi)*drangen(u(3)) + u(1)=sqrt(1.d0-u(3)**2)*cos(phi) + u(2)=sqrt(1.d0-u(3)**2)*sin(phi) + if(u(3).ge.0d0)then !send always hadron backward + do j=1,3 + re(j)=qcm*u(j) + a(j)=-re(j) + enddo + else + do j=1,3 + a(j)=qcm*u(j) + re(j)=-a(j) + enddo + endif + + re(4)=sqrt(qcm**2+re(5)**2) + a(4)=sqrt(qcm**2+a(5)**2) + + if(ish.ge.6)write(ifch,*)'boost : ',qcm + & ,' and momentum in rest frame : ',re,a + + +c Fix re of remnant + +c boost string in collision frame + call utlob2(-1,p1(1),p1(2),p1(3),p1(4),p1(5) + $ ,re(1),re(2),re(3),re(4),81) + + p5sq=(re(4)+re(3))*(re(4)-re(3))-(re(1)*re(1)+re(2)*re(2)) + if(p5sq.ge.ampt2str)then + re(5)=sqrt(p5sq) + else + if(ish.ge.6)then + write(ifch,*)'Pb with remnant mass -> retry' + write(ifch,*)' m^2:',p5sq,' m_min^2:',ampt2str + write(ifch,*)' momentum four vector:',(re(ii),ii=1,4) + endif + if(iret.eq.0)then + goto 777 + else + if(ish.ge.6)write(ifch,*) + & 'Finish with minimal mass for remnant',re(5) + endif + endif + +c Fix a of hadron + +c boost hadron in collision frame + call utlob2(-1,p1(1),p1(2),p1(3),p1(4),p1(5) + $ ,a(1),a(2),a(3),a(4),82) + + p5sq=(a(4)+a(3))*(a(4)-a(3))-(a(1)**2.d0+a(2)**2.d0) + if(abs(p5sq-ampt2dro).le.0.1)then + a(5)=sqrt(p5sq) + else + if(ish.ge.6)then + write(ifch,*)'Pb with hadron mass' + write(ifch,*)' m^2:',p5sq,' m_min^2:',ampt2dro + write(ifch,*)' momentum four vector:',(a(ii),ii=1,4) + endif + a(4)=sqrt(a(5)*a(5)+a(3)*a(3)+a(2)*a(2)+a(1)*a(1)) + if(ish.ge.6)write(ifch,*)'Fix E with M and P:',(a(ii),ii=1,5) + endif + + +c if(iret.eq.1)then !If problem with momenta do not update remnant +c +c if(ish.ge.4) +c * write(ifch,*)'no hadron emission in gethad' +c +c else !update the 3-momentum and energy of remnant: ep + + if(ish.ge.1.and.abs(ep(4)-re(4)-a(4)).gt.1.d-2*ep(4))then + write(ifmt,*)'Pb with energy conservation in gethad' + if(ish.ge.6)then + write(ifch,*)'Pb with energy conservation :' + write(ifch,*)' p1_ini:',ep(1),' p1:',re(1)+a(1) + write(ifch,*)' p2_ini:',ep(2),' p2:',re(2)+a(2) + write(ifch,*)' p3_ini:',ep(3),' p3:',re(3)+a(3) + write(ifch,*)' p4_ini:',ep(4),' p4:',re(4)+a(4) + endif + endif + + do i=1,5 + ep(i)=re(i) + enddo + if(ish.ge.5)then + write(ifch,*)'get hadron with id and 5-momentum:',idf, a + endif + +c endif + + !do i=1,5 + ! sm(i)=ep(i)+a(i) + !enddo + !write(*,'(a,5f8.3,i5)')'p after: ',sm,iret + +c ghost condition +c if(abs((a(4)+a(3))*(a(4)-a(3)) +c $ -a(2)**2-a(1)**2-a(5)**2).gt.0.3 +c $ .and. abs(1.-abs(a(3))/a(4)).gt.0.01)print*,iret,dd + +c$$$ if(iodiba.eq.1)then ! for H-dibaryon study ?????????? +c$$$ call idenco(jc,ic,iret) +c$$$ if(ic(1).eq.222000.and.ic(2).eq.0)ep(5)=ep(5)-bidiba +c$$$ endif + + if(ish.ge.5)then + write(ifch,*)'new remnant flavor and 5-momentum:',jc, ep,iret + endif + iret=0 +c write(ifmt,*)'get hadron with id and 5-momentum:',idf, a +c write(ifmt,*)'new remnant flavor and 5-momentum:',jc, ep + + 1000 call utprix('gethad',ish,ishini,5) + + return + end + + + +c------------------------------------------------------------------ + subroutine getdroplet(ir,iept,ic,jc,z,ep,a,pass,xmdrmax) +c------------------------------------------------------------------ +c emit a droplet, update the remnant string flavor and 5-momentum +c +c input +c ir ........ 1 projectile, -1 target remnant +c iept ...... particle excitation +c ep ........ remnant 5-momentum +c jc ........ remnant jc +c z ........ Z factor from splitting +c output +c pass ... .true. = successful droplet emission +c jc, ep ....... droplet ic and 5-momentum +c ic, a ........ remnant string jc and 5-momentum +c .false. = unsuccessful +c jc, ep .... unchanged, +c considered as droplet jc and 5-momentum +c----------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + double precision ep(5),a(5),p1(5),re(5),eps,amasex,xmdrmax + double precision xxx,rr,alp,p5sq,xmin,xmax,ampt2str + & ,sxini,strmas,xxxmax,xxxmin,ampt2dro,xmdrmaxi + parameter(eps=1.d-20) + integer jc(nflav,2),ic(2),icx(2) + integer jcini(nflav,2),jcfin(nflav,2) + logical pass + common/cems5/plc,s + double precision s,plc,ptm,qcm,u(3),utpcmd,ptt,drangen,phi + + call utpri('getdro',ish,ishini,4) + + iret=0 + iret2=0 + xmdrmaxi=min(50.d0,xmdrmax) + pass=.true. + idps=0 + idms=0 + do i=1,nflav + jcini(i,1)=jc(i,1) + jcini(i,2)=jc(i,2) + jcfin(i,1)=0 + jcfin(i,2)=0 + enddo + + + call idquacjc(jcini,nqu,naq) + + do i=1,5 + a(i)=0.d0 + re(i)=0.d0 + enddo + npart=nqu+naq + nqc=jcini(4,1)+jcini(4,2) + + if(ir.eq.1)then + iclpt=iclpro + else + iclpt=icltar + endif + + if(ish.ge.5)then + write(ifch,10)'remnant flavor and 5-momentum:' + & ,jc,ep,nqu,naq,nqc,iept + 10 format(a,/,'jc:',6i3,' |',6i3,/,'ep:',5(e10.3,1x),/,4i4) + endif + +c get id of string ends, the remnant string jc is updated + if(iremn.eq.3)then ! remnant content=string content (droplet empty) + + do i=1,nflav + jcfin(i,1)=jcini(i,1) + jcfin(i,2)=jcini(i,2) + jcini(i,1)=0 + jcini(i,2)=0 + enddo + + else + + if(npart.lt.3.and.ep(5).lt.xmdrmax.and.nqc.eq.0)then !light droplet with few quarks + pass=.false. + goto 1000 + elseif(npart.lt.3)then !few quarks but heavy, add some quarks to extract a q-qbar string (should not exit directly because of the large mass) + ifq=idrafl(iclpt,jcini,2,'r',3,iret2) + if(nqu.eq.1.and.naq.eq.1)then + idps=1 + idms=1 + nqu=2 + naq=2 + else + call utstop('This should not happen (getdrop) !&') + endif + elseif(nqu.eq.2.and.naq.eq.2)then + idps=1 + idms=1 + elseif(naq.eq.0)then + idps=5 + idms=1 + elseif(nqu.eq.0)then + idps=1 + idms=5 + else !There is enough q or aq to do qq-q string + + + if(jcini(4,1)-jcini(4,2).eq.0)then !if c-cbar + + idps=1 + idms=1 + + else + +c One chooses the first q or aq + + rrr=rangen() + npart=nqu+naq + if(jcini(4,1)+jcini(4,2).ne.0)then !if some charm take it out + if(jcini(4,1).ne.0)then + idps=1 + nqu=nqu-1 + else + idms=1 + naq=naq-1 + endif + elseif(rrr.gt.float(naq)/float(npart))then + idps=1 + nqu=nqu-1 + else + idms=1 + naq=naq-1 + endif + +c One chooses the second one + + rrr=rangen() + npart=nqu+naq + if(idps.eq.1.and.jcini(4,1).ne.0)then !if some charm take it out + idps=5 + elseif(idms.eq.1.and.jcini(4,2).ne.0)then !if some charm take it out + idms=5 + elseif(rrr.gt.float(naq)/float(npart))then + if(idps.eq.1.and.nqu.ge.2)then + idps=5 + else + idps=1 + endif + else + if(idms.eq.1.and.naq.ge.2)then + idms=5 + else + idms=1 + endif + endif + +c If there is already 2 q or 2 aq as string end, we know that we need +c a third one to complete the string + + if(idps.eq.5)idms=1 + if(idms.eq.5)idps=1 + if(idps.eq.1.and.idms.ne.5)idms=1 + if(idms.eq.1.and.idps.ne.5)idps=1 + + endif + + endif + + if(ish.ge.5)then + write(ifch,*)'remnant string ends :',idps,idms + endif + + if(idps.ne.5.and.idms.ne.5)then ! q-aq string + if(jcini(4,1).eq.1)then + ifq=idrafl(iclpt,jcini,1,'c',1,iret) + else + ifq=idrafl(iclpt,jcini,1,'v',1,iret) + endif + if(jcini(4,1).eq.1)then + ifa=idrafl(iclpt,jcini,2,'c',1,iret) + else + ifa=idrafl(iclpt,jcini,2,'v',1,iret) + endif + jcfin(ifq,1)=1 + jcfin(ifa,2)=1 + + elseif(idps.eq.5)then ! qq-q string + do ik=1,3 + if(jcini(4,1).ne.0)then + i=idrafl(iclpt,jcini,1,'c',1,iret) + else + i=idrafl(iclpt,jcini,1,'v',1,iret) + endif + jcfin(i,1)=jcfin(i,1)+1 + enddo + + elseif(idms.eq.5)then !aqaq-aq string + do ik=1,3 + if(jcini(4,2).ne.0)then + i=idrafl(iclpt,jcini,2,'c',1,iret) + else + i=idrafl(iclpt,jcini,2,'v',1,iret) + endif + jcfin(i,2)=jcfin(i,2)+1 + enddo + endif + + endif !iremn=3 + + if(iret.ne.0)call utstop('Not enough quark in getdro ???&') + if(jcini(4,1)+jcini(4,2).ne.0) + & call utstop('There is sitll charm quark in getdro???&') + +c string id + + call idenco(jcfin,icx,iret) + if(iret.eq.1)then + call utstop('Exotic flavor in getdroplet !&') + endif + + +c boost remnant in rest frame + if(ish.ge.6) write (ifch,*) 'on-shell check' + do k=1,5 + p1(k)=ep(k) + enddo + p1(5)=(p1(4)-p1(3))*(p1(4)+p1(3))-p1(2)**2-p1(1)**2 + if(p1(5).gt.0d0.and.abs(p1(5)-ep(5)*ep(5)).lt.ep(5))then + p1(5)=sqrt(p1(5)) + else + if(ish.ge.2)write(ifch,*)'Precision problem in getdro, p:', + & (p1(k),k=1,5),ep(5)*ep(5) + p1(5)=ep(5) + p1(4)=sqrt(p1(3)*p1(3)+p1(2)*p1(2)+p1(1)*p1(1)+p1(5)*p1(5)) + endif + if(ish.ge.6) write (ifch,*) 'boost vector:',p1 + +c limits for momenta + + mamod=4 + mamos=4 + fad=alpdro(1) + if(iremn.eq.3)fad=fad*(1.+z*zdrinc) + fad=max(1.5,fad) + ptm=p1(5) + amasex=dble(fad*utamnz(jcini,mamod)) + fas=2. + if(iremn.eq.3)then + id=idtra(icx,ier,ires,0) + if(ier.eq.0)then + call idmass(id,amass) !minimum is particle mass + strmas=dble(amass) + else + strmas=dble(fas*utamnz(jcfin,mamos)) + endif + else + strmas=dble(fas*utamnz(jcfin,mamos)) + endif + + +c redo + + nredo=0 + 777 continue + nredo=nredo+1 + if(nredo.eq.10)then + amasex=1.5d0*dble(utamnz(jcini,mamod)) + if(iremn.ne.3)strmas=1.5d0*dble(utamnz(jcfin,mamos)) + elseif(nredo.gt.20)then + !write(ifch,*)'nredo.gt.20 -> only drop' + if(ish.ge.4)write(ifch,*) + & 'Pb with string mass in Getdrop, continue with gethad' + pass=.false. + goto 1000 + endif + +c fix pt + + sxini=ptm*ptm + ptt=dble(ranpt()*alpdro(2))**2 !pt + if(ptt.ge.sxini)goto 777 + sxini=sqrt(sxini-ptt) + + + ampt2dro=amasex**2d0 + ampt2str=strmas**2d0 + if(ampt2dro.gt.xmdrmaxi)then + xmdrmaxi=2d0*ampt2dro +c write(ifmt,*)'Warning Mmin>Mmax in Getdroplet' + endif + + xxxmax=min(xmdrmaxi,(sxini-strmas)**2) !strmas/(strmas+ampt2) + xxxmin=ampt2dro + + if(xxxmin.gt.xxxmax)then + !write(ifch,*)'Warning Mmin>sxini -> only drop' + if(ish.ge.4)write(ifch,*) + & 'Pb with ampt2 in Getdrop, retry',nredo,ir + & ,ampt2dro,ampt2str,xxxmin,xxxmax,sxini,ptt,xmdrmaxi + goto 777 + endif + + + +c fix mass + + rr=drangen(xxxmax) + xmax=xxxmax + xmin=xxxmin + alp=dble(alpdro(3)) + if(dabs(alp-1.d0).lt.eps)then + xxx=xmax**rr*xmin**(1d0-rr) + else + xxx=(rr*xmax**(1d0-alp)+(1d0-rr)*xmin**(1d0-alp)) + & **(1d0/(1d0-alp)) + endif + + +c write(ifch,*)'ini',xmin,xxx,xmax,rr,ampt2dro +c & ,(sxini-sqrt(xxx)),ampt2str,p1(5) + + + + re(5)=sqrt(xxx) + a(5)=sxini-re(5) + if(a(5).lt.strmas)then + if(ish.ge.6)write(ifch,*) + & 'Pb with initial mass in Getdrop, retry',ir + & ,xmin,xxx,xmax,rr,ampt2dro,ampt2str,a(5) + goto 777 + endif + + +c two body decay + if(ish.ge.6)write(ifch,*)'2 body decay',ptm,re(5),a(5) + qcm=utpcmd(ptm,re(5),a(5),iret) + u(3)=0.d0 !2.d0*drangen(qcm)-1.d0 + phi=2.d0*dble(pi)*drangen(u(3)) + u(1)=sqrt(1.d0-u(3)**2)*cos(phi) + u(2)=sqrt(1.d0-u(3)**2)*sin(phi) + if(u(3).lt.0d0)then !send always droplet backward +c if(u(3).gt.0d0)then !send always droplet forward ????? + do j=1,3 + re(j)=qcm*u(j) + a(j)=-re(j) + enddo + else + do j=1,3 + a(j)=qcm*u(j) + re(j)=-a(j) + enddo + endif + + re(4)=sqrt(qcm**2+re(5)**2) + a(4)=sqrt(qcm**2+a(5)**2) + + if(ish.ge.6)write(ifch,*)'momentum in rest frame : ',re,a + + + +c Fix a of string + +c boost string in collision frame + call utlob2(-1,p1(1),p1(2),p1(3),p1(4),p1(5) + $ ,a(1),a(2),a(3),a(4),71) + + p5sq=(a(4)+a(3))*(a(4)-a(3))-(a(1)**2.d0+a(2)**2.d0) + if(p5sq.gt.ampt2str)then + a(5)=sqrt(p5sq) + else + if(ish.ge.6)then + write(ifch,*)'Pb with string mass -> retry' + write(ifch,*)' m^2:',p5sq,' m_min^2:',ampt2str + write(ifch,*)' momentum four vector:',(a(ii),ii=1,4) + endif + goto 777 + endif + +c Fix ep of droplet + +c boost droplet in collision frame + call utlob2(-1,p1(1),p1(2),p1(3),p1(4),p1(5) + $ ,re(1),re(2),re(3),re(4),72) + + p5sq=(re(4)+re(3))*(re(4)-re(3))-(re(1)*re(1)+re(2)*re(2)) + if(p5sq.gt.ampt2dro)then + re(5)=sqrt(p5sq) + else + if(ish.ge.6)then + write(ifch,*)'Pb with droplet mass -> retry' + write(ifch,*)' m^2:',p5sq,' m_min^2:',ampt2dro + write(ifch,*)' momentum four vector:',(re(ii),ii=1,4) + endif + goto 777 + endif + + + if(ish.ge.1.and.abs(ep(4)-re(4)-a(4)).gt.1.d-2*ep(4))then + write(ifmt,*)'Pb with energy conservation in getdro' + if(ish.ge.6)then + write(ifch,*)'Pb with energy conservation :' + write(ifch,*)' p1_ini:',ep(1),' p1:',re(1)+a(1) + write(ifch,*)' p2_ini:',ep(2),' p2:',re(2)+a(2) + write(ifch,*)' p3_ini:',ep(3),' p3:',re(3)+a(3) + endif + endif + +c If OK, save flavors of droplet and string + do i=1,5 + ep(i)=re(i) + enddo + ic(1)=icx(1) + ic(2)=icx(2) + do i=1,nflav + jc(i,1)=jcini(i,1) + jc(i,2)=jcini(i,2) + enddo + + if(ish.ge.6)then + write(ifch,20)'droplet:',jc,ep + write(ifch,30)'string remnant:',ic,a + endif + 20 format(a,/,'jc:',6i3,' |',6i3,/,'ep:',5(e10.3,1x)) + 30 format(a,/,'ic:',i7,' |',i7,/,'a:',5(e10.3,1x)) + + 1000 continue + call utprix('getdro',ish,ishini,4) + end + +c------------------------------------------------------------------ + subroutine getdropx(ir,iept,m,ic,jc,jcv,z,ep,a,pass,xmdrmax) +c------------------------------------------------------------------ +c emit a droplet taken into account momentum fraction without screening, +c update the remnant string flavor and 5-momentum (to be used with iremn=2) +c +c input +c ir ........ 1 projectile, -1 target remnant +c iept ...... particle excitation +c m ........ remnant index +c ep ........ remnant 5-momentum +c jc ........ remnant jc +c jcv ....... remnant jc valence quark +c z ........ Z factor from splitting +c output +c pass ... .true. = successful droplet emission +c jc, ep ....... droplet ic and 5-momentum +c ic, a ........ remnant string jc and 5-momentum +c .false. = unsuccessful +c jc, ep .... unchanged, +c considered as droplet jc and 5-momentum +c----------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + double precision ep(5),a(5),p1(5),re(5),eps,amasex,xmdrmax + double precision xxx,rr,alpm,p5sq,xmin,xmax,ampt2str,xmsmax + & ,sxini,strmas,xxxmax,xxxmin,ampt2dro,xmdrmaxi,xprmi,xmrmi + & ,xprmd,xmrmd,xprms,xmrms,xpti,ypti,xptd,yptd,xpts,ypts,xptt,yptt + double precision om1xpr,xremd,xrems,freduc + & ,atil(ntymi:ntymx),btilp(ntymi:ntymx),btilpp(ntymi:ntymx) + parameter(eps=1.d-20) + integer jc(nflav,2),jcv(nflav,2),ic(2),icx(2) + integer jcvini(nflav,2),jcini(nflav,2) + & ,jcfin(nflav,2),jcvfin(nflav,2) + logical pass + common/cems5/plc,s + double precision s,plc,ptm,qcm,u(3),utpcmd,ptt,drangen,phi + logical strcomp,valqu + + call utpri('getdrx',ish,ishini,4) + + iret=0 + xmdrmaxi=min(50.d0,xmdrmax) + pass=.true. + idps=0 + idms=0 + do i=1,nflav + jcini(i,1)=jc(i,1) + jcini(i,2)=jc(i,2) + jcvini(i,1)=jcv(i,1) + jcvini(i,2)=jcv(i,2) + jcfin(i,1)=0 + jcfin(i,2)=0 + jcvfin(i,1)=0 + jcvfin(i,2)=0 + enddo + + + call idquacjc(jcini,nqu,naq) + call idquacjc(jcvini,nqv,nav) + + do i=1,5 + a(i)=0.d0 + re(i)=0.d0 + enddo + nqc=jcini(4,1)+jcini(4,2) + + idrf=0 + if(nqu-naq.ne.0)idrf=1 + if(ir.eq.1)then + iclpt=iclpro + if(idrf.eq.0)idrf=idp(m) !change it only if not 1 + xprmi=xpp(m) + xmrmi=xmp(m) + xpti=xxp(m) + ypti=xyp(m) + if(lproj3(m).gt.0)then + nlnk=max(1,nint(z*float(lproj3(m)))) + else + nlnk=0 + endif + else + iclpt=icltar + if(idrf.eq.0)idrf=idt(m) !change it only if not 1 + xprmi=xmt(m) + xmrmi=xpt(m) + xpti=xxt(m) + ypti=xyt(m) + if(ltarg3(m).gt.0)then + nlnk=max(1,nint(z*float(ltarg3(m)))) + else + nlnk=0 + endif + endif + + if(ish.ge.5)then + write(ifch,10)'remnant flavor and 5-momentum:' + & ,jc,jcv,ep,nqu,naq,nqv,nav,nqc,idrf,iept,nlnk + 10 format(a,/,'jc:',6i3,' |',6i3,/,'jcv:',6i3,' |',6i3,/ + & ,'ep:',5(e10.3,1x),/,8i4) + endif + +c check formation conditions + + strcomp=.false. + valqu=.false. !if true, valence quark will always be in strings : reduce lambda production + if((nqu.eq.3.and.naq.eq.0).or.(nqu.eq.0.and.naq.eq.3) + & .or.(nqu.eq.1.and.naq.eq.1).and.nlnk.ne.0)then +c not enough quark for the droplet, check mass + if(iept.ne.5.and.ep(5)*ep(5).lt.xmdrmax.and.nqc.eq.0)then + pass=.false. !continue without droplet + if(ish.ge.4)write(ifch,*) + & 'Normal remnant in Getdropx, continue only with droplet ...' + goto 1000 + endif +c create q-aq from sea (but no charm) + do n=1,nlnk + idum=idrafl(iclpt,jcini,1,'r',3,iret) + nqu=nqu+1 + naq=naq+1 + enddo + strcomp=.true. + valqu=.false. + elseif(mod(nqu-naq,3).ne.0)then + call utstop('This should not happen (getdropx) !&') + endif + +c get id of string ends, the remnant string jc is updated + +c First remove all charm + + if(nqc.ne.0.and.jcini(4,1)-jcini(4,2).eq.0)then !if c-cbar + + if(jcini(4,1).eq.1)then + idps=1 + idms=1 + else + call utstop('getdropx can not manage more than c-cb !&') + endif + + elseif(nqc.ne.0.and.jcini(4,1)*jcini(4,2).ne.0)then + + call utstop('getdropx can not manage c quarks this way !&') + + else + + + if(nqc.ne.0)then !if some charm take it out + if(jcini(4,1).ne.0)then + if(nqu.lt.3)then + idrf=0 !can not use c in antibaryon + elseif(jcini(4,1).gt.1)then + idrf=1 !more than 1 c quark only in baryon + endif + elseif(jcini(4,2).ne.0)then + if(naq.lt.3)then + idrf=0 !can not use cb in baryon + elseif(jcini(4,2).gt.1)then + idrf=1 !more than 1 c antiquark only in antibaryon + endif + endif + if(idrf.ne.0.and.jcini(4,1).gt.0.and.jcini(4,1).le.3)then + idps=5 + idms=1 + elseif(idrf.ne.0.and.jcini(4,2).gt.0.and.jcini(4,2).le.3)then + idps=1 + idms=5 + elseif(jcini(4,1).gt.1.or.jcini(4,2).gt.1)then + call utstop('getdropx can not use more than 3 c/cb !&') + endif + endif + +c take into account number of diquark in final remnant string + + if(idps.eq.0)then + + if(idrf.ne.0)then !use a diquark + if(nqu.gt.naq)then !qq-q + idps=5 + idms=1 + elseif(nqu.lt.naq)then !qbqb-qb + idps=1 + idms=5 + endif + else !q-qb + idps=1 + idms=1 + endif + + endif + + endif !string end type + + if(ish.ge.5)then + write(ifch,*)'remnant string ends :',idps,idms + endif + +c choose flavor with priority to valence quark (after charm) + + if(idps.ne.5.and.idms.ne.5)then ! q-aq string + j=1 + if(jcini(4,j).gt.0)then + i=4 + jcini(i,j)=jcini(i,j)-1 + if(jcvini(i,j).gt.0)then + jcvfin(i,j)=jcvfin(i,j)+1 + jcvini(i,j)=jcvini(i,j)-1 + nqv=nqv-1 + endif + elseif(valqu.and.nqv.gt.0)then + i=idraflz(jcvini,j) + jcvfin(i,j)=jcvfin(i,j)+1 + jcini(i,j)=jcini(i,j)-1 + nqv=nqv-1 + else + i=idrafl(iclpt,jcini,j,'v',1,iret) + if(jcini(i,j)-jcvini(i,j).lt.0)then + jcvini(i,j)=jcvini(i,j)-1 + jcvfin(i,j)=jcvfin(i,j)+1 + endif + endif + ifq=i + j=2 + if(jcini(4,j).gt.0)then + i=4 + jcini(i,j)=jcini(i,j)-1 + if(jcvini(i,j).gt.0)then + jcvfin(i,j)=jcvfin(i,j)+1 + jcvini(i,j)=jcvini(i,j)-1 + nav=nav-1 + endif + elseif(valqu.and.nav.gt.0)then + i=idraflz(jcvini,j) + jcvfin(i,j)=jcvfin(i,j)+1 + jcini(i,j)=jcini(i,j)-1 + nav=nav-1 + else + i=idrafl(iclpt,jcini,j,'v',1,iret) + if(jcini(i,j)-jcvini(i,j).lt.0)then + jcvini(i,j)=jcvini(i,j)-1 + jcvfin(i,j)=jcvfin(i,j)+1 + endif + endif + ifa=i + jcfin(ifq,1)=1 + jcfin(ifa,2)=1 + + elseif(idps.eq.5)then ! qq-q string + j=1 + do ik=1,3 + if(jcini(4,j).ne.0)then + i=4 + jcini(i,j)=jcini(i,j)-1 + if(jcvini(i,j).gt.0)then + jcvfin(i,j)=jcvfin(i,j)+1 + jcvini(i,j)=jcvini(i,j)-1 + nqv=nqv-1 + endif + elseif(valqu.and.nqv.gt.0)then + i=idraflz(jcvini,j) + jcvfin(i,j)=jcvfin(i,j)+1 + jcini(i,j)=jcini(i,j)-1 + nqv=nqv-1 + else + i=idrafl(iclpt,jcini,j,'v',1,iret) + if(jcini(i,j)-jcvini(i,j).lt.0)then + jcvini(i,j)=jcvini(i,j)-1 + jcvfin(i,j)=jcvfin(i,j)+1 + endif + endif + jcfin(i,j)=jcfin(i,j)+1 + enddo + + elseif(idms.eq.5)then !aqaq-aq string + j=2 + do ik=1,3 + if(jcini(4,j).gt.0)then + i=4 + jcini(i,j)=jcini(i,j)-1 + if(jcvini(i,j).gt.0)then + jcvfin(i,j)=jcvfin(i,j)+1 + jcvini(i,j)=jcvini(i,j)-1 + nav=nav-1 + endif + elseif(valqu.and.nav.gt.0)then + i=idraflz(jcvini,j) + jcvfin(i,j)=jcvfin(i,j)+1 + jcini(i,j)=jcini(i,j)-1 + nav=nav-1 + else + i=idrafl(iclpt,jcini,j,'v',1,iret) + if(jcini(i,j)-jcvini(i,j).lt.0)then + jcvini(i,j)=jcvini(i,j)-1 + jcvfin(i,j)=jcvfin(i,j)+1 + endif + endif + jcfin(i,j)=jcfin(i,j)+1 + enddo + + endif + + if(iret.ne.0)call utstop('Not enough quark in getdropx ???&') + if(jcini(4,1)+jcini(4,2).ne.0) + & call utstop('There is sitll charm quark in getdropx???&') + +c string id + + call idenco(jcfin,icx,iret) + if(iret.eq.1)then + call utstop('Exotic flavor in getdropx !&') + endif + + +c boost remnant in rest frame + if(ish.ge.6) write (ifch,*) 'on-shell check' + do k=1,5 + p1(k)=ep(k) + enddo + p1(5)=(p1(4)-p1(3))*(p1(4)+p1(3))-p1(2)**2-p1(1)**2 + if(p1(5).gt.0d0.and.abs(p1(5)-ep(5)*ep(5)).lt.ep(5))then + p1(5)=sqrt(p1(5)) + else + if(ish.ge.2)write(ifch,*)'Precision problem in getdropx, p:', + & (p1(k),k=1,5),ep(5)*ep(5) + p1(5)=ep(5) + p1(4)=sqrt(p1(3)*p1(3)+p1(2)*p1(2)+p1(1)*p1(1)+p1(5)*p1(5)) + endif + +c limits for momenta + + mamod=4 + mamos=4 + fad=alpdro(1) + fad=max(1.5,fad*(1.+z*zdrinc)) + ptm=p1(5) + amasex=dble(fad*utamnz(jcini,mamod)) + fas=2. + strmas=dble(fas*utamnz(jcfin,mamos)) + ampt2dro=amasex**2d0 + ampt2str=strmas**2d0 + if(ampt2dro.gt.xmdrmaxi)then + xmdrmaxi=2d0*ampt2dro +c write(ifmt,*)'Warning Mmin>Mmax in Getdropx' + endif + + +c redo + + xxxmin=1d0-xprmi + if(xxxmin.gt.ampt2dro/(s*xmrmi))then + xmrmd=ampt2dro/(s*xxxmin) + else + nlnk=0 + endif + nredo=-1 + freduc=1d0 + 777 continue + nredo=nredo+1 + if(strcomp.and.nredo.eq.20)then !after 19 try and remnant compatible with a string + pass=.false. !continue without droplet + if(ish.ge.4)write(ifch,'(a,2i3,4e12.5)') + & 'Pb with splitting in Getdropx, continue without split ...' + & ,nlnk,nvirt,xxxmax,xxxmin,ep(5)**2,xmdrmax + goto 1000 + elseif(nredo.eq.10.or.nredo.eq.26)then !reduce minimum mass + amasex=1.5d0*dble(utamnz(jcini,mamod)) + strmas=1.5d0*dble(utamnz(jcfin,mamos)) + ampt2dro=amasex**2d0 + ampt2str=strmas**2d0 + xmrmd=ampt2dro/(s*xxxmin) + elseif(nredo.eq.20)then !after 19 try, use 2 body decay + xmrmd=1d0+xmrmi + if(ish.ge.4)write(ifch,*) + & 'nredo>20, use 2 body decay ...',nvirt,xxxmax,xxxmin + amasex=dble(fad*utamnz(jcini,mamod)) + strmas=dble(fas*utamnz(jcfin,mamos)) + ampt2dro=amasex**2d0 + ampt2str=strmas**2d0 + if(ish.ge.6) write (ifch,*) 'boost vector:',p1 + elseif(nredo.ge.30)then + !write(ifch,*)'nredo.gt.20 -> only drop' + if(ish.ge.4)write(ifch,*) + & 'Pb with string mass in Getdropx, continue without split ...' + pass=.false. + goto 1000 + endif + + if(xmrmd.lt.xmrmi.and.nlnk.gt.0)then !kinetic compatibility + + xmrms=xmrmi-xmrmd + +c fix the virtual number of collision (no screening) + iscreensave=iscreen + iscreen=0 + imin=ntymin + imax=ntymx + if(iomega.eq.2)imax=1 + spp=sngl(s) + nvirt=0 + xxxmax=0d0 + xpts=0d0 + ypts=0d0 + if(ir.eq.1)then + do l=1,lproj3(m) !use all pairs attached to remnant + kp=kproj3(m,l) + nvirt=nvirt+1 + do i=imin,imax + call Gfunpar(0.,0.,1,i,bk(kp),spp,alp,bet,betp,epsp,epst + & ,epss,gamv) + atil(i)=dble(alp) + btilp(i)=dble(bet) + btilpp(i)=dble(betp) + enddo + xprms=1d0-xxxmax +c take x from an "unscreened" Pomeron (reduction factor if too high) + xxx=om1xpr(atil,btilp,btilpp,xprms,xmrmi,ir)*freduc + ptt=dble(ranptcut(1.)*alpdro(2)) +c ptt=dble(ranptcut(ptsems)*alpdro(2)) + phi=2d0*dble(pi)*drangen(ptt) + xprms=1d0-xxxmax-xxx + xptt=xpts+ptt*cos(phi) + yptt=ypts+ptt*sin(phi) + xrems=xprms*xmrms*s-(xpti+xptt)**2-(ypti+yptt)**2 + if(xrems.gt.ampt2str)then + xxxmax=xxxmax+xxx + xpts=xptt + ypts=yptt + endif + enddo + else + do l=1,ltarg3(m) !use all pairs attached to remnant + kt=ktarg3(m,l) + nvirt=nvirt+1 + do i=imin,imax + call Gfunpar(0.,0.,1,i,bk(kt),spp,alp,bet,betp,epsp,epst + & ,epss,gamv) + atil(i)=dble(alp) + btilp(i)=dble(bet) + btilpp(i)=dble(betp) + enddo + xprms=1d0-xxxmax +c take x from an "unscreened" Pomeron (reduction factor if too high) + xxx=om1xpr(atil,btilp,btilpp,xprms,xmrmi,ir)*freduc + ptt=dble(ranptcut(1.)*alpdro(2)) +c ptt=dble(ranptcut(ptsems)*alpdro(2)) + phi=2d0*dble(pi)*drangen(ptt) + xprms=1d0-xxxmax-xxx + xptt=xpts+ptt*cos(phi) + yptt=ypts+ptt*sin(phi) + xrems=xprms*xmrms*s-(xpti+xptt)**2-(ypti+yptt)**2 + if(xrems.gt.ampt2str)then + xxxmax=xxxmax+xxx + xpts=xptt + ypts=yptt + endif + enddo + endif + iscreen=iscreensave + + if(xxxmax.le.xxxmin)goto 777 + + +c check string mass and energy + + xprms=1d0-xxxmax + xpts=xpti+xpts + ypts=ypti+ypts + xrems=xprms*xmrms*s-xpts*xpts-ypts*ypts + if(xrems.lt.ampt2str)then + if(ish.ge.4)write(ifch,*) + & 'Pb with string mass in Getdropx, retry',nredo,ir + & ,ampt2str,xrems,xprms,xmrms,xpts,ypts + goto 777 + endif + +c check droplet mass and energy + +c Droplet mass should not exceed to much mdrmaxi. Use random to smooth distrib. + xmsmax=xmdrmaxi*(1.+drangen(xmdrmaxi)) + xprmd=xprmi-xprms + xptd=xpti-xpts + yptd=ypti-ypts + xremd=xprmd*xmrmd*s-xptd*xptd-yptd*yptd + if(xremd.lt.ampt2dro)then +c Droplet should not have a mass too low. + if(ish.ge.4)write(ifch,*) + & 'Pb with drop mass (low) in Getdropx, retry',nredo,ir + & ,ampt2dro,xremd,xprmd,xmrmd,xptd,yptd + goto 777 + elseif(xremd.ge.xmsmax)then +c Droplet should not have a mass too high. + if(ish.ge.4)write(ifch,*) + & 'Pb with drop mass (high) in Getdropx, retry',nredo,ir + & ,xremd,xmsmax,xprmd,xmrmd,xptd,yptd + freduc=freduc*0.5d0 + goto 777 + endif + + + re(1)=xptd + re(2)=yptd + if(ir.eq.1)then + re(3)=(xprmd-xmrmd)*plc*0.5d0 + else + re(3)=(xmrmd-xprmd)*plc*0.5d0 + endif + re(4)=(xprmd+xmrmd)*plc*0.5d0 + re(5)=sqrt(xremd) + + a(1)=xpts + a(2)=ypts + if(ir.eq.1)then + a(3)=(xprms-xmrms)*plc*0.5d0 + else + a(3)=(xmrms-xprms)*plc*0.5d0 + endif + a(4)=(xprms+xmrms)*plc*0.5d0 + a(5)=sqrt(xrems) + + + + else !if xm to small, use two body decay (should be rare) + + if(ish.ge.6)write (ifch,*)'kinematic limit -> boost vector:',p1 + +c fix pt + + sxini=ptm*ptm + ptt=dble(ranpt()*alpdro(2))**2 !pt + if(ptt.ge.sxini)goto 777 + sxini=sqrt(sxini-ptt) + + + + xmsmax=xmdrmaxi*(1.+drangen(xmdrmaxi)) + xxxmax=min(xmsmax,(sxini-strmas)**2) !strmas/(strmas+ampt2) + xxxmin=ampt2dro + + if(xxxmin.gt.xxxmax)then + !write(ifch,*)'Warning Mmin>sxini -> only drop' + if(ish.ge.4)write(ifch,*) + & 'Pb with ampt2 in Getdropx, retry',nredo,ir + & ,ampt2dro,ampt2str,xxxmin,xxxmax,sxini,ptt,xmsmax + goto 777 + endif + + + +c fix mass + + rr=drangen(xxxmax) + xmax=xxxmax + xmin=xxxmin + alpm=dble(alpdro(3)) + if(dabs(alpm-1.d0).lt.eps)then + xxx=xmax**rr*xmin**(1d0-rr) + else + xxx=(rr*xmax**(1d0-alpm)+(1d0-rr)*xmin**(1d0-alpm)) + & **(1d0/(1d0-alpm)) + endif + + +c write(ifch,*)'ini',xmin,xxx,xmax,rr,ampt2dro +c & ,(sxini-sqrt(xxx)),ampt2str,p1(5) + + + + re(5)=sqrt(xxx) + a(5)=sxini-re(5) + if(a(5).lt.strmas)then + if(ish.ge.6)write(ifch,*) + & 'Pb with initial mass in Getdropx, retry',ir + & ,xmin,xxx,xmax,rr,ampt2dro,ampt2str,a(5) + goto 777 + endif + + +c two body decay + if(ish.ge.6)write(ifch,*)'2 body decay',ptm,re(5),a(5) + qcm=utpcmd(ptm,re(5),a(5),iret) + u(3)=2.d0*drangen(qcm)-1.d0 + phi=2.d0*dble(pi)*drangen(u(3)) + u(1)=sqrt(1.d0-u(3)**2)*cos(phi) + u(2)=sqrt(1.d0-u(3)**2)*sin(phi) + do j=1,3 + re(j)=qcm*u(j) + a(j)=-re(j) + enddo + + re(4)=sqrt(qcm**2+re(5)**2) + a(4)=sqrt(qcm**2+a(5)**2) + + if(ish.ge.6)write(ifch,*)'momentum in rest frame : ',re,a + + + +c Fix a of string + +c boost string in collision frame + call utlob2(-1,p1(1),p1(2),p1(3),p1(4),p1(5) + $ ,a(1),a(2),a(3),a(4),73) + + p5sq=(a(4)+a(3))*(a(4)-a(3))-(a(1)**2.d0+a(2)**2.d0) + if(p5sq.gt.ampt2str)then + a(5)=sqrt(p5sq) + else + if(ish.ge.6)then + write(ifch,*)'Pb with string mass -> retry' + write(ifch,*)' m^2:',p5sq,' m_min^2:',ampt2str + write(ifch,*)' momentum four vector:',(a(ii),ii=1,4) + endif + goto 777 + endif + +c Fix ep of droplet + +c boost droplet in collision frame + call utlob2(-1,p1(1),p1(2),p1(3),p1(4),p1(5) + $ ,re(1),re(2),re(3),re(4),74) + + p5sq=(re(4)+re(3))*(re(4)-re(3))-(re(1)*re(1)+re(2)*re(2)) + if(p5sq.gt.ampt2dro)then + re(5)=sqrt(p5sq) + else + if(ish.ge.6)then + write(ifch,*)'Pb with droplet mass -> retry' + write(ifch,*)' m^2:',p5sq,' m_min^2:',ampt2dro + write(ifch,*)' momentum four vector:',(re(ii),ii=1,4) + endif + goto 777 + endif + + endif !test of xm + + + if(ish.ge.1.and.abs(ep(4)-re(4)-a(4)).gt.1.e-2*ep(4))then + write(ifmt,*)'Pb with energy conservation in getdropx' + if(ish.ge.6)then + write(ifch,*)'Pb with energy conservation :' + write(ifch,*)' p1_ini:',ep(1),' p1:',re(1)+a(1) + write(ifch,*)' p2_ini:',ep(2),' p2:',re(2)+a(2) + write(ifch,*)' p3_ini:',ep(3),' p3:',re(3)+a(3) + endif + endif + +c If OK, save flavors of droplet and string + do i=1,5 + ep(i)=re(i) + enddo + ic(1)=icx(1) + ic(2)=icx(2) + do i=1,nflav + jc(i,1)=jcini(i,1) + jc(i,2)=jcini(i,2) + jcv(i,1)=jcvfin(i,1) + jcv(i,2)=jcvfin(i,2) + enddo + + if(ish.ge.6)then + write(ifch,20)'droplet:',jc,ep + write(ifch,30)'string remnant:',ic,a + write(ifch,'(a)')'valence:' + write(ifch,'(6i3)')jcv + endif + 20 format(a,/,'jc:',6i3,' |',6i3,/,'ep:',5(e10.3,1x)) + 30 format(a,/,'ic:',i7,' |',i7,/,'a:',5(e10.3,1x)) + + 1000 continue + call utprix('getdrx',ish,ishini,4) + end + +c----------------------------------------------------- + subroutine neworder(n1, n2, n3) +c----------------------------------------------------- +c make 3 integers ordered like 1 2 3 +c------------------------------------------------------ + if(n2.lt.n1)then + ifb=n2 + n2=n1 + n1=ifb + endif + if(n3.lt.n1)then + ifb=n3 + n3=n2 + n2=n1 + n1=ifb + elseif(n3.lt.n2)then + ifb=n3 + n3=n2 + n2=ifb + endif + end + +c----------------------------------------------------- + subroutine neworderx(x1,x2,x3,i1,i2,i3) +c----------------------------------------------------- +c make 3 reals ordered like 1 2 3 +c------------------------------------------------------ + if(x2.lt.x1)then + xfb=x2 + x2=x1 + x1=xfb + ifb=i2 + i2=i1 + i1=ifb + endif + if(x3.lt.x1)then + xfb=x3 + x3=x2 + x2=x1 + x1=xfb + ifb=i3 + i3=i2 + i2=i1 + i1=ifb + elseif(x3.lt.x2)then + xfb=x3 + x3=x2 + x2=xfb + ifb=i3 + i3=i2 + i2=ifb + endif + end + +c----------------------------------------------------------------------- + function idtr2(ic) +c----------------------------------------------------------------------- +c transforms ic to id such that only hadrons have nonzero id +c----------------------------------------------------------------------- + parameter (nidt=30) + integer idt(3,nidt),ic(2) + data idt/ + * 100000,100000, 110 ,100000,010000, 120 ,010000,010000, 220 + *,100000,001000, 130 ,010000,001000, 230 ,001000,001000, 330 + *,100000,000100, 140 ,010000,000100, 240 ,001000,000100, 340 + *,000100,000100, 440 + *,300000,000000,1111 ,210000,000000,1120 ,120000,000000,1220 + *,030000,000000,2221 ,201000,000000,1130 ,111000,000000,1230 + *,021000,000000,2230 ,102000,000000,1330 ,012000,000000,2330 + *,003000,000000,3331 ,200100,000000,1140 ,110100,000000,1240 + *,020100,000000,2240 ,101100,000000,1340 ,011100,000000,2340 + *,002100,000000,3340 ,100200,000000,1440 ,010200,000000,2440 + *,001200,000000,3440 ,000300,000000,4441/ + + idtr2=0 + if(ic(1).eq.0.and.ic(2).eq.0)then + if(rangen().ge.0.5)then + idtr2=110 + ic(1)=100000 + ic(2)=100000 + else + idtr2=220 + ic(1)=10000 + ic(2)=10000 + endif + return + endif + do 1 i=1,nidt + if(ic(2).eq.idt(1,i).and.ic(1).eq.idt(2,i))idtr2=-idt(3,i) + if(ic(1).eq.idt(1,i).and.ic(2).eq.idt(2,i))idtr2=idt(3,i) +1 continue + return + end + +c---------------------------------------------------------------------- + subroutine emsini(e,idpji,idtgi) +c---------------------------------------------------------------------- +c energy-momentum sharing initializations +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + common/cemsr5/at(0:1,0:5) + common/cems5/plc,s + common/cems10/a(0:ntypmx),b(0:ntypmx),d(0:ntypmx) + common/ems6/ivp0,iap0,idp0,isp0,ivt0,iat0,idt0,ist0 + double precision d,a,b,plc,s,amd,dcel,xvpr,xdm,at,xdm2 + common/ems3/dcel,ad + common/cems13/xvpr(0:3) + + +c parameter test + + if(nflavems.lt.nrflav) + & call utstop("nflavems<nrflav : change it in epos-ems !&") + + +c abreviations + + plc=dble(e) + s=plc**2 + amd=0.5d0 !dble(delrex) !(large enough in case of strangeness in string end + + +c alpha (0=0, 1=s, 2=v, 4=d, 8=f) + + a(0)=0d0 + a(1)=dble(alpsea) + a(2)=dble(alpval) + a(3)= 0.0d0 + a(4)=dble(alpdiq) + a(5)=dble(a(4)) + a(6)= 0.0d0 + a(7)= 0.0d0 + a(8)=dble(a(2)) + a(9)= 0.0d0 + +c beta (0=0, 1=s, 2=v, 4=d, 8=f) + + b(0)=0.0d0 + b(1)=dble(-alpqua) + b(2)=dble(-alpqua) + b(3)=0.0d0 + b(4)=0.0d0 + b(5)=0.0d0 + b(6)=0.0d0 + b(7)=0.0d0 + b(8)=dble(-alpqua) + b(9)=0.0d0 + + +c alpha_trailing and beta_trailing (0=meson, 1=baryon; +c 0=no excit, 1=nondiffr, 2=diffr, +c 3=nondiffr split, 5=diffr split) + + at(0,0)=0.0d0 + at(0,1)=dble(alpndi) + at(0,2)=dble(alpdi) + at(0,3)=dble(alpdro(3)) + at(0,4)=10d0 + at(0,5)=dble(alpdro(3)) + at(1,0)=0.0d0 + at(1,1)=dble(alpndi) + at(1,2)=dble(alpdi) + at(1,3)=dble(alpdro(3)) + at(1,4)=10d0 + at(1,5)=dble(alpdro(3)) + +c minimal string masses ( i+j, each one: 0=0, 1=s, 2=v, 4=d, 5=d, 8=f) + + ammn(0)=0d0 + ammn(1)=0d0 + ammn(2)=dble(ammsqq)+amd + ammn(3)=dble(ammsqq) + ammn(4)=dble(ammsqq) + ammn(5)=dble(ammsqd)+amd + ammn(6)=dble(ammsqd)+amd + ammn(7)=0d0 + ammn(8)=dble(ammsdd)+amd + ammn(9)=dble(ammsqd)+amd + ammn(10)=dble(ammsqd)+amd + ammn(12)=dble(ammsqd)+amd + ammn(16)=0.14d0 + +c minimal pomeron masses (0=soft or gg, 1=qg, 2=gq, 3=qq) + + amprmn(0)=ammsqq + amprmn(1)=dsqrt(4d0*dble(q2min)) + amprmn(2)=amprmn(1) + amprmn(3)=amprmn(1) + +c cutoff for virtual pomeron (0=0, 1=soft Pom, 2=regge, 3=hard) + +c xvpr(0)=0d0 +c xvpr(1)=dble(cumpom**2)/s +c xvpr(2)=dble(cumpom**2)/s +c xvpr(3)=0.0d0**2/s + +c minimal remnant masses (0=meson, 1=baryon) + + idpj=idpji + xdm=0.35d0 !<pt> + call idmass(idpj,ampj) + if(iabs(idpj).gt.1000)then + ampmn(0)=0.14d0+xdm + ampmn(1)=dble(ampj)+xdm + else + ampmn(0)=dble(ampj)+xdm + ampmn(1)=0.94d0+xdm + endif + idtg=idtgi + if(idtg.eq.0)idtg=1120 + call idmass(idtg,amtg) + if(iabs(idtg).gt.1000)then + amtmn(0)=0.14d0+xdm + amtmn(1)=dble(amtg)+xdm + else + amtmn(0)=dble(amtg)+xdm + amtmn(1)=0.94d0+xdm + endif + +c minimal excitation masses (0=meson, 1=baryon +c 0=no excit, 1=nondiffr, 2=diffr, +c 6=nondiffr but no pomeron) + + xdm2=0.35d0 + amemn(0,0)=0.d0 + amemn(1,0)=0.d0 + amemn(0,4)=0.d0 + amemn(1,4)=0.d0 + amemn(0,6)=0.d0 + amemn(1,6)=0.d0 + + amemn(0,1)=xdm2!+dble(delrex) + amemn(0,2)=xdm2!+dble(delrex) + amemn(0,3)=xdm2!+dble(delrex) + amemn(0,5)=xdm2+dble(delrex) !remnant excited without connexion (split) + + amemn(1,1)=xdm2!+dble(delrex) + amemn(1,2)=xdm2!+dble(delrex) + amemn(1,3)=xdm2!+dble(delrex) + amemn(1,5)=xdm2+dble(delrex) !remnant excited without connexion (split) + +c maximal excitation masses (0=no excit, 1=nondiffr, 2=diffr) + + amemx(0)=2d0*xdm + amemx(1)=plc + amemx(2)=plc + + if(idpj.gt.1000)then ! baryon + +c initial quark configuration + ivp0=3 + iap0=0 + idp0=1 + isp0=1 + +c no val quark for exotic projectile + if(iremn.ge.2.and.(idpj.ne.1120.and.idpj.ne.1220))ivp0=0 + + elseif(idpj.lt.-1000)then ! antibaryon + +c initial quark configuration + ivp0=0 + iap0=3 + idp0=1 + isp0=1 + +c no val quark for exotic projectile + if(iremn.ge.2.and.(idpj.ne.-1120.and.idpj.ne.-1220))iap0=0 + + else ! meson + +c initial quark configuration + ivp0=1 + iap0=1 + idp0=0 + if(iclpro.eq.1)then + isp0=0 + else + isp0=1 + endif + +c no val quark for exotic projectile + if(iremn.ge.2.and.(mod(abs(idpj/100),10).gt.4 + & .or.mod(abs(idpj/10),10).gt.4 + & .or.mod(abs(idpj/100),10)/mod(abs(idpj/10),10).eq.1))then + ivp0=0 + iap0=0 + endif + endif + + if(idtg.gt.1000)then ! baryon + +c initial quark configuration + ivt0=3 + iat0=0 + idt0=1 + ist0=0 + +c no val quark for exotic target + if(iremn.ge.2.and.(idtg.ne.1120.and.idtg.ne.1220))ivt0=0 + + elseif(idtg.lt.-1000)then ! antibaryon + +c initial quark configuration + ivt0=0 + iat0=3 + idt0=1 + ist0=0 + +c no val quark for exotic target + if(iremn.ge.2.and.(idtg.ne.-1120.and.idtg.ne.-1220))iat0=0 + + else ! meson + +c initial quark configuration + ivt0=1 + iat0=1 + if(icltar.eq.1)then + idt0=0 + else + idt0=1 + endif + ist0=0 + +c no val quark for exotic target + if(iremn.ge.2.and.(mod(abs(idtg/100),10).gt.4 + & .or.mod(abs(idtg/10),10).gt.4 + & .or.mod(abs(idtg/100),10)/mod(abs(idtg/10),10).eq.1))then + ivt0=0 + iat0=0 + endif + + endif + + +c eikonal parameters + + dcel=dble(chad(iclpro)*chad(icltar)) + +c counters + + antot=0. + ansh=0. + ansf=0. + antotf=0. + anshf=0. + ansff=0. + pp4max=0. + pp4ini=0. + andropl=0. + anstrg0=0. + anstrg1=0. + anreso0=0. + anreso1=0. + anghadr=0. + antotre=0. + anintdiff=0. + anintsdif=0. + anintine=0. + + return + end + +c----------------------------------------------------------------------- + subroutine emsigr +c----------------------------------------------------------------------- +c initialize grid +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + + common/emsptl/nppr(npommx,kollmx),npproj(mamx),nptarg(mamx) + + call utpri('emsigr',ish,ishini,5) + + do k=1,koll !----k-loop----> + +c determine length of k-th line of grid + + o=max(1.e-5,min(sngl(om1intc(k)),float(npommx)))!if GFF used for propo + if(ish.ge.7)write(ifch,*)'emsigr:k,o',k,o + n=0 + if(o.le.50)then + p=1./(exp(o)-1) + else + p=0. + endif +10 n=n+1 + p=p*o/n + if(ish.ge.7)write(ifch,*)'emsigr:n,p',n,p + if((p.gt.1e-4.or.n.lt.int(o)).and.n.lt.npommx + *.and.n.lt.nprmax)goto 10 + + if(ish.ge.5)write(ifch,*)'emsigr:nmax,b',n,bk(k) + + npr(0,k)=n + nprmx(k)=n + nprt(k)=0 + do i=1,3 + npr(i,k)=0 + enddo + + +c initial value for interaction type + + itpr(k)=0 + +c initial value for nuclear splitting + + do ir=1,2 + knucnt(ir,k)=0 + do ncon=1,mamx + npnuc(ncon,ir,k)=0 + irnuc(ncon,ir,k)=0 + xxnuc(ncon,ir,k)=0d0 + enddo + enddo + +c initialize grid + + + do n=1,nprmx(k) + idpr(n,k)=0 + idfpr(n,k)=0 + ivpr(n,k)=1 + nppr(n,k)=0 + nbkpr(n,k)=0 + nvpr(n,k)=0 + idsppr(n,k)=0 + idstpr(n,k)=0 + idrpr(n,k)=0 + idhpr(n,k)=0 + bhpr(n,k)=0. + xpr(n,k)=0d0 + ypr(n,k)=0d0 + xppr(n,k)=0d0 + xmpr(n,k)=0d0 + xp1pr(n,k)=0d0 + xp2pr(n,k)=0d0 + xm1pr(n,k)=0d0 + xm2pr(n,k)=0d0 + xp1pr(n,k)=0d0 + xp2pr(n,k)=0d0 + xm1pr(n,k)=0d0 + xm2pr(n,k)=0d0 + idp1pr(n,k)=0 + idp2pr(n,k)=0 + idm1pr(n,k)=0 + idm2pr(n,k)=0 + xxp1pr(n,k)=0d0 + xyp1pr(n,k)=0d0 + xxp2pr(n,k)=0d0 + xyp2pr(n,k)=0d0 + xxm1pr(n,k)=0d0 + xym1pr(n,k)=0d0 + xxm2pr(n,k)=0d0 + xym2pr(n,k)=0d0 + enddo + + enddo ! <----k-loop----- + + call utprix('emsigr',ish,ishini,5) + return + end + +c----------------------------------------------------------------------- + subroutine emsipt +c----------------------------------------------------------------------- +c initialize projectile and target +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + + common/emsptl/nppr(npommx,kollmx),npproj(mamx),nptarg(mamx) + common/cems5/plc,s + common/ems3/dcel,ad + common/ems6/ivp0,iap0,idp0,isp0,ivt0,iat0,idt0,ist0 + common /cncl/xproj(mamx),yproj(mamx),zproj(mamx) + * ,xtarg(mamx),ytarg(mamx),ztarg(mamx) + + double precision dcel,s,plc + +c initialize projectile + + do i=1,maproj + idp(i)=idp0 + ivp(i)=ivp0+iap0 + iap(i)=iap0 + isp(i)=isp0 + iep(i)=-1 + ifp(i)=0 + kolp(i)=0 + npp(i)=0 + npproj(i)=0 + xxp(i)=0d0 + xyp(i)=0d0 + xpmn(i)=(amemn(idp(i),0)+ampmn(isp(i)))**2/s + xpmx(i)=dmin1(1d0,(amemx(0)+ampmn(isp(i)))**2/s) + xpos(i)=0.9d0*(amemx(0)+ampmn(isp(i)))**2/s + xppmx(i)=0.5d0/(1d0+1d0/dble(maproj)**0.3d0)!1d0-dsqrt(xpmn(i))/maproj + xmpmx(i)=0.5d0/(1d0+1d0/dble(matarg)**0.3d0)!1d0-dsqrt(xpmn(i))/matarg + xmpmn(i)=xpmn(i)/xppmx(i) + xppmn(i)=xpmn(i)/xmpmx(i) + xpp(i)=1d0 + xmp(i)=0d0 + xppst(i)=0.d0 + xmpst(i)=0.d0 + xposst(i)=0.d0 + enddo + +c initialize target + + do j=1,matarg + idt(j)=idt0 + ivt(j)=ivt0+iat0 + iat(j)=iat0 + ist(j)=ist0 + iet(j)=-1 + ift(j)=0 + kolt(j)=0 + npt(j)=0 + nptarg(j)=0 + xxt(j)=0d0 + xyt(j)=0d0 + xtmn(j)=(amemn(idt(j),0)+amtmn(ist(j)))**2/s + xtmx(j)=dmin1(1d0,(amemx(0)+amtmn(ist(j)))**2/s) + xtos(j)=0.9d0*(amemx(0)+amtmn(ist(j)))**2/s + xmtmx(j)=0.5d0/(1d0+1d0/dble(matarg)**0.3d0)!1d0-dsqrt(xtmn(j))/matarg + xptmx(j)=0.5d0/(1d0+1d0/dble(maproj)**0.3d0)!1d0-dsqrt(xtmn(j))/maproj + xptmn(j)=xtmn(j)/xmtmx(j) + xmtmn(j)=xtmn(j)/xptmx(j) + xmt(j)=1d0 + xpt(j)=0d0 + xmtst(j)=0.d0 + xptst(j)=0.d0 + xtosst(j)=0.d0 + enddo + + return + end + + +c----------------------------------------------------------------------- + subroutine emszz +c----------------------------------------------------------------------- +c completes /cptl/ for nucleons, checks for no interaction +c writes /cevt/ +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + common/nucl3/phi,bimp + common/col3/ncol,kolpt + integer kolpz(mamx),koltz(mamx) + + call utpri('emszz ',ish,ishini,6) + +c write /cptl/ +c ------------ + + if(iokoll.eq.1)then ! precisely matarg collisions + +c nothing to do + ntg=0 + npj=0 + ncoli=0 + + else + +c determine ncol + + ncolx=ncol + ncol=0 + ncoli=0 + do 8 k=1,koll + if(ish.ge.7)write(ifch,*)'k,itpr,ncol,ncolx',k,itpr(k),ncol,ncolx + if(itpr(k).eq.0)goto 8 + if(abs(itpr(k)).eq.1)ncoli=ncoli+1 + ncol=ncol+1 + if(itpr(k).ne.3)then !empty pair, remnant not modified + i=iproj(k) + j=itarg(k) + istptl(i)=1 + iorptl(i)=-1 + tivptl(2,i)=coord(4,k) + istptl(maproj+j)=1 + iorptl(maproj+j)=-1 + tivptl(2,maproj+j)=coord(4,k) + endif +8 continue + if(ncolx.ne.ncol)write(6,*)'ncolx,ncol:', ncolx,ncol + if(ncolx.ne.ncol)call utstop('********ncolx.ne.ncol********&') + if(ncol.eq.0)goto1001 + +c determine npj, ntg + + do ip=1,maproj + kolpz(ip)=0 + enddo + do it=1,matarg + koltz(it)=0 + enddo + do k=1,koll + if(itpr(k).ne.0.and.itpr(k).ne.3)then + ip=iproj(k) + it=itarg(k) + kolpz(ip)=kolpz(ip)+1 + koltz(it)=koltz(it)+1 + endif + enddo + npj=0 + do ip=1,maproj + if(kolpz(ip).gt.0.or.iep(ip).ge.3)npj=npj+1 + enddo + ntg=0 + do it=1,matarg + if(koltz(it).gt.0.or.iet(it).ge.3)ntg=ntg+1 + enddo +c write(6,*)'npj,ntg,npj+ntg:',npj,ntg,npj+ntg + + endif + +c write /cevt/ +c ------------ + + nevt=1 + bimevt=bimp + phievt=phi + kolevt=ncol + koievt=ncoli + kohevt=0 !not yet defined + npjevt=npj + ntgevt=ntg + pmxevt=pnll + egyevt=engy + !print*,' ===== ',kolevt,koievt' =====' + +c exit +c ---- + + if(ish.ge.7)then + do n=1,nptl + write(ifch,115)iorptl(n),jorptl(n),n,istptl(n) + *,tivptl(1,n),tivptl(2,n) + enddo + 115 format(1x,'/cptl/',2i6,2i10,2(e10.3,1x)) + endif + +1000 continue + call utprix('emszz ',ish,ishini,6) + return + +1001 continue + if(ish.ge.3)then + write(ifch,*) + write(ifch,*)' ***** no interaction!!!' + write(ifch,*)' ***** ncol=0 detected in emszz' + write(ifch,*) + endif + goto 1000 + + end + +c----------------------------------------------------------------------- + subroutine ProCop(i,ii) +c----------------------------------------------------------------------- +c Propose Coordinates of remnants from active projectile nucleons +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + + double precision xmptmp,aproj + common/cems5/plc,s + common/emsptl/nppr(npommx,kollmx),npproj(mamx),nptarg(mamx) + integer icrmn(2),jc(nflav,2),icini(2) + double precision s,plc + + nptl=nptl+1 + npproj(i)=nptl + idptl(nptl)=idptl(ii)*100+99 !100*10**idp(i)+iep(i) + istptl(nptl)=40 + ityptl(nptl)=40 + iorptl(nptl)=ii + jorptl(nptl)=0 + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + do j=1,2 + do k=1,nflav + jc(k,j)=0 + enddo + enddo + + istptl(ii)=1 + +c determine kolz + + if(lproj(i).gt.1)then + zmax=-ainfin + kolz=0 + do l=1,lproj(i) + k=kproj(i,l) + z=coord(3,k) + if(itpr(k).ne.0.and.z.gt.zmax)then + zmax=z + kolz=k + endif + enddo + else + kolz=1 + endif +c if(kolz.eq.0)call utstop(' kolz=0 (proj)&') + if(kolz.eq.0)then + t=0. + else + t=coord(4,kolz) + endif + + xorptl(1,nptl)=xorptl(1,ii) + xorptl(2,nptl)=xorptl(2,ii) + xorptl(3,nptl)=xorptl(3,ii) + xorptl(4,nptl)=t + tivptl(1,nptl)=t + tivptl(2,nptl)=t + naq=0 + nqu=0 + + if(iremn.ge.2)then !update icproj + idp(i)=min(1,abs(idp(i))) + k=1 + nqu=0 + do n=1,nrflav + jc(n,k)=jcpref(n,k,i) + nqu=nqu+jc(n,k) + enddo + k=2 + naq=0 + do n=1,nrflav + jc(n,k)=jcpref(n,k,i) + naq=naq+jc(n,k) + enddo + isum=nqu+naq + call idenco(jc,icrmn,iret) + if(iret.eq.0.and.(isum.le.3.or.iremn.ne.3))then + icproj(1,i)=icrmn(1) + icproj(2,i)=icrmn(2) + elseif(iremn.eq.3)then + write(ifch,*)'Problem in projectile flavor :',i,' ->',jc,' :',isum + call utstop('Procop: Problem in projectile flavor !&') + else !for iremn=2 and large number of quark define icproj=999999 + icproj(1,i)=999999 + icproj(2,i)=999999 + endif + endif + + icrmn(1)=icproj(1,i) + icrmn(2)=icproj(2,i) + + if(iremn.ge.1)then !excited remnant ? + call idtr4(idptl(ii),icini) + if(ish.ge.5)write(ifch,*)'Procop icini proj',i,icini,' ->',icrmn + if((icrmn(1)-icini(1))+(icrmn(2)-icini(2)).ne.0)then + if(iep(i).eq.6)then + write(ifch,'(a,d25.15)') + &'Flavor problem in proj for pseudo-inelastic collision !',seedc + elseif(iep(i).eq.0)then + iep(i)=1 + endif + endif + + if(iremn.eq.2)then + if(.not.((nqu.eq.3.and.naq.eq.0).or.(nqu.eq.0.and.naq.eq.3) + & .or.(nqu.eq.1.and.naq.eq.1)))iep(i)=3 + + endif + endif + + if(ish.ge.5)write(ifch,'(a,i3,a,i3,a,i2)') + & 'Procop part ',ii,', iep(',i,'): ',iep(i) + + if(iremn.le.1)call iddeco(icrmn,jc) + if(iep(i).ge.1.and.iep(i).ne.6)then + aproj=dble(max(amproj,fremnux(jc))) + else + aproj=dble(max(amproj,fremnux2(jc))) + endif +c aprojex=max(ampmn(isp(i))+amemn(idp(i),iep(i)) +c & ,dble(fremnux(jc))) + xmptmp=(aproj**2+xxp(i)*xxp(i)+xyp(i)*xyp(i)) + & /(xpp(i)*s) + xpos(i)=xpp(i)*xmptmp + if(ish.ge.5)write(ifch,*)'Procop mass : ',aproj,xpos(i)*s + if(xmptmp.gt.1.d0)then + xmptmp=0.d0 + if(ish.ge.1)write(ifmt,*)'Warning in ProCop, Remnant mass too low' + endif + + pptl(1,nptl)=sngl(xxp(i)) + pptl(2,nptl)=sngl(xyp(i)) + pptl(3,nptl)=sngl((xpp(i)-xmptmp)*plc/2d0) + pptl(4,nptl)=sngl((xpp(i)+xmptmp)*plc/2d0) + pptl(5,nptl)=aproj + +c write(ifmt,*)'ProCop',i,nptl + + return + + end + +c----------------------------------------------------------------------- + subroutine ProCot(j,jj) +c----------------------------------------------------------------------- +c Propose Coordinates of remnants from active targets nucleons +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + + double precision xpttmp,atarg + common/cems5/plc,s + common/emsptl/nppr(npommx,kollmx),npproj(mamx),nptarg(mamx) + integer icrmn(2),jc(nflav,2),icini(2) + double precision s,plc + + nptl=nptl+1 + nptarg(j)=nptl + + idptl(nptl)=idptl(jj)*100+99 !100*10**idt(j)+iet(j) + istptl(nptl)=40 + ityptl(nptl)=50 + iorptl(nptl)=jj + jorptl(nptl)=0 + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + do k=1,2 + do i=1,nflav + jc(i,k)=0 + enddo + enddo + + istptl(jj)=1 + +c determine kolz + + if(ltarg(j).gt.1)then + zmin=ainfin + kolz=0 + do l=1,ltarg(j) + k=ktarg(j,l) + z=coord(3,k) + if(itpr(k).ne.0.and.z.lt.zmin)then + zmin=z + kolz=k + endif + enddo + else + kolz=1 + endif +c if(kolz.eq.0)call utstop(' kolz=0 (targ)&') + if(kolz.eq.0)then + t=0. + else + t=coord(4,kolz) + endif + + xorptl(1,nptl)=xorptl(1,jj) + xorptl(2,nptl)=xorptl(2,jj) + xorptl(3,nptl)=xorptl(3,jj) + xorptl(4,nptl)=t + tivptl(1,nptl)=t + tivptl(2,nptl)=t + naq=0 + nqu=0 + + if(iremn.ge.2)then !update ictarg + idt(j)=min(1,abs(idt(j))) + k=1 + nqu=0 + do n=1,nrflav + jc(n,k)=jctref(n,k,j) + nqu=nqu+jc(n,k) + enddo + k=2 + naq=0 + do n=1,nrflav + jc(n,k)=jctref(n,k,j) + naq=naq+jc(n,k) + enddo + isum=nqu+naq + call idenco(jc,icrmn,iret) + if(iret.eq.0.and.(isum.le.3.or.iremn.ne.3))then + ictarg(1,j)=icrmn(1) + ictarg(2,j)=icrmn(2) + elseif(iremn.eq.3)then + write(ifch,*)'Problem in projectile flavor :',j,' ->',jc,' :',isum + call utstop('Procot: Problem in target flavor !&') + else !for iremn=2 and large number of quark define ictarg=999999 + ictarg(1,j)=999999 + ictarg(2,j)=999999 + endif + endif + + icrmn(1)=ictarg(1,j) + icrmn(2)=ictarg(2,j) + + if(iremn.ge.1)then !excited remnant ? + call idtr4(idptl(jj),icini) + if(ish.ge.5)write(ifch,*)'Procot icini targ',j,icini,' ->',icrmn + if((icrmn(1)-icini(1))+(icrmn(2)-icini(2)).ne.0)then + if(iet(j).eq.6)then + write(ifch,'(a,d25.15)') + &'Flavor problem in targ for pseudo-inelastic collision !',seedc + elseif(iet(j).eq.0)then + iet(j)=1 + endif + endif + + if(iremn.eq.2)then + if(.not.((nqu.eq.3.and.naq.eq.0).or.(nqu.eq.0.and.naq.eq.3) + & .or.(nqu.eq.1.and.naq.eq.1)))iet(j)=3 + + endif + endif + if(ish.ge.5)write(ifch,'(a,i3,a,i3,a,i2)') + & 'Procot part ',jj,', iet(',j,'): ',iet(j) + + + + if(iremn.le.1)call iddeco(icrmn,jc) + if(iet(j).ge.1.and.iet(j).ne.6)then + atarg=dble(max(amtarg,fremnux(jc))) + else + atarg=dble(max(amtarg,fremnux2(jc))) + endif +c atargex=max(amtmn(ist(j))+amemn(idt(j),iet(j)) +c & ,dble(fremnux(jc))) + xpttmp=(atarg**2+xxt(j)*xxt(j)+xyt(j)*xyt(j)) + & /(xmt(j)*s) + xtos(j)=xpttmp*xmt(j) + if(ish.ge.5)write(ifch,*)'Procot mass : ',atarg,xtos(j)*s + if(xpttmp.gt.1.d0)then + xpttmp=0.d0 + if(ish.ge.1)write(ifch,*)'Warning in ProCot, Remnant mass too low' + endif + + pptl(1,nptl)=sngl(xxt(j)) + pptl(2,nptl)=sngl(xyt(j)) + pptl(3,nptl)=sngl((xpttmp-xmt(j))*plc/2d0) + pptl(4,nptl)=sngl((xpttmp+xmt(j))*plc/2d0) + pptl(5,nptl)=atarg + +c write(ifmt,*)'ProCot',j,nptl + + return + end + +c----------------------------------------------------------------------- + subroutine emswrp(i,ii) +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + + double precision p5sq + common/cems5/plc,s + common/emsptl/nppr(npommx,kollmx),npproj(mamx),nptarg(mamx) + double precision s,plc + parameter(eps=1.e-5) + + if(npproj(i).eq.0)then + write(*,*)'emswrp i ii',i,ii + call utstop('emswrp with npproj=0 should never happen !&') + +c t=xorptl(4,kolp(i)) +c istptl(ii)=1 +c iorptl(ii)=-1 +c tivptl(2,ii)=t +c nptl=nptl+1 +c npproj(i)=nptl +c idptl(nptl)=idptl(ii)*100+99 !100*10**idp(i)+iep(i) +c istptl(nptl)=40 +c ityptl(nptl)=40 +c iorptl(nptl)=ii +c jorptl(nptl)=kolp(i) +c ifrptl(1,nptl)=0 +c ifrptl(2,nptl)=0 +c xorptl(1,nptl)=xorptl(1,ii) +c xorptl(2,nptl)=xorptl(2,ii) +c xorptl(3,nptl)=xorptl(3,ii) +c xorptl(4,nptl)=t +c tivptl(1,nptl)=t +c tivptl(2,nptl)=t +c mm=nptl +c kolp(i)=1 + else + mm=npproj(i) + endif + if(iLHC.eq.1.and.(iep(i).eq.0.or.iep(i).eq.6)) + &xmp(i)=min(1d0-xpp(i),xmp(i)) + pptl(1,mm)=sngl(xxp(i)) + pptl(2,mm)=sngl(xyp(i)) + pptl(3,mm)=sngl((xpp(i)-xmp(i))*plc/2d0) + pptl(4,mm)=sngl((xpp(i)+xmp(i))*plc/2d0) + if(pptl(4,mm).lt.-eps)call utstop('E pro<0 !&') + p5sq=xpp(i)*xmp(i)*s-xxp(i)*xxp(i)-xyp(i)*xyp(i) + if(p5sq.gt.1.d-10)then + pptl(5,mm)=sngl(sqrt(p5sq)) + elseif(iep(i).eq.0)then + pptl(5,mm)=pptl(5,ii) + else + if(ish.ge.2)then + write(ifch,*)'problem with mass for projectile, ' + & ,'continue with zero mass' + write(ifch,*)i,mm,xxp(i),xyp(i),xpp(i),xmp(i),p5sq + endif + pptl(5,mm)=0. + endif + + do l=1,4 + ibptl(l,mm)=0 + enddo + + return + + end + +c----------------------------------------------------------------------- + subroutine emswrt(j,jj) +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + + double precision p5sq + common/cems5/plc,s + common/emsptl/nppr(npommx,kollmx),npproj(mamx),nptarg(mamx) + double precision s,plc + parameter(eps=1.e-5) + + if(nptarg(j).eq.0)then + + write(*,*)'emswrt j jj',j,jj + call utstop('emswrt with nptarg=0 should never happen !&') + +c t=xorptl(4,kolt(j)) +c istptl(jj)=1 +c iorptl(jj)=-1 +c tivptl(2,jj)=t +c nptl=nptl+1 +c nptarg(j)=nptl +c idptl(nptl)=idptl(jj)*100+99 !100*10**idp(i)+iep(i) +c istptl(nptl)=40 +c ityptl(nptl)=50 +c iorptl(nptl)=jj +c jorptl(nptl)=kolt(j) +c ifrptl(1,nptl)=0 +c ifrptl(2,nptl)=0 +c xorptl(1,nptl)=xorptl(1,jj) +c xorptl(2,nptl)=xorptl(2,jj) +c xorptl(3,nptl)=xorptl(3,jj) +c xorptl(4,nptl)=t +c tivptl(1,nptl)=t +c tivptl(2,nptl)=t +c mm=nptl +c kolt(j)=1 + else + mm=nptarg(j) + endif + if(iLHC.eq.1.and.(iet(j).eq.0.or.iet(j).eq.6)) + &xpt(j)=min(1d0-xmt(j),xpt(j)) + pptl(1,mm)=sngl(xxt(j)) + pptl(2,mm)=sngl(xyt(j)) + pptl(3,mm)=sngl((xpt(j)-xmt(j))*plc/2d0) + pptl(4,mm)=sngl((xpt(j)+xmt(j))*plc/2d0) + if(pptl(4,mm).lt.-eps)call utstop('E targ<0 !&') + p5sq=xpt(j)*xmt(j)*s-xxt(j)*xxt(j)-xyt(j)*xyt(j) + if(p5sq.gt.1.d-10)then + pptl(5,mm)=sngl(sqrt(p5sq)) + elseif(iet(j).eq.0)then + pptl(5,mm)=pptl(5,jj) + else + if(ish.ge.2)then + write(ifch,*)'problem with mass for target, ' + & ,'continue with zero mass' + write(ifch,*)j,mm,xxt(j),xyt(j),xpt(j),xmt(j),p5sq + endif + pptl(5,mm)=0. + endif + + do l=1,4 + ibptl(l,mm)=0 + enddo + + return + end + +c----------------------------------------------------------------------- + subroutine emswrpom(k,i,j) +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + + common/cems5/plc,s + common/emsptl/nppr(npommx,kollmx),npproj(mamx),nptarg(mamx) + double precision s,px,py,plc + + do 30 n=1,nprmx(k) + if(idpr(n,k).eq.0.or.ivpr(n,k).eq.0)goto30 + nptl=nptl+1 + nppr(n,k)=nptl + px=xxp1pr(n,k)+xxp2pr(n,k)+xxm1pr(n,k)+xxm2pr(n,k) + py=xyp1pr(n,k)+xyp2pr(n,k)+xym1pr(n,k)+xym2pr(n,k) + pptl(1,nptl)=sngl(px) + pptl(2,nptl)=sngl(py) + pptl(3,nptl)=sngl(dsqrt(xpr(n,k))*dsinh(ypr(n,k))*plc) + pptl(4,nptl)=sngl(dsqrt(xpr(n,k))*dcosh(ypr(n,k))*plc) + pptl(5,nptl)=sngl(dsqrt(xpr(n,k)*s-px*px-py*py)) + ! print*,pptl(5,nptl)/plc + idptl(nptl)=idpr(n,k)*10000 + & +idp1pr(n,k)*1000 + & +idp2pr(n,k)*100 + & +idm1pr(n,k)*10 + & +idm2pr(n,k) + idptl(nptl)=idptl(nptl)*100+99 + istptl(nptl)=30 + iorptl(nptl)=i + jorptl(nptl)=j + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + xorptl(1,nptl)=coord(1,k) + xorptl(2,nptl)=coord(2,k) + xorptl(3,nptl)=coord(3,k) + xorptl(4,nptl)=coord(4,k) + tivptl(1,nptl)=coord(4,k) + tivptl(2,nptl)=coord(4,k) + if(idpr(n,k).eq.1)then + ityptl(nptl)=20 + if(itpr(k).gt.0)ityptl(nptl)=25 + elseif(idpr(n,k).eq.3)then + ityptl(nptl)=30 + if(itpr(k).gt.0)ityptl(nptl)=35 + else + call utstop('emswrpom: unknown id&') + endif + do l = 1,4 + ibptl(l,nptl)=0 + enddo +30 continue + + return + end + +c----------------------------------------------------------------------- + subroutine emsfrag(iret) +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + double precision pfrx(mamxx),pfry(mamxx),pfrz(mamxx),xmean,ymean + & ,zmean,spec + integer ityp(mamxx) + + iret=0 + +c Projectile fragment(s) + + irest = maproj*100+abs(laproj) + inew=0 + idrest=0 + mapro=maproj + xmean=0d0 + ymean=0d0 + zmean=0d0 + spec=0d0 + amrest=0. + imin=maproj + imax=1 + + do is=1,maproj + + if(istptl(is).eq.0)then + if ( iorptl(is) .eq. 0 ) then + if(infragm.eq.0)then !keep free nucleons +c copy spectators at the end of the list (necessary for hepmc interface) + nptl=nptl+1 + if(nptl.gt.mxptl)then + iret=1 + goto 1000 + endif + call utrepl(nptl,is) + istptl(is)=1 + ifrptl(1,is)=nptl + ifrptl(2,is)=nptl + istptl(nptl)=0 + iorptl(nptl)=is + else +c compose projectile spectators to remaining nucleus + spec=spec+1d0 + tivptl(2,is)=0d0 + xmean=xmean+xorptl(1,is) + ymean=ymean+xorptl(2,is) + zmean=0d0 + amrest=amrest+pptl(5,is) + imin=min(imin,is) + imax=max(imax,is) + istptl(is)=1 + ifrptl(1,is)=nptl+1 + ifrptl(2,is)=nptl+1 + idrest = is + id=idptl(is) + if ( id .eq. 1120 ) then + inew = inew + 101 + irest = irest - 101 + elseif ( id .eq. 1220 ) then + inew = inew + 100 + irest = irest - 100 + endif + endif + endif + elseif( iorptl(is) .le. 0 .and. istptl(is) .eq. 1 ) then + if( iorptl(is) .eq. 0 )jorptl(is)=1 + mapro=mapro-1 + endif + + enddo + + if(inew.eq.0)goto 100 + + xmean=xmean/spec + ymean=ymean/spec + zmean=zmean/spec + nptla=nptl +c prepare intermediate particle to produce nuclear fragment + nptl=nptl+1 + if(nptl.gt.mxptl)then + iret=1 + goto 1000 + endif + + if( inew .eq. 100 .or. inew .eq. 101 ) then +c remaining nucleus is single neutron or proton + call utrepl(nptl,idrest) + ifrptl(1,idrest)=nptl + ifrptl(2,idrest)=nptl + istptl(nptl)=0 + iorptl(nptl)=idrest + goto 100 + + else + +c intermediate particles for father/mother relationship + idptl(nptl)=800000000+inew + ea = float(inew/100)*pptl(4,idrest) +c momenta squared + ptm = sqrt(max(0.,(ea-amrest)*(ea+amrest))) + istptl(nptl)=51 + pptl(1,nptl)=0. + pptl(2,nptl)=0. + pptl(3,nptl)=ptm + pptl(4,nptl)=sqrt(pptl(1,nptl)**2+pptl(2,nptl)**2 + * +pptl(3,nptl)**2+amrest**2) + pptl(5,nptl)=amrest !mass + ityptl(nptl)=40 + iorptl(nptl)=imax + jorptl(nptl)=imax + ifrptl(1,nptl)=nptl+1 + ifrptl(2,nptl)=0 + xorptl(1,nptl)=0d0 + xorptl(2,nptl)=0d0 + xorptl(3,nptl)=0d0 + xorptl(4,nptl)=0d0 + tivptl(1,nptl)=0d0 + tivptl(2,nptl)=0d0 + + if ( infragm .ge. 2 ) then +c remaining nucleus is evaporating nucleons and alpha particles + jfin = 0 + call epovapor( maproj,inew,jfin,ityp,pfrx,pfry,pfrz ) + if ( jfin .eq. 0 )then !something failed + iret=1 + goto 1000 + endif +c loop to treat the remnants of the desintegrated fragment + do 135 j = 1, jfin + if(ityp(j).lt.0.)then + idnucl=-ityp(j) + inucl= idnucl/100 + if(idnucl.eq.402)then !helium (alpha) + idnucl=19 + elseif(idnucl.eq.301)then !tritium + idnucl=18 + elseif(idnucl.eq.201)then !deuterium + idnucl=17 + else + iprot= mod(idnucl,100) + idnucl=1000000000+iprot*10000+inucl*10 !PDG code for nucleus + endif + else + inucl=1 + idnucl=ityp(j) + endif + ea = float(inucl)*pptl(4,idrest) +c momenta squared + call idmass(idnucl,am) + ptm = ( ea - am ) * ( ea + am ) + pt2 = sngl( pfrx(j)**2 + pfry(j)**2 ) + if(ish.ge.6)write(ifch,*) 'pro fragment: j,id,ea,ptm,pt2=', + * j,idnucl,ea,ptm,pt2 + if ( pt2 + pfrz(j)**2 .ge. ptm ) then + if (ish.ge.2) write(ifch,*) 'emsfrag: pt reject particle',j + nnn=0 + is=0 + do while (is.lt.maproj.and.nnn.lt.inucl) + is=is+1 + if(istptl(is).eq.1 + & .and.jorptl(is).eq.0.and.iorptl(is).eq.0)then + nnn=nnn+1 +c copy spectators at the end of the list (necessary for hepmc interface) + nptl=nptl+1 + if(nptl.gt.mxptl)then + iret=1 + goto 1000 + endif + call utrepl(nptl,is) + jorptl(is)=1 + ifrptl(1,is)=nptl + ifrptl(2,is)=nptl + istptl(nptl)=0 + iorptl(nptl)=is + endif + enddo + goto 135 + else + plong = sqrt(ptm-pt2) + endif + nptl=nptl+1 + if(nptl.gt.mxptl)then + iret=1 + goto 1000 + endif + istptl(nptl)=0 + pptl(1,nptl)=sngl(pfrx(j)) + pptl(2,nptl)=sngl(pfry(j)) + pptl(3,nptl)=plong+sngl(pfrz(j)) !OK if plong >> pfrz + pptl(4,nptl)=sqrt(pptl(1,nptl)**2+pptl(2,nptl)**2 + * +pptl(3,nptl)**2+am**2) + pptl(5,nptl)=am !mass + ityptl(nptl)=0 + iorptl(nptl)=nptla+1 + jorptl(nptl)=0 + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + xorptl(1,nptl)=xmean + xorptl(2,nptl)=ymean + xorptl(3,nptl)=zmean + xorptl(4,nptl)=zmean + tivptl(1,nptl)=zmean + tivptl(2,nptl)=tivptl(2,idrest) + idptl(nptl)=idnucl + 135 continue + + elseif ( infragm .eq. 1 ) then +c remaining nucleus is one fragment + nptl=nptl+1 + if(nptl.gt.mxptl)then + iret=1 + goto 1000 + endif + istptl(nptl)=0 + pptl(1,nptl)=0.d0 + pptl(2,nptl)=0.d0 + pptl(4,nptl)=0.d0 + inucl=0 + do is=1,maproj + if(iorptl(is).eq.0.and.jorptl(is).eq.0)then + inucl=inucl+1 + pptl(4,nptl)=pptl(4,nptl)+dble(pptl(4,is)) + endif + enddo + if(inucl.ne.inew/100)call utstop('Pb in emsfrag !&') + idnucl=1000000000+mod(inew,100)*10000+(inew/100)*10 + call idmass(idnucl,am) + pptl(5,nptl)=am !mass + ptot=(pptl(4,nptl)+am)*(pptl(4,nptl)-am) + pptl(3,nptl)=sqrt(ptot) + ityptl(nptl)=0 + istptl(nptl)=0 + iorptl(nptl)=nptla+1 + jorptl(nptl)=0 + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + xorptl(1,nptl)=xmean + xorptl(2,nptl)=ymean + xorptl(3,nptl)=zmean + xorptl(4,nptl)=zmean + tivptl(1,nptl)=zmean + tivptl(2,nptl)=tivptl(2,idrest) + idptl(nptl)=idnucl + endif + ifrptl(2,nptla+1)=nptl + if(ifrptl(1,nptla+1).gt.ifrptl(2,nptla+1))then + ifrptl(1,nptla+1)=0 + ifrptl(2,nptla+1)=0 + endif + endif + +c possible decay of fragments + call decayall(nptla+1) + + do is=nptla+1,nptl + if(ish.ge.5)write(ifch,'(a,i5,a,i10,a,4(e10.4,1x),f6.3)') + $ ' Projectile fragments ',is,' id :',idptl(is) + $ , ' momentum :',(pptl(k,is),k=1,5) + enddo + + 100 continue + +c Target fragment(s) + + irest = matarg*100+abs(latarg) + inew=0 + matar=matarg + xmean=0d0 + ymean=0d0 + zmean=0d0 + spec=0d0 + amrest=0. + imin=maproj+matarg + imax=maproj+1 + + do is=maproj+1,maproj+matarg + + if(istptl(is).eq.0)then + if ( iorptl(is) .eq. 0 ) then + if(infragm.eq.0)then !keep free nucleons +c copy spectators at the end of the list (necessary for hepmc interface) + nptl=nptl+1 + if(nptl.gt.mxptl)then + iret=1 + goto 1000 + endif + call utrepl(nptl,is) + istptl(is)=1 + ifrptl(1,is)=nptl + ifrptl(2,is)=nptl + istptl(nptl)=0 + iorptl(nptl)=is + else +c compose projectile spectators to remaining nucleus + spec=spec+1d0 + tivptl(2,is)=0d0 + xmean=xmean+xorptl(1,is) + ymean=ymean+xorptl(2,is) + zmean=0d0 + amrest=amrest+pptl(5,is) + imin=min(imin,is) + imax=max(imax,is) + istptl(is)=1 + ifrptl(1,is)=nptl+1 + ifrptl(2,is)=nptl+1 + idrest = is + id=idptl(is) + if ( id .eq. 1120 ) then + inew = inew + 101 + irest = irest - 101 + elseif ( id .eq. 1220 ) then + inew = inew + 100 + irest = irest - 100 + endif + endif + endif + + elseif( iorptl(is) .le. 0 .and. istptl(is) .eq. 1 ) then + if( iorptl(is) .eq. 0 ) jorptl(is)=1 + matar=matar-1 + endif + + enddo + + if(inew.eq.0)goto 1000 + + xmean=xmean/spec + ymean=ymean/spec + zmean=zmean/spec + nptla=nptl +c prepare intermediate particle to produce nuclear fragment + nptl=nptl+1 + if(nptl.gt.mxptl)then + iret=1 + goto 1000 + endif + + if( inew .eq. 100 .or. inew .eq. 101 ) then +c remaining nucleus is single neutron or proton + call utrepl(nptl,idrest) + ifrptl(1,idrest)=nptl + ifrptl(2,idrest)=nptl + istptl(nptl)=0 + iorptl(nptl)=idrest + goto 1000 + + else + +c intermediate particles for father/mother relationship + idptl(nptl)=800000000+inew + ea = float(inew/100)*pptl(4,idrest) +c momenta squared + ptm = sqrt(max(0.,(ea-amrest)*(ea+amrest))) + istptl(nptl)=51 + pptl(1,nptl)=0. + pptl(2,nptl)=0. + pptl(3,nptl)=-ptm + pptl(4,nptl)=sqrt(pptl(1,nptl)**2+pptl(2,nptl)**2 + * +pptl(3,nptl)**2+amrest**2) + pptl(5,nptl)=amrest !mass + ityptl(nptl)=50 + iorptl(nptl)=imax + jorptl(nptl)=imax + ifrptl(1,nptl)=nptl+1 + ifrptl(2,nptl)=0 + xorptl(1,nptl)=0d0 + xorptl(2,nptl)=0d0 + xorptl(3,nptl)=0d0 + xorptl(4,nptl)=0d0 + tivptl(1,nptl)=0d0 + tivptl(2,nptl)=0d0 + + if ( infragm .ge. 2 ) then +c remaining nucleus is evaporating nucleons and alpha particles + jfin = 0 + call epovapor( matarg,inew,jfin,ityp,pfrx,pfry,pfrz ) + if ( jfin .eq. 0 )then !something failed + iret=1 + goto 1000 + endif +c loop to treat the remnants of the desintegrated fragment + do 235 j = 1, jfin + if(ityp(j).lt.0.)then + idnucl=-ityp(j) + inucl= idnucl/100 + if(idnucl.eq.402)then !helium (alpha) + idnucl=19 + elseif(idnucl.eq.301)then !tritium + idnucl=18 + elseif(idnucl.eq.201)then !deuterium + idnucl=17 + else + iprot= mod(idnucl,100) + idnucl=1000000000+iprot*10000+inucl*10 !PDG code for nucleus + endif + else + inucl=1 + idnucl=ityp(j) + endif + ea = float(inucl)*pptl(4,idrest) +c momenta squared + call idmass(idnucl,am) + ptm = ( ea - dble(am) ) * ( ea + dble(am) ) + pt2 = sngl( pfrx(j)**2 + pfry(j)**2 ) + if(ish.ge.6)write(ifch,*) 'tar fragment: j,id,ea,ptm,pt2=', + * j,idnucl,ea,ptm,pt2 + if ( pt2 + pfrz(j)**2 .ge. ptm ) then + if (ish.ge.2) write(ifch,*) 'emsfrag: pt reject particle',j + nnn=0 + is=maproj + do while (is.lt.maproj+matarg.and.nnn.lt.inucl) + is=is+1 + if(istptl(is).eq.1 + & .and.jorptl(is).eq.0.and.iorptl(is).eq.0)then + nnn=nnn+1 +c copy spectators at the end of the list (necessary for hepmc interface) + nptl=nptl+1 + if(nptl.gt.mxptl)then + iret=1 + goto 1000 + endif + call utrepl(nptl,is) + jorptl(is)=1 + ifrptl(1,is)=nptl + ifrptl(2,is)=nptl + istptl(nptl)=0 + iorptl(nptl)=is + endif + enddo + goto 235 + else + plong=-sqrt(ptm-pt2) + endif + nptl=nptl+1 + if(nptl.gt.mxptl)then + iret=1 + goto 1000 + endif + istptl(nptl)=0 + pptl(1,nptl)=sngl(pfrx(j)) + pptl(2,nptl)=sngl(pfry(j)) + pptl(3,nptl)=plong+sngl(pfrz(j)) !OK if plong >> pfrz + pptl(4,nptl)=sqrt(pptl(1,nptl)**2+pptl(2,nptl)**2 + * +pptl(3,nptl)**2+am**2) + pptl(5,nptl)=am !mass + ityptl(nptl)=0 + iorptl(nptl)=nptla+1 + jorptl(nptl)=0 + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + xorptl(1,nptl)=xmean + xorptl(2,nptl)=ymean + xorptl(3,nptl)=zmean + xorptl(4,nptl)=zmean + tivptl(1,nptl)=zmean + tivptl(2,nptl)=tivptl(2,idrest) + idptl(nptl)=idnucl + 235 continue + + elseif ( infragm .eq. 1 ) then +c remaining nucleus is one fragment + nptl=nptl+1 + if(nptl.gt.mxptl)then + iret=1 + goto 1000 + endif + istptl(nptl)=0 + pptl(1,nptl)=0.d0 + pptl(2,nptl)=0.d0 + pptl(4,nptl)=0.d0 + inucl=0 + do is=maproj+1,maproj+matarg + if(iorptl(is).eq.0.and.jorptl(is).eq.0)then + inucl=inucl+1 + pptl(4,nptl)=pptl(4,nptl)+dble(pptl(4,is)) + endif + enddo + if(inucl.ne.inew/100)call utstop('Pb in emsfrag !&') + idnucl=1000000000+mod(inew,100)*10000+(inew/100)*10 + call idmass(idnucl,am) + pptl(5,nptl)=am !mass + ptot=(pptl(4,nptl)+am)*(pptl(4,nptl)-am) + pptl(3,nptl)=sqrt(ptot) + ityptl(nptl)=0 + istptl(nptl)=0 + iorptl(nptl)=nptla+1 + jorptl(nptl)=0 + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + xorptl(1,nptl)=xmean + xorptl(2,nptl)=ymean + xorptl(3,nptl)=zmean + xorptl(4,nptl)=zmean + tivptl(1,nptl)=zmean + tivptl(2,nptl)=tivptl(2,idrest) + idptl(nptl)=idnucl + endif + ifrptl(2,nptla+1)=nptl + if(ifrptl(1,nptla+1).gt.ifrptl(2,nptla+1))then + ifrptl(1,nptla+1)=0 + ifrptl(2,nptla+1)=0 + endif + endif + +c possible decay of fragments + call decayall(nptla+1) + + do is=nptla+1,nptl + if(ish.ge.5)write(ifch,'(a,i5,a,i10,a,4(e10.4,1x),f6.3)') + $ ' Target fragments ',is,' id :',idptl(is) + $ , ' momentum :',(pptl(k,is),k=1,5) + enddo + + + 1000 continue + + + end + +cc-------------------------------------------------------------------------- +c subroutine reaction(idpj,idtg,ireac) +cc-------------------------------------------------------------------------- +cc returns reaction code ireac +cc-------------------------------------------------------------------------- +c iap=iabs(idpj/10) +c iat=iabs(idtg/10) +c isp=idpj/10/iap +c ist=idtg/10/iat +c call idchrg(idpj,cp) +c call idchrg(idtg,ct) +c ac=abs(cp+ct) +c if(iap.gt.100)then +c if(iat.gt.100)then +c if(isp.eq.1)then +c if(ist.eq.1)then +c ireac=1 +c else +c ireac=6 +c endif +c else +c if(ist.eq.1)then +c ireac=6 +c else +c ireac=1 +c endif +c endif +c elseif(iat.eq.11.or.iat.eq.12.or.iat.eq.22)then +c if(ac.ge.2.)then +c ireac=2 +c else +c ireac=3 +c endif +c else +c if(ac.ge.2.)then +c ireac=4 +c else +c ireac=5 +c endif +c endif +c elseif(iap.eq.11.or.iap.eq.12.or.iap.eq.22)then +c if(iat.gt.100)then +c if(ac.ge.2.)then +c ireac=2 +c else +c ireac=3 +c endif +c elseif(iat.eq.11.or.iat.eq.12.or.iat.eq.22)then +c ireac=7 +c else +c ireac=8 +c endif +c else +c if(iat.gt.100)then +c if(ac.ge.2.)then +c ireac=4 +c else +c ireac=5 +c endif +c elseif(iat.eq.11.or.iat.eq.12.or.iat.eq.22)then +c ireac=8 +c else +c ireac=9 +c endif +c endif +c +c end +c +c----------------------------------------------------------------------- + subroutine xEmsI1(iii,kc,omlog) +c----------------------------------------------------------------------- +c plot omlog vs iter +c plot nr of pomerons vs iter +c plot number of collisions vs iter +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + + parameter(nbin=100) + common/cmc/ot(0:nbin),zz(0:nbin),i(0:nbin) + *,yt1,yt2,kx(0:nbin) + parameter(nbim=100) + common/cmc1/xp(0:nbim),xt(0:nbim),x(0:nbim),o(0:nbim) + *,y1,y2,car + character car*5 + double precision xp,xt,x,omlog,om1intbc + character ce*8 + double precision plc,s,seedp + common/cems5/plc,s + +c if(iemsi2.eq.0)call utstop('ERROR in XemsI1: iemsi2 = 0&') + + if(iii.eq.1)then + + o(kc)=sngl(omlog) + nptk=0 + kollx=0 + do ko=1,koll + nptk=nptk+nprt(ko) +c if(itpr(ko).gt.0)then + if(nprt(ko).gt.0)then + kollx=kollx+1 + endif + enddo + zz(kc)=nptk + kx(kc)=kollx + + elseif(iii.eq.2)then + + call ranfgt(seedp) + sum=0 + kollx=0 + sumg=0 + kollg=0 + kollini=koll + koll=1 + do ko=1,kollini +ctp060829 ip=iproj(ko) +ctp060829 it=itarg(ko) + om1i=sngl(om1intbc(bk(ko))) +ctp060829 wk=1. +ctp060829 wp=0. +ctp060829 wt=0. + om1g=sngl(om1intbc(bk(ko))) + sum=sum+om1i + sumg=sumg+om1g + if(rangen().lt.1.-exp(-om1i))then + kollx=kollx+1 + endif + if(rangen().lt.1.-exp(-om1g))then + kollg=kollg+1 + endif + enddo + koll=kollini + call ranfst(seedp) + + x1=0 + x2=nbin + write(ce,'(f8.2)')sngl(plc) + + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i3)') '! log omega for event ',nrevt+1 + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i1)') 'openhisto name omega-',nrevt+1 + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'yrange auto auto ' + write(ifhi,'(a)') 'text 0 0 "xaxis iteration"' + write(ifhi,'(a)') 'text 0 0 "yaxis ln[W]"' + write(ifhi,'(a,a)') 'text 0.5 0.90 "E ='//ce//'"' + write(ifhi,'(a)') 'array 2' + do k=0,nbim + write(ifhi,'(2e11.3)')float(k),o(k) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i3)')'! nr of coll`s for event ',nrevt+1 + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i1)') 'openhisto name coll-',nrevt+1 + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'text 0 0 "xaxis iteration"' + write(ifhi,'(a)') 'text 0 0 "yaxis nr of collisions"' + write(ifhi,'(a)') 'array 2' + do k=0,nbin + write(ifhi,'(2e11.3)')float(k),float(kx(k)) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'array 2' + do k=0,nbin + write(ifhi,'(2e11.3)')float(k),float(kollx) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'array 2' + do k=0,nbin + write(ifhi,'(2e11.3)')float(k),float(kollg) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i3)')'! nr of pom`s for event ',nrevt+1 + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i1)') 'openhisto name pom-',nrevt+1 + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'text 0 0 "xaxis iteration"' + write(ifhi,'(a)') 'text 0 0 "yaxis nr of Pomerons"' + write(ifhi,'(a)') 'array 2' + do k=0,nbin + write(ifhi,'(2e11.3)')float(k),zz(k) + enddo + write(ifhi,'(a)') ' endarray' + if(sum.lt.4*zz(nbin))then + write(ifhi,'(a)') 'closehisto plot 0-' + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'array 2' + do k=0,nbin + write(ifhi,'(2e11.3)')float(k),sum + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'array 2' + do k=0,nbin + write(ifhi,'(2e11.3)')float(k),sumg + enddo + write(ifhi,'(a)') ' endarray' + endif + write(ifhi,'(a)') 'closehisto plot 0' + + endif + + return + end + +c----------------------------------------------------------------------- + subroutine xEmsI2(iii,kc) +c----------------------------------------------------------------------- +c plot quanities vs iter +c plot 1: <x> for Pomeron vs iter +c plot 2: <x> for projectile vs iter +c plot 3: <x> for target vs iter +c arguments: +c iii: modus (1,2) +c kc: iteration step +c omega: config probability +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + + parameter(nbim=100) + common/cmc1/xp(0:nbim),xt(0:nbim),x(0:nbim),o(0:nbim) + *,y1,y2,car + character car*5 + double precision xp,xt,x,xpo,xpj,xtg + common/cemsi2/xpo,xpj,xtg + + if(iii.eq.1)then + + npom=0 + xpo=0 + do k=1,koll +c ip=iproj(k) +c it=itarg(k) + if(nprmx(k).gt.0)then + do n=1,nprmx(k) + if(idpr(n,k).gt.0.and.ivpr(n,k).gt.0)then + xpo=xpo+xpr(n,k) + npom=npom+1 + endif + enddo + endif + enddo + if(npom.gt.0)xpo=xpo/npom + + npk=0 + xpj=0d0 + do i=1,maproj + if(xpp(i).lt.0.999)then + xpj=xpj+xpp(i)!*xmp(i) + npk=npk+1 + endif + enddo + if(npk.gt.0)xpj=xpj/dble(npk) + + ntk=0 + xtg=0d0 + do j=1,matarg + if(xmt(j).lt.0.999)then + xtg=xtg+xmt(j)!*xpt(j) + ntk=ntk+1 + endif + enddo + if(ntk.gt.0)xtg=xtg/dble(ntk) + + x(kc)=xpo + xp(kc)=xpj + xt(kc)=xtg + + elseif(iii.eq.2)then + + x1=0 + x2=nbim + + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i3)') '! average x Pom for event ',nrevt+1 + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i1)') 'openhisto name avxPom-',nrevt+1 + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'text 0 0 "xaxis iteration"' + write(ifhi,'(a)') 'text 0 0 "yaxis average x Pomeron"' + write(ifhi,'(a)') 'array 2' + do k=0,nbim + write(ifhi,'(2e11.3)')float(k),x(k) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i3)') '! average x proj for event ',nrevt+1 + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i1)') 'openhisto name avxProj-',nrevt+1 + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'text 0 0 "xaxis iteration"' + write(ifhi,'(a)') 'text 0 0 "yaxis average x proj"' + write(ifhi,'(a)') 'array 2' + do k=0,nbim + write(ifhi,'(2e11.3)')float(k),xp(k) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i3)') '! average x targ for event ',nrevt+1 + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i1)') 'openhisto name avxTarg-',nrevt+1 + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'text 0 0 "xaxis iteration"' + write(ifhi,'(a)') 'text 0 0 "yaxis average x targ"' + write(ifhi,'(a)') 'array 2' + do k=0,nbim + write(ifhi,'(2e11.3)')float(k),xt(k) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + endif + + return + end + +c----------------------------------------------------------------------- + subroutine xEmsRx(iii,id,xp,xm) +c----------------------------------------------------------------------- +c plot x+, x-, x, y distribution of remnants +c----------------------------------------------------------------------- + + include 'epos.inc' + + parameter(nbix=50,nbiy=50,nid=2) + common/cxp/nxp(nid),nxm(nid),nx(nid),ny(nid) + *,wxp(nbix,nid),wxm(nbix,nid),wx(nbix,nid),wy(nbiy,nid) + *,xpu,xpo,xmu,xmo,xu,xo,yu,yo,dy + + if(iemsrx.eq.0)call utstop('ERROR in XemsRx: iemsrx = 0&') + + if(iii.eq.0)then + + xpu=10/engy**2 + xpo=1 + xmu=10/engy**2 + xmo=1 + xu=10/engy**2 + xo=1 + yu=-alog(engy**2) + yo=alog(engy**2) + dy=(yo-yu)/nbiy + do j=1,nid + nxp(j)=0 + nxm(j)=0 + nx(j)=0 + do i=1,nbix + wxp(i,j)=0 + wxm(i,j)=0 + wx(i,j)=0 + enddo + ny(j)=0 + do i=1,nbiy + wy(i,j)=0 + enddo + enddo + + elseif(iii.eq.1)then + + i=0 + if(xp.lt.xpu)goto1 + i=1+int(alog(xp/xpu)/alog(xpo/xpu)*nbix) + if(i.gt.nbix)goto1 + if(i.lt.1)goto1 + wxp(i,id)=wxp(i,id)+1 + nxp(id)=nxp(id)+1 +1 continue + + if(xm.lt.xmu)goto2 + i=1+int(alog(xm/xmu)/alog(xmo/xmu)*nbix) + if(i.gt.nbix)goto2 + if(i.lt.1)goto2 + wxm(i,id)=wxm(i,id)+1 + nxm(id)=nxm(id)+1 +2 continue + + x=xp*xm + if(x.lt.xu)goto3 + i=1+int(alog(x/xu)/alog(xo/xu)*nbix) + if(i.gt.nbix)goto3 + if(i.lt.1)goto3 + wx(i,id)=wx(i,id)+1 + nx(id)=nx(id)+1 +3 continue + + if(xm.le.0.)goto4 + if(xp.le.0.)goto4 + y=0.5*alog(xp/xm) + if(y.lt.yu)goto4 + i=int((y-yu)/dy)+1 + if(i.gt.nbiy)goto4 + if(i.lt.1)goto4 + wy(i,id)=wy(i,id)+1 + ny(id)=ny(id)+1 +4 continue + + elseif(iii.eq.2)then + + do j=1,nid + if(j.eq.1)then + iclrem=iclpro + elseif(j.eq.2)then + iclrem=icltar + else + iclrem=0 + endif + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a)') '! remnant xp distribution ' + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a,i1)') 'openhisto name xpRemnant-',j + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xpu,xpo + write(ifhi,'(a)') 'text 0 0 "xaxis remnant x+"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(x+)"' + write(ifhi,'(a)') 'array 2' + do i=1,nbix + x=xpu*(xpo/xpu)**((i-0.5)/nbix) + dx=xpu*(xpo/xpu)**(1.*i/nbix)*(1.-(xpo/xpu)**(-1./nbix)) + if(nxp(j).ne.0)write(ifhi,'(2e11.3)')x,wxp(i,j)/dx/nxp(j) + if(nxp(j).eq.0)write(ifhi,'(2e11.3)')x,0. + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'array 2' + do i=1,nbix + x=xu*(xo/xu)**((i-0.5)/nbix) + write(ifhi,'(2e11.3)')x,x**alplea(iclrem)*(1+alplea(iclrem)) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a)') '! remnant xm distribution ' + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a,i1)') 'openhisto name xmRemnant-',j + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xmu,xmo + write(ifhi,'(a)') 'text 0 0 "xaxis remnant x-"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(x-)"' + write(ifhi,'(a)') 'array 2' + do i=1,nbix + x=xmu*(xmo/xmu)**((i-0.5)/nbix) + dx=xmu*(xmo/xmu)**(1.*i/nbix)*(1.-(xmo/xmu)**(-1./nbix)) + if(nxm(j).ne.0)write(ifhi,'(2e11.3)')x,wxm(i,j)/dx/nxm(j) + if(nxm(j).eq.0)write(ifhi,'(2e11.3)')x,0. + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a)') '! remnant x distribution ' + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a,i1)') 'openhisto name xRemnant-',j + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xu,xo + write(ifhi,'(a)') 'text 0 0 "xaxis remnant x"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(x)"' + write(ifhi,'(a)') 'array 2' + do i=1,nbix + x=xu*(xo/xu)**((i-0.5)/nbix) + dx=xu*(xo/xu)**(1.*i/nbix)*(1.-(xo/xu)**(-1./nbix)) + if(nx(j).ne.0)write(ifhi,'(2e11.3)')x,wx(i,j)/dx/nx(j) + if(nx(j).eq.0)write(ifhi,'(2e11.3)')x,0. + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a)') '! remnant y distribution ' + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a,i1)') 'openhisto name yRemnant-',j + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod lin ymod log' + write(ifhi,'(a,2e11.3)')'xrange',yu,yo + write(ifhi,'(a)') 'text 0 0 "xaxis remnant y"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(y)"' + write(ifhi,'(a)') 'array 2' + do i=1,nbix + y=yu+dy/2.+(i-1)*dy + if(ny(j).ne.0)write(ifhi,'(2e11.3)')y,wy(i,j)/dy/ny(j) + if(ny(j).eq.0)write(ifhi,'(2e11.3)')y,0. + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + enddo + + endif + + return + end + +c----------------------------------------------------------------------- + subroutine xEmsPm(iii,ko,nmci,nmcmx) +c----------------------------------------------------------------------- +c m (pomeron number) distribution for different b-bins. +c arguments: +c iii: modus (0,1,2) +c ko: pair number (1 - AB) +c nmc: number of pomerons +c nmcmx: number max of pomerons +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + common/geom/rmproj,rmtarg,bmax,bkmx + parameter(nbin=200) + parameter(nbib=32) + common/cn/wn(0:nbin,nbib),wnmc(0:nbin,nbib),npmx(nbib),nn(nbib) + & ,nn2(nbib),dn(nbib) + common/cb1/db,b1,b2,bb(nbib),nbibx + double precision plc,s,om1intbc + character ce*8,cb*4 + common/cems5/plc,s + common/cemspm/sumb(nbib) + + if(iemspm.eq.0)call utstop('ERROR in XemsPm: iemspm = 0&') + + if(iii.eq.0)then + + do k=1,nbib + nn(k)=0 + nn2(k)=0 + sumb(k)=0 + do i=0,nbin + wnmc(i,k)=0 + enddo + enddo + nbibx=6 + b1=0 + b2=2 + db=(b2-b1)/nbibx + + + elseif(iii.eq.1)then + + k=int((bk(ko)-b1)/db)+1 +c nmc=nmci + if(k.gt.nbibx)k=nbibx + if(k.lt.1)k=1 + dn(k)=max(1.,float(nmcmx)/float(nbin)) + nmc=nint(float(nmci)/dn(k)+0.499999) + if(nmc.gt.nbin)nmc=nbin + if(nmc.lt.0)return + nn(k)=nn(k)+1 + wnmc(nmc,k)=wnmc(nmc,k)+1./dn(k) + sumb(k)=sumb(k)+bk(ko) + + + elseif(iii.eq.2)then + + kollini=koll + koll=1 !to have screening for pp + + do 1 k=1,nbibx + + bb(k)=b1+(k-0.5)*db + if(maproj.eq.1.and.matarg.eq.1.and.bmaxim.eq.0.)bb(k)=b1 + om1i=sngl(om1intbc(bb(k))) + wntmp=0. + do 10 i=0,nbin + wn(i,k)=0. + if(wntmp.gt.1e5)goto 10 + do j=i,i+int(dn(k))-1 + if(j.eq.0)then + wntmp=exp(-om1i) + else + wntmp=wntmp*om1i/j + endif + wn(i,k)=wn(i,k)+wntmp/dn(k) + enddo + if(wn(i,k).gt.0.000001*(1.-exp(-om1i)))npmx(k)=i + 10 continue + + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a)') '! distr of Pomeron number vs b' + write(ifhi,'(a)') '!##################################' + write(ce,'(f8.2)')sngl(plc) + write(cb,'(f4.2)')bb(k) + if(nn(k).gt.0)then + write(ifhi,'(a,i1)') 'openhisto name mPom-',k + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod lin ymod log' + write(ifhi,'(a,2e11.3)')'xrange',0.,float(npmx(k))*dn(k) + write(ifhi,'(a)') 'text 0 0 "xaxis number m of Pomerons"' + write(ifhi,'(a)') 'text 0 0 "yaxis prob(m)"' + if(k.eq.1) + *write(ifhi,'(a,a)') 'text 0.5 0.90 "E ='//ce//'"' + write(ifhi,'(a,a)') 'text 0.5 0.80 "b ='//cb//'"' + write(ifhi,'(a)') 'array 2' + do i=0,nbin + write(ifhi,'(2e11.3)')float(i)*dn(k),wnmc(i,k)/max(1,nn(k)) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + endif + + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a)') '! distr of Pomeron number vs b' + write(ifhi,'(a)') '! traditional approach' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i1)') 'openhisto name mPomTradi-',k + write(ifhi,'(a)') 'htyp lba' + write(ifhi,'(a)') 'xmod lin ymod log' + write(ifhi,'(a,2e11.3)')'xrange',0.,float(npmx(k))*dn(k) + write(ifhi,'(a)') 'array 2' + do i=0,nbin + write(ifhi,'(2e11.3)')float(i)*dn(k),wn(i,k) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + 1 continue + + koll=kollini + + endif + + return + end + +c----------------------------------------------------------------------- + subroutine xEmsB(iii,jjj,ko) +c----------------------------------------------------------------------- +c b distribution at different stages +c arguments: +c iii: modus (0,1,2) +c jjj: stage or type of interaction +c just after Metropolis: +c 1 ... all +c 2 ... interaction +c after defining diffraction: +c 3 ... nothing +c 4 ... cut +c 5 ... diffr +c 6 ... cut + diffr cut +c ko: pair number (1 - AB) +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + parameter(njjj=6) + parameter(nbib=32) + common/cxemsb1/w(0:njjj,nbib),nn(njjj) + common/cxemsb2/db,b1,b2 + common/cxemsb3/njjj1 + double precision PhiExact,om1intbi,PhiExpo!,PhiUnit + common/geom/rmproj,rmtarg,bmax,bkmx + dimension uua2(nbib),uuo2(nbib),uu3(nbib) + + if(iemsb.eq.0)call utstop('ERROR in XemsB: iemsB = 0&') + + if(iii.eq.0)then + + do k=1,nbib + do j=0,njjj + w(j,k)=0 + enddo + enddo + do j=1,njjj + nn(j)=0 + enddo + njjj1=0 + + elseif(iii.eq.1)then + + b1=0 + b2=bkmx*1.2 + db=(b2-b1)/nbib + k=int((bk(ko)-b1)/db)+1 + if(k.gt.nbib)return + if(k.lt.1)return + w(jjj,k)=w(jjj,k)+1 + nn(jjj)=nn(jjj)+1 + if(jjj.eq.1)njjj1=1 + + elseif(iii.eq.2)then + + if(njjj1.ne.1)call utstop + &('xEmsB must be called also with jjj=1&') + ymax=0 + kollini=koll + koll=1 + do k=1,nbib + x=b1+(k-0.5)*db + y=w(1,k)/nn(1)/(pi*((x+0.5*db)**2-(x-0.5*db)**2)) + ymax=max(ymax,y) + enddo + fk=bkmx**2*pi + ymax=1.4 + + do 1 j=1,njjj + if(nn(j).eq.0)goto1 + + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a)') '! b distr exact theory ' + write(ifhi,'(a)') '!##################################' + if(j.ge.2.and.j.le.6)then + write(ifhi,'(a,i1,a)') 'openhisto name b',j,'Exact' + write(ifhi,'(a)') 'htyp lba xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(b)"' + write(ifhi,'(a)') 'array 2' + do k=1,nbib + b=b1+(k-0.5)*db + if(j.eq.2)then + uuo2(k)=sngl(PhiExpo(0.,0.,1.,1.d0,1.d0,engy**2,b)) + uua2(k)=min(uuo2(k),max(0., + & sngl(Phiexact(0.,0.,1.,1.d0,1.d0,engy**2,b)))) + uu3(k)=sngl(min(50d0,exp(om1intbi(b,2)/dble(r2hads(iclpro) + & +r2hads(icltar))))) + endif + if(j.eq.2)y=(1.-uua2(k)) + if(j.eq.3)y=uua2(k) + if(j.eq.4.or.j.eq.6)y=(1.-uua2(k)*uu3(k)) + if(j.eq.5)y=uua2(k)*(uu3(k)-1.) + write(ifhi,'(2e11.3)')b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + endif + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a)') '! b distr unitarized theory ' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i1,a)') 'openhisto name b',j,'Unit' + write(ifhi,'(a)') 'htyp lbf xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(b)"' + write(ifhi,'(a)') 'array 2' + do k=1,nbib + b=b1+(k-0.5)*db + if(j.eq.1)y=1 + if(j.eq.2)y=(1.-uuo2(k)) + if(j.eq.3)y=uuo2(k) + if(j.eq.4.or.j.eq.6)y=(1.-uuo2(k)*uu3(k)) + if(j.eq.5)y=uuo2(k)*(uu3(k)-1.) + write(ifhi,'(2e11.3)')b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a)') '! b distr for cross section ' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i1,a)') 'openhisto name b',j,'Unit' + write(ifhi,'(a)') 'htyp lge xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(b)"' + write(ifhi,'(a)') 'array 2' + do k=1,nbib + b=b1+(k-0.5)*db + if(j.eq.1)y=1 + if(j.eq.2)y=(1.-(uuo2(k)+uua2(k))*0.5) + if(j.eq.3)y=(uuo2(k)+uua2(k))*0.5 + if(j.eq.4.or.j.eq.6)y=(1.-(uuo2(k)+uua2(k))*0.5*uu3(k)) + if(j.eq.5)y=(uuo2(k)+uua2(k))*0.5*(uu3(k)-1.) + write(ifhi,'(2e11.3)')b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a)') '! b distribution simulation' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i1,a)') 'openhisto name b',j,'Simu' + write(ifhi,'(a)') 'htyp lrf xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',0.0,b2 + write(ifhi,'(a,2e11.3)')'yrange',0.,ymax + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(b)"' + if(j.eq.1)write(ifhi,'(a)')'text 0.1 0.35 "after Metropolis"' + if(j.eq.1)write(ifhi,'(a)')'text 0.2 0.20 "all "' + if(j.eq.2)write(ifhi,'(a)')'text 0.3 0.85 "after Metropolis"' + if(j.eq.2)write(ifhi,'(a)')'text 0.5 0.70 "interaction "' + if(j.eq.3)write(ifhi,'(a)')'text 0.3 0.85 "nothing"' + if(j.eq.4)write(ifhi,'(a)')'text 0.3 0.85 "cut"' + if(j.eq.5)write(ifhi,'(a)')'text 0.3 0.85 "diffr"' + if(j.eq.6)write(ifhi,'(a)')'text 0.3 0.85 "cut + diffr cut"' + write(ifhi,'(a)') 'array 2' + do k=1,nbib + x=b1+(k-0.5)*db + if(j.eq.1)y=fk*w(j,k)/nn(1)/(pi*((x+0.5*db)**2-(x-0.5*db)**2)) + if(j.ne.1)y=0. + if(j.ne.1.and.w(1,k).ne.0.)y=w(j,k)/w(1,k) + if(nn(j).gt.0)write(ifhi,'(2e11.3)')x,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + 1 continue + + koll=kollini + + endif + + return + end + +c----------------------------------------------------------------------- + subroutine xEmsBg(iii,jjj,ko) +c----------------------------------------------------------------------- +c b distribution at different stages for different group +c arguments: +c iii: modus (0,1,2,3) +c jjj: group of interaction (1,2 ... ,7) +c ko: pair number (1 - AB) +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + parameter(njjj=7) + parameter(nbib=16) + common/cxemsb4/wg(-1:njjj,nbib),nng(nbib),uug(nbib),kollx + common/cxemsb5/dbg,b1g,b2g + common/cxemsb6/njjj0 + double precision seedp,PhiExpo!,PhiExact + common/geom/rmproj,rmtarg,bmax,bkmx + + if(iemsbg.eq.0)call utstop('ERROR in XemsBg: iemsbg = 0&') + + if(iii.eq.0)then + + do k=1,nbib + nng(k)=0 + do j=-1,njjj + wg(j,k)=0 + enddo + enddo + njjj0=0 + kollx=0 + + elseif(iii.eq.1)then + + b1g=0 + b2g=bkmx*1.2 + dbg=(b2g-b1g)/nbib + k=int((bk(ko)-b1g)/dbg)+1 + if(k.gt.nbib)return + if(k.lt.1)return + if(jjj.eq.-1.or.jjj.eq.0)then + wg(jjj,k)=wg(jjj,k)+1 + else + wg(jjj,k)=wg(jjj,k)+1 + nng(k)=nng(k)+1 + endif + if(jjj.eq.0)njjj0=1 + + elseif(iii.eq.3)then + + call ranfgt(seedp) + do k=1,koll + om1i=sngl(om1intc(k)) + if(rangen().lt.1.-exp(-om1i))then +c om1i=sngl(PhiExpo(0.,0.,1.,1.d0,1.d0,engy*engy,bk(k))) +c if(rangen().lt.1.-om1i)then + kollx=kollx+1 + endif + enddo + call ranfst(seedp) + + elseif(iii.eq.2)then + + if(njjj0.ne.1)call utstop + &('xEmsBg must be called also with jjj=0&') + ymax=1.4 + kollini=koll + koll=1 + + wtot=1. + if(matarg+maproj.gt.2)then + wtot=0. + do k=1,nbib + wtot=wtot+wg(-1,k) + enddo + if(kollx.gt.0)wtot=wtot/float(kollx) + endif + + do 1 j=1,njjj + + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a)') '! b distribution simulation' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i1,a)') 'openhisto name bg',j,'Simu' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',0.,b2g + write(ifhi,'(a,2e11.3)')'yrange',0.,ymax + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(b)"' + if(wtot.gt.0.d0) + &write(ifhi,'(a,f7.4,a)') 'text 0.5 0.8 "alpha=',1./wtot,'"' + write(ifhi,'(a)') 'array 2' + do k=1,nbib + b=b1g+(k-0.5)*dbg + y=0. + if(nng(k).ne.0.and.wg(0,k).ne.0) + & y=wg(j,k)/float(nng(k))*wg(-1,k)/wg(0,k)!/wtot +c if(wg(0,k).ne.0..and.nng(k).ne.0)y=wg(j,k)/nng(k)*wg(-1,k)/wg(0,k) +c!???????????? better normalization ? probability to have an interaction +c in epos compared to eikonal probability, instead of normalized by the +c probability of a collision for a pair (the number collision/number +c active pair). + uug(k)=uug(k)+y + write(ifhi,'(2e11.3)')b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + 1 continue + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a)') '! b distr tot simul theory ' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a)') 'openhisto name btotSimu' + write(ifhi,'(a)') 'htyp pfc xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(b)"' + write(ifhi,'(a)') 'array 2' + do k=1,nbib + b=b1g+(k-0.5)*dbg + write(ifhi,'(2e11.3)')b,uug(k) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a)') '! b distr unitarized theory ' + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i1,a)') 'openhisto name bg',j,'Unit' + write(ifhi,'(a)') 'htyp lba xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(b)"' + write(ifhi,'(a)') 'array 2' + do k=1,nbib + b=b1g+(k-0.5)*dbg +c a1=Phiexact(0.,0.,1.,1.d0,1.d0,engy**2,b) + a1=sngl(PhiExpo(0.,0.,1.,1.d0,1.d0,engy**2,b)) + y=(1.-a1) + write(ifhi,'(2e11.3)')b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + koll=kollini + + endif + + return + end + +c----------------------------------------------------------------------- + subroutine xEmsPx(iii,xmc,ymc,npos) +c----------------------------------------------------------------------- +c plot x-distribution and y-distribution of Pomerons +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + common/geom/rmproj,rmtarg,bmax,bkmx + + parameter(nbix=30,nbib=51) + common/cx/x(2,nbix),dx(2,nbix),wxmc(2,nbix),wxmcI(2,nbix) + * ,xl(2,nbix),dxl(2,nbix),wxp(2,nbix),wxm(2,nbix),wxpI(2,nbix) + *,wxmI(2,nbix),wxpY(2,nbix),wxmY(2,nbix),wxmcY(2,nbix) + parameter(nbiy=50) + common/cy/y(nbiy),wymc(nbiy),wymcY(nbiy),wymcI(nbiy),nyp,nym + double precision PomIncXExact,PomIncPExact,PomIncMExact,dcel + double precision PomIncXIExact,PomIncPIExact,PomIncMIExact + common/ems3/dcel,ad + common/cemspx/xu,xo,yu,yo,dy,xlu,xlo,bb,nn,db,mm,nm,nt + character mod*5, imod*5, txtxm*6 + + nposi=5 + + if(iemspx.eq.0)call utstop('ERROR in XemsPx: iemspx = 0&') + + if(iii.eq.0)then + + xu=0.1/engy**2 + xo=1. + xlu=0.01/engy + xlo=1. + yu=-alog(engy**2) + yo=alog(engy**2) + dy=(yo-yu)/nbiy + do i=1,nbix + x(1,i)=xu*(xo/xu)**((i-0.5)/nbix) + x(2,i)=xu+(xo-xu)*((i-0.5)/nbix) + dx(1,i)=xu*(xo/xu)**(1.*i/nbix)*(1.-(xo/xu)**(-1./nbix)) + dx(2,i)=(xo-xu)/nbix + wxmc(1,i)=0. + wxmc(2,i)=0. + wxmcI(1,i)=0. + wxmcI(2,i)=0. + wxmcY(1,i)=0. + wxmcY(2,i)=0. + enddo + do i=1,nbix + xl(1,i)=xlu*(xlo/xlu)**((i-0.5)/nbix) + xl(2,i)=xlu+(xlo-xlu)*((i-0.5)/nbix) + dxl(1,i)=xlu*(xlo/xlu)**(1.*i/nbix)*(1.-(xlo/xlu)**(-1./nbix)) + dxl(2,i)=(xlo-xlu)/nbix + wxp(1,i)=0. + wxp(2,i)=0. + wxm(1,i)=0. + wxm(2,i)=0. + wxpI(1,i)=0. + wxpI(2,i)=0. + wxmI(1,i)=0. + wxmI(2,i)=0. + wxpY(1,i)=0. + wxpY(2,i)=0. + wxmY(1,i)=0. + wxmY(2,i)=0. + enddo + do i=1,nbiy + y(i)=yu+dy/2.+float(i-1)*dy + wymc(i)=0. + wymcI(i)=0. + wymcY(i)=0. + enddo + mm=0 + nt=0 + nyp=0 + nym=0 + db=bkmx*2./float(nbib-1) + + elseif(iii.eq.1)then + + xp=sqrt(xmc)*exp(ymc) + xm=sqrt(xmc)*exp(-ymc) + mm=mm+1 + + if(xmc.lt.xu)goto11 + i=1+int(alog(xmc/xu)/alog(xo/xu)*nbix) + if(i.gt.nbix)goto1 + if(i.lt.1)goto1 + wxmc(1,i)=wxmc(1,i)+1. + if(npos.eq.1) wxmcI(1,i)=wxmcI(1,i)+1. + if(npos.eq.nposi)wxmcY(1,i)=wxmcY(1,i)+1. +1 continue + i=1+int((xmc-xu)/(xo-xu)*nbix) + if(i.gt.nbix)goto11 + if(i.lt.1)goto11 + wxmc(2,i)=wxmc(2,i)+1. + if(npos.eq.1) wxmcI(2,i)=wxmcI(2,i)+1. + if(npos.eq.nposi)wxmcY(2,i)=wxmcY(2,i)+1. +11 continue + + if(xp.lt.xlu)goto12 + i=1+int(alog(xp/xlu)/alog(xlo/xlu)*nbix) + if(i.gt.nbix)goto2 + if(i.lt.1)goto2 + wxp(1,i)=wxp(1,i)+1. + if(npos.eq.1) wxpI(1,i)=wxpI(1,i)+1. + if(npos.eq.nposi)wxpY(1,i)=wxpY(1,i)+1. +2 continue + i=1+int((xp-xlu)/(xlo-xlu)*nbix) + if(i.gt.nbix)goto12 + if(i.lt.1)goto12 + wxp(2,i)=wxp(2,i)+1. + if(npos.eq.1) wxpI(2,i)=wxpI(2,i)+1. + if(npos.eq.nposi)wxpY(2,i)=wxpY(2,i)+1. +12 continue + + if(xm.lt.xlu)goto13 + i=1+int(alog(xm/xlu)/alog(xlo/xlu)*nbix) + if(i.gt.nbix)goto3 + if(i.lt.1)goto3 + wxm(1,i)=wxm(1,i)+1. + if(npos.eq.1) wxmI(1,i)=wxmI(1,i)+1. + if(npos.eq.nposi)wxmY(1,i)=wxmY(1,i)+1. +3 continue + i=1+int((xm-xlu)/(xlo-xlu)*nbix) + if(i.gt.nbix)goto13 + if(i.lt.1)goto13 + wxm(2,i)=wxm(2,i)+1. + if(npos.eq.1) wxmI(2,i)=wxmI(2,i)+1. + if(npos.eq.nposi)wxmY(2,i)=wxmY(2,i)+1. +13 continue + + if(ymc.lt.yu)return + i=int((ymc-yu)/dy)+1 + if(i.gt.nbiy)return + if(i.lt.1)return + wymc(i)=wymc(i)+1 + if(npos.eq.1) wymcI(i)=wymcI(i)+1 + if(npos.eq.nposi)wymcY(i)=wymcY(i)+1 + if(ymc.gt.0)nyp=nyp+1 + if(ymc.lt.0)nym=nym+1 + + elseif(iii.eq.2)then + + if(maproj.eq.1.and.matarg.eq.1.and.bminim.eq.bmaxim)then + mmmm=1 + bb=bmaxim + ff=float(nrevt)/float(ntevt) + imod=' dn' + elseif(maproj.eq.1.and.matarg.eq.1)then + mmmm=3 + ff=1. + imod=' dn' + elseif(bminim.lt.0.001.and.bmaxim.gt.20)then + mmmm=2 + area=pi*(rmproj+rmtarg)**2 + ff=area*float(nrevt)/float(ntevt)/(maproj*matarg)/sigine*10 + imod=' dn' + else + write(ifmt,*)'xEmsPx ignored' + return + endif + kollini=koll + koll=1 + + kk1=nint(xpar1) + kk2=nint(xpar2) + + do kk=kk1,kk2 + + if(kk.eq.1)mod=' log ' + if(kk.eq.2)mod=' lin ' + + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a)') '! Pomeron x distribution '//mod + write(ifhi,'(a)') '!----------------------------------' + + write(ifhi,'(a)') 'openhisto name xPomSimuL'//mod(3:4) + write(ifhi,'(a)') 'htyp lru xmod'//mod//'ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xu,xo + write(ifhi,'(a)') 'text 0 0 "xaxis x?PE!"' + write(ifhi,'(a)') 'text 0 0 "yaxis'//imod//'?Pom! / dx?PE!"' + if(kk.eq.1)write(ifhi,'(a,f5.2,a)')'text 0.1 0.3 "f=',ff,'"' + if(kk.eq.2)write(ifhi,'(a,f5.2,a)')'text 0.1 0.1 "f=',ff,'"' + write(ifhi,'(a)') 'array 2' + s1=0 + do i=1,nbix + u=x(kk,i) + z=ff*wxmc(kk,i)/dx(kk,i)/nrevt + s1=s1+z*dx(kk,i) + write(ifhi,'(2e11.3)')u,z + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto name xPomUnitL'//mod(3:4) + write(ifhi,'(a)') 'htyp lba xmod'//mod//'ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xu,xo + write(ifhi,'(a)') 'text 0 0 "xaxis x?PE!"' + write(ifhi,'(a)') 'text 0 0 "yaxis'//imod//'?Pom! / dx?PE!"' + write(ifhi,'(a)') 'array 2' + s2=0 + do i=1,nbix + u=x(kk,i) + if(mmmm.eq.1)z=sngl(PomIncXExact(dble(u),bb)) + if(mmmm.eq.2)z=sngl(PomIncXIExact(dble(u)))/sigine*10 + if(mmmm.eq.3)z=sngl(PomIncXIExact(dble(u)))/sigine*10 + s2=s2+dx(kk,i)*z + write(ifhi,'(2e11.3)')u,z + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a,f5.3,a,f5.3,a)') + * 'text .1 .85 "I= ',s1,' (',s2,')"' + write(ifhi,'(a)') 'closehisto plot 0' + + write(ifhi,'(a)') '!--------------------------------' + write(ifhi,'(a)') '! Pomeron y distribution '//mod + write(ifhi,'(a)') '!--------------------------------' + + write(ifhi,'(a)') 'openhisto name yPomSimuL'//mod(3:4) + write(ifhi,'(a)') 'htyp lru xmod lin ymod'//mod + write(ifhi,'(a,2e11.3)')'xrange',yu,yo + write(ifhi,'(a)') 'text 0 0 "xaxis y?PE!"' + write(ifhi,'(a)') 'text 0 0 "yaxis'//imod//'?Pom!/dy?PE!"' + write(ifhi,'(a,f5.2,a)')'text 0.1 0.7 "f=',ff,'"' + write(ifhi,'(a)') 'array 2' + s1=0 + do i=1,nbiy + u=y(i) + z=ff*wymc(i)/dy/nrevt + s1=s1+z*dy + write(ifhi,'(2e11.3)')u,z + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a)') '! Pomeron x+ distribution '//mod + write(ifhi,'(a)') '!----------------------------------' + + write(ifhi,'(a)') 'openhisto name xpPomSimuL'//mod(3:4) + write(ifhi,'(a)') 'htyp lru xmod'//mod//'ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xlu,xlo + write(ifhi,'(a)') 'text 0 0 "xaxis x+?PE!"' + write(ifhi,'(a)') 'text 0 0 "yaxis'//imod//'?Pom! / dx+?PE!"' + if(kk.eq.1)write(ifhi,'(a,f5.2,a)')'text 0.1 0.3 "f=',ff,'"' + if(kk.eq.2)write(ifhi,'(a,f5.2,a)')'text 0.1 0.1 "f=',ff,'"' + write(ifhi,'(a)') 'array 2' + s1=0 + do i=1,nbix + u=xl(kk,i) + z=ff*wxp(kk,i)/dxl(kk,i)/nrevt + s1=s1+z*dxl(kk,i) + write(ifhi,'(2e11.3)')u,z + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto name xpPomUnitL'//mod(3:4) + write(ifhi,'(a)') 'htyp lba xmod'//mod//'ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xlu,xlo + write(ifhi,'(a)') 'text 0 0 "xaxis x+?PE!"' + write(ifhi,'(a)') 'text 0 0 "yaxis'//imod//'?Pom! / dx+?PE!"' + write(ifhi,'(a)') 'array 2' + s2=0 + do i=1,nbix + u=xl(kk,i) + if(mmmm.eq.1)z=sngl(PomIncPExact(dble(u),bb)) + if(mmmm.eq.2)z=sngl(PomIncPIExact(dble(u)))/sigine*10 + if(mmmm.eq.3)z=sngl(PomIncPIExact(dble(u)))/sigine*10 + s2=s2+dxl(kk,i)*z + write(ifhi,'(2e11.3)')u,z + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a,f5.3,a,f5.3,a)') + * 'text .1 .85 "I= ',s1,' (',s2,')"' + write(ifhi,'(a)') 'closehisto plot 0' + + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a)') '! x-?PE! distribution '//mod + write(ifhi,'(a)') '!----------------------------------' + + write(ifhi,'(a)') 'openhisto name xmPomSimuL'//mod(3:4) + write(ifhi,'(a)') 'htyp lru xmod'//mod//'ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xlu,xlo + write(ifhi,'(a)') 'text 0 0 "xaxis x-?PE!"' + write(ifhi,'(a)') 'text 0 0 "yaxis'//imod//'?Pom! / dx-?PE!"' + if(kk.eq.1)write(ifhi,'(a,f5.2,a)')'text 0.1 0.3 "f=',ff,'"' + if(kk.eq.2)write(ifhi,'(a,f5.2,a)')'text 0.1 0.1 "f=',ff,'"' + write(ifhi,'(a)') 'array 2' + s1=0 + do i=1,nbix + u=xl(kk,i) + z=ff*wxm(kk,i)/dxl(kk,i)/nrevt + s1=s1+z*dxl(kk,i) + write(ifhi,'(2e11.3)')u,z + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto name xmPomUnitL'//mod(3:4) + write(ifhi,'(a)') 'htyp lba xmod'//mod//'ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xlu,xlo + write(ifhi,'(a)') 'text 0 0 "xaxis x-?PE!"' + write(ifhi,'(a)') 'text 0 0 "yaxis'//imod//'?Pom! / dx-"' + write(ifhi,'(a)') 'array 2' + s2=0 + do i=1,nbix + u=xl(kk,i) + if(mmmm.eq.1)z=sngl(PomIncMExact(dble(u),bb)) + if(mmmm.eq.2)z=sngl(PomIncMIExact(dble(u))/sigine*10) + if(mmmm.eq.3)z=sngl(PomIncMIExact(dble(u))/sigine*10) + s2=s2+dxl(kk,i)*z + write(ifhi,'(2e11.3)')u,z + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a,f5.3,a,f5.3,a)') + * 'text .1 .85 "I= ',s1,' (',s2,')"' + write(ifhi,'(a)') 'closehisto plot 0' + + !................................................................ + + xm=-1. !xm integration + txtxm='xm int' + do jjb=0,3 + b=jjb*0.5 + do jj=0,2 + + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a,3i1)') '! ffom11 '//mod,jjb,jj + write(ifhi,'(a)') '!----------------------------------' + + write(ifhi,'(a,2i1)')'openhisto name ffom11L'//mod(3:4),jjb,jj+8 + write(ifhi,'(a)') 'htyp lin xmod'//mod//'ymod log' + write(ifhi,'(a,2e11.3)')'xrange ',xlu,xlo + write(ifhi,'(a)')'txt "xaxis x+?PE!"' + write(ifhi,'(a)')'txt "yaxis dn?Pom! / dx+?PE! "' + write(ifhi,'(a)')'text 0.05 0.1 "fit and exact, all contrib."' + if(jjb.lt.3)write(ifhi,'(a,f4.1,3a)') + * 'txt "title ffom11 b =',b,' ',txtxm,'"' + if(jjb.ge.3)write(ifhi,'(3a)') + * 'txt "title ffom11 b aver ',txtxm,'"' + write(ifhi,'(a)') 'array 2' + do i=1,nbix + u=xl(kk,i) + if(jjb.lt.3.and.jj.eq.0)z= ffom11(u,xm,b,-1,-1) + if(jjb.lt.3.and.jj.eq.1)z= ffom11(u,xm,b,0,5) + if(jjb.lt.3.and.jj.eq.2)z= ffom11(u,xm,b,0,4) + if(jjb.eq.3.and.jj.eq.0)z=ffom11a(u,xm,-1,-1) + if(jjb.eq.3.and.jj.eq.1)z=ffom11a(u,xm,0,5) + if(jjb.eq.3.and.jj.eq.2)z=ffom11a(u,xm,0,4) + write(ifhi,'(2e11.3)')u,z + enddo + write(ifhi,'(a)') ' endarray' + if(jj.le.1)write(ifhi,'(a)') 'closehisto plot 0-' + if(jj.eq.2)write(ifhi,'(a)') 'closehisto plot 0' + + enddo + enddo + + do jjb=0,3 + b=jjb*0.5 + do jjj=1,6 + jj=jjj + if(jjj.eq.6)jj=0 + + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a,3i1)') '! ffom11 '//mod,jjb,jj + write(ifhi,'(a)') '!----------------------------------' + + write(ifhi,'(a,3i1)')'openhisto name om1ffL'//mod(3:4),jjb,jj + if(jj.ne.0)write(ifhi,'(a)') 'htyp lin xmod'//mod//'ymod log' + if(jj.eq.0)write(ifhi,'(a)') 'htyp lro xmod'//mod//'ymod log' + write(ifhi,'(a,2e11.3)')'xrange ',xlu,xlo + if(jj.eq.1)then + write(ifhi,'(a)') 'txt "xaxis x+?PE!"' + write(ifhi,'(a)') 'txt "yaxis dn?Pom! / dx+?PE! "' + if(kk.eq.2)then + write(ifhi,'(a)') 'text 0.1 0.2 "soft sea-sea"' + write(ifhi,'(a)') 'text 0.1 0.1 "val-sea sea-val val-val"' + else + write(ifhi,'(a)') 'text 0.05 0.8 "soft"' + write(ifhi,'(a)') 'text 0.05 0.7 "diff"' + write(ifhi,'(a)') 'text 0.05 0.6 "sea-sea"' + write(ifhi,'(a)') 'text 0.05 0.5 "val-sea"' + write(ifhi,'(a)') 'text 0.05 0.4 "sea-val"' + write(ifhi,'(a)') 'text 0.05 0.3 "val-val"' + endif + if(jjb.lt.3)write(ifhi,'(a,f4.1,3a)') + * 'txt "title ffom11 b =',b,' ',txtxm,'"' + if(jjb.ge.3)write(ifhi,'(3a)') + * 'txt "title ffom11 b aver ',txtxm,'"' + endif + write(ifhi,'(a)') 'array 2' + do i=1,nbix + u=xl(kk,i) + if(jjb.lt.3)z= ffom11(u,xm,b,jj,jj) + if(jjb.eq.3)z=ffom11a(u,xm,jj,jj) + write(ifhi,'(2e11.3)')u,z + enddo + write(ifhi,'(a)') ' endarray' + if(jjj.ne.6)write(ifhi,'(a)') 'closehisto plot 0-' + if(jjj.eq.6)write(ifhi,'(a)') 'closehisto plot 0' + + enddo + enddo + + enddo + + koll=kollini + endif + + return + end + +c----------------------------------------------------------------------- + subroutine xEmsP2(iii,jaa,jex,xpd,xmd,xpb,xmb,pt1,pt2) +c----------------------------------------------------------------------- +c plot x+ distributions of Pomeron ends (PE) (xpd) +c and Pomeron's in Born (IB) partons (xpb), +c and pt dist of Pomeron's out Born (OB) partons +c integrated over x- bins (xmd,xmb) +c iii=0: initialize +c ii=1: fill arrays +c iii>=2: make histogram +c (2 - Pomeron end PE, 3 - in Born IB, 4 - out Born OB) +c jaa: type of semihard Pomeron +c 0= sea-sea diff, +c 1= sea-sea, 2= val=sea, 3= sea-val, 4= val-val +c 5= all for iii=2 +c jex: emission type +c 1= no emission, 2= proj emis, 3= targ emis, 4= both sides +c 5= all for iii=2 +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + common/geom/rmproj,rmtarg,bmax,bkmx + parameter(nbixp=25,nbixm=5,nbipt=20) + common/cxb/xlp(2,nbixp),dxlp(2,nbixp) + * ,xlm(2,nbixm),dxlm(2,nbixm) + * ,wxb(2,0:4,4,nbixp,nbixm) + * ,wxe(2,0:4,4,nbixp,nbixm) + common/cptb/ptu,pto,ptob(nbipt),wptob(0:4,4,nbipt) + common/cemspbx/xlub1,xlub2,xlob +ctp060829 character imod*5 + + if(iemspbx.eq.0)call utstop('ERROR in xEmsP2: iemspbx = 0&') + + if(iii.eq.0)then + + xlub1=0.01/engy + xlub2=0. + xlob=1. + do i=1,nbixp + xlp(1,i)=xlub1*(xlob/xlub1)**((i-0.5)/nbixp) + xlp(2,i)=xlub2+(xlob-xlub2)*((i-0.5)/nbixp) + dxlp(1,i)=xlub1*(xlob/xlub1)**(1.*i/nbixp) + * *(1.-(xlob/xlub1)**(-1./nbixp)) + dxlp(2,i)=(xlob-xlub2)/nbixp + enddo + do i=1,nbixm + xlm(1,i)=xlub1*(xlob/xlub1)**((i-0.5)/nbixm) + xlm(2,i)=xlub2+(xlob-xlub2)*((i-0.5)/nbixm) + dxlm(1,i)=xlub1*(xlob/xlub1)**(1.*i/nbixm) + * *(1.-(xlob/xlub1)**(-1./nbixm)) + dxlm(2,i)=(xlob-xlub2)/nbixm + enddo + do i=1,nbixp + do j=1,nbixm + do jaai=0,4 + do jexi=1,4 + wxb(1,jaai,jexi,i,j)=0. + wxb(2,jaai,jexi,i,j)=0. + wxe(1,jaai,jexi,i,j)=0. + wxe(2,jaai,jexi,i,j)=0. + enddo + enddo + enddo + enddo + ptu=2 + pto=20 + do i=1,nbipt + ptob(i)=ptu+(pto-ptu)*(i-0.5)/nbipt + do jaai=0,4 + do jexi=1,4 + wptob(jaai,jexi,i)=0 + enddo + enddo + enddo + + elseif(iii.eq.1)then + + xp=xpb + xm=xmb + if(xp.lt.xlub1)goto2 + if(xm.lt.xlub1)goto2 + i=1+int(alog(xp/xlub1)/alog(xlob/xlub1)*nbixp) + if(i.gt.nbixp)goto2 + if(i.lt.1)goto2 + j=1+int(alog(xm/xlub1)/alog(xlob/xlub1)*nbixm) + if(j.gt.nbixm)goto2 + if(j.lt.1)goto2 + wxb(1,jaa,jex,i,j)=wxb(1,jaa,jex,i,j)+1. +2 continue + + if(xp.lt.xlub2)goto12 + if(xm.lt.xlub2)goto12 + i=1+int((xp-xlub2)/(xlob-xlub2)*nbixp) + if(i.gt.nbixp)goto12 + if(i.lt.1)goto12 + j=1+int((xm-xlub2)/(xlob-xlub2)*nbixm) + if(j.gt.nbixm)goto12 + if(j.lt.1)goto12 + wxb(2,jaa,jex,i,j)=wxb(2,jaa,jex,i,j)+1. +12 continue + + xp=xpd + xm=xmd + if(xp.lt.xlub1)goto22 + if(xm.lt.xlub1)goto22 + i=1+int(alog(xp/xlub1)/alog(xlob/xlub1)*nbixp) + if(i.gt.nbixp)goto22 + if(i.lt.1)goto22 + j=1+int(alog(xm/xlub1)/alog(xlob/xlub1)*nbixm) + if(j.gt.nbixm)goto22 + if(j.lt.1)goto22 + wxe(1,jaa,jex,i,j)=wxe(1,jaa,jex,i,j)+1. + 22 continue + + if(xp.lt.xlub2)goto32 + if(xm.lt.xlub2)goto32 + i=1+int((xp-xlub2)/(xlob-xlub2)*nbixp) + if(i.gt.nbixp)goto32 + if(i.lt.1)goto32 + j=1+int((xm-xlub2)/(xlob-xlub2)*nbixm) + if(j.gt.nbixm)goto32 + if(j.lt.1)goto32 + wxe(2,jaa,jex,i,j)=wxe(2,jaa,jex,i,j)+1. + 32 continue + + do m=1,2 + if(m.eq.1)pt=pt1 + if(m.eq.2)pt=pt2 + i=1+int((pt-ptu)/(pto-ptu)*nbipt) + if(i.lt.1)goto42 + if(i.gt.nbipt)goto42 + wptob(jaa,jex,i)=wptob(jaa,jex,i)+1 + 42 continue + enddo + + elseif(iii.ge.2)then + + if(maproj.eq.1.and.matarg.eq.1.and.bminim.eq.bmaxim)then +ctp060829 mmmm=1 +ctp060829 bb=bmaxim + ff=float(nrevt)/float(ntevt) +ctp060829 imod=' dn' + elseif(maproj.eq.1.and.matarg.eq.1)then +ctp060829 mmmm=3 + ff=1. +ctp060829 imod=' dn' + elseif(bminim.lt.0.001.and.bmaxim.gt.20)then +ctp060829 mmmm=2 + area=pi*(rmproj+rmtarg)**2 + ff=area*float(nrevt)/float(ntevt)/(maproj*matarg)/sigine*10 +ctp060829 imod=' dn' + else + write(ifmt,*)'xEmsP2 ignored' + return + endif + + j1=1 !nint(xpar1) !first xminus bin + j2=5 !nint(xpar2) !last xminus bin + if(iii.eq.4)j2=1 + kkk=2 !nint(xpar3) !1 (log binning) 2 (lin binning) + if(kkk.eq.1)then +ctp060829 xmi1=xlub1*(xlob/xlub1)**((j1-1.)/nbixm) +ctp060829 xmi2=xlub1*(xlob/xlub1)**((j2-0.)/nbixm) + xlub=xlub1 + elseif(kkk.eq.2)then +ctp060829 xmi1=xlub2+(xlob-xlub2)*((j1-1.)/nbixm) +ctp060829 xmi2=xlub2+(xlob-xlub2)*((j2-0.)/nbixm) + xlub=xlub2 + endif + + jaa1=jaa + jaa2=jaa + jex1=jex + jex2=jex + if(jaa.eq.5)then + jaa1=0 + jaa2=4 + endif + if(jex.eq.5)then + jex1=1 + jex2=4 + endif + + if(jex.eq.1)then + je1=0 + je2=0 + elseif(jex.eq.2)then + je1=1 + je2=0 + elseif(jex.eq.3)then + je1=0 + je2=1 + elseif(jex.eq.4)then + je1=1 + je2=1 + elseif(jex.eq.5)then + je1=2 + je2=2 + endif + + if(iii.eq.2)then + + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a,3i1)') '! PE ',jaa,jex + write(ifhi,'(a)') '!----------------------------------' + + sum=ffom12aii(max(1,jaa),je1,je2) + write(ifhi,'(a,2i1)')'openhisto name ffom12a',jaa,jex + write(ifhi,'(a)')'htyp lin xmod lin ymod log' + write(ifhi,'(a,2e11.3)')'xrange ',xlub,xlob + write(ifhi,'(a)') 'txt "xaxis x+?PE!"' + write(ifhi,'(a)') 'txt "yaxis dn?semi! / dx+?PE! "' + write(ifhi,'(a,2i1,a)')'txt "title ffom12a + MC (',jaa,jex,')"' + write(ifhi,'(a)') 'array 2' + do i=1,nbixp + u=xlp(kkk,i) + z=ffom12ai(u,max(1,jaa1),jaa2,je1,je2) + write(ifhi,'(2e11.3)')u,z + enddo + write(ifhi,'(a)') ' endarray' + if(jex.eq.5)then + write(ifhi,'(a)') 'closehisto plot 0-' + write(ifhi,'(a,2i1)')'openhisto name ffom11',jaa,jex + write(ifhi,'(a)')'htyp lba' + write(ifhi,'(a)')'text 0.05 0.5 "+ ffom11a "' + write(ifhi,'(a)')'array 2' + do i=1,nbixp + u=xlp(kkk,i) + z=ffom11a(u,-1.,max(1,jaa1),jaa2) + write(ifhi,'(2e11.3)')u,z + enddo + write(ifhi,'(a)') ' endarray' + endif + + elseif(iii.eq.3)then + + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a,3i1)') '! IB ',jaa,jex + write(ifhi,'(a)') '!----------------------------------' + + !.......total integral + s2min=4*q2min + zmin=s2min/engy**2 + zmax=1 + xpmin0 = 0.01/engy + xpmax=1 + ig1=3 + ig2=3 + r1=0 + do i1=1,ig1 + do m1=1,2 + z=zmin*(zmax/zmin)**(.5+tgss(ig1,i1)*(m1-1.5)) + xpmin=max(z,xpmin0) + r2=0 + if(xpmin.lt.xpmax)then + do i2=1,ig2 + do m2=1,2 + xp=xpmin*(xpmax/xpmin)**(.5+tgss(ig2,i2)*(m2-1.5)) + xm=z/xp + r2=r2+wgss(ig2,i2)*ffsigiut(xp,xm,max(1,jaa),je1,je2) + enddo + enddo + endif + r2=r2*0.5*log(xpmax/xpmin) + r1=r1+wgss(ig1,i1)*r2*z + enddo + enddo + r1=r1*0.5*log(zmax/zmin) + res= r1 * factk * .0390 /sigine*10 + sum=res + !.......plot + xx2min = 0.01/engy !max(xpar1,0.01/engy) + xx2max = 1 !xpar2 + xx1min = 0.01/engy !max(xpar3,0.01/engy) + xx1max = 1 !xpar4 + nbins = 10 !nint(xpar5) + + write(ifhi,'(a,2i1)') 'openhisto xrange 0 1 name ffsig',jaa,jex + write(ifhi,'(a)') 'yrange auto auto htyp lin xmod lin ymod log' + write(ifhi,'(a)') 'txt "xaxis x+?IB! " ' + write(ifhi,'(a)') 'txt "yaxis dn?semi! / dx+?IB! "' + write(ifhi,'(a,2i1,a)')'txt "title ffsig + MC (',jaa,jex,')"' + write(ifhi,'(a)') 'array 2' + del=(xx1max-xx1min)/nbins + do ii=1,nbins + xx1=xx1min+(ii-0.5)*del + ig2=3 + r2=0 + do i2=1,ig2 + do m2=1,2 + xx2=xx2min*(xx2max/xx2min)**(.5+tgss(ig2,i2)*(m2-1.5)) + r2=r2+wgss(ig2,i2)*ffsigiut(xx1,xx2,max(1,jaa),je1,je2)*xx2 + enddo + enddo + sig=r2*0.5*log(xx2max/xx2min) + sig = sig * factk * .0390 /sigine*10 + write(ifhi,'(2e12.4)')xx1,sig + enddo + write(ifhi,'(a)') ' endarray' + + elseif(iii.eq.4)then + + write(ifhi,'(a)') '!----------------------------------' + write(ifhi,'(a,3i1)') '! OB ',jaa,jex + write(ifhi,'(a)') '!----------------------------------' + + !...... integral + y2 = 10 + ptmin = 2 + ptmax = 6 + sum=0 + ig=2 + do i=1,ig + do m=1,2 + pt=ptmin*(ptmax/ptmin)**(.5+tgss(ig,i)*(m-1.5)) + sig=ffsigi(pt**2,y2) + sig =sig * factk * .0390 /sigine*10 * 2 ! 2 partons! + sum=sum+wgss(ig,i)*sig*pt + enddo + enddo + sum=sum*0.5*log(ptmax/ptmin) + !...... pt distr + y2 = 10 + ptmin = 2 + ptmax = 20 + nbins = 18 + sx=engy**2 + do jj=3,1,-1 + write(ifhi,'(a,i1)')'openhisto name jet',jj + write(ifhi,'(a)')'xrange 0 20 xmod lin ymod log ' + write(ifhi,'(a)') 'txt "xaxis pt?OB! " ' + write(ifhi,'(a)') 'txt "yaxis dn?ptn! / dpt?OB! "' + if(jj.eq.1)write(ifhi,'(a)')'htyp lro' + if(jj.eq.2)write(ifhi,'(a)')'htyp lgo' + if(jj.eq.3)write(ifhi,'(a)')'htyp lyo' + write(ifhi,'(a,f7.2,a)') 'text 0.05 0.1 "1/f=',1./ff,'"' + write(ifhi,'(a)')'array 2' + delpt=(ptmax-ptmin)/nbins + do i=1,nbins + pt=ptmin+(i-0.5)*delpt + sig=1 + if(jj.eq.1)then + sig=ffsigi(pt**2,y2) ! our stuff + elseif(jj.eq.2)then + if(engy.ge.10.)sig=psjvrg1(pt**2,sx,y2) ! grv + elseif(jj.eq.3)then + if(engy.ge.10.)sig=psjwo1(pt**2,sx,y2) !duke-owens + endif + sig =sig * factk * .0390 /sigine*10 * 2 + write(ifhi,'(2e12.4)')pt,sig + enddo + write(ifhi,'(a)') ' endarray' + if(jj.ne.1)write(ifhi,'(a)') 'closehisto' + if(jj.ne.1)write(ifhi,'(a)') 'plot 0-' + enddo + + endif + + x=0.1+(min(3,iii)-2)*0.30 + y=0.2+(min(3,iii)-2)*0.55 + if(engy.gt.100.)then + write(ifhi,'(a,2f5.2,a,f6.3,a)')'text',x,y,' " form ',sum,'"' + else + write(ifhi,'(a,2f5.2,a,f6.5,a)')'text',x,y,' " form ',sum,'"' + endif + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') "!-----------------------------" + write(ifhi,'(a)') "! MC " + write(ifhi,'(a)') "!-----------------------------" + + if(iii.eq.2) + * write(ifhi,'(a,i1,i1)')'openhisto name dndxPE',jaa,jex + if(iii.eq.3) + * write(ifhi,'(a,i1,i1)')'openhisto name dndxIB',jaa,jex + if(iii.eq.4) + * write(ifhi,'(a,i1,i1)')'openhisto name dndptOB',jaa,jex + write(ifhi,'(a)') 'htyp prs' + write(ifhi,'(a)') 'array 2' + sum=0 + imax=nbixp + if(iii.eq.4)imax=nbipt + do i=1,imax + u=xlp(kkk,i) + if(iii.eq.4)u=ptob(i) + z=0 + do j=j1,j2 + do jaai=jaa1,jaa2 + do jexi=jex1,jex2 + if(iii.eq.2)z=z+wxe(kkk,jaai,jexi,i,j) + if(iii.eq.3)z=z+wxb(kkk,jaai,jexi,i,j) + if(iii.eq.4)z=z+wptob(jaai,jexi,i) + enddo + enddo + enddo + del=dxlp(kkk,i) + if(iii.eq.4)del=(pto-ptu)/nbipt + z=z/del*ff/nrevt + write(ifhi,'(2e11.3)')u,z + sum=sum+z*del + enddo + write(ifhi,'(a)') ' endarray' + x=0.1+(min(3,iii)-2)*0.30 + y=0.1+(min(3,iii)-2)*0.55 + if(engy.gt.100)then + write(ifhi,'(a,2f5.2,a,f6.3,a)')'text',x,y,' " simu ',sum,'"' + else + write(ifhi,'(a,2f5.2,a,f6.5,a)')'text',x,y,' " simu ',sum,'"' + endif + write(ifhi,'(a)') 'closehisto' + + endif + + return + end + +c----------------------------------------------------------------------- + subroutine xEmsSe(iii,xmc,ptmc,ih,iqq) +c----------------------------------------------------------------------- +c iqq = 1 : String End mass and rapidity +c iqq = 2 : String mass and rapidity +c----------------------------------------------------------------------- + + include 'epos.inc' + + parameter(nbix=50) + common/cxpar/nx(2),x(nbix),wxmc(nbix,2),xmn,xmx,xu,xo + parameter(nbiy=40) + common/cypar/ny(2),y(nbiy),wymc(nbiy,2),ymin,ymax,dy,yu,yo + + s=engy**2 + + if(iii.eq.0)then + + nx(iqq)=0 + xu=0.1/engy**2 + xo=1. + do i=1,nbix + x(i)=xu*(xo/xu)**((i-0.5)/nbix) + wxmc(i,iqq)=0 + enddo + yo=alog(s) + yu=-yo + dy=(yo-yu)/nbiy + ny(iqq)=0 + do i=1,nbiy + y(i)=yu+dy/2.+(i-1)*dy + wymc(i,iqq)=0 + enddo + + elseif(iii.eq.1)then + + if(xmc.lt.xu)return + if(ptmc.eq.0.)return + ymc=0. + if(iqq.eq.1)ymc=0.5*alog(xmc*s/ptmc)*ih + if(iqq.eq.2)ymc=0.5*alog(xmc/ptmc) + i=1+int(alog(xmc/xu)/alog(xo/xu)*nbix) + if(i.gt.nbix)goto1 + if(i.lt.1)goto1 + wxmc(i,iqq)=wxmc(i,iqq)+1 + nx(iqq)=nx(iqq)+1 +1 continue + if(ymc.lt.yu)return + i=int((ymc-yu)/dy)+1 + if(i.gt.nbiy)return + if(i.lt.1)return + wymc(i,iqq)=wymc(i,iqq)+1 + ny(iqq)=ny(iqq)+1 + + elseif(iii.eq.2)then + + write(ifhi,'(a)') '!--------------------------------' + write(ifhi,'(a)') '! string end x distr ' + write(ifhi,'(a)') '!--------------------------------' + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xu,xo + if(iqq.eq.1)write(ifhi,'(a)') 'text 0 0 "xaxis string end x"' + if(iqq.eq.2)write(ifhi,'(a)') 'text 0 0 "xaxis string x"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(x)"' + write(ifhi,'(a)') 'array 2' + do i=1,nbix + dx=xu*(xo/xu)**(1.*i/nbix)*(1.-(xo/xu)**(-1./nbix)) + if(nx(iqq).gt.0) + * write(ifhi,'(2e11.3)')x(i),wxmc(i,iqq)/dx/nx(iqq) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',yu,yo + if(iqq.eq.1)write(ifhi,'(a)') 'text 0 0 "xaxis string end y"' + if(iqq.eq.2)write(ifhi,'(a)') 'text 0 0 "xaxis string y"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(y)"' + write(ifhi,'(a)') 'array 2' + do i=1,nbiy + if(ny(iqq).gt.0) + * write(ifhi,'(2e11.3)')y(i),wymc(i,iqq)/dy/ny(iqq) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + endif + + return + end + +c----------------------------------------------------------------------- + subroutine xEmsDr(iii,xpmc,xmmc,ie) +c----------------------------------------------------------------------- + + include 'epos.inc' + + parameter(nbix=50,nie=4) + common/cxpardr/nxp(nie),nxm(nie),x(nbix),wxpmc(nbix,nie) + & ,wxmmc(nbix,nie),xmn,xmx,xu,xo,wxmc(nbix,nie),nx(nie) + parameter(nbiy=40) + common/cypardr/ny(nie),y(nbiy),wymc(nbiy,nie),ymin,ymax,dy,yu,yo + + s=engy**2 + + if(iii.eq.0)then + + do ni=1,nie + nxp(ni)=0 + nxm(ni)=0 + nx(ni)=0 + enddo + xu=0.1/engy**2 + xo=1. + do i=1,nbix + x(i)=xu*(xo/xu)**((i-0.5)/nbix) + do ni=1,nie + wxpmc(i,ni)=0 + wxmmc(i,ni)=0 + wxmc(i,ni)=0 + enddo + enddo + yo=alog(s) + yu=-yo + dy=(yo-yu)/nbiy + do ni=1,nie + ny(ni)=0 + enddo + do i=1,nbiy + y(i)=yu+dy/2.+(i-1)*dy + do ni=1,nie + wymc(i,ni)=0 + enddo + enddo + + elseif(iii.eq.1)then + + if(ie.lt.1.or.ie.gt.nie)return + + if(xpmc.lt.xu)return + i=1+int(alog(xpmc/xu)/alog(xo/xu)*nbix) + if(i.gt.nbix)goto1 + if(i.lt.1)goto1 + wxpmc(i,ie)=wxpmc(i,ie)+1 + nxp(ie)=nxp(ie)+1 + if(xmmc.lt.xu)return + i=1+int(alog(xmmc/xu)/alog(xo/xu)*nbix) + if(i.gt.nbix)goto1 + if(i.lt.1)goto1 + wxmmc(i,ie)=wxmmc(i,ie)+1 + nxm(ie)=nxm(ie)+1 +1 continue + if(xmmc.ge.xu)then + ymc=0.5*alog(xpmc/xmmc) + else + return + endif + if(ymc.lt.yu)return + i=int((ymc-yu)/dy)+1 + if(i.gt.nbiy)return + if(i.lt.1)return + wymc(i,ie)=wymc(i,ie)+1 + ny(ie)=ny(ie)+1 + + xmc=xpmc*xmmc + if(xmc.lt.xu)return + i=1+int(alog(xmc/xu)/alog(xo/xu)*nbix) + if(i.gt.nbix)return + if(i.lt.1)return + wxmc(i,ie)=wxmc(i,ie)+1 + nx(ie)=nx(ie)+1 + + elseif(iii.eq.2)then + + do ii=1,nie + + if(ii.eq.1)write(ifhi,'(a)')'!----- projectile droplet ----' + if(ii.eq.2)write(ifhi,'(a)')'!----- target droplet ----' + if(ii.eq.3)write(ifhi,'(a)')'!----- projectile string end ----' + if(ii.eq.4)write(ifhi,'(a)')'!----- target string end ----' + write(ifhi,'(a)') '!--------------------------------' + write(ifhi,'(a)') '! droplet/string x+ distr ' + write(ifhi,'(a)') '!--------------------------------' + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xu,xo + if(ii.eq.1.or.ii.eq.2) + * write(ifhi,'(a)') 'text 0 0 "xaxis droplet x+"' + if(ii.eq.3.or.ii.eq.4) + * write(ifhi,'(a)') 'text 0 0 "xaxis string end x+"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(x)"' + write(ifhi,'(a)') 'array 2' + do i=1,nbix + dx=xu*(xo/xu)**(1.*i/nbix)*(1.-(xo/xu)**(-1./nbix)) + if(nxp(ii).gt.0) + * write(ifhi,'(2e11.3)')x(i),wxpmc(i,ii)/dx/nxp(ii) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + write(ifhi,'(a)') '!--------------------------------' + write(ifhi,'(a)') '! droplet/string x- distr ' + write(ifhi,'(a)') '!--------------------------------' + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lba' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xu,xo + if(ii.eq.1.or.ii.eq.2) + * write(ifhi,'(a)') 'text 0 0 "xaxis droplet x-"' + if(ii.eq.3.or.ii.eq.4) + * write(ifhi,'(a)') 'text 0 0 "xaxis string end x-"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(x)"' + write(ifhi,'(a)') 'array 2' + do i=1,nbix + dx=xu*(xo/xu)**(1.*i/nbix)*(1.-(xo/xu)**(-1./nbix)) + if(nxm(ii).gt.0) + * write(ifhi,'(2e11.3)')x(i),wxmmc(i,ii)/dx/nxm(ii) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + write(ifhi,'(a)') '!--------------------------------' + write(ifhi,'(a)') '! droplet/string y distr ' + write(ifhi,'(a)') '!--------------------------------' + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',yu,yo + if(ii.eq.1.or.ii.eq.2) + * write(ifhi,'(a)') 'text 0 0 "xaxis droplet y"' + if(ii.eq.3.or.ii.eq.4) + * write(ifhi,'(a)') 'text 0 0 "xaxis string end y"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(y)"' + write(ifhi,'(a)') 'array 2' + do i=1,nbiy + if(ny(ii).gt.0) + * write(ifhi,'(2e11.3)')y(i),wymc(i,ii)/dy/ny(ii) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + enddo + + write(ifhi,'(a)') '!--------------------------------' + write(ifhi,'(a)') '! droplet/string mass distr ' + write(ifhi,'(a)') '!--------------------------------' + do ii=1,nie + + + if(ii.eq.2.or.ii.eq.4)write(ifhi,'(a)') 'closehisto plot 0-' + if(ii.eq.3)write(ifhi,'(a)') 'closehisto plot 0' + write(ifhi,'(a)') 'openhisto' + if(ii.eq.1.or.ii.eq.3)write(ifhi,'(a)') 'htyp lru' + if(ii.eq.2.or.ii.eq.4)write(ifhi,'(a)') 'htyp lba' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',sqrt(xu*s),sqrt(s*xo) + if(ii.eq.1.or.ii.eq.2) + * write(ifhi,'(a)') 'text 0 0 "xaxis droplet mass (GeV)"' + if(ii.eq.4.or.ii.eq.3) + * write(ifhi,'(a)') 'text 0 0 "xaxis string end mass (GeV)"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(x)"' + write(ifhi,'(a)') 'array 2' + do i=1,nbix + dx=xu*(xo/xu)**(1.*i/nbix)*(1.-(xo/xu)**(-1./nbix)) + if(nx(ii).gt.0) + * write(ifhi,'(2e11.3)')sqrt(x(i)*s),wxmc(i,ii)/dx/nx(ii) + enddo + write(ifhi,'(a)') ' endarray' + enddo + write(ifhi,'(a)') 'closehisto plot 0' + + endif + + return + end + +cc-------------------------------------------------------------------------- +c subroutine xtype(k,n,i1,i2,text) +cc-------------------------------------------------------------------------- +c +c include 'epos.inc' +c include 'epos.incems' +c parameter(itext=40) +c character text*40 +c +c imax=itext+1 +c do i=itext,1,-1 +c if(text(i:i).eq.'&')imax=i +c enddo +c +c ip=iproj(k) +c it=itarg(k) +c +c if(i1.eq.1)then +c write(ifch,*) +c write(ifch,*)('-',ll=1,27) +c write(ifch,*)' '//text(1:imax-1) +c write(ifch,*)('-',ll=1,27) +c endif +c +c if(i2.eq.1)then +c write(ifch,*) +c write(ifch,*)'k:',k,' n:',n,' ip:',ip,' it:',it +c write(ifch,*)'bk:',bk(k) +c if(n.ne.0)write(ifch,*)'idpr:',idpr(n,k) +c write(ifch,*)'iep:',iep(ip),' iet:',iet(it) +c write(ifch,*)'idp:',idp(ip),' idt:',idt(it) +c endif +c +c end +c +c------------------------------------------------------------------------ + subroutine XPrint(text) +c------------------------------------------------------------------------ + include 'epos.inc' + include 'epos.incems' + double precision xpptot,xmptot,xpttot,xmttot +c parameter(itext=15) + character text*(*) + imax=index(text,'&') + if(imax.gt.1)write(ifch,'(1x,a)')text(1:imax-1) + + write(ifch,'(a)') + *' k: itpr: npr0: npr1: nprmx: Pomeron id lattice:' + do k=1,koll + write(ifch,'(1x,i6,1x,i4,4x,i4,2x,i4,3x,i4,a3,$)') + * k,itpr(k),npr(0,k),npr(1,k),nprmx(k),' ' + do n=1,nprmx(k) + write(ifch,'(i2,$)')idpr(n,k) + enddo + write(ifch,*)' ' + enddo + + xpptot=0d0 + xmptot=0d0 + xpttot=0d0 + xmttot=0d0 + write(ifch,'(a)')' Pomeron xy lattice:' + do k=1,koll + do n=1,nprmx(k) + xpptot=xpptot+xppr(n,k) + xmttot=xmttot+xmpr(n,k) + write(ifch,'(i6,1x,i2,1x,d10.3,1x,d10.3,3x,$)') + * k,n,xpr(n,k),ypr(n,k) + enddo + write(ifch,*)' ' + enddo + + write(ifch,'(a)')' projectile remnants x+,x-,px,py,x,iep:' + do ip=1,maproj + xpptot=xpptot+xpp(ip) + xmptot=xmptot+xmp(ip) + write(ifch,'(i3,2x,5d12.3,i3)')ip,xpp(ip),xmp(ip),xxp(ip),xyp(ip) + * ,xpos(ip),iep(ip) + enddo + + write(ifch,'(a)')' target remnants x-,x+,px,py,x,iet:' + do it=1,matarg + xpttot=xpttot+xpt(it) + xmttot=xmttot+xmt(it) + write(ifch,'(i3,2x,5d12.3,i3)')it,xmt(it),xpt(it),xxt(it),xyt(it) + * ,xtos(it),iet(it) + enddo + + write(ifch,*)' remnant balance x+,x-:' + &,(xpptot+xpttot)/dble(maproj) + &,(xmptot+xmttot)/dble(matarg) + end + + +c------------------------------------------------------------------------- + subroutine xfom +c------------------------------------------------------------------------- + include 'epos.inc' + double precision fom,x + write(ifhi,'(a)') '!##################################' + write(ifhi,'(a,i3)') '! fom ' + write(ifhi,'(a)') '!##################################' + b=0. + do i=1,6 + z=0.2*exp(0.8*i) + xi=0.01+0.16*float(i-1) + write(ifhi,'(a,i1)') 'openhisto name fom',i + write(ifhi,'(a)') 'htyp lin xmod lin ymod log' + write(ifhi,'(a)') 'xrange 0 1' + write(ifhi,'(a)') 'yrange 0.1 1000 ' + write(ifhi,'(a)') 'text 0 0 "xaxis x "' + write(ifhi,'(a)') 'text 0 0 "yaxis fom"' + if(z.lt.10.) + & write(ifhi,'(a,f4.2,a,f4.1,a)')'text ',xi,' 0.9 "',z,'"' + if(z.ge.10.) + & write(ifhi,'(a,f4.2,a,f4.0,a)')'text ',xi,' 0.9 "',z,'"' + write(ifhi,'(a)') 'array 2' + do n=1,99 + x=dble(n)*0.01d0 + write(ifhi,'(2e11.3)')x,fom(z,x,b) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') ' closehisto ' + if(i.lt.6)write(ifhi,'(a)') 'plot 0-' + if(i.eq.6)write(ifhi,'(a)') 'plot 0' + enddo + end + + +c----------------------------------------------------------------------- + subroutine xbDens(jjj) +c----------------------------------------------------------------------- +c plots b distribution for all pairs +c---------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + common/geom/rmproj,rmtarg,bmax,bkmx + + if(jjj.eq.1)then +c prepare plot for xbDens + if(ixbDens.eq.1)then + iii=1 !proj + Nnucla=0 + do ip=1,maproj + if(lproj(ip).ne.0)then + Nnucla=Nnucla+1 + do l=1,lproj(ip) + k=kproj(ip,l) + b=bk(k) + i=1+int(b/bkmx*float(mxnucl)) + if(i.le.mxnucl)bnucl(i,iii)=bnucl(i,iii)+1. + enddo + endif + if(lproj3(ip).ne.0)then + do l=1,lproj3(ip) + k=kproj3(ip,l) + b=bk(k) + i=1+int(b/bkmx*float(mxnucl)) + if(i.le.mxnucl)bnucl(i,iii+2)=bnucl(i,iii+2)+1. + enddo + endif + enddo + xbtot(iii)=xbtot(iii)+float(Nnucla) + iii=2 !targ + Nnucla=0 + do it=1,matarg + if(ltarg(it).ne.0)then + Nnucla=Nnucla+1 + do l=1,ltarg(it) + k=ktarg(it,l) + b=bk(k) + i=1+int(b/bkmx*float(mxnucl)) + if(i.le.mxnucl)bnucl(i,iii)=bnucl(i,iii)+1. + enddo + endif + if(ltarg3(it).ne.0)then + do l=1,ltarg3(it) + k=ktarg3(it,l) + b=bk(k) + i=1+int(b/bkmx*float(mxnucl)) + if(i.le.mxnucl)bnucl(i,iii+2)=bnucl(i,iii+2)+1. + enddo + endif + enddo + xbtot(iii)=xbtot(iii)+float(Nnucla) + endif + + else + + if(xbtot(1).gt.0.)then + xbtot(3)=xbtot(1) + xbtot(4)=xbtot(2) + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin name bdens' + write(ifhi,'(a)') '- txt "xaxis b (fm)" ' + write(ifhi,'(a)') '+ txt "yaxis P(b) proj " ' + write(ifhi,'(a)') '+ txt "yaxis P(b) targ " ' + write(ifhi,'(a)') '+ txt "yaxis P(b) scr proj " ' + write(ifhi,'(a)') '+ txt "yaxis P(b) scr targ " ' + write(ifhi,'(a)') 'array 5' + db=bkmx/float(mxnucl) + do j=1,mxnucl + b=(j-0.5)*db + d=pi*((b+db)**2-b**2) + write(ifhi,'(2e12.4)') b,(bnucl(j,iii)/xbtot(iii)/d,iii=1,4) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + write(ifhi,'(a)') 'plot bdens+1- plot bdens+2-' + write(ifhi,'(a)') 'plot bdens+3- plot bdens+4 ' + endif + + endif + + end diff --git a/modules/epos/epos-fra-lhc.f b/modules/epos/epos-fra-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..4282590408c64b1526c7f5a46afacce84f018af3 --- /dev/null +++ b/modules/epos/epos-fra-lhc.f @@ -0,0 +1,2976 @@ +c----------------------------------------------------------------------- + subroutine gakfra(iclu,iret) +c----------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + include 'epos.incpar' + parameter (eta=0.4,etap=0.1) + parameter (mxnbr=500,mxnba=5000) + common /gag/nob,pst(4,0:mxnba),ipst(0:mxnba) + $ ,nbr,ijb(2,0:mxnbr),xyb(2,0:mxnbr) + & ,ptb(4,0:mxnbr),iflb(0:mxnbr),ip(0:mxnbr),co,x,y +c common /cpptr/ pptr(4,mxptl),ystr(mxptl) + double precision p1,p12,p2 + dimension co(12),ind(0:mxnbr),p1(5),p2(5) + dimension ic2(2),ic1(2),ic(2),fkap(3) + common/pb/pb /cnsbp/nsbp /cn8ptl/n8ptl + common/czz/kky,krm,kdrm,kzrm,pui(3),pdi(3),psi(3),pci(3),zzzz,itp + &,pduui(3),pdudi(3),pdusi(3),pduci(3),pdddi(3),pddsi(3),pddci(3) + &,pdssi(3),pdsci(3),pdcci(3) + double precision psg + common/zpsg/psg(5) + logical go + + pf(i,j)=(pst(4,i)-pst(3,i))*(pst(4,j)+pst(3,j)) + & -pst(2,i)*pst(2,j)-pst(1,i)*pst(1,j) + + nob=0 + call utpri('gakfra',ish,ishini,4) + iret=0 +c.....search string in pptl-list................................... + nkmax=nptl + nk1=maproj+matarg+1 + 2 continue + if(nclean.gt.0.and.nptl.gt.mxptl/2)then + nnnpt=0 + do iii=maproj+matarg+1,nptl + go=.true. + if(nclean.eq.1.and.istptl(iii).le.istmax)go=.false. + if(go.and.mod(istptl(iii),10).ne.0)then + istptl(iii)=99 + nnnpt=nnnpt+1 + endif + enddo + if(nnnpt.gt.mxptl-nptl)then + nptl0=nptl + call utclea(maproj+matarg+1,nptl0) + nkmax=nptl + nk1=maproj+matarg+1 +c write(ifch,'(a)')' ---------after utclea------------' +c call blist('&',nk1,nkmax) + endif + endif + + do while(nk1.le.nkmax) + if(istptl(nk1).eq.20)then + nk2=nk1+1 + do while(idptl(nk2).eq.9) + nk2=nk2+1 + enddo + goto 3 !ok, string from nk1 to nk2 + else + nk1=nk1+1 + endif + enddo + + goto 9999 !no more string + + +c....................................................................... +c decay string nk1 - nk2 +c....................................................................... + + 3 nob=-1 + if(ish.ge.3)then + write(ifch,'(/1x,25a1/5x,a/1x,25a1/)') + * ('-',k=1,25),'string decay',('-',k=1,25) + write(ifch,'(a)')' ---------string------------' + call blist('&',nk1,nk2) + endif + + itp=ityptl(nk1) + if(iLHC.eq.1)then + if(jorptl(nk1).ne.0.or.jorptl(nk2).ne.0)then + kky=1 + else + kky=0 + endif + else + kky=0 +c if(nk2-nk1.gt.1.or.iappl.eq.6)kky=1 + if((itp.ge.30.and.itp.le.39).or.iappl.eq.6)kky=1 + endif + krm=0 + if((itp.ge.50.and.itp.le.59).or.(itp.ge.40.and.itp.le.49))krm=1 + kdrm=0 + if(itp.eq.43.or.itp.eq.53)kdrm=1 +c Excited remnant due to split + kzrm=0 + if(itp.eq.44.or.itp.eq.54.or.itp.eq.46.or.itp.eq.56)kzrm=1 + + do k=1,5 + p1(k)=0d0 + enddo + do i=nk1,nk2 + do k=1,5 + p2(k)=dble(pptl(k,i)) + enddo + p2(4)=sqrt(p2(3)**2+p2(2)**2+p2(1)**2+p2(5)**2) + do k=1,4 + p1(k)=p1(k)+p2(k) + enddo + enddo + p1(5)=(p1(4)-p1(3))*(p1(4)+p1(3))-p1(2)**2-p1(1)**2 + if(p1(5).gt.0.d0)then + p1(5)=sqrt(p1(5)) + else + iorrem=iorptl(nk1) + write(*,*)'Precision problem in gakfra, p:', + & p1(5),p1(4),p1(3),p1(2),p1(1) + write(*,*)'origin : ',iorrem + p1(5)=0.d0 +c if(iorrem.ne.0.and. +c & (ityptl(iorrem).eq.40.or.ityptl(iorrem).eq.10)) +c & p1(5)=dble(pptl(5,iorrem)) + if(iorrem.ne.0)then + write(*,*)'string mass : ',ityptl(iorrem),pptl(5,iorrem) + p1(5)=dble(pptl(5,iorrem)) + endif + endif + do k=1,5 + psg(k)=p1(k) + enddo + +c.....pbreak ................................ + + pbi=pbreak + zz=0. + if(iLHC.eq.1)then + x=p1(5) !sub string mass (energy in cms) for e+e- and pp + if(pbi.gt.0.d0.or.(pbi.gt.-0.99999d0.and.kky.eq.0))then +c around 0.4 for soft because of pi0 spectra for CR and pp multiplicity +c and pt spectra at RHIC + pb=abs(pbi) + else +c fit is important not only in e+e- but for all particle production + pb0=abs(pbi) + + pb=pb0+(1.-exp(-x/40.))*(pbreakg-pb0) + +c {{14,0.25},{22,0.22},{34,0.22},{91.2,0.15}} !new + endif + else + x0=1. + x=sqrt(qsqptl(nk1)) !string energy + if(iappl.ne.6)then +c in hadronic collisions, strings are substring of big string from a Pomeron +c the ratio Energy_tot / Energy_sub is used to quantify the modification of fkappa + x0=x !pomeron energy + x=p1(4) !sub string energy + endif +c if(pbi.gt.0.d0.or.(pbi.gt.-0.99999d0.and.krm.eq.1))then + if(pbi.gt.0.d0.or.(pbi.gt.-0.99999d0.and.kky.eq.0))then +c around 0.4 for soft because of pi0 spectra for CR and pp multiplicity +c and pt spectra at RHIC + pb=abs(pbi) + else +c fit is important not only in e+e- but for all particle production + pb0=0.33 + +c pb=0.065 + 3600./x**3 - 400./x**2 + 17./x !<-------- + pb=pb0*(1.+exp(-x**2/1000))*0.5 + +c {{14,0.25},{22,0.22},{34,0.22},{91.2,0.15}} !new + if(iappl.ne.6)then + zz=x0/x !energy dependence from ratio + if(iLHC.eq.1)zz=log(max(1.,zz)) + endif + endif + endif + + if(iLHC.eq.1)then + fkap(1)=fkappa + fkap(3)=fkappag + fkap(2)=0.5*(fkap(1)+fkap(3)) + else + fkap(1)=fkappa + if(zz.gt.0.)then + zzz=min(fkamax,fkainc*zz) + zzz=sqrt(1.+zzz) + if(iLHC.eq.0)pb=pb/zzz + fkap(1)=fkap(1)*zzz !fix increase of ap and K at Tevatron + endif +c write(*,*)'pb',kky,krm,kdrm,x,x0,pb,zz,fkap + endif + +c write(*,*)'pb',kky,krm,kdrm,x,pb,zpaptl(1,nk1)+zpaptl(1,nk2) + + zzzz=1. + if(isplit.eq.1.and.iappl.ne.6)then !for pt + zzzz=0. + zzz=0. +c if(krm.eq.0)then !both hard and soft (not good for mesons for HERA-B or pp RHIC, but good for baryons) + if(kky.eq.1)then !only hard +c if((kky.eq.1.or.(iLHC.eq.1.and.krm.eq.0)))then +c zzzz=zipinc*(zpaptl(1,nk1)+zpaptl(1,nk2)) +c zzzz=sqrt(1.+zzzz) + zz=(zpaptl(1,nk1)*(1.+zodinc*log(zpaptl(2,nk2))) !zpaptl(2,nk1)=# of connected pom + & +zpaptl(1,nk2)*(1.+zodinc*log(zpaptl(2,nk2)))) +c print *,zpaptl(2,nk1),zpaptl(2,nk2) +c & ,1./cosh(0.007*max(0.,zpaptl(2,nk1)-50.)) +c reduce zz before fusion (make it proportionnal to b and E because at low energy not so many fragments are used and then if only one fragment is used all others particles are fragmented without particular effect + if(iclu.eq.1)zz=zz/cosh(min(30., + & 0.0085*max(0.,zpaptl(2,nk1)-30.))) + zzzz=zipinc*zz + if(iLHC.eq.1)then + zzz=min(fkamax,fkainc*zz) + zzz=sqrt(1.+zzz) + fkap(1)=fkap(1)*zzz !fix increase of ap and K at Tevatron + fkap(2)=fkap(2)*zzz + fkap(3)=fkap(3)*zzz + endif +c print *,bimevt,zzzz,zz,0.75*(zpaptl(1,nk1)+zpaptl(1,nk2)) +c zzz=fkainc*zz + elseif(kzrm.eq.1)then + zz=zpaptl(1,nk1) + zzzz=0. !zopinc*zz + zzz=0.!zodinc*zz + zzz=sqrt(1.+zzz) + fkap(1)=fkap(1)*zzz + pb=pb/zzz + endif + zzzz=sqrt(1.+zzzz) + endif + if(ish.ge.4)write(ifch,*)"String parameters:" + & ,iclu,itp,krm,kdrm,kzrm,fkap,zzzz,pb,x + if(fkap(1).le.0..or.zzzz.le.0.) + & call utstop("fkappa<=0. not allowed !&") + + igmx=1 + if(iLHC.eq.1)igmx=3 + do ig=1,igmx + pui(ig)=1. + pdi(ig)=pui(ig)*exp(-pi*difud/fkap(ig)) !assymmetric u and d relevant because of assymmetry Kch / K0 in e+e- + psi(ig)=pui(ig)*exp(-pi*difus/fkap(ig)) + pduui(ig)=pui(ig)*exp(-pi*difuuu/fkap(ig)) + pdudi(ig)=pui(ig)*exp(-pi*difuud/fkap(ig)) + pdusi(ig)=pui(ig)*exp(-pi*difuus/fkap(ig)) + pdddi(ig)=pui(ig)*exp(-pi*difudd/fkap(ig)) + pddsi(ig)=pui(ig)*exp(-pi*difuds/fkap(ig)) + pdssi(ig)=pui(ig)*exp(-pi*difuss/fkap(ig)) + if(nrflav.gt.3)then + pci(ig)=pui(ig)*exp(-pi*difuc/fkap(ig)) + pduci(ig)=pui(ig)*exp(-pi*difuuc/fkap(ig)) + pddci(ig)=pui(ig)*exp(-pi*difudc/fkap(ig)) + pdsci(ig)=pui(ig)*exp(-pi*difusc/fkap(ig)) + pdcci(ig)=pui(ig)*exp(-pi*difucc/fkap(ig)) + else + pci(ig)=0. + pduci(ig)=0. + pddci(ig)=0. + pdsci(ig)=0. + pdcci(ig)=0. + endif + enddo + +c.....light like ............................................... + + if(ish.ge.6) call blist("before light like&",nk1,nk2) + if(rangen().lt.0.5)then + i1=nk1 + i2=nk1+1 + else + i1=nk2-1 + i2=nk2 + endif + ii=1 + do while(ii.ge.0) + do i=1,4 + p2(i)=dble(pptl(i,i1))+dble(pptl(i,i2)) + enddo +c p2(5)=sqrt(p2(4)**2-p2(3)**2-p2(2)**2-p2(1)**2) + am1=pptl(5,i1)**2 + am2=pptl(5,i2)**2 + am12=max(0d0,p2(4)**2-p2(3)**2-p2(2)**2-p2(1)**2-am1-am2)/2 + if(am12**2.gt.am1*am2)then + ak1=.5*((am2+am12)/sqrt(am12**2-am1*am2))-.5 + ak2=.5*((am1+am12)/sqrt(am12**2-am1*am2))-.5 + else + ak1=0. + ak2=0. + endif + if(ish.ge.6)write(ifch,'(a,2i4,9f12.6)') 'overlaps' + $ ,i1,i2,ak1,ak2,sqrt(2.*am12) + & ,am1,am2 + do j=1,4 + a1=(1.+ak1)*pptl(j,i1)-ak2*pptl(j,i2) + a2=(1.+ak2)*pptl(j,i2)-ak1*pptl(j,i1) + pptl(j,i1)=a1 + pptl(j,i2)=a2 + enddo + pptl(5,i1)=0. + pptl(5,i2)=0. + if(nk2-nk1.eq.1) ii=-1 + ii=ii-1 + if (nk1.eq.i1)then + i1=nk2-1 + i2=nk2 + else + i1=nk1 + i2=nk1+1 + endif + enddo + +c.....inverse ............................................... + +c if(nk2.eq.nk1+1.and.nptl.lt.mxptl)then +c call utrepla(nptl+1,nk2) +c call utrepla(nk2,nk1) +c call utrepla(nk1,nptl+1) +c endif + + if(ish.ge.6) call blist("after light like&",nk1,nk2) + +c.....on-shell and copy ............................................... + + if(ish.ge.6) write (ifch,*) 'on-shell check' + do i=nk1,nk2 + do k=1,5 + p2(k)=dble(pptl(k,i)) + enddo + p12=p2(4) + p2(4)=sqrt(p2(3)**2+p2(2)**2+p2(1)**2+p2(5)**2) + if(abs(p12-p2(4))/max(.1d0,p12,p2(4)).ge.1e-1.and.ish.ge.2)then + write(ifch,*)'warning: on-shell problem:' + & ,i, idptl(i),(pptl(k,i),k=1,4),' (',sngl(p2(4)),') ' + & ,pptl(5,i), istptl(i) + endif + if(ish.ge.6) write (ifch,*) p12 ,'->',p2(4) + call utlob2(1,p1(1),p1(2),p1(3),p1(4),p1(5) + $ ,p2(1),p2(2),p2(3),p2(4),60) + f=1.0 + if(i.ne.nk1.and.i.ne.nk2)f=0.5 + nmax=1 + ff=1. + aemax=1000. ! here max band mass +c write(ifch,*)"test",f,p2(4),aemax,f*p2(4).gt.aemax + if(f*p2(4).gt.aemax) then + nmax = int(f*p2(4)/aemax)+1 + ff=1./float(nmax) +c print *,"nmax",nmax +c write(ifch,*)"nmax",nmax + endif + nn=1 + do while(nn.le.nmax) + f=.5 + if(i.eq.nk1.and.nn.eq. 1 ) f=1. + if(i.eq.nk2.and.nn.eq.nmax) f=1. + nob=nob+1 + if(nob.gt.mxnba-7)stop'gakfra: increase parameter mxnba ' +c if(nmax.ge.2) print *, nob,ff,f,i +c if(nmax.ge.2) write(ifch,*)'nob',nob,ff,f,i + do k=1,4 + pst(k,nob)=ff*f*p2(k) + ipst(nob)=i + enddo + nn=nn+1 + enddo + enddo !i + + do i1=nob-1,1,-1 ! copy again gluons + nob=nob+1 + if(nob.gt.mxnba-7)stop'gakfra: increase parameter mxnba ' + do k=1,4 + pst(k,nob)=pst(k,i1) + ipst(nob)=ipst(i1) + enddo + enddo + nob=nob+1 ! nob is number of kinks + if(nob.gt.mxnba-7)stop'gakfra: increase parameter mxnba ' + if(ish.ge.6) then + write (ifch,*) 'bands:' + do i=0,nob-1 + write (ifch,'(i4,4g20.13)') i,(pst(k,i),k=1,4) + enddo + endif + +c.....total momentum............................................... + do k=1,4 + pst(k,nob)=0. + enddo + do i=0,nob-1 + do k=1,4 + pst(k,nob)=pst(k,nob)+pst(k,i) + enddo + enddo + + + +c.....write total string on pptl - list............................. + nptl=nptl+1 + if(nptl.gt.mxptl)call utstop('gakfra: mxptl too small ...&') + call idtr5(idptl(nk1),ic1) + call idtr5(idptl(nk2),ic2) + ic(1)=ic1(1)+ic2(1) + ic(2)=ic1(2)+ic2(2) + idptl(nptl) = 8*10**8+ ic(1)*100 + ic(2)/100 !nbr+1 + istptl(nptl)=10 + n8ptl=nptl + do i=1,5 + pptl(i,nptl)=p1(i) + enddo + if(ish.ge.3)then + write(ifch,'(a)')' ---------total string------------' + call blist('&',nptl,nptl) + endif + +c.................................................................... + ijb(1,0)=-1 + ijb(2,0)=-1 + ijb(1,1)=-1 + ijb(2,1)=-1 + iflb(0)=-idptl(nk1) + iflb(1)= idptl(nk2) + do i=1,4 + ptb(i,0)=0. + ptb(i,1)=0. + enddo + +c...................light string.................................... + amm=ammin(idptl(nk1),idptl(nk2)) + + if(sqrt(max(0.,pf(nob,nob))).lt.amm)then + id=idsp( idptl(nk1),idptl(nk2) ) + if(ish.ge.1)then + write (ifch,*) + . '-------string too light to decay--------' + write (ifch,*) id,p1(5),amm + write (ifch,*) id, sqrt(max(0.,pf(nob,nob))) ,amm + endif + if(id.ne.0.or.iLHC.ne.1)then + am=sqrt(max(0.,pf(nob,nob))) + call idress(id,am,idr,iadj) + if(ish.ge.1)write (ifch,*) id,am,idr,iadj + nptl=nptl+1 + if(nptl.gt.mxptl) + & call utstop('gakfra (light): mxptl too small ...&') + do i=1,5 + pptl(i,nptl)=p1(i) + enddo + do i=nk1,nk2 + istptl(i)=21 + ifrptl(1,i)=n8ptl + ifrptl(2,i)=0 + enddo + istptl(n8ptl)=29 !code for fragmented string + ityptl(n8ptl)=ityptl(nk1) + itsptl(n8ptl)=itsptl(nk1) + rinptl(n8ptl)=-9999 + iorptl(n8ptl)=nk1 + jorptl(n8ptl)=nk2 + ifrptl(1,n8ptl)=n8ptl+1 + ifrptl(2,n8ptl)=nptl + ityptl(nptl)=ityptl(nk1) + itsptl(nptl)=itsptl(nk1) + rinptl(nptl)=-9999 + istptl(nptl)=0 + iorptl(nptl)=n8ptl + jorptl(nptl)=0 + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + if(idr.ne.0)then + idptl(nptl)=idr + else + idptl(nptl)=id + endif + do j=1,4 + xorptl(j,nptl)=xorptl(j,nk1) + enddo + tivptl(1,nptl)=xorptl(4,nptl) + call idtau(idptl(nptl),pptl(4,nptl),pptl(5,nptl),taugm) + tivptl(2,nptl)=tivptl(1,nptl)+taugm*(-alog(rangen())) + if(abs(p1(5)-am).gt.0.01)then +c write (*,*) 'light string --- particle off-shell!!!!' +c write (*,*) idr,' mass:',p1(5),' should be:',am + endif + goto 98 + endif + endif + +c................search breakpoints................................... + + n=0 + nsbp=1 + nbr=0 + iok=0 + + 11 continue + if(nsbp.gt.10000)then + if(ish.ge.1)then + write(*,*)'Gakfra : string can not be fragmented, redo event !' + write(*,*)nk1,idptl(nk1),nk2,idptl(nk2),istptl(nk1) + write(ifch,*)'Gakfra : redo event !' + endif + iret=1 + goto 9999 + endif + + !----------------------! + call gaksbp(0,1,iok) + !----------------------! + nbrtry=0 + goto 10 + +c..............delete breakpoint.................................... + 9 if(ish.ge.4)write(ifch,*) 'delete breakpoint',n,' -> ' + &,nbr-1,' breakpoints left' + call gakdel(n) !hier loeschen + +c..............no more breakpoints -> redo.......................... + if(nbr.eq.0)then + nsbp=nsbp+1 + if(ish.ge.3)write (ifch,*) + & 'no breakpoints left ... try again (',nsbp,')' + if(ish.ge.3)write (ifch,*)' ' + goto 11 + endif + +c................make index list of breakpoints to adjust........... + 10 continue + nbrtry=nbrtry+1 + nind=0 + do i=1,nbr + if(ip(i).eq.0.or.ip(i+1).eq.0)then + nind=nind+1 + ind(nind)=i + endif + enddo + if(nbrtry.gt.1000000)then + if(ish.ge.1)then + write(*,*)'Gakfra : string can not be fragmented, redo event !' + write(*,*)nk1,nk2,nbr,nind,pb + endif + iret=1 + goto 9999 + endif + +c.....no more breakpoint to adjust............................... + if(nind.eq.0) goto 100 + +c................................................................ + if(ish.ge.5)then + write(ifch,*) 'breakpoints:' + write(ifch,'(i3,i5)') 0,-iflb(0) + do i=1,nbr + write(ifch,'(i3,2i5,1x,4e12.4,2x,2i3,2f6.3)') + & i,iflb(i),-iflb(i),(ptb(j,i),j=1,4) + & ,ijb(1,i),ijb(2,i),xyb(1,i),xyb(2,i) + enddo + write(ifch,'(i3,i5)') nbr+1,iflb(nbr+1) + endif + +c.....choose breakpoint, calculate masses, lambda.................. + r=rangen() + nn=1+int(r*float(nind)) +c nn=1+(nind-1)*int(r+0.5) + n=ind(nn) + if(ish.ge.4)write(ifch,*) 'choose breakpoint',n + nl=n-1 + nr=n+1 + do while (nl.gt.0.and.ip(nl).eq.0) + nl=nl-1 + enddo + do while (nr.lt.nbr+1.and.ip(nr+1).eq.0) + nr=nr+1 + enddo + if(ish.ge.6)write (ifch,*) 'nl,n,nr:',nl,n,nr +c print *,'------------------------------------',1 + call gaksco(n-1,n,n+1,ijb(1,n),ijb(2,n),x1,x2,y1,y2) + if(x2.le.x1.or.y2.le.y1)goto 9 +cc x=(xyb(1,n)-x1)/(x2-x1) +cc y=(xyb(2,n)-y1)/(y2-y1) + x=xyb(1,n) + y=xyb(2,n) + aml2=co(1)+x*co(2)+y*co(3)+x*y*co(4) + amr2=co(5)+x*co(6)+y*co(7)+x*y*co(8) + ala2=co(9)+x*co(10)+y*co(11)+x*y*co(12) + +c.....determine id of both particles.............................. + aml=sqrt(max(0.,aml2)) + idl=idsp( -iflb(n-1) , iflb(n) ) + amr=sqrt(max(0.,amr2)) + idr=idsp( -iflb(n) , iflb(n+1) ) + +c.....if mass to small (because of spacelike pt) reject.......... +c amin=0.0 +c if (aml2.le.amin.or.amr2.le.amin) goto 9 + +c.....if no left or right ptl id -> reject......... + if(idl.eq.0.or.idr.eq.0)then + if(ish.ge.5)write(ifch,*)'no left or right ptl id' + goto 9 + endif + + iadjl=0 + iadjr=0 + idrl=0 + idrr=0 + +c.....if no adjusted mass on left side, check for resonance........... + if(ip(n) .eq.0) then + aml=sqrt(max(0.,aml2+0.*min(0.,amr2))) !!!???? + amlxx=aml + call idress(idl,aml,idrl,iadjl) + r=rangen() + if(idrl.eq.110.and.r.lt.0.5)then + if (r.gt.eta+etap) goto 9 !rare numerical errors + idl=220 + aml=.549 + if(r.lt.etap)aml=.958 + amlxx=aml + call idress(idl,aml,idrl,iadjl) + iadjl=1 + endif + if(ish.ge.5)write(ifch,'(a,i5,2f12.6,1i10,i5)') + & ' l: ',idl,amlxx,aml,idrl,iadjl + else + if(ish.ge.5)write(ifch,'(a,i5,2f12.6,i10,a5)') + & ' l: ',idl,aml,aml,ip(n),'ok' + endif + +c.....if no adjusted mass on right side, check for resonance........... + if(ip(n+1).eq.0) then + amr=sqrt(max(0.,amr2+0.*min(0.,aml2))) !!!???? + amrxx=amr + call idress(idr,amr,idrr,iadjr) + r=rangen() + if(idrr.eq.110.and.r.lt.0.5)then + if (r.gt.eta+etap) goto 9 !rare numerical errors + idr=220 + amr=.549 + if(r.lt.etap)amr=.958 + amrxx=amr + call idress(idr,amr,idrr,iadjr) + iadjr=1 + endif + if(ish.ge.5)write(ifch,'(a,i5,2f12.6,1i10,i5)') + & ' r: ',idr,amrxx,amr,idrr,iadjr + else + if(ish.ge.5)write(ifch,'(a,i5,2f12.6,i10,a5)') + & ' r: ',idr,amr,amr,ip(n+1),'ok' + endif + +c.....mass adjustments......................................... + iok=0 + if(ip(n+1).ne.0)then !.........adjusted mass on right side + if(idrl.eq.0)then + call gaksbp(n-1,n,iok) + if(iok.eq.1)goto 9 + goto 10 + endif + if(iadjl.eq.1)then + if(ish.ge.5)write(ifch,*)'mass adjustment 1' + n2=n+1 + call gakanp(n-1,n,n2,aml**2,amr**2,0.,iok) + endif + if(iok.eq.1)goto 9 + ip(n)=idrl + elseif(ip(n).ne.0)then !.........adjusted mass on left side + if(idrr.eq.0)then + call gaksbp(n,n+1,iok) + if(iok.eq.1)goto 9 + goto 10 + endif + if(iadjr.eq.1)then + if(ish.ge.5)write(ifch,*)'mass adjustment 2' + n2=n+1 + call gakanp(n-1,n,n2,aml**2,amr**2,0.,iok) + endif + if(iok.eq.1)goto 9 + ip(n+1)=idrr + else !.........adjusted mass neither left nor right + if(idrr.eq.0.and.idrl.eq.0)then + call gaksbp(n,n+1,iok) + if(iok.eq.1)goto 9 + call gaksbp(n-1,n,iok) + if(iok.eq.1)goto 9 + goto 10 + elseif(idrl.ne.0.and.idrr.eq.0)then + if(iadjl.eq.1) then + if(ish.ge.5)write(ifch,*)'mass adjustment 3' + call gakanp(n-1,n,nr,aml**2,0.,ala2,iok) + endif + elseif(idrl.eq.0.and.idrr.ne.0)then + if(iadjr.eq.1) then + if(ish.ge.5)write(ifch,*)'mass adjustment 4' + n2=n+1 + call gakanp(nl,n,n2,0.,amr**2,ala2,iok) + endif + else !if(idrl.ne.0.and.idrr.ne.0)then + if(iadjl.eq.1.or.iadjr.eq.1) then + if(ish.ge.5)write(ifch,*)'mass adjustment 5' + n2=n+1 + call gakanp(n-1,n,n2,aml**2,amr**2,0.,iok) + endif + endif + if(iok.eq.1)goto 9 + ip(n)=idrl + ip(n+1)=idrr + endif + if(ish.ge.4)then + write(ifch,*) 'left/right particles:' + & ,ip(n),aml,' ',ip(n+1),amr + endif + goto 10 + +c................................................................ +c end of string decay +c................................................................ + +c.....final list............................................... + 100 if(ish.ge.4)then + write(ifch,*) ' ************ OK **************' + write(ifch,*) 'final breakpoints:' + write(ifch,'(i3,i5)') 0,-iflb(0) + do i=1,nbr + write(ifch,'(i3,2i5,1x,4e12.4,2x,2i3,2f6.3)') + & i,iflb(i),-iflb(i),(ptb(j,i),j=1,4) + & ,ijb(1,i),ijb(2,i),xyb(1,i),xyb(2,i) + enddo + write(ifch,'(i3,i5)') nbr+1,iflb(nbr+1) + endif + +c.....write particles in pptl-list................................ + if(ish.ge.3)then + write(ifch,'(a)')' ---------produced particles---------' + endif + + nptlini=nptl + if(nptlini+nbr+1.gt.mxptl) + & call utstop('gakfra (end): mxptl too small ...&') + do i=1,nbr+1 + nptl=nptl+1 + if(i.lt.nbr+1)then !particle = left side of breakpoints + call gaksco(i-1,i,i+1,ijb(1,i),ijb(2,i),x1,x2,y1,y2) +c taubrr=pst(4,nob+7)+x*pst(4,nob+8)+y*pst(4,nob+9) + x=xyb(1,i) + y=xyb(2,i) + aml2=co(1)+x*co(2)+y*co(3)+x*y*co(4) + amr2=co(5)+x*co(6)+y*co(7)+x*y*co(8) + + ala2=co(9)+x*co(10)+y*co(11)+x*y*co(12) + aml=sign(sqrt(abs(aml2)),aml2) + amr=sign(sqrt(abs(amr2)),amr2) + if(aml.le.0.d0.or.amr.le.0.d0)then + if(ish.ge.4)write(ifch,*) + & 'Negative mass, fragmentation not OK -> redo ...' + n=i + nptl=nptlini + goto 9 + endif + qsqptl(nptl)=ala2 + pptl(5,nptl)=aml + do j=1,4 + pptl(j,nptl)=pst(j,nob+1)- + & x*pst(j,nob+2)+y*pst(j,nob+3) +c pptr(j,nptl)=ptb(j,i) + enddo + else !last particle = right side of last breakpoint + pptl(5,nptl)=amr + qsqptl(nptl)=0. + do j=1,4 + pptl(j,nptl)=pst(j,nob+4)+ + & x*pst(j,nob+5)-y*pst(j,nob+6) +c pptr(j,nptl)=ptb(j,i) !should be zero + enddo +c taubrr=0. + endif + idptl(nptl)=ip(i) + if(ish.ge.7)call blist('&',nptl,nptl) + if(pptl(4,nptl).le.0.d0)then + if(ish.ge.4)write(ifch,*) + & 'Negative energy, fragmentation not OK -> redo ...' + n=i + nptl=nptlini + goto 9 + endif + + enddo + + nptl=nptlini + + if(ish.ge.7)then + write(ifch,'(a)')' ---------produced particles---------' + endif + + + do i=1,nbr+1 + nptl=nptl+1 + + call utlob4(-1,p1(1),p1(2),p1(3),p1(4),p1(5) + $ ,pptl(1,nptl),pptl(2,nptl),pptl(3,nptl),pptl(4,nptl)) +c call utlob4(-1,p1(1),p1(2),p1(3),p1(4),p1(5) +c $ ,pptr(1,nptl),pptr(2,nptl),pptr(3,nptl),pptr(4,nptl)) + + +c........Origin.................................................. + istptl(nptl)=0 + iorptl(nptl)=n8ptl + jorptl(nptl)=0 + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + + r=rangen() + tauran=-taurea*alog(r)*pptl(4,nptl)/pptl(5,nptl) +c if(jpsi.ge.1)tauran=0. +c tauran=max(taubrl,taubrr) !take formation time from string-theory + do j=1,4 + xorptl(j,nptl)=xorptl(j,nk1)+pptl(j,nptl) + & /pptl(4,nptl)*tauran + enddo + tivptl(1,nptl)=xorptl(4,nptl) + call idtau(idptl(nptl),pptl(4,nptl),pptl(5,nptl),taugm) + tivptl(2,nptl)=tivptl(1,nptl)+taugm*(-alog(rangen())) + ityptl(nptl)=ityptl(nk1) + itsptl(nptl)=itsptl(nk1) + rinptl(nptl)=-9999 + if(ish.ge.3)call blist('&',nptl,nptl) +ctp060829 taubrl=taubrr + enddo + iorptl(n8ptl)=nk1 + jorptl(n8ptl)=nk2 + ityptl(n8ptl)=ityptl(nk1) + do i=nk1,nk2 + istptl(i)=21 + ifrptl(1,i)=n8ptl + ifrptl(2,i)=0 + enddo + istptl(n8ptl)=29 !code for fragmented string + ifrptl(1,n8ptl)=n8ptl+1 + ifrptl(2,n8ptl)=nptl + if(ish.ge.5)then + write(ifch,*)'string momentum sum:' + do kk=1,5 + pptl(kk,nptl+1)=0 + do ii=n8ptl+1,nptl + pptl(kk,nptl+1)=pptl(kk,nptl+1)+pptl(kk,ii) + enddo + enddo + call alist2('&',n8ptl,n8ptl,nptl+1,nptl+1) + endif + + + +c.....another string?......................................... + 98 nk1=nk2+1 + goto 2 !next string + +c.....end of fragmentation..................................... + 9999 continue + call utprix('gakfra',ish,ishini,4) + return + end + +c--------------------------------------------------------------------- + subroutine gaksbp(ibr1,ibr2,iok) +c--------------------------------------------------------------------- + ! search break points + !----------------------------------------- + ! nbr ... number of break points + ! + ! + ! + !-------------------------------------------------------------- + include 'epos.inc' + + parameter (mxnbr=500,mxnba=5000) + common /gag/nob,pst(4,0:mxnba),ipst(0:mxnba) + $ ,nbr,ijb(2,0:mxnbr),xyb(2,0:mxnbr) + & ,ptb(4,0:mxnbr),iflb(0:mxnbr),ip(0:mxnbr),co,x,y + common/pb/pb /cnsbp/nsbp /cn8ptl/n8ptl + double precision ax,ay,az,ae,am,bx,by,bz,be + dimension co(12) + logical weiter + common/czz/kky,krm,kdrm,kzrm,pui(3),pdi(3),psi(3),pci(3),zzzz,itp + &,pduui(3),pdudi(3),pdusi(3),pduci(3),pdddi(3),pddsi(3),pddci(3) + &,pdssi(3),pdsci(3),pdcci(3) + double precision psg + common/zpsg/psg(5) +c dimension pleft(5),pright(5) + + pf(i,j)=pst(4,i)*pst(4,j)-pst(3,i)*pst(3,j) + & -pst(2,i)*pst(2,j)-pst(1,i)*pst(1,j) + mmod(i)=mod(mod(i,nob)+nob,nob) + + call utpri('gaksbp',ish,ishini,5) + + + + ib1=ibr1 + ib2=ibr2 + iside=1 + if(rangen().lt.0.5)iside=2 + if(ish.ge.6)write(ifch,*)'iside:',iside + Amxx=80./pb + if(ish.ge.4)write(ifch,*) + &'search brk between ib1=',ib1,' and ib2=',ib2 + ntry=0 + nbrold=nbr + Amin=0. + Amax=Amxx + 26 ntry=ntry+1 + A0=-log(exp(-pb*Amin)+rangen()*(exp(-pb*Amax)-exp(-pb*Amin)))/pb + if(ish.ge.6)write(ifch,*)'pb, Amin, Amax, A0:',pb, Amin, Amax, A0 + A=A0 + Amaxn=0. + if(iside.eq.2)goto 51 +c..................................................................... + if(ib1.eq.0)then !startwert der j-schleife + jj=nob-1 + else + jj=ijb(2,ib1) + endif + do while (jj.gt.0) + if(jj.eq.ijb(2,ib1) )then !linker brk im Streifen jj? + y1=xyb(2,ib1) + else !nein + y1=0. + endif + if(jj.eq.ijb(2,ib2))then !rechter brk im Streifen jj? + y2=xyb(2,ib2) + else !nein + y2=1. + endif + if(y1.eq.y2) goto 9999 + if(abs(y1-y2)/abs(y1+y2).le.1e-7) goto 9999 + if(ish.ge.6)write(ifch,*)'y1,y2,A',y1,y2,A + !startwert der i-schleife + if(ib1.eq.0)then !ohne linken brkpt + ii=mmod(jj+1) + if(jj.lt.nob/2)ii=mmod(nob-jj+1) + if(ib2.le.nbr.and.mmod(ii+nob/2) + & .gt.mmod(ijb(1,ib2)+nob/2))then + if(ish.ge.6)write(ifch,*) 'very special case',ii,jj + goto12 + endif + else + ii=ijb(1,ib1) + if(jj.lt.nob/2 .and. + $ mmod(nob-jj+1+nob/2).gt. mmod(ii+nob/2) + $ )ii=mmod(nob-jj+1) + endif + weiter=.true. + aa=0. + if(ii.eq.jj) then + if(ish.ge.6)write(ifch,*) 'Rand erreicht' + goto 15 + endif + do while(weiter) + if(ii.eq.ijb(1,ib1))then !linker brk im Feld (ii,jj) + x2=xyb(1,ib1) + else + x2=1. + endif + + if(ii.eq.ijb(1,ib2))then !rechter brk im Feld (ii,jj) + x1=xyb(1,ib2) + else + x1=0. + endif + if(x1.eq.x2) goto 9999 + if(abs(x1-x2)/abs(x1+x2).le.1e-7) goto 9999 + f=1.0 + if(ipst(ii).ne.ipst(jj))aa=aa+2.*(x2-x1)*(y2-y1)*f*pf(ii,jj) + if(ish.ge.6)write(ifch,*)'ii,jj,x1,x2,aa:',ii,jj + $ ,ipst(ii).ne.ipst(jj),x1,x2,aa + & ,pf(ii,jj) + if(ii.eq.ijb(1,ib2))then + weiter=.false. + else + ii=mmod(ii+1) + if(ii.eq.jj.or.mmod(ii+jj).eq.0)weiter=.false. + endif + enddo + Amaxn=Amaxn+aa + if(aa.gt.A)goto 10 + A=A-aa + if(jj.eq.ijb(2,ib2)) then + if(ish.ge.6)write(ifch,*) 'brk erreicht' + goto 15 + endif + 12 jj=mmod(jj-1) + enddo + goto 15 + + 10 continue + yb=A/aa*(y2-y1)+y1 + if(ish.ge.6)write(ifch,*)'jj,yb ok:',jj,yb + r=rangen() + ra=aa*r + if(ish.ge.6)write(ifch,*)'r,ra,aa',r,ra,aa + !nochmal die letzte ii-Schleife + if(ib1.eq.0)then !ohne linken brkpt + ii=mmod(jj+1) + if(jj.lt.nob/2)ii=mmod(nob-jj+1) + else + ii=ijb(1,ib1) + if(jj.lt.nob/2 .and. + $ mmod(nob-jj+1+nob/2).gt. mmod(ii+nob/2) + $ )ii=mmod(nob-jj+1) + endif + do while(ra.gt.0.) + if(ii.eq.ijb(1,ib1))then !linker brk im Feld (ii,jj) + x2=xyb(1,ib1) + else + x2=1. + endif + + if(ii.eq.ijb(1,ib2))then !rechter brk im Feld (ii,jj) + x1=xyb(1,ib2) + else + x1=0. + endif + f=1.0 + ab=0. + if(ipst(ii).ne.ipst(jj)) ab=2.*(x2-x1)*(y2-y1)*f*pf(ii,jj) + if(ish.ge.6)write(ifch,*)'ii,jj,x1,x2,ab,ra:',ii,jj + $ ,ipst(ii).ne.ipst(jj),x1,x2,ab,ra + if(ab.gt.ra)then + xb=ra/ab*(x2-x1)+x1 + else + ii=mmod(ii+1) + endif + ra=ra-ab + enddo + if(ish.ge.5)write(ifch,*) 'breakpoint in field ',ii,jj + & ,' at position ',xb,yb + goto 95 + +c...................................................................... + !von rechts + 51 if(ib2.eq.nbr+1)then !startwert der i-schleife + ii=nob/2-1 + else + ii=ijb(1,ib2) + endif + do while (ii.ne.nob/2) + if(ii.eq.ijb(1,ib1))then !linker brk im Streifen (ii) + x2=xyb(1,ib1) + else + x2=1. + endif + if(ii.eq.ijb(1,ib2))then !rechter brk im Streifen (ii) + x1=xyb(1,ib2) + else + x1=0. + endif + if(x1.eq.x2) goto 9999 + if(abs(x1-x2)/abs(x1+x2).le.1e-7) goto 9999 + if(ish.ge.6)write(ifch,*)'x1,x2 A',x1,x2,A + + if(ib2.eq.nbr+1)then + jj=mmod(ii+1) + if(ii.gt.nob/2)jj=mmod(nob-ii+1) + if(ib1.ge.1.and.jj.gt.ijb(2,ib1))then + if(ish.ge.6)write(ifch,*) 'very special case',ii,jj + goto 13 + endif + else + jj=ijb(2,ib2) + if(ii.gt.nob/2 .and. mmod(nob-ii+1).gt.jj)jj=mmod(nob-ii+1) + endif + weiter=.true. + aa=0. + if(ii.eq.jj) then + if(ish.ge.6)write(ifch,*) 'Rand erreicht' + goto 15 + endif + do while(weiter) + if(jj.eq.ijb(2,ib1))then !linker brk im Feld (ii,jj) + y1=xyb(2,ib1) + else + y1=0. + endif + if(jj.eq.ijb(2,ib2))then !rechter brk im Feld (ii,jj) + y2=xyb(2,ib2) + else + y2=1. + endif + if(y1.eq.y2) goto 9999 + if(abs(y1-y2)/abs(y1+y2).le.1e-7) goto 9999 + f=1.0 + if(ipst(ii).ne.ipst(jj))aa=aa+2.*(x2-x1)*(y2-y1)*f*pf(ii,jj) + if(ish.ge.6)write(ifch,*)'ii,jj,x1,x2,aa:',ii,jj + $ ,ipst(ii).ne.ipst(jj),x1,x2,aa + & ,pf(ii,jj) + if(jj.eq.ijb(2,ib1))then + weiter=.false. + else + jj=mmod(jj+1) + if(jj.eq.ii.or.mmod(ii+jj).eq.0)weiter=.false. + endif + enddo + Amaxn=Amaxn+aa + if(aa.gt.A)goto 14 + A=A-aa + if(ii.eq.ijb(1,ib1)) then + if(ish.ge.6)write(ifch,*) 'brk erreicht' + goto 15 + endif + 13 ii=mmod(ii-1) + enddo + goto 15 + + + + 14 continue + xb=A/aa*(x2-x1)+x1 + if(ish.ge.6)write(ifch,*)'ii,xb ok:',ii,xb + r=rangen() + ra=aa*r + if(ish.ge.6)write(ifch,*)'r,ra,aa',r,ra,aa + !nochmal die letzte jj-Schleife + if(ib2.eq.nbr+1)then + jj=mmod(ii+1) + if(ii.gt.nob/2)jj=mmod(nob-ii+1) + else + jj=ijb(2,ib2) + if(ii.gt.nob/2 .and. mmod(nob-ii+1).gt.jj)jj=mmod(nob-ii+1) + endif + + do while(ra.gt.0.) + if(jj.eq.ijb(2,ib1))then !linker brk im Feld (ii,jj) + y1=xyb(2,ib1) + else + y1=0. + endif + + if(jj.eq.ijb(2,ib2))then !rechter brk im Feld (ii,jj) + y2=xyb(2,ib2) + else + y2=1. + endif + f=1.0 + ab=0. + if(ipst(ii).ne.ipst(jj)) ab=2.*(x2-x1)*(y2-y1)*f*pf(ii,jj) + if(ish.ge.6)write(ifch,*)'ii,jj,x1,x2,ab,ra:',ii,jj + $ ,ipst(ii).ne.ipst(jj),x1,x2,ab,ra + if(ab.gt.ra)then + yb=ra/ab*(y2-y1)+y1 + else + jj=mmod(jj+1) + endif + ra=ra-ab + enddo + if(ish.ge.5)write(ifch,*) 'breakpoint in field ',ii,jj + & ,' at position ',xb,yb + + 95 continue + +c.....breakpoint accepted...................... + nbr=nbr+1 + if(nbr.gt.mxnbr-2) stop 'gaksbp: increase parameter mxnbr' + do i=nbr+1,ib1+1,-1 + do j=1,2 + ijb(j,i)=ijb(j,i-1) + xyb(j,i)=xyb(j,i-1) + enddo + do k=1,4 + ptb(k,i)=ptb(k,i-1) + enddo + iflb(i)=iflb(i-1) + ip(i)=ip(i-1) + enddo + ip(ib1+1)=0 + ip(ib1+2)=0 + ijb(1,ib1+1)=ii + ijb(2,ib1+1)=jj + xyb(1,ib1+1)=xb + xyb(2,ib1+1)=yb + + +cc ..........diquark............................................... +c +c +c pdiqu=pdiqua +c if(kzrm.eq.1.or.krm.eq.0)then +cc pdiqu=exp(log(pdiqua)/sqrt(1.+fkainc*(zzzz-1.))) +cc pdiqu=exp(log(pdiqua)/(1.+fkainc*(zzzz-1.))) +c endif +cc if(iappl.eq.1.and.krm.eq.0)then +cc pdiqu=pdiquak +cc endif +c +c +c if(nbr.le.2.and.abs(psg(3)/psg(4)).gt.diqcut)pdiqu=0. +c +c +c +c if(rangen().lt.pdiqu.and.iabs(iflb(ib1)).lt.6 +c & .and.iabs(iflb(ib2)).lt.6)then +c jqu=2 +c else +c jqu=1 +c endif +c + +c ..........flavor............................................... + + ig=1 + if(iLHC.eq.1)then + if(jorptl(ipst(ii)).eq.-9)ig=ig+1 + if(jorptl(ipst(jj)).eq.-9)ig=ig+1 + endif + + pu=pui(ig) + pd=pdi(ig) + ps=psi(ig) + pc=pci(ig) + pduu=pduui(ig) + pdud=pdudi(ig) + pdus=pdusi(ig) + pduc=pduci(ig) + pddd=pdddi(ig) + pdds=pddsi(ig) + pddc=pddci(ig) + pdss=pdssi(ig) + pdsc=pdsci(ig) + pdcc=pdcci(ig) + + +! print *,pu,pd,ps,pc,difud,difus,difuc +c print *,krm,kdrm,nbr,abs(psg(3)/psg(4)) + +c suppress forward (proj) or backward (targ) diquark production +c in non central strings (baryon spectra in pion collisions or NA49 data) +c ----> this should not be used for meson projectile because of kaon spectra +c at 100 GeV (Barton, etc) <-------- +c if(kdrm.eq.1.and.ib1.le.1.and.abs(psg(3)/psg(4)).gt.strcut)then +c ps=0. +c pc=0. +c endif + + if(iLHC.eq.1)then +c kill baryon production in case of high pt or forward production + if((ib1.le.1.or.ib2.ge.nbr-1) + & .and.sqrt(psg(1)**2+psg(2)**2+psg(3)**2)/psg(4).gt.diqcut)then + pduu=0. + pdud=0. + pdus=0. + pduc=0. + pddd=0. + pdds=0. + pddc=0. + pdss=0. + pdsc=0. + pdcc=0. + endif + else +c suppress forward (proj) or backward (targ) diquark production +c in non central strings (baryon spectra in pion collisions or NA49 data) + if(kdrm.eq.1.and.ib1.le.1.and.abs(psg(3)/psg(4)).gt.diqcut)then + pduu=0. + pdud=0. + pdus=0. + pduc=0. + pddd=0. + pdds=0. + pddc=0. + pdss=0. + pdsc=0. + pdcc=0. + endif + endif + + + + pdiqu=pduu+pdud+pdus+pduc+pddd+pdds+pddc+pdss+pdsc+pdcc + psum=pu+pd+ps+pc+pdiqu +c print *,krm,kdrm,kky,zzzz,ps/(pu+pd+ps),pdiqu/psum + + r=rangen()*psum + jqu=1 + ifl2=0 + if(r.gt.psum-pdiqu)then + jqu=2 + if(r.gt.pu+pd+ps+pc+pduu+pdud+pdus+pduc+pddd+pdds+pddc+pdss+pdsc + & .and.pdcc.gt.0.)then + ifl1=4 + ifl2=4 + elseif(r.gt.pu+pd+ps+pc+pduu+pdud+pdus+pduc+pddd+pdds+pddc+pdss + & .and.pdsc.gt.0.)then + if(rangen().gt.0.5)then + ifl1=3 + ifl2=4 + else + ifl1=4 + ifl2=3 + endif + elseif(r.gt.pu+pd+ps+pc+pduu+pdud+pdus+pduc+pddd+pdds+pddc + & .and.pdss.gt.0.)then + ifl1=3 + ifl2=3 + elseif(r.gt.pu+pd+ps+pc+pduu+pdud+pdus+pduc+pddd+pdds + & .and.pddc.gt.0.)then + if(rangen().gt.0.5)then + ifl1=2 + ifl2=4 + else + ifl1=4 + ifl2=2 + endif + elseif(r.gt.pu+pd+ps+pc+pduu+pdud+pdus+pduc+pddd + & .and.pdds.gt.0.)then + if(rangen().gt.0.5)then + ifl1=2 + ifl2=3 + else + ifl1=3 + ifl2=2 + endif + elseif(r.gt.pu+pd+ps+pc+pduu+pdud+pdus+pduc.and.pddd.gt.0.)then + ifl1=2 + ifl2=2 + jqu=2 + elseif(r.gt.pu+pd+ps+pc+pduu+pdud+pdus.and.pduc.gt.0.)then + if(rangen().gt.0.5)then + ifl1=1 + ifl2=4 + else + ifl1=4 + ifl2=1 + endif + elseif(r.gt.pu+pd+ps+pc+pduu+pdud.and.pdus.gt.0.)then + if(rangen().gt.0.5)then + ifl1=1 + ifl2=3 + else + ifl1=3 + ifl2=1 + endif + elseif(r.gt.pu+pd+ps+pc+pduu.and.pdud.gt.0.)then + if(rangen().gt.0.5)then + ifl1=1 + ifl2=2 + else + ifl1=2 + ifl2=1 + endif + else + ifl1=1 + ifl2=1 + endif + elseif(r.gt.pu+pd+ps.and.pc.gt.0.)then + ifl1=4 + elseif(r.gt.pu+pd.and.ps.gt.0.)then + ifl1=3 + elseif(r.gt.pu.and.pd.gt.0.)then + ifl1=2 + else + ifl1=1 + endif + + if(jqu.eq.2)then !diquark ------ + ifl=-min(ifl1,ifl2)*1000-max(ifl1,ifl2)*100 + else !quark ------ + ifl=ifl1 + endif + + if(iflb(ib1).lt.0.and.iflb(ib1).ge.-6)ifl=-ifl + if(iflb(ib1).gt.1000)ifl=-ifl + iflb(ib1+1)=ifl + if(ish.ge.5)write(ifch,20) ig,ifl,pu,pd,ps,pc,pdiqu/psum + &,sqrt(psg(1)**2+psg(2)**2+psg(3)**2)/psg(4).gt.diqcut + &,pduu,pdud,pdus,pduc,pddd,pdds,pddc,pdss,pdsc,pdcc + 20 format('ig,flavor,pu,pd,ps,pc,pdiqu,dcut:',i2,i6,5g13.5,l2/ + &,' diquark u:',4g15.5,/,' diquark d:',3g15.5,/ + &,' diquark s:',2g15.5,10x,'diquark c:',g15.5) +c..............................pt....................................... +c if(krm.ne.1.and.kdrm.ne.1)then +c icub=ib1+1 +c !--------------------------------------------------------------------------- +c ! ib1+1 is the current break point index +c ! (between 1 and nbr) +c ! ijb(1,ib1) and ijb(2,ib1) are band indices +c ! each index from 0 to nob-1 (nob= number of bands) +c ! 0 is left, then come the gluons, then antiquark, then agin gluons +c ! like q - g - g - g - ~q - g - g - g +c !-------------------------------------------------------------------------- +c call gaksco(icub-1,icub,icub+1 +c & ,ijb(1,icub),ijb(2,icub),x1,x2,y1,y2) +c x=xyb(1,icub) +c y=xyb(2,icub) +c aml2=co(1)+x*co(2)+y*co(3)+x*y*co(4) +c amr2=co(5)+x*co(6)+y*co(7)+x*y*co(8) +c aml=sign(sqrt(abs(aml2)),aml2) +c amr=sign(sqrt(abs(amr2)),amr2) +c !------segment left of current breakpoint icub ----- +c pleft(5)=aml +c do j=1,4 +c pleft(j)=pst(j,nob+1)-x*pst(j,nob+2)+y*pst(j,nob+3) +c enddo +c call utlob4(-1,psg(1),psg(2),psg(3),psg(4),psg(5) +c $ ,pleft(1),pleft(2),pleft(3),pleft(4)) +c !------segment right of current breakpoint icub----- +c pright(5)=amr +c do j=1,4 +c pright(j)=pst(j,nob+4)+x*pst(j,nob+5)-y*pst(j,nob+6) +c enddo +c call utlob4(-1,psg(1),psg(2),psg(3),psg(4),psg(5) +c $ ,pright(1),pright(2),pright(3),pright(4)) +c !------------------------- +c amt=pleft(5)**2+pleft(1)**2+pleft(2)**2 +c if(amt.gt.0..and.pleft(4)+abs(pleft(3)).gt.0.d0)then +c amt=sqrt(amt) +c yleft=sign(1.,pleft(3))*alog((pleft(4)+abs(pleft(3)))/amt) +c else +c yleft=0. ! +c endif +c amt=pright(5)**2+pright(1)**2+pright(2)**2 +c if(amt.gt.0..and.pright(4)+abs(pright(3)).gt.0.d0)then +c amt=sqrt(amt) +c yright=sign(1.,pright(3))*alog((pright(4)+abs(pright(3)))/amt) +c else +c yright=0. ! +c endif +c ybrk=(yleft+yright)/2. +c yhax=2 !0.5*yhaha +c zzipx=1 +c if(ybrk.gt.yhax)then +c zzipx=zzipx+(zzipp-1) +c elseif(ybrk.gt.-yhax)then +c zzipx=zzipx+(zzipp-1)*(ybrk+yhax)/(2*yhax) +c endif +c if(ybrk.lt.-yhax)then +c zzipx=zzipx+(zzipt-1) +c elseif(ybrk.lt.yhax)then +c zzipx=zzipx+(zzipt-1)*(yhax-ybrk)/(2*yhax) +c endif +c endif + delptfra=0. +c if(ifl1.eq.3.and.ifl2.eq.0)delptfra=delptfra+ptfrasr +c if(ifl1.eq.3.or.ifl2.eq.3)delptfra=delptfra+ptfrasr + fnsbp=1 + if(nsbp.gt.9)fnsbp=0 +c pt kink due to split elastic scattering (if zzzz.ne.1.) + if(iLHC.eq.1)then + pttra=(ptfra+delptfra)*(zzzz-1.)*fnsbp + if(ig.ge.0)then !quark and soft strings +c if(ig.eq.1)then !quark and soft strings +c if(krm.eq.0)then !quark and soft strings + pt=ranpt()*(ptfra + pttra)!/float(jqu) + else + pt=ranpt()*(ptfraqq + pttra)!/float(jqu) + endif + else + pttra=(ptfra+delptfra)*(zzzz-1.)*fnsbp + if(jqu.eq.1)then + pt=ranpt()*(ptfra + pttra) + else + pt=ranpt()*(ptfraqq + pttra) + pt=pt*0.5 + endif + endif + + beta=2.*pi*rangen() + + if(ish.ge.5)then + write(ifch,*) 'pt:',pt + endif + ptb(1,ib1+1)=pt*cos(beta) + ptb(2,ib1+1)=pt*sin(beta) + ptb(3,ib1+1)=0. + ptb(4,ib1+1)=0. + if(ish.ge.8)then + write(ifch,*) 'the bands' + write(ifch,'(4g12.6)') (pst(i,ii),i=1,4) + write(ifch,'(4g12.6)') (pst(i,jj),i=1,4) + write(ifch,*) 'pt before rotation' + write(ifch,'(4f12.8)') (ptb(i,ib1+1),i=1,4) + endif + ax=dble(pst(1,ii))+dble(pst(1,jj)) + ay=dble(pst(2,ii))+dble(pst(2,jj)) + az=dble(pst(3,ii))+dble(pst(3,jj)) + ae=dble(pst(4,ii))+dble(pst(4,jj)) + am=sqrt(max(1d-10,(ae+az)*(ae-az)-ax**2-ay**2)) !????????? + if(ish.ge.8)then + write(ifch,*) 'boost vector ( region ) ' + write(ifch,'(5g12.6)') ax,ay,az,ae,am,pf(ii,jj) + endif + bx=pst(1,ii) + by=pst(2,ii) + bz=pst(3,ii) + be=pst(4,ii) + call utlob2(1,ax,ay,az,ae,am,bx,by,bz,be,60) + if(ish.ge.8) then + write (ifch,*) 'boost of b' + write (ifch,*) 'bx,by,bz,be',bx,by,bz,be + endif + if(abs(bx)+abs(by)+abs(bz).gt.0.)then + call utrot4(-1,bx,by,bz,ptb(1,ib1+1),ptb(2,ib1+1),ptb(3,ib1+1)) + else + write(ifmt,*) 'null rot of pt',bx,by,bz + write(ifmt,'(4f12.8)') (ptb(i,ib1+1),i=1,4) + endif + if(ish.ge.8) then + write (ifch,*) 'rot of pt' + write(ifch,'(4f12.8)') (ptb(i,ib1+1),i=1,4) + endif + + call utlob4(-1,ax,ay,az,ae,am + & ,ptb(1,ib1+1),ptb(2,ib1+1),ptb(3,ib1+1),ptb(4,ib1+1)) + + if(ish.ge.8) then + write (ifch,*) 'backboost of pt' + write(ifch,'(4f12.8)') (ptb(i,ib1+1),i=1,4) + endif +c if(az.eq.0..and.ay.eq.0.)az=1e-8 !not needed if following line commented +c if(ish.ge.8)write(ifch,*)'rot vector:',ax,ay,az,ae,am + +c.....call utrota(-1,sngl(ax),sngl(ay),sngl(az) !already commented in nexus2 +c....& ,ptb(1,ib1+1),ptb(2,ib1+1),ptb(3,ib1+1)) + + if(ish.ge.6)then + write(ifch,*) 'pt' + write(ifch,'(4g12.6)') (ptb(i,ib1+1),i=1,4) + write (ifch,*) ijb(1,ib1+1),ijb(2,ib1+1),xyb(1,ib1+1) + $ ,xyb(2,ib1+1) + endif + + if(iside.eq.1)then + ib1=ib1+1 + ib2=ib2+1 + endif + + +c Amin=0. +c if(Amax.lt.Amxx) goto 15 +c goto 25 + + 15 continue + if(ish.ge.6)write(ifch,*) 'Amax:',Amax,Amaxn + if (nbr.eq.nbrold) then + Amax=Amaxn + Amin=0. + if(pb*Amax.le.0..or.ntry.ge.1000)then + goto 9999 + endif + goto 26 + endif + + if(ish.ge.6)then + write(ifch,*) 0,iflb(0) + do i=1,nbr + if(i.eq.ib2) write(ifch,*) '.................' + write(ifch,'(i3,2x,2(i3),2(" ",g14.7),3x,i5,4(" ",g12.6))') + & i,ijb(1,i),ijb(2,i),xyb(1,i),xyb(2,i) + & ,iflb(i),(ptb(j,i),j=1,4) + if(i.eq.ibr1) write(ifch,*) '.................' + enddo + write(ifch,*) nbr+1,iflb(nbr+1) + endif + + 9999 if(nbr.eq.nbrold)iok=1 + call utprix('gaksbp',ish,ishini,5) + return + end + +c---------------------------------------------------------------------- + function ranptcut(xcut) +c---------------------------------------------------------------------- +c .........exp(-x**2) +c if(xcut.gt.0.)then +c x=sqrt(-(log(rangen()))/(3.1415927/4.)/xcut) !gauss +c else +c x=sqrt(-(log(rangen()))/(3.1415927/4.)) !gauss +c endif + 12 x=sqrt(-(log(rangen()))/(3.1415927/4.)) !gauss + + + if(xcut.gt.0.)then + if(rangen().lt.x/xcut)goto 12 + endif + + ranptcut=x + + return + +c .........exp(-x) +c 12 xmx=50 +c r=2. +c do while (r.gt.1.) +c 11 x=sqrt(exp(rangen()*log(1+xmx**2))-1) +c if(x.eq.0.)goto11 +c r=rangen() / ( exp(-x)*(1+x**2) ) +c enddo +c x=x/2. + + end + +cc---------------------------------------------------------------------- +c function ranpticut(xcut) +cc---------------------------------------------------------------------- +c +cc .........exp(-x) +c +c 12 xmx=50 +c r=2. +c do while (r.gt.1.) +c 11 x=sqrt(exp(rangen()*log(1+xmx**2))-1) +c if(x.eq.0.)goto11 +c r=rangen() / ( exp(-x)*(1+x**2) ) +c enddo +c x=x/2. +c if(rangen().gt.xcut/x)goto 12 +c +c ranpticut=x +c +c end + +c---------------------------------------------------------------------- + function ranpt() +c---------------------------------------------------------------------- + +c .........exp(-x) + xmx=50 + r=2. + do while (r.gt.1.) + 11 x=sqrt(exp(rangen()*log(1+xmx**2))-1) + if(x.eq.0.)goto11 + r=rangen() / ( exp(-x)*(1+x**2) ) + enddo + ranpte=x/2. + +c ------------- + ranpt=ranpte + return +c ------------- +cc .........exp(-x**2) +c ranptg=sqrt(-log(rangen())/(3.1415927/4.)) !gauss +c +cc .........exp(-sqrt(x)) +c xmx=500 +c r=2. +c do while (r.gt.1.) +c x=sqrt(exp(rangen()*log(1+xmx**2))-1) +c r=rangen() / ( exp(-sqrt(x))*(1+x**2)/5. ) +c enddo +c ranpts=x/20. +c + + end +c---------------------------------------------------------------------- + function ranptk() +c---------------------------------------------------------------------- + +c .........exp(-x) + xmx=50 + r=2. + do while (r.gt.1.) + 11 x=sqrt(exp(rangen()*log(1+xmx**2))-1) + if(x.eq.0.)goto11 + r=rangen() / ( exp(-x)*(1+x**2) ) + enddo + ranpte=x/2. + +c ------------- + ranptk=ranpte + return +c ------------- +c +cc .........exp(-x**2) +c ranptg=sqrt(-log(rangen())/(3.1415927/4.)) !gauss +c +cc .........exp(-sqrt(x)) +c xmx=500 +c r=2. +c do while (r.gt.1.) +c x=sqrt(exp(rangen()*log(1+xmx**2))-1) +c r=rangen() / ( exp(-sqrt(x))*(1+x**2)/5. ) +c enddo +c ranpts=x/20. + + end + +c---------------------------------------------------------------------- + function ranptd() +c---------------------------------------------------------------------- + +c .........exp(-x**2) + ranptg=sqrt(-log(rangen())/(3.1415927/4.)) !gauss + + +c ------------- + ranptd=ranptg + return +c ------------- +c +cc .........exp(-x) +c xmx=50 +c r=2. +c do while (r.gt.1.) +c 11 x=sqrt(exp(rangen()*log(1+xmx**2))-1) +c if(x.eq.0.)goto11 +c r=rangen() / ( exp(-x)*(1+x**2) ) +c enddo +c ranpte=x/2. +c +cc .........exp(-sqrt(x)) +c xmx=500 +c r=2. +c do while (r.gt.1.) +c x=sqrt(exp(rangen()*log(1+xmx**2))-1) +c r=rangen() / ( exp(-sqrt(x))*(1+x**2)/5. ) +c enddo +c ranpts=x/20. + + + + + + end +c---------------------------------------------------------------------- + subroutine gakdel(ibr) +c---------------------------------------------------------------------- + parameter (mxnbr=500,mxnba=5000) + common /gag/nob,pst(4,0:mxnba),ipst(0:mxnba) + $ ,nbr,ijb(2,0:mxnbr),xyb(2,0:mxnbr) + & ,ptb(4,0:mxnbr),iflb(0:mxnbr),ip(0:mxnbr),co,x,y + dimension co(12) + + do i=ibr,nbr+1 + do j=1,2 + ijb(j,i)=ijb(j,i+1) + xyb(j,i)=xyb(j,i+1) + enddo + do k=1,4 + ptb(k,i)=ptb(k,i+1) + enddo + iflb(i)=iflb(i+1) + ip(i)=ip(i+1) + enddo + ip(ibr)=0 + nbr=nbr-1 + end + +c---------------------------------------------------------------------- + subroutine gaksco(ibr1,ibr,ibr2,ib,jb,x1,x2,y1,y2) +c---------------------------------------------------------------------- + include 'epos.inc' + + parameter (mxnbr=500,mxnba=5000) + common /gag/nob,pst(4,0:mxnba),ipst(0:mxnba) + $ ,nbr,ijb(2,0:mxnbr),xyb(2,0:mxnbr) + & ,ptb(4,0:mxnbr),iflb(0:mxnbr),ip(0:mxnbr),co,x,y + dimension co(12) + logical weiter + + pf(i,j)=pst(4,i)*pst(4,j)-pst(3,i)*pst(3,j) + & -pst(2,i)*pst(2,j)-pst(1,i)*pst(1,j) + mmod(i)=mod(mod(i,nob)+nob,nob) + + call utpri('gaksco',ish,ishini,8) + + if(ish.ge.8)then + write(ifch,*) 'zwischen brk:',ibr1,ibr,ibr2,'(',nob,')',nbr + write(ifch,*) 'region:',ib,jb + endif + if(ib.eq.ijb(1,ibr1))then + x2=xyb(1,ibr1) + else + x2=1. + endif + if(ib.eq.ijb(1,ibr2))then + x1=xyb(1,ibr2) + else + x1=0. + endif + if(jb.eq.ijb(2,ibr1))then + y1=xyb(2,ibr1) + else + y1=0. + endif + if(jb.eq.ijb(2,ibr2))then + y2=xyb(2,ibr2) + else + y2=1. + endif + +c.....left side................................................... + n=nob+1 + if(ish.ge.8)write(ifch,*)'x1,x2',x1,x2 + do i=1,4 +cc pst(i,n)=(x2-x1)*pst(i,ib)+ptb(i,ibr)-ptb(i,ibr1) + pst(i,n)= x2*pst(i,ib)+ptb(i,ibr)-ptb(i,ibr1)-y1*pst(i,jb) + enddo + if(ish.ge.8)write(ifch,*) 'add a 1 ii',1.,ib + ii=mmod(ib-1) + weiter=.true. + if(ib.eq.ijb(1,ibr1))weiter=.false. + do while(ii.ne.jb.and.weiter) !linker Rand?? + f1=1. + if(ii.eq.ijb(1,ibr1))f1=xyb(1,ibr1) + do i=1,4 + pst(i,n)=pst(i,n)+f1*pst(i,ii) + enddo + if(ish.ge.8)write(ifch,*) 'add a f1 ii',f1,ii + if(ii.eq.ijb(1,ibr1))weiter=.false. + ii=mmod(ii-1) + enddo + jj=mmod(jb+1) + weiter=.not.weiter + if(jb.eq.ijb(2,ibr1))weiter=.false. + do while(weiter) + f1=1. + if(jj.eq.ijb(2,ibr1))f1=1.-xyb(2,ibr1) + do i=1,4 + pst(i,n)=pst(i,n)+f1*pst(i,jj) + enddo + if(ish.ge.8)write(ifch,*) 'add b f1 ii',f1,jj + if(jj.eq.ijb(2,ibr1))weiter=.false. + jj=mmod(jj+1) + enddo + do i=1,4 +cc pst(i,n+1)=(x2-x1)*pst(i,ib) + pst(i,n+1)= pst(i,ib) +cc pst(i,n+2)=(y2-y1)*pst(i,jb) + pst(i,n+2)= pst(i,jb) + enddo + co(1)= pf(n,n) + co(2)=-2.*pf(n,n+1) + co(3)= 2.*pf(n,n+2) + co(4)=-2.*pf(n+1,n+2) + if(ish.ge.8) then + do i=n,n+2 + write (ifch,'(4g12.5)') (pst(j,i),j=1,4) + enddo + endif + if(ish.ge.8)write(ifch,*) 'co left:',co(1),co(2),co(3),co(4) + +c.....right side................................................... + n=nob+4 + if(ish.ge.8)write(ifch,*)'y1,y2',y1,y2 + do i=1,4 +cc pst(i,n)=(y2-y1)*pst(i,jb)-ptb(i,ibr)+ptb(i,ibr2) + pst(i,n)= y2*pst(i,jb)-ptb(i,ibr)+ptb(i,ibr2)-x1*pst(i,ib) + enddo + if(ish.ge.8)write(ifch,*) 'add a 1 jj',1.,jb + ii=mmod(ib+1) + weiter=.true. + if(ib.eq.ijb(1,ibr2))weiter=.false. + do while(ii.ne.jb.and.weiter) + f1=1. + if(ii.eq.ijb(1,ibr2))f1=1.-xyb(1,ibr2) + do i=1,4 + pst(i,n)=pst(i,n)+f1*pst(i,ii) + enddo + if(ish.ge.8)write(ifch,*) 'add a f1 ii',f1,ii + if(ii.eq.ijb(1,ibr2))weiter=.false. + ii=mmod(ii+1) + enddo + jj=mmod(jb-1) + weiter=.not.weiter + if(jb.eq.ijb(2,ibr2))weiter=.false. + do while(weiter) + f1=1. + if(jj.eq.ijb(2,ibr2))f1=xyb(2,ibr2) + do i=1,4 + pst(i,n)=pst(i,n)+f1*pst(i,jj) + enddo + if(ish.ge.8)write(ifch,*) 'add b f1 ii',f1,jj + if(jj.eq.ijb(2,ibr2))weiter=.false. + jj=mmod(jj-1) + enddo + do i=1,4 +cc pst(i,n+1)=(x2-x1)*pst(i,ib) + pst(i,n+1)= pst(i,ib) +cc pst(i,n+2)=(y2-y1)*pst(i,jb) + pst(i,n+2)= pst(i,jb) + enddo + co(5)=pf(n,n) + co(6)= 2.*pf(n,n+1) + co(7)=-2.*pf(n,n+2) + co(8)=-2.*pf(n+1,n+2) + if(ish.ge.8) then + do i=n,n+2 + write (ifch,'(4g12.5)') (pst(j,i),j=1,4) + enddo + endif + if(ish.ge.8)write(ifch,*) 'co right:',co(5),co(6),co(7),co(8) + +c.....lambda (absolute past)..................................... + n=nob+7 + do i=1,4 +cc pst(i,n)= x1*pst(i,ib)+y1*pst(i,jb) + pst(i,n)= 0. + enddo + ii=mmod(ib+1) + do while (mmod(ii+jb).ne.0) + if(ish.ge.8)write(ifch,*) 'add lambda',ii + do i=1,4 + pst(i,n)=pst(i,n)+pst(i,ii) + enddo + ii=mmod(ii+1) + enddo + do i=1,4 +cc pst(i,n+1)=(x2-x1)*pst(i,ib) +cc pst(i,n+2)=(y2-y1)*pst(i,jb) + pst(i,n+1)= pst(i,ib) + pst(i,n+2)= pst(i,jb) + enddo + co(9)= pf(n,n) + co(10)= 2.*pf(n,n+1) + co(11)= 2.*pf(n,n+2) + co(12)= 2.*pf(n+1,n+2) + if(ish.ge.8)write(ifch,*)'co lambda:',co(9),co(10),co(11),co(12) + call utprix('gaksco',ish,ishini,8) + end + +c--------------------------------------------------------------------- + subroutine gakanp(ibr1,ibr,ibrr2,aml2,amr2,ala2,iok) +c--------------------------------------------------------------------- +c mass adjustment of fragments +c ibr1-ibr ibr-ibrr2 +c where ibr1,ibr,ibrr2 are break point indices +c aml2,amr2 are the reqired squared masses (if zero -> any mass) +c iok=0 (ok) or ok=1 (error) +c--------------------------------------------------------------------- + include 'epos.inc' + parameter (mxnbr=500,mxnba=5000,mxnin=2000) + common /gag/nob,pst(4,0:mxnba),ipst(0:mxnba) + $ ,nbr,ijb(2,0:mxnbr),xyb(2,0:mxnbr) + & ,ptb(4,0:mxnbr),iflb(0:mxnbr),ip(0:mxnbr),co,x,y + double precision ax,ay,az,ae,am,bx,by,bz,be,A,B,C + dimension co(12),am2(0:2),nin(2,0:mxnin) + logical weiter +c pf(i,j)=pst(4,i)*pst(4,j)-pst(3,i)*pst(3,j) +c & -pst(2,i)*pst(2,j)-pst(1,i)*pst(1,j) + mmod(i)=mod(mod(i,nob)+nob,nob) + call utpri('gakanp',ish,ishini,6) + + ibr2=ibrr2 + if(ish.ge.6)write(ifch,*) ibr1,ibr,ibr2,aml2,amr2,ala2,iok + iok=0 + ib=ijb(1,ibr) + jb=ijb(2,ibr) + ni=0 + 10 do i=1,ni + if((nin(1,i).eq.ib.and.nin(2,i).eq.jb) + $ .or.(ipst(ib).eq.ipst(jb)))then + iok=1 + if(ish.ge.4)then + write(ifch,*) 'error ... endless loop' + if(ib.eq.ipst(jb)) write(ifch,*) ' in zero mass region' + endif + goto 9999 + endif + enddo + ni=ni+1 + if(ni.gt.mxnin)stop'gakanp: increase parameter mxnin ' + nin(1,ni)=ib + nin(2,ni)=jb + if(ish.ge.6)write(ifch,*) + if(ish.ge.6)write(ifch,*) 'ib,jb=',ib,jb + if(ni.ge.2)then + if(ish.ge.6)write(ifch,*)'rotate pt to new band' + if(ish.ge.6)write(ifch,*)'from',nin(1,ni-1),nin(2,ni-1) + if(ish.ge.6)write(ifch,*)' to',ib,jb + if(ish.ge.6)write(ifch,'(4f12.8)') (ptb(i,ibr),i=1,4) + ax=pst(1,nin(1,ni-1))+pst(1,nin(2,ni-1)) + ay=pst(2,nin(1,ni-1))+pst(2,nin(2,ni-1)) + az=pst(3,nin(1,ni-1))+pst(3,nin(2,ni-1)) + ae=pst(4,nin(1,ni-1))+pst(4,nin(2,ni-1)) + am=sngl(sqrt(max(1d-8,dble(ae)**2-dble(ax)**2 + $ -dble(ay)**2-dble(az)**2))) !??????????????????????? + bx=pst(1,nin(1,ni-1)) + by=pst(2,nin(1,ni-1)) + bz=pst(3,nin(1,ni-1)) + be=pst(4,nin(1,ni-1)) + if(ish.ge.6)write (ifch,*) 'bx,by,bz,be',bx,by,bz,be + call utlob2(1,ax,ay,az,ae,am,bx,by,bz,be,60) + if(ish.ge.6)write (ifch,*) 'bx,by,bz,be',bx,by,bz,be + call utlob4( 1,ax,ay,az,ae,am + & ,ptb(1,ibr),ptb(2,ibr),ptb(3,ibr),ptb(4,ibr)) + if(ish.ge.6)write(ifch,'(4f12.8)') (ptb(i,ibr),i=1,4) + if(abs(bx)+abs(by)+abs(bz).gt.0.)then + call utrot4( 1,bx,by,bz,ptb(1,ibr),ptb(2,ibr),ptb(3,ibr)) + else + write(ifmt,*) 'null rot of pt (2)',bx,by,bz + write(ifmt,'(4f12.8)') (ptb(i,ibr),i=1,4) + endif + if(ish.ge.6)write(ifch,'(4f12.8)') (ptb(i,ibr),i=1,4) + ax=pst(1,ib)+pst(1,jb) + ay=pst(2,ib)+pst(2,jb) + az=pst(3,ib)+pst(3,jb) + ae=pst(4,ib)+pst(4,jb) + am=sngl(sqrt(max(1d-8,dble(ae)**2-dble(ax)**2 + $ -dble(ay)**2-dble(az)**2))) !??????????????????????? + if(am.le.1.1e-4)then + if(ish.ge.5)write(ifch,*)'error ... am<1.1e-4' + iok=1 + goto 9999 + endif + bx=pst(1,ib) + by=pst(2,ib) + bz=pst(3,ib) + be=pst(4,ib) + if(ish.ge.6)write (ifch,*) 'bx,by,bz,be',bx,by,bz,be + if(ish.ge.6)write (ifch,*) 'ax,ay,az,ae',ax,ay,az,ae,am + call utlob2(1,ax,ay,az,ae,am,bx,by,bz,be,60) + if(ish.ge.6)write (ifch,*) 'bx,by,bz,be',bx,by,bz,be + if(abs(bx)+abs(by)+abs(bz).gt.0.)then + call utrot4(-1,bx,by,bz,ptb(1,ibr),ptb(2,ibr),ptb(3,ibr)) + else + write(ifmt,*) 'null rot of pt (3)',bx,by,bz + write(ifmt,'(4f12.8)') (ptb(i,ibr),i=1,4) + endif + if(ish.ge.6)write(ifch,'(4f12.8)') (ptb(i,ibr),i=1,4) + call utlob4(-1,ax,ay,az,ae,am + & ,ptb(1,ibr),ptb(2,ibr),ptb(3,ibr),ptb(4,ibr)) + if(ish.ge.6)write(ifch,'(4f12.8)') (ptb(i,ibr),i=1,4) + endif + call gaksco(ibr1,ibr,ibr2,ib,jb,x1,x2,y1,y2) +c if(ni.eq.1)print *,'------------------------------------',2 +cc x=(xyb(1,ibr)-x1)/(x2-x1) +cc y=(xyb(2,ibr)-y1)/(y2-y1) + x=xyb(1,ibr) + y=xyb(2,ibr) + am2(0)=aml2 + am2(1)=amr2 + am2(2)=ala2 + if(ish.ge.6)write(ifch,*) ibr1,ibr,ibr2,aml2,amr2,ala2,iok + if(amr2.le.0.)then + l1=2 + l2=0 + elseif(aml2.le.0.)then + l1=1 + l2=2 + elseif(ala2.le.0.)then + l1=1 + l2=0 + else + stop' not like this , please...' + endif + if(ish.ge.6.and.amr2.le.0)write(ifch,*) 'adjust: 1',l1,l2 + if(ish.ge.6.and.aml2.le.0)write(ifch,*) 'adjust: 2' ,l1,l2 + if(ish.ge.6.and.ala2.le.0)write(ifch,*) 'adjust: 3',l1,l2 + i=4*l1 + j=4*l2 + A = dble(co(i+4))*dble(co(j+3)) - dble(co(j+4))*dble(co(i+3)) + B = dble(co(i+4))*dble(co(j+1)) - dble(co(i+3))*dble(co(j+2)) + & + dble(co(i+2))*dble(co(j+3)) - dble(co(i+1))*dble(co(j+4)) + & - dble(am2(l2))*dble(co(i+4)) + dble(am2(l1))*dble(co(j+4)) + C = dble(co(i+2))*dble(co(j+1)) - dble(co(i+1))*dble(co(j+2)) + & + dble(am2(l1))*dble(co(j+2)) - dble(am2(l2))*dble(co(i+2)) + if (ish.ge.7) then + write(ifch,*) 'ABC,q ',A,B,C,B**2-4.*A*C + if(abs(A).gt.0.d0)then + write(ifch,*) sqrt(max(0d0,B**2-4d0*A*C))/2d0/A-B/A/2d0 + write(ifch,*) -sqrt(max(0d0,B**2-4d0*A*C))/2d0/A-B/A/2d0 + endif + endif + x=0. + y=0. + xx=0. + yy=0. + if(abs(A).gt.1.d-20.and.B*B-4.*A*C.ge.0.d0)then + y=sngl(sqrt(max(0.d0,B**2-4.*A*C))/2.d0/A-B/A/2.d0) + if(abs(co(i+2)+y*co(i+4)).gt.0.) + & x=(am2(l1)-co(i+1)-y*co(i+3))/(co(i+2)+y*co(i+4)) + elseif(abs(A).le.1.d-20.and.abs(B).gt.0.d0)then + y=-sngl(C/B) + if(abs(co(i+2)+y*co(i+4)).gt.0.) + & x=(am2(l1)-co(i+1)-y*co(i+3))/(co(i+2)+y*co(i+4)) + else + if(ish.ge.5)write(ifch,*)'error ... no solution of quadr equ' + iok=1 + goto 9999 + endif + if(abs(A).gt.1.d-20.and.B**2-4.*A*C.ge.0.d0)then + yy=sngl(-sqrt(max(0.d0,B**2-4.*A*C))/2.d0/A-B/A/2.d0) + if(abs(co(i+2)+yy*co(i+4)).gt.0.) + & xx=(am2(l1)-co(i+1)-yy*co(i+3))/(co(i+2)+yy*co(i+4)) + elseif(abs(A).le.1.d-20.and.abs(B).gt.0.d0)then + yy=-sngl(C/B) + if(abs(co(i+2)+yy*co(i+4)).gt.0.) + & xx=(am2(l1)-co(i+1)-yy*co(i+3))/(co(i+2)+yy*co(i+4)) + else + if(ish.ge.5)write(ifch,*)'error ... no solution (2) ' + iok=1 + goto 9999 + endif + if(ish.ge.6)then + write(ifch,*) x ,y ,(co(i+2)+ y*co(i+4)),' OK ' + write(ifch,*) xx,yy,(co(i+2)+yy*co(i+4)),' OK ' + endif + weiter=.true. + 50 if(x.gt.x1.and.x.lt.x2.and.y.gt.y1.and.y.lt.y2)then +cc xyb(1,ibr)=x1+(x2-x1)*x +cc xyb(2,ibr)=y1+(y2-y1)*y + xyb(1,ibr)=x + xyb(2,ibr)=y + ijb(1,ibr)=ib + ijb(2,ibr)=jb + e1=pst(4,nob+1)-x*pst(4,nob+2)+y*pst(4,nob+3) + e2=pst(4,nob+4)+x*pst(4,nob+5)-y*pst(4,nob+6) + if( e1.lt.0. .or. e2.lt.0. ) then + if(ish.ge.5)write(ifch,*)'error ... e1<0 or e2<0' + iok=1 + goto 9999 + endif + !amal2=co(1)+co(2)*x+co(3)*y+co(4)*x*y + !amar2=co(5)+co(6)*x+co(7)*y+co(8)*x*y + if(ish.ge.6)then + amal2=co(1)+co(2)*x+co(3)*y+co(4)*x*y + amar2=co(5)+co(6)*x+co(7)*y+co(8)*x*y + write(ifch,*) 'brkshift:',xyb(1,ibr),xyb(2,ibr),ib,jb + write (ifch,*)'E:',e1 + write (ifch,*)'E:',e2 + write(ifch,'(2(a6,1g12.6))') 'aml:' + & ,sqrt(max(0.,amal2)),'amr:',sqrt(max(0.,amar2)) + endif + i=ibr1+1 + do while(i.le.ibr-1) + if((mmod(ijb(1,i)+nob/2) .lt. mmod(ijb(1,ibr)+nob/2) + & .or.(mmod(ijb(1,i)+nob/2) .eq. mmod(ijb(1,ibr)+nob/2) + & .and.(xyb(1,i).gt.xyb(1,ibr)))) + & .and. + & (ijb(2,i) .gt. ijb(2,ibr) + & .or.(ijb(2,i) .eq. ijb(2,ibr) + & .and.xyb(2,i).lt.xyb(2,ibr)))) goto 150 + if(ish.ge.6) then + write(ifch,*) 'away:' + & ,i,xyb(1,i),xyb(2,i),ijb(1,i),ijb(2,i) + endif + call gakdel(i) + i=i-1 + ibr=ibr-1 + ibr2=ibr2-1 + 150 i=i+1 + enddo + i=ibr+1 + do while (i.le.ibr2-1) + if((mmod(ijb(1,i)+nob/2) .gt. mmod(ijb(1,ibr)+nob/2) + & .or.(mmod(ijb(1,i)+nob/2) .eq. mmod(ijb(1,ibr)+nob/2) + & .and.(xyb(1,i).lt.xyb(1,ibr)))) + & .and. + & (ijb(2,i) .lt. ijb(2,ibr) + & .or.(ijb(2,i) .eq. ijb(2,ibr) + & .and.xyb(2,i).gt.xyb(2,ibr)))) goto 160 + if(ish.ge.6) then + write(ifch,*) 'away:' + & ,i,xyb(1,i),xyb(2,i),ijb(1,i),ijb(2,i) + endif + call gakdel(i) + ibr2=ibr2-1 + i=i-1 + 160 i=i+1 + enddo + goto 9999 + else + if(x.gt.x2 + & .and.ib.ne.ijb(1,ibr1) !brk-begrenzung + & .and.mmod(ib-1).ne.jb !linker oder rechter Rand + & .and.mmod(ib-1+jb).ne.0)then !oben oder unten + ib=mmod(ib-1) + goto 10 + endif + if(x.lt.x1 + & .and.ib.ne.ijb(1,ibr2) !brk-begrenzung + & .and.mmod(ib+1).ne.jb !linker oder rechter Rand + & .and.mmod(ib+1+jb).ne.0)then !oben oder unten + ib=mmod(ib+1) + goto 10 + endif + if(y.gt.y2 + & .and.jb.ne.ijb(2,ibr2) !brk-begrenzung + & .and.mmod(jb-1).ne.ib !linker oder rechter Rand + & .and.mmod(jb-1+ib).ne.0)then !oben oder unten + jb=mmod(jb-1) + goto 10 + endif + if(y.lt.y1 + & .and.jb.ne.ijb(2,ibr1) !brk-begrenzung + & .and.mmod(jb+1).ne.ib !linker oder rechter Rand + & .and.mmod(jb+1+ib).ne.0)then !oben oder unten + jb=mmod(jb+1) + goto 10 + endif + if(weiter)then + weiter=.false. + x=xx + y=yy + goto 50 + endif + if(ish.ge.5)write(ifch,*)'error ... x,y not in allowed range' + iok=1 + endif + 9999 if(amr2.eq.0.) ibrr2=ibr2 + call utprix('gakanp',ish,ishini,6) + end + +cc---------------------------------------------------------------------- +c subroutine gakstr(ifl) +cc---------------------------------------------------------------------- +cc +cc calculates string-fragments by taking off pt of breakup +cc do with ifl=1 undo with ifl=-1 +cc +cc---------------------------------------------------------------------- +c include 'epos.inc' +c common /cpptr/ pptr(4,mxptl),ystr(mxptl) +c +c do i=1,nptl +c if(istptl(i).eq.29)then +c nk1=ifrptl(1,i) +c nk2=ifrptl(2,i) +c do j=nk1,nk2 +c if ((istptl(j).eq.0.or.istptl(j-1).eq.0).and.j.ne.nk1) then +c do k=1,4 +c pptl(k,j)=pptl(k,j)+pptr(k,j-1)*ifl +c enddo +c !write(ifch,*)"left side back to ",j,(pptr(k,j-1),k=1,4) +c endif +c if ((istptl(j).eq.0.or.istptl(j+1).eq.0).and.j.ne.nk2) then +c do k=1,4 +c pptl(k,j)=pptl(k,j)-pptr(k,j)*ifl +c enddo +c !write(ifch,*)"right side back to ",j,(-pptr(k,j),k=1,4) +c endif +c if(ifl.eq.-1.and.istptl(j).eq.0)then +c e=pptl(1,j)**2+pptl(2,j)**2+pptl(3,j)**2 +c & +pptl(5,j)**2 +c e=sqrt(e) +c !dif=abs(e-pptl(4,j)) +c !if(dif.gt.0.01.and.dif/e.gt.0.1)print*,j,e,pptl(4,j) +c pptl(4,j)=e +c endif +c enddo +c endif +c if(istptl(i).eq.0)then +c if ( ifl.eq.1 ) then +c ystr(i)=sign(1.,pptl(3,i))*alog((pptl(4,i)+abs(pptl(3,i))) +c * /sqrt(pptl(5,i)**2+pptl(1,i)**2+pptl(2,i)**2) ) +c endif +c endif +c enddo +c end + +c---------------------------------------------------------------------- + subroutine gakli2(nn1,nn2) +c---------------------------------------------------------------------- + + include 'epos.inc' + double precision pgampr,rgampr + common/cgampr/pgampr(5),rgampr(4) +c double precision db1,db2,db3,db4,db5 + character label*8,idlabl*8 +c db1=0d0 +c db2=0d0 +c db3=rgampr(4) +c db4=sqrt(rgampr(1)**2+rgampr(2)**2+rgampr(3)**2) +c db5=sqrt( db4**2-rgampr(4)**2) + n1=nn1 + n2=nn2 + if (n1.eq.0) n1=1 + if (n2.eq.0) n2=nptl + write (ifch,'(1a4,5a12,4a4,a10,2a4)') + &'no.','px','py','pz','E','m','ior','jor','if1','if2' + &,'id','ist','ity' + do i=n1,n2 + if (idptl(i).lt.10000)then + label=' ' + label=idlabl(idptl(i)) + else + label=' ' + endif + chrg=0. + if(iabs(idptl(i)).le.9999)call idchrg(idptl(i),chrg) + write (ifch,125) i,(pptl(j,i),j=1,5),iorptl(i),jorptl(i) + & ,ifrptl(1,i),ifrptl(2,i),idptl(i) + $ ,chrg !charge + & ,istptl(i),ityptl(i),label + enddo + 125 format (1i4,5g18.10,4i6,1i10 + $ ,1f5.2 !charge + $ ,2i4,' ',A8 +c $ ,7g12.4,i5 + $ ) + return + end + +c---------------------------------------------------------------------- +c subroutine gakli4 +cc---------------------------------------------------------------------- +c +c include 'epos.inc' +c parameter (mxnbr=500,mxnba=5000) +c common /gag/nob,pst(4,0:mxnba),ipst(0:mxnba) +c $ ,nbr,ijb(2,0:mxnbr),xyb(2,0:mxnbr) +c & ,ptb(4,0:mxnbr),iflb(0:mxnbr),ip(0:mxnbr),co,x,y +c dimension co(12) +c do i=0,nob-1 +c write (ifch,10) i,(pst(j,i),j=1,4) +c enddo +c 10 format(1i4,5g18.10) +c return +c end +c +cc---------------------------------------------------------------------- +c subroutine gakli3 +cc---------------------------------------------------------------------- +c +c include 'epos.inc' +c parameter (mxnbr=500,mxnba=5000) +c common /gag/nob,pst(4,0:mxnba),ipst(0:mxnba) +c $ ,nbr,ijb(2,0:mxnbr),xyb(2,0:mxnbr) +c & ,ptb(4,0:mxnbr),iflb(0:mxnbr),ip(0:mxnbr),co,x,y +c dimension co(12),p1(5),p2(5) +c +c write(ifch,*) 'particle list of string decay' +c do i=1,5 +c p1(i)=0. +c enddo +c do i=1,nbr+1 +c if(i.lt.nbr+1)then +c call gaksco(i-1,i,i+1,ijb(1,i),ijb(2,i),x1,x2,y1,y2) +c if(x2.gt.x1)then +ccc x=(xyb(1,i)-x1)/(x2-x1) +c x=xyb(1,i) +c else +c x=0. +c endif +c if(y2.gt.y1)then +ccc y=(xyb(2,i)-y1)/(y2-y1) +c y=xyb(2,i) +c else +c y=0. +c endif +c aml2=co(1)+x*co(2)+y*co(3)+x*y*co(4) +c amr2=co(5)+x*co(6)+y*co(7)+x*y*co(8) +c aml=sign(sqrt(abs(aml2)),aml2) +c amr=sign(sqrt(abs(amr2)),amr2) +c do j=1,4 +c p2(j)=pst(j,nob+1)-x*pst(j,nob+2)+y*pst(j,nob+3) +c p1(j)=p1(j)+p2(j) +c enddo +c p2(5)=aml +c else +c do j=1,4 +c p2(j)=pst(j,nob+4)+x*pst(j,nob+5)-y*pst(j,nob+6) +c p1(j)=p1(j)+p2(j) +c enddo +c p2(5)=amr +c endif +c write(ifch,'(2i4,i6,a,i5,i10,5g14.6)') i-1,i +c & ,-iflb(i-1),'==',iflb(i),ip(i) +c & ,(p2(j),j=1,5) +c enddo +c am2=p1(4)**2-p1(3)**2-p1(2)**2-p1(1)**2 +c p1(5)=sign(sqrt(abs(am2)),am2) +c write(ifch,'(12x,a60)') +c & '------------------------------------------------------------' +c write(ifch,'(14x,5g14.6)') (p1(j),j=1,5) +c write(ifch,*) +c +c end +c + +c--------------------------------------------------------------------- + subroutine idress(id,am,idr,iadj) +c--------------------------------------------------------------------- + include 'epos.inc' + call idres(id,am,idr,iadj) + if(idr.eq.0)then + return + endif + ids=max(mod(iabs(id)/100,10),mod(iabs(id)/10,10)) + if(iabs(idr).le.999) then +c write (ifch,*) ' ',id,idr,ids + if(ids.le.4)return !???? if the following is used, bad result + if(ids.le.2)then + idr=sign(iabs(id)+int(rangen()+0.5),id) + elseif(ids.eq.3)then + idr=sign(iabs(id)+int(rangen()+0.6),id) + else + idr=sign(iabs(id)+int(rangen()+0.75),id) + endif +c write (ifch,*) '->',id,idr + call idmass(idr,am) + elseif(iabs(idr).le.9999)then + if(ids.le.3)return + if(mod(iabs(idr),10).gt.1)then + if(iabs(id).ne.1111.and.iabs(id).ne.2221.and.iabs(id).ne.3331) + $ then + idr=sign(iabs(id)+1,id) + call idmass(idr,am) + else + idr=id + call idmass(idr,am) + endif + endif + endif + + end + + +c--------------------------------------------------------------------- + SUBROUTINE gaksphe(sphe,r,mstu41) + +C...Purpose: to perform sphericity tensor analysis to give sphericity, +C...aplanarity and the related event axes. stolen from jetset ;-) + include 'epos.inc' + dimension sphe(4,3) + DIMENSION SM(3,3),SV(3,3) + +C...Calculate matrix to be diagonalized. + NP=0 + JA=0 + JB=0 + JC=0 +c MSTU41=2 + DO 110 J1=1,3 + DO 100 J2=J1,3 + SM(J1,J2)=0. + 100 CONTINUE + 110 CONTINUE + PS=0. + DO 140 I=1,nptl + IF(istptl(i).ne.0) GOTO 140 + IF(MSTU41.GE.2) THEN + ida=iabs(idptl(i)) + IF(ida.EQ.0.OR.ida.EQ.11.OR.ida.EQ.13.OR.ida.EQ.15) GOTO 140 + IF(MSTU41.GE.3) then + call idchrg(idptl(i),chrg) + if (abs(chrg).le.0.1) goto 140 + endif + ENDIF + NP=NP+1 + PA=SQRT(pptl(1,i)**2+pptl(2,I)**2+pptl(3,i)**2) + PWT=1. + IF(ABS(r-2.).GT.0.001) PWT=MAX(1E-10,PA)**(r-2.) + DO 130 J1=1,3 + DO 120 J2=J1,3 + SM(J1,J2)=SM(J1,J2)+PWT*pptl(j1,i)*pptl(j2,i) + 120 CONTINUE + 130 CONTINUE + PS=PS+PWT*PA**2 + 140 CONTINUE + +C...Very low multiplicities (0 or 1) not considered. + IF(NP.LE.1) THEN + if(ish.ge.1)then + CALL utmsg('sphe ') + write(ifch,*) 'too few particles for analysis' + call utmsgf + endif + sphe(4,1)=-1. + RETURN + ENDIF + DO 160 J1=1,3 + DO 150 J2=J1,3 + SM(J1,J2)=SM(J1,J2)/PS + 150 CONTINUE + 160 CONTINUE + +C...Find eigenvalues to matrix (third degree equation). + SQ=(SM(1,1)*SM(2,2)+SM(1,1)*SM(3,3)+SM(2,2)*SM(3,3)-SM(1,2)**2- + & SM(1,3)**2-SM(2,3)**2)/3.-1./9. + SR=-0.5*(SQ+1./9.+SM(1,1)*SM(2,3)**2+SM(2,2)*SM(1,3)**2+SM(3,3)* + & SM(1,2)**2-SM(1,1)*SM(2,2)*SM(3,3)) + & +SM(1,2)*SM(1,3)*SM(2,3)+1./27. + SP=COS(ACOS(MAX(MIN(SR/SQRT(-SQ**3),1.),-1.))/3.) + sphe(4,1)=1./3.+SQRT(-SQ)*MAX(2.*SP,SQRT(3.*(1.-SP**2))-SP) + sphe(4,3)=1./3.+SQRT(-SQ)*MIN(2.*SP,-SQRT(3.*(1.-SP**2))-SP) + sphe(4,2)=1.-sphe(4,1)-sphe(4,3) + IF(sphe(4,2).LT.1E-5) THEN + if(ish.ge.1)then + CALL utmsg('gaksphe') + write(ifch,*) 'all particles back-to-back' + call utmsgf + endif + sphe(4,1)=-1. + RETURN + ENDIF + +C...Find first and last eigenvector by solving equation system. + DO 240 I=1,3,2 + DO 180 J1=1,3 + SV(J1,J1)=SM(J1,J1)-sphe(4,I) + DO 170 J2=J1+1,3 + SV(J1,J2)=SM(J1,J2) + SV(J2,J1)=SM(J1,J2) + 170 CONTINUE + 180 CONTINUE + SMAX=0. + DO 200 J1=1,3 + DO 190 J2=1,3 + IF(ABS(SV(J1,J2)).LE.SMAX) GOTO 190 + JA=J1 + JB=J2 + SMAX=ABS(SV(J1,J2)) + 190 CONTINUE + 200 CONTINUE + SMAX=0. + DO 220 J3=JA+1,JA+2 + J1=J3-3*((J3-1)/3) + RL=SV(J1,JB)/SV(JA,JB) + DO 210 J2=1,3 + SV(J1,J2)=SV(J1,J2)-RL*SV(JA,J2) + IF(ABS(SV(J1,J2)).LE.SMAX) GOTO 210 + JC=J1 + SMAX=ABS(SV(J1,J2)) + 210 CONTINUE + 220 CONTINUE + JB1=JB+1-3*(JB/3) + JB2=JB+2-3*((JB+1)/3) + sphe(JB1,I)=-SV(JC,JB2) + sphe(jb2,I)=SV(JC,JB1) + sphe(jb,I)=-(SV(JA,JB1)*sphe(jb1,I)+SV(JA,JB2) + & *sphe(jb2,I))/SV(JA,JB) + PA=SQRT(sphe(1,I)**2+sphe(2,I)**2+sphe(3,I)**2) + SGN=(-1.)**INT(rangen()+0.5) + DO 230 J=1,3 + sphe(j,I)=SGN*sphe(j,I)/PA + 230 CONTINUE + 240 CONTINUE + +C...Middle axis orthogonal to other two. Fill other codes. + SGN=(-1.)**INT(rangen()+0.5) + sphe(1,2)=SGN*(sphe(2,1)*sphe(3,3)-sphe(3,1)*sphe(2,3)) + sphe(2,2)=SGN*(sphe(3,1)*sphe(1,3)-sphe(1,1)*sphe(3,3)) + sphe(3,2)=SGN*(sphe(1,1)*sphe(2,3)-sphe(2,1)*sphe(1,3)) + + do i=1,3 + do j=1,4 + pptl(j,nptl+i)=sphe(j,i) + enddo + enddo + + +C...Calculate sphericity and aplanarity. Select storing option. +ccc SPH=1.5*(sphe(4,2)+sphe(4,3)) +ccc APL=1.5*sphe(4,3) + + RETURN + END + +C********************************************************************* + + SUBROUTINE gakthru(thru,mstu41) + +C...Purpose: to perform thrust analysis to give thrust, oblateness +C...and the related event axes. stolen from jetset ;-) + include 'epos.inc' + DIMENSION TDI(3),TPR(3) + dimension thru(4,3) + +C...Take copy of particles that are to be considered in thrust analysis. + IAGR=0 + NP=0 + PS=0. +c MSTU41=2 + MSTU44=4 + MSTU45=2 + PARU42=1.0 + PARU48=0.0000001 + DO 100 I=1,nptl + IF(istptl(i).ne.0)goto 100 + ida=iabs(idptl(i)) + IF(ida.EQ.0.OR.ida.EQ.11.OR.ida.EQ.13.OR.ida.EQ.15)GOTO 100 + IF(MSTU41.GE.3) then + call idchrg(idptl(i),chrg) + if (abs(chrg).le.0.1) goto 100 + endif + + IF(nptl+NP.GE.mxptl) THEN + CALL utstop('gakthru: no more memory left in cptl&') + thru(4,1)=-1. + RETURN + ENDIF + NP=NP+1 +c K(nptl+NP,1)=23 + pptl(1,nptl+NP)=pptl(1,I) + pptl(2,nptl+NP)=pptl(2,I) + pptl(3,nptl+NP)=pptl(3,I) + pptl(4,nptl+NP)=SQRT(pptl(1,I)**2+pptl(2,I)**2+pptl(3,I)**2) + pptl(5,nptl+NP)=1. + IF(ABS(PARU42-1.).GT.0.001) + & pptl(5,nptl+NP)=pptl(4,nptl+NP)**(PARU42-1.) + PS=PS+pptl(4,nptl+NP)*pptl(5,nptl+NP) + 100 CONTINUE + +C...Very low multiplicities (0 or 1) not considered. + IF(NP.LE.1) THEN + CALL utmsg('thru ') + write(ifch,*) 'too few particles for analysis' + call utmsgf + thru(4,1)=-1 + RETURN + ENDIF + +C...Loop over thrust and major. T axis along z direction in latter case. + DO 320 ILD=1,2 + IF(ILD.EQ.2) THEN +c PHI=GAKANG(pptl(1,nptl+NP+1),pptl(2,nptl+NP+1)) +c CALL lurot(nptl+1,nptl+NP+1,0.,-PHI) +c THE=GAKANG(pptl(3,nptl+NP+1),pptl(1,nptl+NP+1)) +c CALL lurot(nptl+1,nptl+NP+1,-THE,0.) + ax=pptl(1,nptl+NP+1) + ay=pptl(2,nptl+NP+1) + az=pptl(3,nptl+NP+1) + do irot=nptl+1,nptl+NP+1 + call utrota(1,ax,ay,az + & ,pptl(1,irot),pptl(2,irot),pptl(3,irot)) + enddo + if(np.eq.2)then + pptl(1,nptl+NP+2)=1. + pptl(2,nptl+NP+2)=0. + pptl(3,nptl+NP+2)=0. + pptl(4,nptl+NP+2)=0. + goto 325 + endif + ENDIF + +C...Find and order particles with highest p (pT for major). + DO 110 ILF=nptl+NP+4,nptl+NP+MSTU44+4 + pptl(4,ILF)=0. + 110 CONTINUE + DO 160 I=nptl+1,nptl+NP + IF(ILD.EQ.2) pptl(4,I)=SQRT(pptl(1,I)**2+pptl(2,I)**2) + DO 130 ILF=nptl+NP+MSTU44+3,nptl+NP+4,-1 + IF(pptl(4,I).LE.pptl(4,ILF)) GOTO 140 + DO 120 J=1,5 + pptl(j,ILF+1)=pptl(j,ILF) + 120 CONTINUE + 130 CONTINUE + ILF=nptl+NP+3 + 140 DO 150 J=1,5 + pptl(j,ILF+1)=pptl(j,I) + 150 CONTINUE + 160 CONTINUE + +C...Find and order initial axes with highest thrust (major). + DO 170 ILG=nptl+NP+MSTU44+5,nptl+NP+MSTU44+15 + pptl(4,ILG)=0. + 170 CONTINUE + NC=2**(MIN(MSTU44,NP)-1) + DO 250 ILC=1,NC + DO 180 J=1,3 + TDI(J)=0. + 180 CONTINUE + DO 200 ILF=1,MIN(MSTU44,NP) + SGN=pptl(5,nptl+NP+ILF+3) + IF(2**ILF*((ILC+2**(ILF-1)-1)/2**ILF).GE.ILC) SGN=-SGN + DO 190 J=1,4-ILD + TDI(J)=TDI(J)+SGN*pptl(j,nptl+NP+ILF+3) + 190 CONTINUE + 200 CONTINUE + TDS=TDI(1)**2+TDI(2)**2+TDI(3)**2 + DO 220 ILG=nptl+NP+MSTU44+MIN(ILC,10)+4,nptl+NP+MSTU44+5,-1 + IF(TDS.LE.pptl(4,ILG)) GOTO 230 + DO 210 J=1,4 + pptl(j,ILG+1)=pptl(j,ILG) + 210 CONTINUE + 220 CONTINUE + ILG=nptl+NP+MSTU44+4 + 230 DO 240 J=1,3 + pptl(j,ILG+1)=TDI(J) + 240 CONTINUE + pptl(4,ILG+1)=TDS + 250 CONTINUE + +C... Iterate direction of axis until stable maximum. + pptl(4,nptl+NP+ILD)=0. + ILG=0 + 260 ILG=ILG+1 + THP=0. + 270 THPS=THP + DO 280 J=1,3 + IF(THP.LE.1E-10) TDI(J)=pptl(j,nptl+NP+MSTU44+4+ILG) + IF(THP.GT.1E-10) TDI(J)=TPR(J) + TPR(J)=0. + 280 CONTINUE + DO 300 I=nptl+1,nptl+NP + SGN=SIGN(pptl(5,I),TDI(1)*pptl(1,I) + & +TDI(2)*pptl(2,I)+TDI(3)*pptl(3,I)) + DO 290 J=1,4-ILD + TPR(J)=TPR(J)+SGN*pptl(j,I) + 290 CONTINUE + 300 CONTINUE + THP=SQRT(TPR(1)**2+TPR(2)**2+TPR(3)**2)/PS + IF(THP.GE.THPS+PARU48) GOTO 270 + +C... Save good axis. Try new initial axis until a number of tries agree. + IF(THP.LT.pptl(4,nptl+NP+ILD)-PARU48.AND.ILG.LT.MIN(10,NC)) + & GOTO 260 + IF(THP.GT.pptl(4,nptl+NP+ILD)+PARU48) + $ THEN + IAGR=0 + SGN=(-1.)**INT(rangen()+0.5) + DO 310 J=1,3 + pptl(j,nptl+NP+ILD)=SGN*TPR(J)/(PS*THP) + 310 CONTINUE + pptl(4,nptl+NP+ILD)=THP + pptl(5,nptl+NP+ILD)=0. + ENDIF + IAGR=IAGR+1 + IF(IAGR.LT.MSTU45.AND.ILG.LT.MIN(10,NC)) GOTO 260 + 320 CONTINUE + +C... Find minor axis and value by orthogonality. + 325 SGN=(-1.)**INT(rangen()+0.5) + pptl(1,nptl+NP+3)=-SGN*pptl(2,nptl+NP+2) + pptl(2,nptl+NP+3)=SGN*pptl(1,nptl+NP+2) + pptl(3,nptl+NP+3)=0. + THP=0. + DO 330 I=nptl+1,nptl+NP + THP=THP+pptl(5,I)*ABS(pptl(1,nptl+NP+3)*pptl(1,I) + & +pptl(2,nptl+NP+3)*pptl(2,I)) + 330 CONTINUE + pptl(4,nptl+NP+3)=THP/PS + pptl(5,nptl+NP+3)=0. + + +C... Fill axis information. Rotate back to original coordinate system. + do irot=nptl+NP+1,nptl+NP+3 + call utrota(-1,ax,ay,az + & ,pptl(1,irot),pptl(2,irot),pptl(3,irot)) + enddo + + do ild=1,3 + do j=1,4 + thru(j,ild)=pptl(j,nptl+NP+ild) + enddo + enddo + +C...Calculate thrust and oblateness. Select storing option. +ccc THR=thru(4,1) +ccc OBL=thru(4,2)-thru(4,3) + + RETURN + END + + subroutine gakjet(ijadu) + include 'epos.inc' + common/njjjj/njets(5,2,mxbins) +c nmin=xpar1 +c nmax=xpar2 + if(nrevt.eq.1)then + do i=1,5 + do j=1,mxbins + njets(i,ijadu,j)=0 + enddo + enddo + endif + do i=1,nrbins + ycut=xminim*(xmaxim/xminim)**((float(i)-0.5)/nrbins) +c if(iologe.ne.1)ycut=xminim+(xmaxim-xminim)/nrbins*(nrbins) + nj=gaknjt(ycut,ijadu) + if(nj.ge.1.and.nj.le.5)then + njets(nj,ijadu,i)=njets(nj,ijadu,i)+1 + endif + enddo + end + + subroutine gakjto + include 'epos.inc' + common/njjjj/njets(5,2,mxbins) + n=xpar4 + ijadu=xpar3 + do i=1,nrbins + ycut=xminim*(xmaxim/xminim)**((float(i)-0.5)/nrbins) + write (ifhi,*) ycut,float(njets(n,ijadu,i))/nrevt + $ ,sqrt(1.*njets(n,ijadu,i))/nrevt + enddo + end +C********************************************************************* + function gaknjt(ycut,ijadu) +c +c ijadu 1 = JADE 2=DURHAM +c ycut - max. distance +c + include 'epos.inc' + + a2j(i,j)=2.*pptl(4,i)*pptl(4,j)*(1.-(pptl(1,i)*pptl(1,j) + & +pptl(2,i)*pptl(2,j)+pptl(3,i)*pptl(3,j)) + & /(sqrt(pptl(1,i)**2+pptl(2,i)**2+pptl(3,i)**2) + & *sqrt(pptl(1,j)**2+pptl(2,j)**2+pptl(3,j)**2)))/evis**2 + + a2d(i,j)=2.*min(pptl(4,i)**2,pptl(4,j)**2) + & *(1.-(pptl(1,i)*pptl(1,j) + & +pptl(2,i)*pptl(2,j)+pptl(3,i)*pptl(3,j)) + & /(sqrt(pptl(1,i)**2+pptl(2,i)**2+pptl(3,i)**2) + & *sqrt(pptl(1,j)**2+pptl(2,j)**2+pptl(3,j)**2)))/evis**2 + + bet(i)=sqrt(pptl(1,i)**2+pptl(2,i)**2+pptl(3,i)**2) + + ska(i,j)=pptl(1,i)*pptl(1,j)+pptl(2,i)*pptl(2,j) + & +pptl(3,i)*pptl(3,j) + + a2c(i,j)= ((bet(i)*bet(j)-ska(i,j)) + & *2.*bet(i)*bet(j) / (0.00001+bet(i)+bet(j))**2 ) + + evis=0. + nn=0 + do i=1,nptl + if (istptl(i).eq.0) then + nn=nn+1 + do j=1,5 + pptl(j,nptl+nn)=pptl(j,i) + enddo + evis=evis+pptl(4,i) + jorptl(i)=nn + endif + enddo + iflag=0 + i1=0 + j1=0 + do while (iflag.eq.0.and.nn.ge.2) + a2min=ycut + iflag=1 + do i=nptl+1,nptl+nn-1 + do j=i+1,nptl+nn + if(ijadu.eq.1)then + a2=a2j(i,j) + elseif(ijadu.eq.2) then + a2=a2d(i,j) + else + a2=a2c(i,j) + endif + if (a2.lt.a2min) then + iflag=0 + i1=i + j1=j + a2min=a2 + endif + enddo + enddo + if (iflag.eq.0) then + do i=1,4 + pptl(i,i1)=pptl(i,i1)+pptl(i,j1) + enddo + do i=1,nptl + if(istptl(i).eq.0.and.jorptl(i).eq.j1-nptl) + & jorptl(i)=i1-nptl + if(istptl(i).eq.0.and.jorptl(i)+nptl.gt.j1) + & jorptl(i)=jorptl(i)-1 + enddo + do i=j1,nptl+nn + do j=1,5 + pptl(j,i)=pptl(j,i+1) + enddo + enddo + nn=nn-1 + endif + enddo + do i=nptl+1,nptl+nn + istptl(i)=-1 + jorptl(i)=i-nptl + pptl(5,i)=sqrt(max(0.,(pptl(4,i)+pptl(3,i)) + & *(pptl(4,i)-pptl(3,i))-pptl(2,i)**2-pptl(1,i)**2)) + enddo + do i=nptl+1,nptl+nn-1 + do j=i+1,nptl+nn + if(pptl(4,jorptl(i)+nptl).lt.pptl(4,jorptl(j)+nptl))then + k=jorptl(i) + jorptl(i)=jorptl(j) + jorptl(j)=k + endif + enddo + enddo + do i=nptl+1,nptl+nn + idptl(nptl+jorptl(i))=9910+i-nptl + enddo + do i=1,nptl + jorptl(i)=0 !jorptl(nptl+jorptl(i)) + enddo +c nptl=nptl+nn + + gaknjt=nn + return + end + + subroutine idtr5(id,ic) + integer ic(2) + ic(1)=0 + ic(2)=0 + ii=1 + if(id.lt.0)ii=2 + i1=1 + if(iabs(id).gt.999)i1=3 + do i=i1,int(log(abs(float(id)))/log(10.))+1 + j=mod(iabs(id)/10**(i-1),10) + if(j.gt.0)then + ic(ii)=ic(ii)+10**(6-j) + endif + enddo + return + end + + function ammin(id1,id2) + dimension ic1(2),ic2(2),jc2(6,2),jc1(6,2) + call idtr5(id1,ic1) + call idtr5(id2,ic2) + call idcomk(ic1) + call idcomk(ic2) + call iddeco(ic1,jc1) + call iddeco(ic2,jc2) + ammin=utamnx(jc1,jc2) + end + + +c function idtr(id1,id2) +c integer ic(2),id(2) +c id(1)=id1 +c id(2)=id2 +c do i=1,2 +c ic(i)=0 +c enddo +c do j=1,2 +c ii=1 +c if(id(j).lt.0)ii=2 +c i1=1 +c if(iabs(id(j)).gt.999)i1=3 +c do i=i1,int(log(abs(float(id(j))))/log(10.))+1 +c jj=mod(iabs(id(j))/10**(i-1),10) +c if(jj.gt.0)then +c ic(ii)=ic(ii)+10**(6-jj) +c endif +c enddo +c enddo +c idtr=idtra(ic,0,0,3) +c if(idtr.ne.idsp(id1,id2))then +c write (*,'(4i6)') idtr,idsp(id1,id2),id1,id2 +c endif +c return +c end + + function idsp(id1,id2) + ia1=iabs(id1) + ia2=iabs(id2) + if(ia1.ge.1000.and.ia2.ge.1000)then + idsp=0 + isign=0 + elseif(ia1.le.1000.and.ia2.le.1000)then + idsp=min(ia1,ia2)*100+max(ia1,ia2)*10 + isign=1 + if(max(ia1,ia2).ne.-min(id1,id2)) isign = -1 + if(idsp.eq.220)idsp=110 + if(idsp.eq.330)idsp=220 + else + isign=1 + if(id1.lt.0.and.id2.lt.0)isign=-1 + idb=min(ia1,ia2) + if(idb.eq.5)then + idsp=0 + return + endif + ida=max(ia1,ia2) + ida1=ida/1000 + ida2=mod(ida/100,10) + if(idb.le.ida1)then + idsp=idb*1000+ida/10 + elseif(idb.le.ida2)then + idsp=ida1*1000+idb*100+ida2*10 + else + idsp=ida+idb*10 + endif + if(ida1.eq.ida2.and.ida2.eq.idb)idsp=idsp+1 + endif + idsp=idsp*isign + return + end + diff --git a/modules/epos/epos-hnb-lhc.f b/modules/epos/epos-hnb-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..659ec906c4575b071d8dfc7acdefa267b5249d39 --- /dev/null +++ b/modules/epos/epos-hnb-lhc.f @@ -0,0 +1,8697 @@ +c---------------------------------------------------------------------- + subroutine hnbaaa(ip,iret) !former hnbaaa156 from epos-yyy +c---------------------------------------------------------------------- +c microcanonical decay of cluster ip via loop over hnbmet +c---------------------------------------------------------------------- + include 'epos.inc' + common/cxyzt/xptl(mxptl),yptl(mxptl),zptl(mxptl),tptl(mxptl) + *,optl(mxptl),uptl(mxptl),sptl(mxptl),rptl(mxptl,3) + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + common/citer/iter,itermx + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat + common /cttaus/ tpro,zpro,ttar,ztar,ttaus,detap,detat + integer jc(nflav,2) + double precision p(5),c(5) + parameter(maxit=50000) + common/count/nacc,nrej,naccit(maxit),nptot,npit(maxit) + dimension be(4),pe(5),pa(5) + common/yradx/yrad(maxp),phirad(maxp) + common/xxxspecsy/ndrop(-4:4,-4:4,-4:4) + common/cdelzet/delzet,delsgr /cvocell/vocell + call utpri('hnbaaa',ish,ishini,4) + + + ntry=0 + 10 continue + ntry=ntry+1 + + if(ish.ge.3)then + write(ifch,140)sngl(ttaus) + 140 format(/' ----------------------------------'/ + *' droplet decay at tau =',f6.2/ + *' ----------------------------------') + write(ifch,*)'droplet:' + call alist('&',ip,ip) + endif + + iret=0 + do j=1,5 + c(j)=pptl(j,ip) + enddo + + call idquac(ip,nqi,nsi,nai,jc) + keu=jc(1,1)-jc(1,2) + ked=jc(2,1)-jc(2,2) + kes=jc(3,1)-jc(3,2) + kec=jc(4,1)-jc(4,2) + keb=jc(5,1)-jc(5,2) + ket=jc(6,1)-jc(6,2) +c write(ifch,*)'droplet uds=',keu,ked,kes,' E=',pptl(5,ip) + + !~~~~~redefine energy in case of radial flow + amin=utamnu(keu,ked,kes,kec,keb,ket,4) !utamnu(...,4) and not utamnu(...,5) + aumin=amuseg+yrmaxi !for rad and long flow + ipo=ip !could be too light after flow + if(ityptl(ip).eq.60)ipo=iorptl(ip) + tecmor=pptl(5,ipo) + if(iappl.eq.4.or.iorsdf.ne.3 + &.or.ityptl(ip).eq.40.or.ityptl(ip).eq.50)then !not for droplets from remnants + yrmax=0 + else + yrmax=yrmaxi + !aumin=amin + !if(yrmax.gt.0.2)print*,'===',tecmor,aamin,yrmax + endif + fradflo=1. + if(yrmax.gt.1e-2)fradflo=fradflii + tecm=pptl(5,ip) + if(tecm.lt.amin)then + iret=1 + if(ish.ge.4)write(ifch,*)'Decay skipped (M too low) !' + & ,tecm,amin + goto 1000 + endif + if(iappl.eq.4.or.iorsdf.ne.3 + &.or.ityptl(ip).eq.40.or.ityptl(ip).eq.50)then !not for droplets from remnants + yco=0 + else + if(ylongmx.lt.0.)then + yco=delzet !* 1.75 + else + yco=ylongmx + endif + endif + corrco=1. + if(yco.gt.0.)corrco=sinh(yco)/yco + + + tecmxx=tecm + if(iLHC.eq.1)then + corr=fradflo/corrco + if(tecm*corr.lt.amin.and.tecm.gt.0.)then + fradflo=min(1.,1.1*amin/tecm*corrco) !if flow too large, do something anyway (saturation of flow) + corr=fradflo/corrco + endif + else + if(tecm*fradflo.lt.amin.and.tecm.gt.0.)fradflo=1.1*amin/tecm !if flow too large, do something anyway (saturation of flow) + corr=fradflo + endif + if(yrmax.gt.1e-2.and.tecmor.gt.aumin + & .and.tecm*corr.ge.amin) then + ! redefine energy to account for collective flow + ! \int_0^yrmax f(y) d2y = E_new (effective mass) + ! \int_0^yrmax cosh(y) f(y) d2y = E_old + tecm=tecm*fradflo + if(tecm.lt.amin)stop'aaahnb: small mass. should not happen. ' + else + yrmax=0. + endif + !~~~~~redefine energy in case of long coll flow +! MANDATORY if RAD FLOW USED BECAUSE IT SMOOTH THE ETA DISTRIBUTION +! because of the grid structure for the cluster, fluctuations in eta +! appears if there is no smearing with long flow ! + tecmx=tecm +c if(yco.gt.0..and.tecmor.gt.aumin) then + if(yco.gt.0) then + if(iLHC.eq.1.and.tecm.ge.aumin)then + tecm=tecm/corrco + do while(tecm.lt.amin) + yco=yco*0.5 + corrco=sinh(yco)/yco + tecm=tecmx/corrco + enddo + else + tecm=tecm/corrco + if(tecm.lt.aumin)then !security to avoid minimum mass + tecm=tecmx + yco=0. + endif + endif + else + yco=0. + endif + if(ish.ge.4)write(ifch,*)'===== cluster energy: ' + & ,pptl(5,ip),tecmx,tecm,amin,aumin + & ,delzet,yrmax,yco,ityptl(ip) + + !~~~~~~~~~define volume~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ + + volu=tecm/epscri(1) + + !~~~~~~~~~decay~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ + call hnbini(iret) + !if(iret.ne.0)write(ifch,*)'***** unsucessfull hnbini *****' + if(iret.ne.0)goto 1000 + if(ioinct.ge.1)goto 1 + + do iter=1,itermx + naccit(iter)=0 + call hnbmet + enddo + +1 continue + + if(ioceau.eq.1.and.iappl.eq.1)call xhnbte(ip) + + !~~~~~~~~~~long coll flow -> particles~~~~~~~~~~~~~~~~ + tecmxxx=tecm + if(yco.gt.0.) then + errlim=0.0001 + tecm=tecmx + niter=0 + 611 energ=0. + niter=niter+1 + do i=1,np + yrad(i)=(2*rangen()-1)*yco + be(3)=sinh(yrad(i)) + be(4)=cosh(yrad(i)) + energ=energ+be(4)*pcm(4,i)-be(3)*pcm(3,i) + enddo + if(abs(energ-tecm).gt.0.1.and.niter.lt.1000)then + goto 611 + elseif(niter.ge.1000)then + if(ish.ge.1)write(ifch,*)'Long Flow failed:' + & ,energ,tecm + yco=0 + tecm=tecmxxx + goto 400 + endif + !print*,'===== energy after flow boosts',energ,' soll: ',tecm + do j=1,4 + pe(j)=0. + enddo + do i=1,np + be(1)= 0 + be(2)= 0 + be(3)= sinh(yrad(i)) + be(4)= cosh(yrad(i)) + call utlob3(1,be(1),be(2),be(3),be(4),1e0 + * , pcm(1,i), pcm(2,i), pcm(3,i), pcm(4,i)) + do j=1,4 + pe(j)=pe(j)+pcm(j,i) + enddo + enddo + pe(5)=sqrt(pe(4)**2-pe(3)**2-pe(2)**2-pe(1)**2) + !write(6,'(a,5e11.3)')'flow boosts',pe + do j=1,4 + pa(j)=0. + enddo + do i=1,np + call utlob3(1,pe(1),pe(2),pe(3),pe(4),pe(5) + * , pcm(1,i), pcm(2,i), pcm(3,i), pcm(4,i)) + do j=1,4 + pa(j)=pa(j)+pcm(j,i) + enddo + enddo + pa(5)=sqrt(pa(4)**2-pa(3)**2-pa(2)**2-pa(1)**2) + !write(6,'(a,5e11.3)')' cms boost ',pa + esoll=tecm + scal=1. + do ipass=1,200 + sum=0. + do j=1,np + do k=1,3 + pcm(k,j)=scal*pcm(k,j) + enddo + pcm(4,j)=sqrt(pcm(1,j)**2+pcm(2,j)**2+pcm(3,j)**2 + * +amass(j)**2) + sum=sum+pcm(4,j) + enddo + scal=esoll/sum + !write(6,*)'ipass,scal,e,esoll:' + ! $ ,ipass,scal,sum,esoll + if(abs(scal-1.).le.errlim) goto301 + enddo + 301 continue + do j=1,4 + pa(j)=0. + enddo + do i=1,np + do j=1,4 + pa(j)=pa(j)+pcm(j,i) + enddo + enddo + pa(5)=sqrt(pa(4)**2-pa(3)**2-pa(2)**2-pa(1)**2) + !write(6,'(a,5e11.3)')' rescaling ',pa + endif + + 400 continue + !~~~~~~~~~~radial flow -> particles~~~~~~~~~~~~~~~~~~ + if(yrmax.gt.0.) then + fecc=0 + aa=1 + bb=0 + cc=0 + dd=1 + if(ityptl(ip).eq.60)then + ipo=iorptl(ip) + xx=uptl(ipo) ! <x**2> + yy=optl(ipo) ! <y**2> + xy=desptl(ipo) ! <x*y> + dta=0.5*abs(xx-yy) + ev1=(xx+yy)/2+sqrt(dta**2+xy**2) + ev2=(xx+yy)/2-sqrt(dta**2+xy**2) + if(xy.lt.0..and.dta.ne.0.)then + theta=0.5*atan(-xy/dta) + elseif(xy.gt.0..and.dta.ne.0.)then + theta=-0.5*atan(xy/dta) + else + theta=0 + endif +c if(dta.ne.0.)then +c theta=0.5*atan(abs(xy)/abs(dta)) +c if( xy.gt.0..and.dta.gt.0.)then +c theta=theta +c elseif(xy.lt.0..and.dta.gt.0.)then +c theta=-theta +c elseif(xy.gt.0..and.dta.lt.0.)then +c theta=pi-theta +c elseif(xy.lt.0..and.dta.lt.0.)then +c theta=theta-pi +c endif +c else +c theta=2.*pi*rangen() +c endif + !eccx=(yy-xx)/(yy+xx) + yy=ev1 + xx=ev2 + ecc=(yy-xx)/(yy+xx) +c print*,'AA',ecc,theta + if(iLHC.eq.1)then + fecc=min(facecc,ecc) !be careful : fecc change <pt> since it is the elliptical deformation of the sub cluster(give strength of v2) + else + fecc=facecc*ecc + fecc=min(0.3,fecc) !be careful : fecc change <pt> since it is the + endif + phiclu=mod(phievt+theta,2.*pi) !do not change otherwise v2 is gone + if(phiclu.lt.-pi)phiclu=phiclu+2*pi + if(phiclu.gt.pi)phiclu=phiclu-2*pi + aa=cos(phiclu) + bb=sin(phiclu) + cc=-sin(phiclu) + dd=cos(phiclu) + endif + errlim=0.0001 + tecm=tecmxx + niter=0 + 610 energ=0. + niter=niter+1 + do i=1,np + yrad(i)=sqrt(rangen()) + phirad(i)=2.*pi*rangen() + pt2=0. + if(iLHC.eq.1)pt2=(pcm(1,i)**2+pcm(2,i)**2) !+amass(i)**2) + bex=dsinh(dble(yrad(i)*yrmax))*cos(phirad(i)) + * *(1+fecc/(1.+pt2)) + bey=dsinh(dble(yrad(i)*yrmax))*sin(phirad(i)) + * *(1-fecc/(1.+pt2)) + be(1)=aa*bex+cc*bey + be(2)=bb*bex+dd*bey + be(3)=-0d0 + be(4)=sqrt(1+be(1)**2+be(2)**2) + bp=0d0 + do k=1,3 + bp=bp+pcm(k,i)*be(k) + enddo + en=be(4)*pcm(4,i)+bp + energ=energ+en +c bp=sqrt(pcm(1,i)**2+pcm(2,i)**2)**yradpp +cc bp=sqrt(amass(i)**2+pcm(1,i)**2+pcm(2,i)**2)**yradpp +c be(1)=pcm(1,i)-bp*(aa*bex+cc*bey) +c be(2)=pcm(2,i)-bp*(bb*bex+dd*bey) +c be(4)=sqrt(be(1)**2+be(2)**2+pcm(3,i)**2 +c * +amass(i)**2) +c en=be(4) +c energ=energ+en + enddo + if(abs(energ-tecm).gt.0.1.and.niter.lt.1000)then + goto 610 + elseif(niter.ge.1000)then + if(ish.ge.1)write(ifch,*)'Radial Flow failed:' + & ,yrmax,energ,tecm,np + iret=1 + if(ish.ge.1)write(ifch,*)'Decay skipped !' + goto 1000 +c goto 300 + endif + energ=0. + do i=1,np + pt2=0. + if(iLHC.eq.1)pt2=(pcm(1,i)**2+pcm(2,i)**2)!+amass(i)**2) + bex=dsinh(dble(yrad(i)*yrmax))*cos(phirad(i)) + * *(1+fecc/(1.+pt2)) + bey=dsinh(dble(yrad(i)*yrmax))*sin(phirad(i)) + * *(1-fecc/(1.+pt2)) + be(1)=aa*bex+cc*bey + be(2)=bb*bex+dd*bey + be(3)=0d0 + be(4)=sqrt(1+be(1)**2+be(2)**2) + call utlob3(1,be(1),be(2),be(3),be(4),1e0 + * , pcm(1,i), pcm(2,i), pcm(3,i), pcm(4,i)) +c bp=sqrt(pcm(1,i)**2+pcm(2,i)**2)**yradpp +cc bp=sqrt(amass(i)**2+pcm(1,i)**2+pcm(2,i)**2) +c pcm(1,i)=pcm(1,i)-bp*(aa*bex+cc*bey) +c pcm(2,i)=pcm(2,i)-bp*(bb*bex+dd*bey) +c pcm(4,i)=sqrt(pcm(1,i)**2+pcm(2,i)**2+pcm(3,i)**2 +c * +amass(i)**2) + energ=energ+pcm(4,i) + enddo + esoll=tecm + scal=1. + do ipass=1,200 + sum=0. + do j=1,np + do k=1,3 + pcm(k,j)=scal*pcm(k,j) + enddo + pcm(4,j)=sqrt(pcm(1,j)**2+pcm(2,j)**2+pcm(3,j)**2 + * +amass(j)**2) + sum=sum+pcm(4,j) + enddo + scal=esoll/sum +c write(6,*)'ipass,scal,e,esoll:' +c $ ,ipass,scal,sum,esoll + if(abs(scal-1.).le.errlim) goto300 + enddo + 300 continue + else + do n=1,np + yrad(n)=0. + phirad(n)=0. + enddo + endif + !~~~~~~~~~~~~~~~ + + nptlb=nptl + do n=1,np + nptl=nptl+1 + if(nptl.gt.mxptl)call utstop('hnbptl: mxptl too small&') + idptl(nptl)=ident(n) + do j=1,4 + p(j)=pcm(j,n) + enddo + p(5)=amass(n) + call utlob2(-1,c(1),c(2),c(3),c(4),c(5),p(1),p(2),p(3),p(4),10) + do j=1,5 + pptl(j,nptl)=p(j) + enddo + if(tecmor.gt.aumin)then + ityptl(nptl)=60 + elseif(ityptl(ip).eq.40.or.ityptl(ip).eq.50)then + ityptl(nptl)=ityptl(ip)+1 + else + ityptl(nptl)=19 + endif + ipo=iorptl(ip) + iorptl(nptl)=ip + jorptl(nptl)=ipo +c protection against very high momentum particle (it can happen very very boosted cluster (which do no really make sense anyway)) + if(iLHC.eq.1.and.p(4).ge.0.5*engy)then + if(ish.ge.4)call alist('&',nptlb+1,nptl) + nptl=nptlb + iret=1 + if(ish.ge.4)write(ifch,*)'Decay skipped (p4 too high) !', ntry + if(ntry.lt.10)goto 10 + goto 1000 + endif + if(ityptl(ip).eq.60)then + if(ityptl(nptl).eq.60)then + xx=uptl(ipo) ! <x**2> + yy=optl(ipo) ! <y**2> + rini=sqrt(5./3.*(xx+yy)) !<r**2>=3/5*R**2 for sphere of radius R + r=1.15*rini*yrad(n) !yrad=y/ymax + tau=2.25/sqrt(yrad(n)**2+0.04)-0.75 + z=xorptl(3,ipo) + t=xorptl(4,ipo) + !zeta=0.5*log((t+z)/(t-z))-0.5*delzet+2*0.5*delzet*rangen() + zeta=0.5*log((p(4)+p(3))/(p(4)-p(3))) + z=tau*sinh(zeta) + t=tau*cosh(zeta) + xorptl(1,nptl)=xorptl(1,ipo)+r*cos(phirad(n)) + xorptl(2,nptl)=xorptl(2,ipo)+r*sin(phirad(n)) + xorptl(3,nptl)=z + xorptl(4,nptl)=t + else + xorptl(1,nptl)=xorptl(1,ip) + xorptl(2,nptl)=xorptl(2,ip) + xorptl(3,nptl)=xorptl(3,ip) + xorptl(4,nptl)=xorptl(4,ip) + endif + endif + enddo + + if(ish.ge.4)then + write(ifch,*)'decay products:' + call alist('&',nptlb+1,nptl) + if(ish.ge.5)then + write(ifch,*)'momentum sum:' + do kk=1,5 + pptl(kk,nptl+1)=0 + do ii=nptlb+1,nptl + pptl(kk,nptl+1)=pptl(kk,nptl+1)+pptl(kk,ii) + enddo + pptl(kk,nptl+2)=c(kk) + enddo + call alist('&',nptl+1,nptl+2) + endif + endif + + 1000 continue + call utprix('hnbaaa',ish,ishini,4) + return + end + + +c#################################################################################### +c#################################################################################### +c#################################################################################### +c#################################################################################### +c#################################################################################### +c######### ######### +c######### hnb and hgc routines ######### +c######### ######### +c#################################################################################### +c#################################################################################### +c#################################################################################### +c#################################################################################### +c#################################################################################### + + +c----------------------------------------------------------------------- + subroutine hgcaaa +c----------------------------------------------------------------------- +c hadronic resonance gas in grand canonical treatment +c returns T, chemical potentials and hadronic yield +c (hadron chemical potentials as combinations of quark chemical potentials) +c +c input: +c iostat: 1: Boltzmann approximation, 0: quantum statistics /metr3/ +c tecm: droplet energy /confg/ +c volu: droplet volume /confg/ +c keu ked kes kec keb ket: net flavor number /drop5/ +c +c output: +c tem : temperature [GeV] /cgchg/ +c chem(1:nflav): quark chem. pot. [GeV] /cflav/ +c chemgc(1:nspecs): hadron chem. pot. [GeV] /cgchg/ +c ptlngc(1:nspecs): hadron number /cgchg/ +c rmsngc(1:nspecs): standard deviation of hadron number /cgchg/ +c +c exact treatment (iostat=0): +c for massive hadrons : first in Boltzmann approximation with analytical +c expressions for particle and energy densities, +c then by using quantum statistics in integral form, +c extracting mu and T using numerical integration +c and an iterative procedure to solve for mu, T +c for massless hadrons : using analytic expressions for massles particles +c and employing the same algorithm as for massive +c----------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cbol/rmsbol(mspecs),ptlbol(mspecs),chebol(mspecs),tembol + common/cflavs/nflavs,kef(nflav),chem(nflav) + common/ciakt/gen,iafs,ians,genm + common/cnrit/nrit + gen=10.0**(-epsgc) + genm=gen/10. + + isho=ish + if(ishsub/100.eq.51)ish=mod(ishsub,100) + + iug=(1+iospec)/2*2-1 + + +c initialization +c -------------- + kef(1)=keu + kef(2)=ked + kef(3)=kes + kef(4)=kec + kef(5)=keb + kef(6)=ket + + if(iug.eq.1)nflavs=1 + if(iug.eq.3)nflavs=2 + if(iug.eq.5)nflavs=2 + if(iug.eq.7)nflavs=3 + if(iug.eq.9)nflavs=3 + if(iug.eq.11)nflavs=3 + tem=0.0 + do i=1,nflavs + chem(i)=0.0 + enddo + call hgchac(0) + do i=1,nspecs + ptlngc(i)=0.0 + rmsngc(i)=0.0 + enddo + nrit=0 + + if(ish.ge.5)then + write(ifch,*)('-',l=1,10) + *,' entry sr hgcaaa ',('-',l=1,30) + write(ifch,'(1x,a,2x,3i3)') + *'>>> grand canonical hadron gas for droplet with u d s content:' + *,keu,ked,kes + write(ifch,'(1x,a,2x,f7.3,2x,a,2x,f7.3)') + *'mass [GeV]:',tecm,'volume [fm^3]:',volu + endif + + if(iug.eq.1.and.keu.ne.0.and.ish.ge.5)then + write(ifch,*)'inversion impossible !!!' + write(ifch,*)'keu=0 required for this option' + write(ifch,*)'T = mu(i) = 0 returned' + if(ish.ge.5)write(ifch,*)('-',i=1,30) + *,' exit sr hgcaaa ',('-',i=1,10) + return + endif + if(iug.eq.3.and.(keu+ked).ne.0.and.ish.ge.5)then + write(ifch,*)'inversion impossible !!!' + write(ifch,*)'keu+ked=0 required for this option' + write(ifch,*)'T = mu(i) = 0 returned' + if(ish.ge.5)write(ifch,*)('-',i=1,30) + *,' exit sr hgcaaa ',('-',i=1,10) + return + endif + kf=keu+ked+kes+kec+keb+ket + kf=abs(kf) + if(kf.ne.0)then + if(mod(kf,3).ne.0.and.ish.ge.5)then + write(ifch,*)'inversion impossible !!!' + write(ifch,*)'sum must be multiple of three' + write(ifch,*)'T = mu(i) = 0 returned' + if(ish.ge.5)write(ifch,*)('-',i=1,30) + *,' exit sr hgcaaa ',('-',i=1,10) + return + endif + endif + + +c initial T (m=0, baryon free) +c ------------------------------- + gfac=0.0 + + if(iostat.eq.0.and.iospec.eq.iug)then + do i=1,nspecs + igsp=int(gspecs(i)) + if(mod(igsp,2).eq.0)then + gfac=gfac+7.*gspecs(i)/8. + else + gfac=gfac+gspecs(i) + endif + enddo + if(iabs(ispecs(nspecs)).lt.10)gfac=gfac+16. + tem=(tecm/volu*hquer**3*30./pi**2/gfac)**.25 + else + do i=1,nspecs + gfac=gfac+gspecs(i) + enddo + if(iabs(ispecs(nspecs)).lt.10)gfac=gfac+16. + tem=(tecm/volu*hquer**3*pi**2/gfac/3.)**.25 + tem=2.*tem + endif + + if(ish.ge.5)write(ifch,1)'initial T :',tem +1 format(1x,a,3x,f9.6) + + if(ish.ge.5)write(ifch,*)'iospec: ',iospec + + if(ish.ge.5.and.iospec.ne.iug)then + write(ifch,*)'inversion in Boltzmann approx. :' + elseif(ish.ge.5.and.iospec.eq.iug)then + write(ifch,*)'inversion for massless hadrons :' + endif + + if(ish.ge.5)then + if(nflavs.eq.1)write(ifch,'(3x,a,8x,a)') + *'T:','chemu:' + if(nflavs.eq.2)write(ifch,'(3x,a,8x,a,5x,a)') + *'T:','chemu:','chemd:' + if(nflavs.eq.3)write(ifch,'(3x,a,8x,a,5x,a,5x,a)') + *'T:','chemu:','chemd:','chems:' + endif + + k=1 +10 continue + if(ish.ge.9.and.mod(k,10).eq.0) + *write(ifch,*)'hgc iteration:',k + if(ish.ge.9)call hgccch(1) + +c search for temperature (chem=const) +c ----------------------------------- + idt=0 + temo=tem + + if(iospec.eq.iug)then + +c massless particles +c ------------------ + if(iostat.eq.0)then + if(ish.ge.9) + *write(ifch,*)'iteration (massless):',k + call hgctm0 + elseif(iostat.eq.1)then + if(ish.ge.9) + *write(ifch,*)'iteration (Boltzmann, massless):',k + call hgctbo(ibna) + if(ibna.eq.1)then + tem=temo + goto20 + endif + endif + + else + +c Boltzmann approxiamtion (massive particles) +c ------------------------------------------- + if(ish.ge.9) + *write(ifch,*)'iteration (Boltzmann, massive):',k + call hgctbo(ibna) + if(ibna.eq.1)then + tem=temo + goto20 + endif + + endif + + if(tem.le.1.e-6.and.ish.ge.5)then + write(ifch,*)'inversion imposssible' + write(ifch,*)'T:',tem + if(ioinco.ge.1)call hnbmin(keu,ked,kes,kec) + if(ish.ge.5)write(ifch,*)('-',i=1,30) + *,' exit sr hgcaaa ',('-',i=1,10) + ish=isho + return + endif + + dt=abs(temo-tem) + if(dt.le.gen*temo.or.dt.le.genm)idt=1 + +c search for chemical potentials (tem=const) +c ------------------------------------------ + idch=0 + ibna=0 + + do iafs=1,nflavs + chemo=chem(iafs) + + if(iospec.eq.iug)then + +c massless particles +c ------------------ + if(iostat.eq.0)then + call hgccm0 + elseif(iostat.eq.1)then + call hgccbo(ibna) + endif + + else + +c Boltzmann approxiamtion (massive particles) +c ------------------------------------------- + call hgccbo(ibna) + + endif + + dch=abs(chemo-chem(iafs)) + if(ish.ge.9)write(ifch,*)'dch:',dch + if(dch.le.abs(gen*chemo).or.dch.le.genm)idch=idch+1 + if(ibna.eq.1)then + chem(iafs)=chemo + call hgchac(0) + goto20 + endif + + enddo + + +c new hadron chem. potentials +c --------------------------- + call hgchac(0) + + + if(ish.ge.5.and.nflavs.eq.1) + *write(ifch,'(1x,f8.6,2x,f9.6)') + *tem,chem(1) + if(ish.ge.5.and.nflavs.eq.2) + *write(ifch,'(1x,f8.6,2x,f9.6,2x,f9.6)') + *tem,chem(1),chem(2) + if(ish.ge.5.and.nflavs.eq.3) + *write(ifch,'(1x,f8.6,2x,f9.6,2x,f9.6,2x,f9.6)') + *tem,chem(1),chem(2),chem(3) + if(idch.eq.nflavs.and.idt.eq.1)goto20 + + + k=k+1 + + if(k.gt.300)then + if(ish.ge.5) + *write(ifch,*)'failure in approximate solution' + goto20 + endif + + goto10 + +20 continue + if(ish.ge.9)call hgccch(0) + if(ish.ge.5)write(ifch,'(1x,a,1x,f9.6)')' T :',tem + do i=1,nflavs + if(i.eq.1.and.ish.ge.5) + *write(ifch,'(1x,a,1x,f9.6)')'chemu:',chem(1) + if(i.eq.2.and.ish.ge.5) + *write(ifch,'(1x,a,1x,f9.6)')'chemd:',chem(2) + if(i.eq.3.and.ish.ge.5) + *write(ifch,'(1x,a,1x,f9.6)')'chems:',chem(3) + enddo + + +c checking results +c ---------------- + if(ish.ge.5)call hgcchb + +c particle yield +c -------------- + call hgcpyi(1) + +c checking flavor conservation +c ---------------------------- + if(ish.ge.5)call hgccfc + + if(iug.eq.iospec.and.iostat.eq.0)then + if(ish.ge.5)write(ifch,*) + *'approximation and exact treatment equal' + if(ish.ge.5)write(ifch,*)('-',i=1,30) + *,' exit sr hgcaaa ',('-',i=1,10) + ish=isho + return + endif + +c continue or return approximate values +c ------------------------------------- + do i=1,nspecs + rmsbol(i)=rmsngc(i) + ptlbol(i)=ptlngc(i) + chebol(i)=chemgc(i) + enddo + tembol=tem + if(iostat.eq.1)then + if(ish.ge.5)write(ifch,*)('-',i=1,30) + *,' exit sr hgcaaa ',('-',i=1,10) + ish=isho + return + endif + + +c quantum statistics +c ------------------ + if(ish.ge.5)write(ifch,*)'quantum statistics:' + if(ish.ge.5.and.nflavs.eq.1)write(ifch,'(3x,a,8x,a)') + *'T:','chemu:' + if(ish.ge.5.and.nflavs.eq.2)write(ifch,'(3x,a,8x,a,6x,a)') + *'T:','chemu:','chemd:' + if(ish.ge.5.and.nflavs.eq.3)write(ifch,'(3x,a,8x,a,6x,a,6x,a)') + *'T:','chemu:','chemd:','chems:' + k=1 + +30 continue + if(ish.ge.9.and.mod(k,10).eq.0) + *write(ifch,*)'hgc iteration:',k + +c new temperature +c --------------- + idt=0 + temo=tem + call hgctex + if(ish.ge.5.and.nflavs.eq.1) + *write(ifch,'(1x,f10.8,2x,f10.7)') + *tem,chem(1) + if(ish.ge.5.and.nflavs.eq.2) + *write(ifch,'(1x,f10.8,2x,f10.7,2x,f10.7)') + *tem,chem(1),chem(2) + if(ish.ge.5.and.nflavs.eq.3) + *write(ifch,'(1x,f10.8,2x,f10.7,2x,f10.7,2x,f10.7)') + *tem,chem(1),chem(2),chem(3) + + if(tem.le.1.e-6.and.ish.ge.5)then + write(ifch,*)'inversion imposssible' + write(ifch,*)'T:',tem + call hnbmin(keu,ked,kes,kec) + if(ish.ge.5)write(ifch,*)('-',i=1,30) + *,' exit sr hgcaaa ',('-',i=1,10) + ish=isho + return + endif + + dt=abs(temo-tem) + if(dt.le.gen*temo.or.dt.le.genm)idt=1 + if(ish.ge.9)write(ifch,*)'dtem:',dt + +c new quark chem. potentials +c -------------------------- + idch=0 + do iafs=1,nflavs + chemo=chem(iafs) + call hgccex + dch=abs(chemo-chem(iafs)) + if(ish.ge.9)write(ifch,*)'dche:',dch + if(dch.le.abs(gen*chemo).or.dch.le.genm)idch=idch+1 + enddo + +c new hadron chem. potentials +c --------------------------- + call hgchac(0) + + if(idch.eq.nflavs.and.idt.eq.1)then + + if(ish.ge.5)write(ifch,*)'results:' + if(ish.ge.5)write(ifch,51)' T :',tem + if(nflavs.ge.1.and.ish.ge.5)write(ifch,51)'chemu:',chem(1) + if(nflavs.ge.2.and.ish.ge.5)write(ifch,51)'chemd:',chem(2) + if(nflavs.ge.3.and.ish.ge.5)write(ifch,51)'chems:',chem(3) +51 format(1x,a,3x,f9.6) + +c checking results +c ---------------- + if(ish.ge.5)call hgcchh(i) + +c particle yield +c -------------- + call hgcpyi(0) + +c checking flavor conservation +c ---------------------------- + call hgccfc + + if(ish.ge.5)write(ifch,*)('-',i=1,30) + *,' exit sr hgcaaa ',('-',i=1,10) + ish=isho + return + endif + + if(k.gt.300)then + if(ish.ge.5) + *write(ifch,*)'failure in exact solution' + if(ish.ge.5)write(ifch,*)'results:' + if(ish.ge.5)write(ifch,51)' T :',tem + if(nflavs.ge.1.and.ish.ge.5)write(ifch,51)'chemu:',chem(1) + if(nflavs.ge.2.and.ish.ge.5)write(ifch,51)'chemd:',chem(2) + if(nflavs.ge.3.and.ish.ge.5)write(ifch,51)'chems:',chem(3) + +c particle yield +c -------------- + call hgcpyi(0) + + if(ish.ge.5)write(ifch,*)('-',i=1,30) + *,' exit sr hgcaaa ',('-',i=1,10) + ish=isho + return + + endif + + k=k+1 + goto30 + + end + + +c--------------------------------------------------------------------- + function hgcbi0(x) +c--------------------------------------------------------------------- + DOUBLE PRECISION p1,p2,p3,p4,p5,p6,p7,q1,q2,q3,q4,q5,q6,q7,q8,q9,y + SAVE p1,p2,p3,p4,p5,p6,p7,q1,q2,q3,q4,q5,q6,q7,q8,q9 + DATA p1,p2,p3,p4,p5,p6,p7/1.0d0,3.5156229d0,3.0899424d0, + *1.2067492d0,0.2659732d0,0.360768d-1,0.45813d-2/ + DATA q1,q2,q3,q4,q5,q6,q7,q8,q9/0.39894228d0,0.1328592d-1, + *0.225319d-2,-0.157565d-2,0.916281d-2,-0.2057706d-1,0.2635537d-1, + *-0.1647633d-1,0.392377d-2/ + if (abs(x).lt.3.75) then + y=dble((x/3.75)**2) + hgcbi0=sngl(p1+y*(p2+y*(p3+y*(p4+y*(p5+y*(p6+y*p7)))))) + else + ax=abs(x) + y=dble(3.75/ax) + hgcbi0=(exp(ax)/sqrt(ax))*(q1+y*(q2+y*(q3+y*(q4+y*(q5+y*(q6+y* + *(q7+y*(q8+y*q9)))))))) + endif + return + end + + +c------------------------------------------------------------------------ + function hgcbi1(x) +c------------------------------------------------------------------------ + DOUBLE PRECISION p1,p2,p3,p4,p5,p6,p7,q1,q2,q3,q4,q5,q6,q7,q8,q9,y + SAVE p1,p2,p3,p4,p5,p6,p7,q1,q2,q3,q4,q5,q6,q7,q8,q9 + DATA p1,p2,p3,p4,p5,p6,p7/0.5d0,0.87890594d0,0.51498869d0, + *0.15084934d0,0.2658733d-1,0.301532d-2,0.32411d-3/ + DATA q1,q2,q3,q4,q5,q6,q7,q8,q9/0.39894228d0,-0.3988024d-1, + *-0.362018d-2,0.163801d-2,-0.1031555d-1,0.2282967d-1,-0.2895312d-1, + *0.1787654d-1,-0.420059d-2/ + if (abs(x).lt.3.75) then + y=dble((x/3.75)**2) + hgcbi1=x*(p1+y*(p2+y*(p3+y*(p4+y*(p5+y*(p6+y*p7)))))) + else + ax=abs(x) + y=dble(3.75/ax) + hgcbi1=(exp(ax)/sqrt(ax))*(q1+y*(q2+y*(q3+y*(q4+y*(q5+y*(q6+y* + *(q7+y*(q8+y*q9)))))))) + if(x.lt.0.)hgcbi1=-hgcbi1 + endif + return + END + + +c--------------------------------------------------------------------- + function hgcbk0(x) +c------------------------------------------------------------------------ + DOUBLE PRECISION p1,p2,p3,p4,p5,p6,p7,q1,q2,q3,q4,q5,q6,q7,y + SAVE p1,p2,p3,p4,p5,p6,p7,q1,q2,q3,q4,q5,q6,q7 + DATA p1,p2,p3,p4,p5,p6,p7/-0.57721566d0,0.42278420d0,0.23069756d0, + *0.3488590d-1,0.262698d-2,0.10750d-3,0.74d-5/ + DATA q1,q2,q3,q4,q5,q6,q7/1.25331414d0,-0.7832358d-1,0.2189568d-1, + *-0.1062446d-1,0.587872d-2,-0.251540d-2,0.53208d-3/ + if (x.le.2.0) then + y=dble(x*x/4.0) + hgcbk0=(-log(x/2.0)*hgcbi0(x))+(p1+y*(p2+y*(p3+y*(p4+y*(p5+y* + *(p6+y*p7)))))) + else + y=dble(2.0/x) + hgcbk0=(exp(-x)/sqrt(x))*(q1+y*(q2+y*(q3+y*(q4+y*(q5+y*(q6+y* + *q7)))))) + endif + return + END + + +c--------------------------------------------------------------- + function hgcbk1(x) +c-------------------------------------------------------------------- + DOUBLE PRECISION p1,p2,p3,p4,p5,p6,p7,q1,q2,q3,q4,q5,q6,q7,y + SAVE p1,p2,p3,p4,p5,p6,p7,q1,q2,q3,q4,q5,q6,q7 + DATA p1,p2,p3,p4,p5,p6,p7/1.0d0,0.15443144d0,-0.67278579d0, + *-0.18156897d0,-0.1919402d-1,-0.110404d-2,-0.4686d-4/ + DATA q1,q2,q3,q4,q5,q6,q7/1.25331414d0,0.23498619d0,-0.3655620d-1, + *0.1504268d-1,-0.780353d-2,0.325614d-2,-0.68245d-3/ + if (x.le.2.0) then + y=dble(x*x/4.0) + hgcbk1=(log(x/2.0)*hgcbi1(x))+(1.0/x)*(p1+y*(p2+y*(p3+y*(p4+y* + *(p5+y*(p6+y*p7)))))) + else + y=dble(2.0/x) + hgcbk1=(exp(-x)/sqrt(x))*(q1+y*(q2+y*(q3+y*(q4+y*(q5+y*(q6+y* + *q7)))))) + endif + return + END + + +c------------------------------------------------------------------- + function hgcbk(n,x) +c------------------------------------------------------------------ + tox=2.0/x + bkm=hgcbk0(x) + bk=hgcbk1(x) + do 11 j=1,n-1 + bkp=bkm+j*tox*bk + bkm=bk + bk=bkp +11 continue + hgcbk=bk + return + END + + +c---------------------------------------------------------------- + subroutine hgccbo(iba) +c---------------------------------------------------------------- +c returns new chem(iafs) for boltzmann statistics +c input: +c tem +c kef/volu +c output: +c chem(iafs) +c----------------------------------------------------------------------- + common/cnsta/pi,pii,hquer,prom,piom,ainfin + common/drop6/tecm,volu + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + parameter(nflav=6) + common/cflavs/nflavs,kef(nflav),chem(nflav) + common/cflac/ifok(nflav,mspecs),ifoa(nflav) + common/ciakt/gen,iafs,ians,genm + external hgcbk + k=1 + iba=0 + c1=-0.5 + c2=0.5 + goto11 + +c new chemical potential +c ---------------------- +10 chem(iafs)=c1+0.5*(c2-c1) +11 continue + fd=0.0 + call hgchac(0) + + do i=1,nspecs + + if(ifok(iafs,i).ne.0)then + if((chemgc(i)/tem).gt.70.)then + hpd=1.e30 + else + hpd=exp(chemgc(i)/tem) + endif + if(aspecs(i).ne.0.)then + fk2=hgcbk(2,aspecs(i)/tem) + hpd=hpd*gspecs(i)*aspecs(i)**2*tem*fk2 + */2./pi**2/hquer**3 + else + hpd=hpd*gspecs(i)*tem**3/pi**2/hquer**3 + endif + hfd=ifok(iafs,i)*hpd + fd=fd+hfd + endif + + enddo + + dfd=abs(fd-(kef(iafs)/volu)) + if(dfd.le.abs(gen*(kef(iafs)/volu)).or.dfd.le.genm)return +c if(abs(fd).ge.100.)then +c iba=1 +c return +c endif + + + if(fd.gt.(kef(iafs)/volu))then + c2=chem(iafs) + else + c1=chem(iafs) + endif + + k=k+1 + if(k.gt.300)return + + goto10 + + end + + +c---------------------------------------------------------------------- + subroutine hgccch(iii) +c---------------------------------------------------------------------- +c checks convergence of iterative algorithm +c plots iteration values for T and mu_i +c---------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cflavs/nflavs,kef(nflav),chem(nflav) + parameter (nbin=500) + common/cdatc/data(nbin),datb(nbin),datc(nbin),datd(nbin) + *,date(nbin),datf(nbin),datg(nbin),dath(nbin),dati(nbin) + common/cnrit/nrit + character cen*4,cvol*4,cu*3,cd*3,cs*3 + + if(iii.gt.0)then + + nrit=nrit+1 + data(nrit)=nrit + datb(nrit)=tem + datc(nrit)=chem(1) + datd(nrit)=chem(2) + date(nrit)=chem(3) + + elseif(iii.eq.0)then + + nrit=nrit+1 + data(nrit)=nrit + datb(nrit)=tem + datc(nrit)=chem(1) + datd(nrit)=chem(2) + date(nrit)=chem(3) + do i=1,nrit + datf(i)=datb(nrit) + datg(i)=datc(nrit) + dath(i)=datd(nrit) + dati(i)=date(nrit) + enddo + + x1=data(1) + x2=data(nrit) + write(cen,'(f4.1)')tecm + write(cvol,'(f4.1)')volu + write(cu,'(i3)')keu + write(cd,'(i3)')ked + write(cs,'(i3)')kes + + + write(ifhi,'(a)') 'newpage zone 1 4 1 openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis Iteration"' + write(ifhi,'(a)') 'text 0 0 "yaxis T (GeV)"' + write(ifhi,'(a)') 'text 0.15 0.9 "E= '//cen//'"' + write(ifhi,'(a)') 'text 0.4 0.9 "V= '//cvol//'"' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(3a)')'yrange',' auto',' auto' + write(ifhi,'(a)') 'array 2' + do j=1,nrit + write(ifhi,'(2e12.4)')data(j),datb(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(3a)')'yrange',' auto',' auto' + write(ifhi,'(a)') 'array 2' + do j=1,nrit + write(ifhi,'(2e12.4)')data(j),datf(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis Iteration"' + write(ifhi,'(a)') 'text 0 0 "yaxis [m]^1! (GeV)"' + write(ifhi,'(a)') 'text 0.15 0.9 "Q^1!= '//cu//'"' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(3a)')'yrange',' auto',' auto' + write(ifhi,'(a)') 'array 2' + do j=1,nrit + write(ifhi,'(2e12.4)')data(j),datc(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(3a)')'yrange',' auto',' auto' + write(ifhi,'(a)') 'array 2' + do j=1,nrit + write(ifhi,'(2e12.4)')data(j),datg(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis Iteration"' + write(ifhi,'(a)') 'text 0 0 "yaxis [m]^2! (GeV)"' + write(ifhi,'(a)') 'text 0.15 0.9 "Q^2!= '//cd//'"' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(3a)')'yrange',' auto',' auto' + write(ifhi,'(a)') 'array 2' + do j=1,nrit + write(ifhi,'(2e12.4)')data(j),datd(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(3a)')'yrange',' auto',' auto' + write(ifhi,'(a)') 'array 2' + do j=1,nrit + write(ifhi,'(2e12.4)')data(j),dath(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis Iteration"' + write(ifhi,'(a)') 'text 0 0 "yaxis [m]^3! (GeV)"' + write(ifhi,'(a)') 'text 0.15 0.9 "Q^3!= '//cs//'"' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(3a)')'yrange',' auto',' auto' + write(ifhi,'(a)') 'array 2' + do j=1,nrit + write(ifhi,'(2e12.4)')data(j),date(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(3a)')'yrange',' auto',' auto' + write(ifhi,'(a)') 'array 2' + do j=1,nrit + write(ifhi,'(2e12.4)')data(j),dati(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + endif + + return + + end + +c----------------------------------------------------------------------- + subroutine hgccex +c----------------------------------------------------------------------- +c returns new chem(iafs) for massive quantum statistics +c input: +c tem +c kef/volu +c output: +c chem(iafs) +c----------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cflavs/nflavs,kef(nflav),chem(nflav) + common/cflac/ifok(nflav,mspecs),ifoa(nflav) + common/ciakt/gen,iafs,ians,genm + external hgcfhn + + k=1 + + c1=-0.5 + c2=0.5 + goto11 + +c new chemical potential +c ---------------------- +10 chem(iafs)=c1+0.5*(c2-c1) +11 continue + + fd=0.0 + do ians=1,nspecs + if(ifok(iafs,ians).ne.0)then + + call hgchac(0) + call hgclim(a,b) + if(b.eq.0.0)then + hpd=0.0 + else + call uttraq(hgcfhn,a,b,hpd) + endif + hpd=hpd*gspecs(ians)/2./pi**2/hquer**3 + fd=fd+hpd*ifok(iafs,ians) + + endif + enddo + + dfd=abs(fd-(kef(iafs)/volu)) + if(dfd.le.abs(gen*(kef(iafs)/volu)).or.dfd.le.genm)return + + if(fd.gt.(kef(iafs)/volu))then + c2=chem(iafs) + else + c1=chem(iafs) + endif + + k=k+1 + if(k.gt.300)then + if(ish.ge.5) + *write(ifch,*)'failure at cex at iafs:',iafs + return + endif + + goto10 + + end + + +c------------------------------------------------------------------ + subroutine hgccfc +c------------------------------------------------------------------ +c checks flavor conservation in particle yield +c------------------------------------------------------------------ + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cflavs/nflavs,kef(nflav),chem(nflav) + common/cflac/ifok(nflav,mspecs),ifoa(nflav) + + if(ish.ge.5)write(ifch,*)'checking flavor conservation' + do i=1,nflavs + ckef=0.0 + do ii=1,nspecs + ckef=ckef+ifok(i,ii)*ptlngc(ii) + enddo + dkef=abs(ckef-kef(i)) + if(dkef.le.1.e-2)then + if(i.eq.1.and.ish.ge.5)write(ifch,*)'u conserved' + if(i.eq.2.and.ish.ge.5)write(ifch,*)'d conserved' + if(i.eq.3.and.ish.ge.5)write(ifch,*)'s conserved' + else + if(i.eq.1.and.ish.ge.5)write(ifch,*)'u not conserved' + if(i.eq.2.and.ish.ge.5)write(ifch,*)'d not conserved' + if(i.eq.3.and.ish.ge.5)write(ifch,*)'s not conserved' + if(ish.ge.5)write(ifch,*)'df:',dkef + endif + enddo + + return + end + +c---------------------------------------------------------------- + subroutine hgcchb +c---------------------------------------------------------------- +c checks results by numerical integration +c---------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cflavs/nflavs,kef(nflav),chem(nflav) + common/cflac/ifok(nflav,mspecs),ifoa(nflav) + common/ciakt/gen,iafs,ians,genm + external hgcfbe + external hgcfbn + if(ish.ge.5)write(ifch,*) + *'check by numer. calc. of expect. values:' + iced=0 + ceden=0.0 + do ians=1,nspecs + call hgclim(a,b) + if(b.eq.0.0)then + cedh=0.0 + else + call uttraq(hgcfbe,a,b,cedh) + endif + if(ish.ge.9)write(ifch,*)'cedh:',cedh + ced=cedh*gspecs(ians)/2./pi**2/hquer**3 + ceden=ceden+ced + enddo + + if(iabs(ispecs(nspecs)).lt.10) + *ceden=ceden+(8.*pi**2*tem**4/15.+bag4rt**4)/hquer**3 + + if(ish.ge.5)write(ifch,*)'energy density :',ceden + ded=abs((tecm/volu)-ceden) + if((tecm/volu)*gen.ge.ded.or.ded.le.gen)iced=1 + icfd=0 + + do i=1,nflavs + cfd=0.0 + do ians=1,nspecs + call hgclim(a,b) + if(b.eq.0.0)then + hpd=0.0 + else + call uttraq(hgcfbn,a,b,hpd) + endif + hfd=ifok(i,ians)*hpd*gspecs(ians)/2./pi**2/hquer**3 + if(ish.ge.9)write(ifch,*)'hfd:',hfd + cfd=cfd+hfd + enddo + if(i.eq.1.and.ish.ge.5)write(ifch,5)'flavor density u :',cfd + if(i.eq.2.and.ish.ge.5)write(ifch,5)'flavor density d :',cfd + if(i.eq.3.and.ish.ge.5)write(ifch,5)'flavor density s :',cfd +5 format(1x,a,1x,f12.6) + dfd=abs(cfd-(kef(i)/volu)) + if(abs(gen*(kef(i)/volu)).ge.dfd.or.dfd.le.gen) + *icfd=icfd+1 + enddo + + if(iced.eq.1.and.icfd.eq.nflavs)then + if(ish.ge.5)write(ifch,*)'results agree' + else + if(ish.ge.5)write(ifch,*)'results disagree' + endif + + return + end + +c---------------------------------------------------------------- + subroutine hgcchh(icorr) +c---------------------------------------------------------------- +c checks results by numerical integration +c---------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cflavs/nflavs,kef(nflav),chem(nflav) + common/cflac/ifok(nflav,mspecs),ifoa(nflav) + common/ciakt/gen,iafs,ians,genm + external hgcfhe + external hgcfhn + icorr=0 + if(ish.ge.5)write(ifch,*) + *'check by numer. calc. of expect. values:' + + iced=0 + ceden=0.0 + do ians=1,nspecs + call hgclim(a,b) + if(b.eq.0.0)then + cedh=0.0 + else + call uttraq(hgcfhe,a,b,cedh) + endif + if(ish.ge.9)write(ifch,*)'cedh:',cedh + ced=cedh*gspecs(ians)/2./pi**2/hquer**3 + ceden=ceden+ced + enddo + + if(iabs(ispecs(nspecs)).lt.10) + *ceden=ceden+(8.*pi**2*tem**4/15.+bag4rt**4)/hquer**3 + + if(ish.ge.5)write(ifch,*)'energy density :',ceden + ded=abs((tecm/volu)-ceden) + if((tecm/volu)*gen.ge.ded.or.ded.le.gen)iced=1 + + icfd=0 + + do i=1,nflavs + cfd=0.0 + do ians=1,nspecs + call hgclim(a,b) + if(b.eq.0.0)then + hpd=0.0 + else + call uttraq(hgcfhn,a,b,hpd) + endif + hfd=ifok(i,ians)*hpd*gspecs(ians)/2./pi**2/hquer**3 + if(ish.ge.9)write(ifch,*)'hfd:',hfd + cfd=cfd+hfd + enddo + if(i.eq.1.and.ish.ge.5)write(ifch,5)'flavor density u :',cfd + if(i.eq.2.and.ish.ge.5)write(ifch,5)'flavor density d :',cfd + if(i.eq.3.and.ish.ge.5)write(ifch,5)'flavor density s :',cfd +5 format(1x,a,1x,f9.6) + dfd=abs(cfd-(kef(i)/volu)) + if(abs(gen*(kef(i)/volu)).ge.dfd.or.dfd.le.gen) + *icfd=icfd+1 + enddo + + if(iced.eq.1.and.icfd.eq.nflavs)then + if(ish.ge.5)write(ifch,*)'results agree' + icorr=1 + else + if(ish.ge.5)write(ifch,*)'results disagree' + endif + + return + end + + +c-------------------------------------------------------------------- + subroutine hgccm0 +c-------------------------------------------------------------------- +c returns new quark chemical potentials for massless quantum statistics +c input: +c tem +c kef/volu +c output: +c chem +c--------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cflavs/nflavs,kef(nflav),chem(nflav) + common/cflac/ifok(nflav,mspecs),ifoa(nflav) + common/ciakt/gen,iafs,ians,genm + external hgcfhn + k=1 + z3=1.2020569 + + c1=-0.5 + c2=0.5 + goto11 + +c new chemical potential +c ---------------------- +10 chem(iafs)=c1+0.5*(c2-c1) +11 continue + + fd=0.0 + call hgchac(0) + + do i=1,nspecs + if(ifok(iafs,i).ne.0)then + + igsp=int(gspecs(i)) + if(mod(igsp,2).eq.0)then + + if(ispecs(i).gt.0)then + hpd=gspecs(i)*(chemgc(i)*tem**2+chemgc(i)**3/pi**2)/6./hquer**3 + else + hpd=0.0 + endif + +c else +c if(ispecs(i).gt.0)then +c hpd=gspecs(i)*(chemgc(i)*tem**2/3.-chemgc(i)**3/pi**2/6.)/hquer**3 +c else +c hpd=0.0 +c endif +c endif + +c n=1 +c0 xx=n*abs(chemgc(i))/tem +c if(xx.le.60.)then +c hpd=hpd+(-1.)**(n+1)/n**3/exp(xx) +c n=n+1 +c goto20 +c endif +c hpd=hpd*gspecs(i)*tem**3/pi**2/hquer**3 +c if(chemgc(i).eq.abs(chemgc(i)))then +c hpd=gspecs(i)*(chemgc(i)*tem**2+chemgc(i)**3/pi**2)/6./hquer**3 +c *-hpd +c endif + +c else +c hpd=3.*gspecs(i)*tem**3*z3/4./pi**2/hquer**3 +c endif + + else + + hpd=gspecs(i)*tem**3*z3/pi**2/hquer**3 + + endif + + hfd=hpd*ifok(iafs,i) + fd=fd+hfd + + endif + enddo + + dfd=abs(fd-(kef(iafs)/volu)) + if(dfd.le.abs(gen*(kef(iafs)/volu)).or.dfd.le.genm)return + + if(fd.gt.(kef(iafs)/volu))then + c2=chem(iafs) + else + c1=chem(iafs) + endif + + k=k+1 + if(k.gt.300)then + if(ish.ge.5) + *write(ifch,*)'failure at cm0 at iafs:',iafs + return + endif + goto10 + end + +c----------------------------------------------------------------------- + function hgcfbe(x) +c----------------------------------------------------------------------- +c integrand of energy density +c------------------------------------------------------------------------ + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/ciakt/gen,iafs,ians,genm + eex=81. + hgcfbe=0.0 + sq=sqrt(x**2+aspecs(ians)**2) + if(tem.ne.0.0)eex=(sq-chemgc(ians))/tem + if(eex.gt.60.)return + if(eex.lt.-60)then + hgcfbe=1.e25 + return + endif + + hgcfbe=sq*x**2*exp(-eex) + + return + end + +c----------------------------------------------------------------- + function hgcfbf(x) +c----------------------------------------------------------------- +c integrand of mean square variance of energy +c---------------------------------------------------------------- + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/ciakt/gen,iafs,ians,genm + eex=61 + hgcfbf=0.0 + + sq=sqrt(x**2+aspecs(ians)**2) + if(tem.ne.0.0)eex=(sq-chemgc(ians))/tem + if(eex.gt.60.)return + if(eex.lt.-60)then + hgcfbf=1.e25 + return + endif + + hgcfbf=(aspecs(ians)**2+x**2)*x**2*exp(-eex) + + return + end + +c----------------------------------------------------------------- + function hgcfbn(x) +c----------------------------------------------------------------- +c integrand of hadron density +c----------------------------------------------------------------- + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/ciakt/gen,iafs,ians,genm + eex=81. + hgcfbn=0.0 + + sq=sqrt(x**2+aspecs(ians)**2) + if(tem.ne.0.0)eex=(sq-chemgc(ians))/tem + if(eex.gt.80.)return + if(eex.lt.-60)then + hgcfbn=1.e25 + return + endif + + hgcfbn=x**2*exp(-eex) + + return + end + +c----------------------------------------------------------------------- + function hgcfhe(x) +c----------------------------------------------------------------------- +c integrand of energy density +c------------------------------------------------------------------------ + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/ciakt/gen,iafs,ians,genm + eex=81. + hgcfhe=0.0 + igsp=int(gspecs(ians)) + + sq=sqrt(x**2+aspecs(ians)**2) + if(tem.ne.0.0)eex=(sq-chemgc(ians))/tem + if(eex.gt.80.)return + + if(mod(igsp,2).ne.0)then + d=-1.0 + if(eex.lt.1.e-10)return + else + d=1.0 + endif + + hgcfhe=sq*x**2/(exp(eex)+d) + + return + end + +c----------------------------------------------------------------- + function hgcfhf(x) +c----------------------------------------------------------------- +c integrand of mean square variance of energy +c---------------------------------------------------------------- + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/ciakt/gen,iafs,ians,genm + eex=61 + hgcfhf=0.0 + igsp=int(gspecs(ians)) + + sq=sqrt(x**2+aspecs(ians)**2) + if(tem.ne.0.0)eex=(sq-chemgc(ians))/tem + if(eex.gt.60.)return + if(eex.lt.(-60.))return + + if(mod(igsp,2).ne.0)then + d=-1.0 + if(eex.lt.1.0e-10.and.eex.gt.(-1.0e-10))return + else + d=1.0 + endif + + hgcfhf=(aspecs(ians)**2+x**2)*x**2/(exp(eex)+2.0*d+exp(-eex)) + + return + end + +c----------------------------------------------------------------- + function hgcfhn(x) +c----------------------------------------------------------------- +c integrand of hadron density +c----------------------------------------------------------------- + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/ciakt/gen,iafs,ians,genm + eex=81. + hgcfhn=0.0 + igsp=int(gspecs(ians)) + + sq=sqrt(x**2+aspecs(ians)**2) + if(tem.ne.0.0)eex=(sq-chemgc(ians))/tem + if(eex.gt.80.)return + + if(mod(igsp,2).ne.0)then + d=-1.0 + if(eex.lt.1.e-10)return + else + d=1.0 + endif + + hgcfhn=x**2/(exp(eex)+d) + + return + end + +c----------------------------------------------------------------- + function hgcfhw(x) +c----------------------------------------------------------------- +c integrand of mean square variance of hadron yield +c---------------------------------------------------------------- + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/ciakt/gen,iafs,ians,genm + eex=61 + hgcfhw=0.0 + igsp=int(gspecs(ians)) + + sq=sqrt(x**2+aspecs(ians)**2) + if(tem.ne.0.0)eex=(sq-chemgc(ians))/tem + if(eex.gt.60.)return + if(eex.lt.(-60.))return + + if(mod(igsp,2).ne.0)then + d=-1.0 + if(eex.lt.1.0e-10.and.eex.gt.(-1.0e-10))return + else + d=1.0 + endif + + hgcfhw=x**2/(exp(eex)+2.0*d+exp(-eex)) + + return + end + + +c----------------------------------------------------------------- + subroutine hgchac(iboco) +c------------------------------------------------------------------ +c returns hadronic chemical potentials as combinations of quark +c chemical potentials +c---------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cflavs/nflavs,kef(nflav),chem(nflav) + common/cflac/ifok(nflav,mspecs),ifoa(nflav) + + do i=1,nspecs + chemgc(i)=0.0 + do ii=1,nflavs + chemgc(i)=chemgc(i)+ifok(ii,i)*chem(ii) + if(ish.ge.9)write(ifch,*)'mu_i:',chem(ii),' k_i:',ifok(ii,i) + enddo + if(ish.ge.9)write(ifch,*)'mu_nu:',chemgc(i) + igsp=int(gspecs(i)) + if(mod(igsp,2).ne.0.and.chemgc(i).gt.aspecs(i).and.iboco.eq.0) + *chemgc(i)=aspecs(i) + enddo + + return + end + + +c----------------------------------------------------------------------- + subroutine hgclim(a,b) +c---------------------------------------------------------------------- +c returns integration limits for numerical evaluation of particle +c and energy densities using quantum statistics +c---------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/ciakt/gen,iafs,ians,genm + + igsp=int(gspecs(ians)) + + if(mod(igsp,2).ne.0)then + a=0.001 + else + a=0.0 + endif + + b=0.0 + bb=(chemgc(ians)+tem*80.)**2-aspecs(ians)**2 + if(ish.ge.9)write(ifch,*)'bb:',bb + if(bb.ge.0.0)b=sqrt(bb) + if(bb.lt.0.0)then + if(ish.ge.9)write(ifch,*)'failure at hgclim, bb=',bb + if(ish.ge.9)write(ifch,'(1x,a,i5,a,2x,f12.6,1x,a,2x,f9.6)') + *'mu(',ispecs(ians),'):',chemgc(ians),' T:',tem + endif + if(ish.ge.9)write(ifch,*)'ians:',ians,' a:',a,' b:',b + return + end + +c------------------------------------------------------------------------ + subroutine hgcnbi(iret) +c----------------------------------------------------------------------- +c uses hgcaaa results to generate initial hadron set, nlattc, iozero +c input: +c ptlngc(1:nspecs): particle number expectation values /cgchg/ +c output: +c nump: number of hadrons /chnbin/ +c ihadro(1:nump): hadron ids /chnbin/ +c nlattc: lattice size /clatt/ +c iozero: zero weight /metr1/ +c----------------------------------------------------------------------- + include 'epos.inc' + parameter(maxp=500) + common/chnbin/nump,ihadro(maxp) + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cgctot/rmstot,ptltot + common/camgc/amgc,samgc,amtot + common/cflavs/nflavs,kef(nflav),chem(nflav) + common/cflac/ifok(nflav,mspecs),ifoa(nflav) + common/clatt/nlattc,npmax + common/cgcnb/nptlgc(mspecs) + common/ctaue/taue + common/cgck/k(nflav),kp(nflav),kps(nflav) + *,idp(maxp),ida(mspecs),idb(mspecs) + integer hgcndn + + iret=0 + isho=ish + if(ishsub/100.eq.50)ish=mod(ishsub,100) + + if(ish.ge.7)write(ifch,*)('-',l=1,10) + *,' entry sr hgcnbi ',('-',l=1,30) + + + nh=nint(ptltot) + iug=(1+iospec)/2*2-1 + if(iug.lt.9)call utstop('hgcnbi: iospec < 9&') + +c determine nlattc +c ---------------- + if(ionlat.eq.1)then + s1=ptltot+2.*rmstot + s2=1.3*ptltot + s=max(s1,s2,6.) + nlattc=nint(s) + elseif(ionlat.eq.2)then + s1=ptltot+3.*rmstot + s2=1.5*ptltot + s=max(s1,s2,6.) + nlattc=nint(s) + elseif(ionlat.eq.3)then + s1=ptltot+4.*rmstot + s2=2.*ptltot + s=max(s1,s2,6.) + nlattc=nint(s) + elseif(ionlat.eq.0)then + nlattc=8*(tecm/10)*(1/(tecm/volu))**0.2*(nspecs/3.)**0.3 + if(aspecs(1).lt.0.010)nlattc=nlattc*3 + nlattc=max(nlattc,20) + endif + + if(ish.ge.7)write(ifch,*)'nlattc:',nlattc + +c determine iozero +c ---------------- + if(iozero.eq.-1)then + iozero=nspecs + elseif(iozero.eq.-2)then + iozero=nspecs*int(sqrt(volu/tecm)) + endif + +c modify iozero for testing +c ------------------------- + if(iozevt.gt.0)then + iozero=(nrevt/iozevt+1)*iozinc !nrevt=event number - 1 !! + write(ifch,*)'nrevt+1:',nrevt+1,' iozero:',iozero + endif + +c initial hadron set +c ------------------ + ammin=2.*aspecs(1) + if(tecm.lt.ammin)then + write(ifch,*)'impossible to generate hadron configuration' + call utstop('hgcnbi: tecm less than two pi0 masses&') + endif + + kk=1 +100 continue + + if(kk.gt.20)then + iret=1 + if(ish.ge.7)then + write(ifch,*)'failed to generate hadron set for' + *,' event:',nrevt+1 + write(ifch,*)'u d s :',keu,ked,kes,' E:',tecm + write(ifch,*)('-',i=1,30) + *,' exit sr hgcnbi ',('-',i=1,10) + endif + ish=isho + return + endif + + amtot=0.0 + do i=1,nspecs + nptlgc(i)=0 + enddo + do ii=1,nflavs + k(ii)=kef(ii) + enddo + + if(ish.ge.7)write(ifch,*) + *'sample hadron multiplicities and total mass:' + + kbar=keu+ked+kes + kpar=iabs(keu)+iabs(ked)+iabs(kes) + nbar=kbar/3. + if(ish.ge.7)write(ifch,*)'baryon number:',nbar,' parton number:' + *,kpar + + nn=2 + if(ioinco.ne.2)then + nn=hgcndn(0) + else + nn=nh + endif + nb=iabs(nbar) + if(ish.ge.7)write(ifch,*)'<n>:',nh,' n_sample:',nn,' n_bar:',nb + if(nn.gt.nb.and.nb.ne.0.and.nb.ge.nh)nn=nb + if(nn.lt.nb.and.nb.ne.0)nn=nb + km=kpar-iabs(kbar) + nt=km/2+nb + if(nt.gt.nn)nn=nt + nn=max(nn,2) + + if(ioinco.eq.2)then + nit=15*taue + else + itpn=100 + nit=nn*itpn + endif + nbb=0 + n=0 + +c start with nb protons + nptlgc(19)=nptlgc(19)+nb + n=nb + amtot=amtot+nb*aspecs(19) + do ii=1,nflavs + k(ii)=k(ii)-ifok(ii,19)*nb + enddo + nbb=nbb+nb + + + do it=1,nit + + xsp=nspecs + x0=0.5 + xib=x0+xsp*rangen() + ib=nint(xib) + if(ib.gt.nspecs)ib=nspecs + if(ib.lt.1)ib=1 + kb=ifok(1,ib)+ifok(2,ib)+ifok(3,ib) + if(rangen().lt.0.5.and.nptlgc(ib).ge.1)then + ni=-1 + else + ni=1 + endif + as=1.0 + if(nptlgc(ib).eq.0)as=0.5 + if(nptlgc(ib).eq.1.and.ni.eq.(-1))as=2.0 + if(ish.ge.9)write(ifch,*) + *'id:',ispecs(ib),' <i>:',ptlngc(ib),' ni:',ni + + if(ni.ne.0)then + + if(ptlngc(ib).gt.5.0)then + + pnla=hgcpnl(ib,0) + pnlb=hgcpnl(ib,ni) + pnlog=-pnla+pnlb + if(ish.ge.9)write(ifch,*)'pnlog:',pnlog + if(pnlog.lt.60)then + pn=exp(pnlog) + else + pn=1.1 + endif + + else + + if(ni.eq.1)then + pn=ptlngc(ib)/(nptlgc(ib)+1) + elseif(ni.eq.(-1).and.ptlngc(ib).gt.1.e-20)then + pn=nptlgc(ib)/ptlngc(ib) + elseif(nptlgc(ib).gt.0)then + pn=1.1 + else + pn=0.0 + endif + + endif + + pm=1.0 + if(ioinfl.ge.0)then + pmla=hgcpml(ib,0,ib,0) + pmlb=hgcpml(ib,ni,ib,0) + pmlog=-pmla+pmlb + if(ish.ge.9)write(ifch,*)'pmlog:',pmlog + if(pmlog.lt.60)then + pm=exp(pmlog) + else + pm=1.1 + endif + endif + + p=pn*pm*as + r=rangen() + if(r.le.p)then + nptlgc(ib)=nptlgc(ib)+ni + n=n+ni + amtot=amtot+ni*aspecs(ib) + do ii=1,nflavs + k(ii)=k(ii)-ifok(ii,ib)*ni + enddo + if(kb.ne.0)nbb=nbb+ni + if(ish.ge.7.and.ni.gt.0)write(ifch,*)'add:' + if(ish.ge.7.and.ni.lt.0)write(ifch,*)'remove:' + if(ish.ge.7)write(ifch,*)'id:',ispecs(ib),' <n_i>:',ptlngc(ib) + *,' n_i:',nptlgc(ib) + if(ish.ge.7)write(ifch,*)'<n>:',nn,' it:',it + if(ish.ge.7)write(ifch,*)'<M>:',amgc,' M:',amtot + if(ish.ge.7)write(ifch,*)'p:',p,' r:',r + if(ish.ge.7)write(ifch,*)'flav defect: u:',k(1),' d:' + *,k(2),' s:',k(3) + if(n.ge.nn.and.ioinco.ne.2)goto102 + endif + + endif + + enddo + + +102 continue + + ndd=0 +c if(nbb.lt.nb)then +c nba=nb-nbb +c if(nbar.gt.0)then +c if(ish.ge.7)write(ifch,*)'add protons: nba:',nba +c nptlgc(19)=nptlgc(19)+nba +c n=n+nba +c amtot=amtot+aspecs(19)*nba +c elseif(nbar.lt.0)then +c if(ish.ge.7)write(ifch,*)'add aprotons: nba:',nba +c nptlgc(20)=nptlgc(20)+nba +c n=n+nba +c amtot=amtot+aspecs(20)*nba +c endif +c endif + if(n.lt.nn.and.ioinco.ne.2)then + ndd=nn-n + nd=mod(ndd,4) + xn=n + xnn=nn + xl=(xnn-xn)/4. + l=aint(xl) + if(ish.ge.7)write(ifch,*)'add pions/etas: ndd:',ndd + *,' l:',l,' nd:',nd + if(l.ge.1)then + do j=1,l + nptlgc(1)=nptlgc(1)+1 + nptlgc(2)=nptlgc(2)+1 + nptlgc(3)=nptlgc(3)+1 + nptlgc(8)=nptlgc(8)+1 + amtot=amtot+aspecs(1)+aspecs(2)+aspecs(3)+aspecs(8) + enddo + endif + if(nd.eq.1)then + nptlgc(1)=nptlgc(1)+1 + amtot=amtot+aspecs(1) + elseif(nd.eq.2)then + nptlgc(2)=nptlgc(2)+1 + nptlgc(3)=nptlgc(3)+1 + amtot=amtot+aspecs(2)+aspecs(3) + elseif(nd.eq.3)then + nptlgc(2)=nptlgc(2)+1 + nptlgc(3)=nptlgc(3)+1 + nptlgc(1)=nptlgc(1)+1 + amtot=amtot+aspecs(2)+aspecs(3)+aspecs(1) + endif + endif + + if(n.eq.0.and.ioinco.eq.2)then + nptlgc(2)=nptlgc(2)+1 + nptlgc(3)=nptlgc(3)+1 + amtot=amtot+aspecs(2)+aspecs(3) + elseif(n.eq.1.and.ioinco.eq.2)then + nptlgc(1)=nptlgc(1)+1 + amtot=amtot+aspecs(1) + endif + + if(amtot.ge.tecm.and.ioinfl.ge.0)then + if(ish.ge.7)write(ifch,*) + *'total mass exceeded , redo configuration' + kk=kk+1 + goto100 + endif + + + iii=0 + if(ish.ge.7)then + write(ifch,*)'u d s :',keu,ked,kes,' E:',tecm + write(ifch,*) + *'hadron set without flavor conservation:' + endif + do i=1,nspecs + n=nptlgc(i) + if(n.ge.1)then + do j=1,n + iii=iii+1 + if(iii.gt.maxp)stop'iii>maxp in hgcnbi' + idp(iii)=ispecs(i) + enddo + endif + enddo + if(ish.ge.7)then + write(ifch,'(1x,10i6)')(idp(i),i=1,iii) + write(ifch,*)'flav defect: u:',k(1),' d:' + *,k(2),' s:',k(3) + write(ifch,*)'M:',amtot,' <M>:',amgc + endif + if(ioinfl.le.0)goto1000 + + ll=1 + llmax=nn*25 + ior=1 + +120 if(k(1).ne.0.or.k(2).ne.0.or.k(3).ne.0)then + + if(kk.gt.6)ior=0 + + if(ish.ge.7)write(ifch,*) + *'remaining flavor defect before operation:',ll + if(ish.ge.7)write(ifch,*)'flav defect: u:',k(1),' d:' + *,k(2),' s:',k(3) + + nida=0 + do i=1,nspecs + if(nptlgc(i).gt.0)then + nida=nida+1 + ida(nida)=i + endif + enddo + + if(nida.eq.0)then + if(ish.ge.7)write(ifch,*)'no proposals in a , redo' + kk=kk+1 + goto100 + endif + + + xna=0.5+nida*rangen() + na=nint(xna) + if(na.gt.nida)na=nida + if(na.lt.1)na=1 + ia=ida(na) + if(ish.ge.7)write(ifch,*)'nida:',nida,' ia:',ia + + nidb=0 + do ii=1,nflavs + kp(ii)=k(ii)+ifok(ii,ia) + kps(ii)=isign(1,kp(ii)) + enddo + if(ish.ge.7)write(ifch,*) + *' assemble: u:',kp(1),' d:',kp(2),' s:',kp(3) + do i=1,nspecs + iacc=0 + naccsp=0 + naccmi=1 + do ii=1,nflavs + naccsp=naccsp+iabs(ifok(ii,i)) + if(kp(ii).ne.0)then + if(kps(ii)*ifok(ii,i).le.kps(ii)*kp(ii) + *.and.kps(ii)*ifok(ii,i).gt.0)iacc=iacc+iabs(ifok(ii,i)) + endif + enddo + if(kp(1).eq.0.and.kp(2).eq.0.and.kp(3).eq.0)naccmi=0 + if(iacc.eq.naccsp.and.naccsp.ge.naccmi)then + nidb=nidb+1 + idb(nidb)=i + endif + enddo + + if(nidb.eq.0)then + if(ish.ge.7)write(ifch,*)'no proposals in b , redo' + kk=kk+1 + goto100 + endif + + xnb=0.5+nidb*rangen() + nb=nint(xnb) + if(nb.gt.nidb)nb=nidb + if(nb.lt.1)nb=1 + ib=idb(nb) + if(ish.ge.7)write(ifch,*)'nidb:',nidb,' ib:',ib + if(ish.ge.7)write(ifch,*) + *'proposal:',ispecs(ia),' --> ',ispecs(ib) + + asym=1.0 + +c if(asym.gt.0.0)then + + if(ptlngc(ia).gt.5.0)then + pnali=hgcpnl(ia,0) + pnalf=hgcpnl(ia,-1) + pnalog=-pnali+pnalf + if(ish.ge.7)write(ifch,*)'pnalog:',pnalog + if(pnalog.lt.60)then + pna=exp(pnalog) + else + pna=1.1 + endif + else + if(ptlngc(ia).gt.1.e-20)then + pna=nptlgc(ia)/ptlngc(ia) + elseif(nptlgc(ia).gt.0)then + pna=1.1 + else + pna=0.0 + endif + endif + + if(ptlngc(ib).gt.5.0)then + pnbli=hgcpnl(ib,0) + pnblf=hgcpnl(ib,1) + pnblog=-pnbli+pnblf + if(ish.ge.7)write(ifch,*)'pnblog:',pnblog + if(pnblog.lt.60)then + pnb=exp(pnblog) + else + pnb=1.1 + endif + else + pnb=ptlngc(ib)/(nptlgc(ib)+1) + endif + + + pmli=hgcpml(ia,0,ib,0) + pmlf=hgcpml(ia,-1,ib,1) + pmlog=-pmli+pmlf + if(ish.ge.7)write(ifch,*)'pmlog:',pmlog + if(pmlog.lt.60)then + pm=exp(pmlog) + else + pm=1.1 + endif + + p=pna*pnb*pm*asym + if(ior.eq.0)then + r=0.0 + else + r=rangen() + endif + +c else + +c r=1.0 +c p=0.0 + +c endif + + if(r.lt.p)then + if(ish.ge.7)write(ifch,*)'p:',p,' r:',r,' asymmetry:',asym + if(ish.ge.7)write(ifch,*)'remove ',ispecs(ia),' add ',ispecs(ib) + *,' proposal accepted' + nptlgc(ia)=nptlgc(ia)-1 + nptlgc(ib)=nptlgc(ib)+1 + amtot=amtot-aspecs(ia)+aspecs(ib) + do ii=1,nflavs + k(ii)=k(ii)+ifok(ii,ia)-ifok(ii,ib) + enddo + endif + + + if(k(1).ne.0.or.k(2).ne.0.or.k(3).ne.0)then + ll=ll+1 + if(ll.le.llmax)then + goto120 + else + if(ish.ge.7)write(ifch,*)'failed to remove defect, redo' + kk=kk+1 + goto100 + endif + endif + + endif + +1000 continue + + nump=0 + kcu=0 + kcd=0 + kcs=0 + do i=1,nspecs + n=nptlgc(i) + if(n.ge.1)then + do j=1,n + nump=nump+1 + ihadro(nump)=ispecs(i) + kcu=kcu+ifok(1,i) + kcd=kcd+ifok(2,i) + kcs=kcs+ifok(3,i) + enddo + endif + enddo + + if(ioinfl.gt.0)then + if(kcu.ne.keu.or.kcd.ne.ked.or.kcs.ne.kes)then + if(ish.ge.7)write(ifch,*) + *'failed to remove flavor defect, redo configuration' + kk=kk+1 + goto100 + endif + endif + + if(ioinct.ge.1)then + chitot=0.0 + nutot=nspecs + do i=1,nspecs + chi=0.0 + if(rmsngc(i).gt.1.e-10)chi=(ptlngc(i)-nptlgc(i))/rmsngc(i) + chitot=chitot+chi**2 + enddo + call xhgccc(chitot) + + u=0 + d=0 + s=0 + do i=1,nspecs + u=u+ifok(1,i)*nptlgc(i) + d=d+ifok(2,i)*nptlgc(i) + s=s+ifok(3,i)*nptlgc(i) + enddo + call xhgcfl(u,d,s,0) + call xhgcam(amtot,0) + endif + + if(ish.ge.7)then + write(ifch,*) + *'initial hadron set for droplet decay:' + write(ifch,'(1x,10i6)')(ihadro(i),i=1,nump) + endif + if(nump.ge.nlattc)then + nlattc=nump+1 + if(ish.ge.7)then + write(ifch,*)'initial set > nlattc !' + write(ifch,*)'new nlattc:',nlattc + endif + endif + if(ish.ge.7)then + write(ifch,*)'keu:',kef(1),' kcu:',kcu,' ku:',k(1) + write(ifch,*)'ked:',kef(2),' kcd:',kcd,' kd:',k(2) + write(ifch,*)'kes:',kef(3),' kcs:',kcs,' ks:',k(3) + write(ifch,*)' nh:',nh,' nump:',nump + write(ifch,*)' nu:',nutot,' chi^2:',chitot + write(ifch,*)'iozero:',iozero,' iomom:',iomom + write(ifch,*) + *'total mass:',amtot,' droplet mass:',tecm + write(ifch,*)'trials needed:',kk + *,' operations needed:',ll + write(ifch,*)'iterations:',it,' pions added:',ndd + write(ifch,*)('-',i=1,30) + *,' exit sr hgcnbi ',('-',i=1,10) + endif + ish=isho + return + + end + +c-------------------------------------------------------------------- + integer function hgcndn(i) +c-------------------------------------------------------------------- +c returns random multiplicity from gaussian distribution for species i +c--------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cgctot/rmstot,ptltot + common/clatt/nlattc,npmax + a=iowidn + kk=0 + + if(i.eq.0)then + +1 continue + kk=kk+1 + p=0.0 + nmin=2 + nh=nint(ptltot) + nmax=nlattc + xn=1.5+(nmax-nmin)*rangen() + n=nint(xn) + x=(n-ptltot)**2/2.0 + y=-70. + if(rmstot.gt.1.e-15)y=-x/rmstot**2*a**2 + if(y.lt.70.)p=exp(y) + if(rmstot.gt.1.e-15.and.iowidn.lt.0)p=p/sqrt(2.*pi)/rmstot + if(p.ge.rangen())then + hgcndn=n + if(ish.ge.9)write(ifch,*)'hgcndn: k:',kk,' n:',hgcndn + return + else + if(kk.le.25)goto1 + hgcndn=max(2,nh) + if(ish.ge.9)write(ifch,*)'hgcndn: k:',kk,' n:',hgcndn + return + endif + + else + +2 continue + kk=kk+1 + p=0.0 + nmin=0 + nh=nint(ptlngc(i)) + nmax=2*nh + nmax=max(2,nmax) + xn=-0.5+(nmax-nmin)*rangen() + n=nint(xn) + x=(n-ptlngc(i))**2/2.0 + if(x.lt.1.e-30)then + p=1. + else + y=-70. + if(rmsngc(i).gt.1.e-15)y=-x/rmsngc(i)**2 + if(y.lt.70.)p=exp(y) + if(rmsngc(i).gt.1.e-15.and.iowidn.lt.0) + *p=p/sqrt(2.*pi)/rmsngc(i) + endif + if(p.ge.rangen())then + hgcndn=n + if(ish.ge.9)write(ifch,*)'hgcndn: k:',kk,' n:',hgcndn + return + else + if(kk.le.25)goto2 + hgcndn=nh + if(ish.ge.9)write(ifch,*)'hgcndn: k:',kk,' n:',hgcndn + return + endif + + endif + + end + +c-------------------------------------------------------------------- + function hgcpml(i1,n1,i2,n2) +c-------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/camgc/amgc,samgc,amtot + common/cgcnb/nptlgc(mspecs) + if(ish.ge.9)write(ifch,*)'i1:',i1,' i2:',i2 + if(ish.ge.9)write(ifch,*)'n1:',n1,' n2:',n2 + hgcpml=-1.e30 + ampr=n1*aspecs(i1)+n2*aspecs(i2) + if((amtot+ampr).lt.tecm.and.(amtot+ampr).ge.0 + *.and.nptlgc(i1).ge.(-n1).and.nptlgc(i2).ge.(-n2))then + hgcpml=0.0 + pl=(amtot-amgc+ampr)**2/2.0 + if(pl.lt.1.e-30)then + hgcpml=0.0 + return + endif + if(samgc.gt.1.e-15)hgcpml=-pl/samgc**2 + endif + if(ish.ge.9)write(ifch,*)'hgcpml:',hgcpml + return + end + +c-------------------------------------------------------------------- + function hgcpnl(i,n) +c-------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cgcnb/nptlgc(mspecs) + if(ish.ge.9)write(ifch,*)'i:',i,' n:',n + hgcpnl=-1.e30 + if(nptlgc(i).ge.(-n))then + pl=(nptlgc(i)-ptlngc(i)+n)**2/2.0 + if(pl.lt.1.e-30)then + hgcpnl=0.0 + return + endif + if(rmsngc(i).gt.1.e-15)hgcpnl=-pl/rmsngc(i)**2 + endif + if(ish.ge.9)write(ifch,*)'hgcpnl:',hgcpnl + return + end + + +c-------------------------------------------------------------------- + subroutine hgcpen +c-------------------------------------------------------------------- +c returns array for twodimensional plot of energy- and flavor- +c density +c-------------------------------------------------------------------- +c xpar1,xpar2 temperature range +c xpar3 # of bins for temperature +c xpar4,xpar5 chem.pot. range +c xpar6 # of bins for chem.pot. +c xpar7 max. density +c xpar8 strange chem.pot. +c-------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cflavs/nflavs,kef(nflav),chem(nflav) + common/cflac/ifok(nflav,mspecs),ifoa(nflav) + common/ciakt/gen,iafs,ians,genm + parameter (nbin=100) + real edensi(nbin,nbin),qdensi(nbin,nbin) + external hgcfhe + external hgcfhn + external hgcfbe + external hgcfbn + + iug=(1+iospec)/2*2-1 + +c initialization +c -------------- + + if(iug.eq.1)nflavs=1 + if(iug.eq.3)nflavs=2 + if(iug.eq.5)nflavs=2 + if(iug.eq.7)nflavs=3 + if(iug.eq.9)nflavs=3 + if(iug.eq.11)nflavs=3 + tem=0.0 + do i=1,nflavs + chem(i)=0.0 + enddo + call hgchac(0) + do i=1,nspecs + ptlngc(i)=0.0 + rmsngc(i)=0.0 + enddo + + nbt=nint(xpar3) + nbc=nint(xpar6) + nbc=min(nbc,100) + nbt=min(nbt,100) + dt=(xpar2-xpar1)/nbt + dc=(xpar5-xpar4)/nbc + ymax=xpar7 + cs=xpar8 + + + t0=xpar1+dt/2. + c0=xpar4+dc/2 + do i=1,nbc + chem(1)=c0+(i-1)*dc + chem(2)=chem(1) + chem(3)=cs + chem(4)=0.0 + chem(5)=0.0 + chem(6)=0.0 + call hgchac(0) + do ii=1,nbt + tem=t0+(ii-1)*dt + if(ish.ge.5)write(ifch,*)' mu:',chem(1),' T:',tem + + qd=0.0 + ed=0.0 + + do ians=1,nspecs + + call hgclim(a,b) + + if(b.eq.0.0)then + hden=0.0 + elseif(iostat.eq.0)then + call uttraq(hgcfhn,a,b,hden) + elseif(iostat.eq.1)then + call uttraq(hgcfbn,a,b,hden) + endif + hd=hden*gspecs(ians)/2./pi**2/hquer**3 + + if(ish.ge.7)write(ifch,*)'i:',ians,' n_u:',ifok(1,ians),' hd:',hd + + qd=qd+ifok(1,ians)*hd+ifok(2,ians)*hd + if(qd.gt.ymax)qd=ymax +c if(qd.gt.ymax)qd=0.0 + if(qd.lt.-ymax)qd=-ymax +c if(qd.lt.-ymax)qd=0.0 + + + if(b.eq.0.0)then + edi=0.0 + elseif(iostat.eq.0)then + call uttraq(hgcfhe,a,b,edi) + elseif(iostat.eq.1)then + call uttraq(hgcfbe,a,b,edi) + endif + edi=edi*gspecs(ians)/2./pi**2/hquer**3 + + if(ish.ge.7)write(ifch,*)'i:',ians,' mu:',chemgc(ians) + * ,' edi:',edi + + ed=ed+edi + if(ed.gt.ymax)ed=ymax +c if(ed.gt.ymax)ed=0.0 + enddo + + if(ish.ge.5)write(ifch,*)' ed:',ed,' qd:',qd + edensi(i,ii)=ed + qdensi(i,ii)=qd + + enddo + enddo + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a,2e11.3)')'xrange',xpar1,xpar2 + write(ifhi,'(a,2e11.3)')'yrange',xpar4,xpar5 + write(ifhi,'(a)') 'set ityp2d 5' + write(ifhi,'(a,i4)') 'array2d',nbt + do j=1,nbc + do jj=1,nbt + write(ifhi,'(e11.3)') edensi(j,jj) + enddo + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot2d' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a,2e11.3)')'xrange',xpar1,xpar2 + write(ifhi,'(a,2e11.3)')'yrange',xpar4,xpar5 + write(ifhi,'(a)') 'set ityp2d 5' + write(ifhi,'(a,i4)') 'array2d',nbt + do j=1,nbc + do jj=1,nbt + write(ifhi,'(e11.3)') qdensi(j,jj) + enddo + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot2d' + + return + end + +c-------------------------------------------------------------------- + subroutine hgcpfl +c-------------------------------------------------------------------- +c returns array for twodimensional plot of energy- and flavor- +c density fluctuations +c-------------------------------------------------------------------- +c xpar1,xpar2 temperature range +c xpar3 # of bins for temperature +c xpar4,xpar5 chem.pot. range +c xpar6 # of bins for chem.pot. +c xpar7 max. density +c xpar8 strange chem.pot. +c-------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cflavs/nflavs,kef(nflav),chem(nflav) + common/ciakt/gen,iafs,ians,genm + parameter (nbin=100) + real efl(nbin,nbin),qfl(nbin,nbin),v(nbin),wn(nbin),we(nbin) + external hgcfhf + external hgcfhe + external hgcfhn + external hgcfhw + external hgcfbf + external hgcfbe + external hgcfbn + + iug=(1+iospec)/2*2-1 + +c initialization +c -------------- + + if(iug.eq.1)nflavs=1 + if(iug.eq.3)nflavs=2 + if(iug.eq.5)nflavs=2 + if(iug.eq.7)nflavs=3 + if(iug.eq.9)nflavs=3 + if(iug.eq.11)nflavs=3 + tem=0.0 + do i=1,nflavs + chem(i)=0.0 + enddo + call hgchac(0) + do i=1,nspecs + ptlngc(i)=0.0 + rmsngc(i)=0.0 + enddo + + nbt=nint(xpar3) + nbv=nint(xpar6) + nbv=min(nbv,100) + nbt=min(nbt,100) + dt=(xpar2-xpar1)/nbt + dv=(xpar5-xpar4)/nbv + ymax=1.e20 + chem(1)=xpar7 + chem(2)=xpar7 + chem(3)=xpar8 + call hgchac(0) + + + t0=xpar1+dt/2. + v0=xpar4 + do i=1,nbv + volu=v0+(i-1)*dv + do ii=1,nbt + tem=t0+(ii-1)*dt + if(ish.ge.5)write(ifch,*)'volu:',volu,' tem:',tem + + ev=0.0 + ee=0.0 + qv=0.0 + qe=0.0 + + do ians=1,nspecs + + call hgclim(a,b) + + if(b.eq.0.0)then + hn=0.0 + hv=0.0 + elseif(iostat.eq.0)then + call uttraq(hgcfhn,a,b,hn) + call uttraq(hgcfhw,a,b,hv) + elseif(iostat.eq.1)then + call uttraq(hgcfbn,a,b,hn) + hv=hn + endif + hn=hn*volu*gspecs(ians)/2./pi**2/hquer**3 + hv=hv*volu*gspecs(ians)/2./pi**2/hquer**3 + if(ish.ge.5)write(ifch,*)'hn:',hn,' hv:',hv + + hn=max(hn,1.e-15) + qv=qv+hv + qe=qe+hn + + + if(qv.gt.ymax)qv=ymax + if(qe.gt.ymax)qe=ymax + + + if(b.eq.0.0)then + eei=0.0 + evi=0.0 + elseif(iostat.eq.0)then + call uttraq(hgcfhe,a,b,eei) + call uttraq(hgcfhf,a,b,evi) + elseif(iostat.eq.1)then + call uttraq(hgcfbe,a,b,eei) + call uttraq(hgcfbf,a,b,evi) + endif + eei=eei*volu*gspecs(ians)/2./pi**2/hquer**3 + evi=evi*volu*gspecs(ians)/2./pi**2/hquer**3 + if(ish.ge.5)write(ifch,*)'eei:',eei,' evi:',evi + + + eei=max(eei,1.e-15) + ev=ev+evi + ee=ee+eei + if(ev.gt.ymax)ev=ymax + if(ee.gt.ymax)ee=ymax + enddo + if(ish.ge.5)write(ifch,*)'qv:',qv,' ev:',ev + + qfl(i,ii)=0. + efl(i,ii)=0. + if(ev.gt.0.0.and.ee.gt.1.e-15)efl(i,ii)=sqrt(ev)/ee + if(qv.gt.0.0.and.ee.gt.1.e-15)qfl(i,ii)=sqrt(qv)/qe + if(tem.eq.0.195)then + we(i)=efl(i,ii) + wn(i)=qfl(i,ii) + v(i)=volu + endif + + enddo + enddo + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a,2e11.3)')'xrange',xpar1,xpar2 + write(ifhi,'(a,2e11.3)')'yrange',xpar4,xpar5 + write(ifhi,'(a)') 'set ityp2d 5' + write(ifhi,'(a,i4)') 'array2d',nbt + do j=1,nbv + do jj=1,nbt + write(ifhi,'(e11.3)') efl(j,jj) + enddo + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot2d' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a,2e11.3)')'xrange',xpar1,xpar2 + write(ifhi,'(a,2e11.3)')'yrange',xpar4,xpar5 + write(ifhi,'(a)') 'set ityp2d 5' + write(ifhi,'(a,i4)') 'array2d',nbt + do j=1,nbv + do jj=1,nbt + write(ifhi,'(e11.3)') qfl(j,jj) + enddo + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot2d' + + write(ifhi,'(a)') 'newpage zone 1 2 1' + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a,2e11.3)')'xrange',xpar4,xpar5 + write(ifhi,'(a)') 'htyp lfu xmod lin ymod lin' + write(ifhi,'(a,i4)') 'array 2' + do j=1,nbv + write(ifhi,'(2e13.5)')v(j),we(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a,2e11.3)')'xrange',xpar4,xpar5 + write(ifhi,'(a)') 'htyp lfu xmod lin ymod lin' + write(ifhi,'(a,i4)') 'array 2' + do j=1,nbv + write(ifhi,'(2e13.5)')v(j),wn(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + + return + end + + +c------------------------------------------------------------------ + subroutine hgcpyi(ist) +c------------------------------------------------------------------ +c returns particle yield +c input: +c tem : temperature +c chemgc: chemical potentials +c output: +c ptlngc: expectation value of particle number for each species +c rmsngc: standard deviation of ptlngc +c ptltot: total particle number +c rmstot: standard deviation of ptltot +c works for hadrons and partons +c ist=1 boltzmann statistics +c ist=0 quantum statistics +c-------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cgctot/rmstot,ptltot + common/camgc/amgc,samgc,amtot + common/ciakt/gen,iafs,ians,genm + external hgcfhw + external hgcfhn + + if(iabs(ispecs(nspecs)).lt.10)then + +c parton yield +c ------------ + if(ish.ge.5)write(ifch,*)'parton yield:' + gln=16.*1.20206*tem**3/pi**2*volu/hquer**3 + sdg=sqrt(gln) !!??? + if(ish.ge.5)write(ifch,'(1x,a,f10.4,2x,a,f9.4,a)') + *'<N( 0)> :',gln,' sigma :',sdg,' (qm-statistics!)' + ptltot=gln + rmstot=0.0 + vartot=gln + + else + + if(ish.ge.5)write(ifch,*)'hadronic yield:' + ptltot=0.0 + rmstot=0.0 + vartot=0.0 + + endif + + amgc=0.0 + samgc=0.0 + + do ians=1,nspecs + +c hadronic yield +c -------------- + if(ist.eq.0)then + + call hgclim(a,b) + if(b.eq.0.0)then + hden=0.0 + else + call uttraq(hgcfhn,a,b,hden) + endif + ptlngc(ians)=hden*volu*gspecs(ians)/2./pi**2/hquer**3 + + else + + if((chemgc(ians)/tem).gt.70.)then + hpd=1.e30 + else + hpd=exp(chemgc(ians)/tem) + endif + if(aspecs(ians).ne.0.)then + fk2=hgcbk(2,aspecs(ians)/tem) + hpd=hpd*gspecs(ians)*aspecs(ians)**2*tem*fk2 + */2./pi**2/hquer**3 + else + hpd=hpd*gspecs(ians)*tem**3/pi**2/hquer**3 + endif + ptlngc(ians)=hpd*volu + + endif + + ptltot=ptltot+ptlngc(ians) + amgc=amgc+ptlngc(ians)*aspecs(ians) + if(amgc.ge.tecm)amgc=tecm*0.9 + +c standard deviation +c ------------------ + rmsngc(ians)=0.0 + + if(ist.eq.0)then + + call uttraq(hgcfhw,a,b,var) + var=var*gspecs(ians)*volu/2./pi**2/hquer**3 + vartot=vartot+var + if(var.ge.0.0)rmsngc(ians)=sqrt(var) + samgc=samgc+var*aspecs(ians) + + else + + if(ptlngc(ians).ge.0.0)rmsngc(ians)=sqrt(ptlngc(ians)) + vartot=vartot+ptlngc(ians) + samgc=samgc+ptlngc(ians)*aspecs(ians) + + endif + + + if(ish.ge.7)write(ifch,'(2x,a,i5,a,2x,f8.4,5x,a,3x,f8.4)') + *'m(',ispecs(ians),') :',aspecs(ians),'mu :',chemgc(ians) + if(ish.ge.5)write(ifch,'(1x,a,i5,a,2x,f8.4,2x,a,2x,f10.4)') + *'<N(',ispecs(ians),')> :',ptlngc(ians),'sigma :',rmsngc(ians) + + enddo + + if(vartot.ge.0.0)rmstot=sqrt(vartot) + if(samgc.ge.0.0)samgc=sqrt(samgc) + if(amgc.ge.tecm)samgc=sqrt(amgc) + if(ish.ge.5)write(ifch,'(1x,a,2x,f8.4,2x,a,2x,f10.4)') + *'<N( all)> :',ptltot,'sigma :',rmstot + if(ish.ge.5)write(ifch,'(1x,a,2x,f8.4,2x,a,2x,f10.4)') + *'<M_tot> :',amgc,'sigma :',samgc + + return + end + +c------------------------------------------------------------------------ + subroutine hgctbo(iba) +c------------------------------------------------------------------------ +c returns new tem using boltzmann statistics in analytic form +c input: +c chemgc +c tecm/volu +c output: +c tem +c---------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/ciakt/gen,iafs,ians,genm + external hgcbk + external hgcbk1 + iba=0 + k=1 + t1=0.0 + t2=1.0 + + goto15 + +10 tem=t1+.5*(t2-t1) + if(tem.le.1.e-7)return +15 eden=0.0 + + do i=1,nspecs + + if(aspecs(i).ne.0)then + if(tem.ne.0.)arr=aspecs(i)/tem + cba=(aspecs(i)/tem+12.*tem/aspecs(i)-3.*chemgc(i)/aspecs(i)) + **hgcbk(2,arr)+(3.-chemgc(i)/tem)*hgcbk1(arr) + else + cba=4.*tem-chemgc(i) + endif + + if(cba.lt.0.0)then + iba=1 + return + endif + + x=0. + if(tem.ne.0.)x=chemgc(i)/tem + + if(x.le.70.)then + y=exp(x) + else + y=1.e30 + endif + + if(aspecs(i).ne.0.)then + edi=y*(3./arr*hgcbk(2,arr)+hgcbk1(arr)) + **gspecs(i)*aspecs(i)**3*tem/2./pi**2/hquer**3 + else + edi=y*3.*gspecs(i)*tem**4/pi**2/hquer**3 + endif + + eden=eden+edi + + enddo + + if(iabs(ispecs(nspecs)).lt.10) + *eden=eden+(8.*pi**2*tem**4/15.+bag4rt**4)/hquer**3 + + de=abs(eden-(tecm/volu)) + if(de.le.gen*(tecm/volu).or.de.le.genm)return +c if(eden.ge.100.)return + + if(eden.gt.(tecm/volu))then + t2=tem + else + t1=tem + endif + + if(k.gt.300)return + + k=k+1 + goto10 + end + +c---------------------------------------------------------------------- + subroutine hgctex +c---------------------------------------------------------------------- +c returns new tem using massive quantum statistics in integral form +c input: +c chemgc +c tecm/volu +c output: +c tem +c---------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/ciakt/gen,iafs,ians,genm + external hgcfhe + k=1 + t1=0.0 + t2=tem+0.1 + goto15 + +c new temperature +c --------------- +10 tem=t1+.5*(t2-t1) +15 continue + if(tem.le.1.e-6)return + eden=0.0 + + do ians=1,nspecs + call hgclim(a,b) + if(b.eq.0.0)then + edi=0.0 + else + call uttraq(hgcfhe,a,b,edi) + endif + edi=edi*gspecs(ians)/2./pi**2/hquer**3 + eden=eden+edi + enddo + + if(iabs(ispecs(nspecs)).lt.10) + *eden=eden+(8.*pi**2*tem**4/15.+bag4rt**4)/hquer**3 + + de=abs(eden-(tecm/volu)) + if(de.le.gen*(tecm/volu).or.de.le.genm)return + + if(eden.gt.(tecm/volu))then + t2=tem + else + t1=tem + endif + + if(k.gt.300)then + if(ish.ge.5) + *write(ifch,*)'failure in tex' + return + endif + + k=k+1 + goto10 + end + +c----------------------------------------------------------------- + subroutine hgctm0 +c----------------------------------------------------------------- +c returns new tem using massless quantum statistics in analytic form +c input: +c chemgc +c tecm/volu +c output: +c tem +c---------------------------------------------------------------------- + + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/ciakt/gen,iafs,ians,genm + + k=1 + + t1=0.0 + t2=1.0 +10 tem=t1+.5*(t2-t1) + if(tem.le.1.e-6)return + eden=0.0 + + do i=1,nspecs + + igsp=int(gspecs(i)) + if(mod(igsp,2).eq.0)then + edhm0=7./240.*pi**2*tem**4+chemgc(i)**2*tem**2/8. + *+chemgc(i)**4/pi**2/16. + else + edhm0=pi**2*tem**4/30.+chemgc(i)**2*tem**2/4. + *-chemgc(i)**4/pi**2/16. + endif + edi=edhm0*gspecs(i)/hquer**3 + + + eden=eden+edi + enddo + + if(iabs(ispecs(nspecs)).lt.10) + *eden=eden+(8.*pi**2*tem**4/15.+bag4rt**4)/hquer**3 + + de=abs(eden-(tecm/volu)) + if(de.le.gen*(tecm/volu).or.de.le.genm)return + + if(eden.gt.(tecm/volu))then + t2=tem + else + t1=tem + endif + + if(k.gt.300)then + if(ish.ge.5) + *write(ifch,*)'failure in tm0' + return + endif + + k=k+1 + goto10 + end + +c------------------------------------------------------------------------------ + subroutine hnbcor(mode) +c------------------------------------------------------------------------------ +c determines(mode=1) and plots (mode=2) two particle correlations +c for the configurations /confg/ +c------------------------------------------------------------------------------ + include 'epos.inc' + integer bns + parameter (maxp=500,bns=100) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + dimension zwei(bns),zz(bns)!,phi(bns),yy(bns) + common/cor/wert(bns),cwert(bns) + character*6 cen,cvol + + if(mode.eq.1)then + + nctcor=nctcor+1 + + if(nctcor.eq.1)then + do nn=1,bns + wert(nn)=0 + cwert(nn)=0 + enddo + endif + + ll=0 + + do ii=1,np-1 + do jj=ii+1,np + + ll=ll+1 + prod=0 + + do kk=1,3 + prod=prod+pcm(kk,ii)*pcm(kk,jj) + enddo + + cs=prod/pcm(5,ii)/pcm(5,jj) + + if(abs(cs).gt.1.)then + cs=aint(cs) + ang=acos(cs) + else + ang=acos(cs) + endif + + if(cs.eq.1.)then + nk=bns + nw=1 + elseif(ang.eq.pi)then + nk=1 + nw=bns + else + nw=1+aint(ang/pi*bns) + nk=1+aint((cs+1.)/2.*bns) + endif + nw=min(nw,bns) + nk=min(nk,bns) + + wert(nw)=wert(nw)+1 + cwert(nk)=cwert(nk)+1 + + enddo + enddo + + elseif(mode.eq.2)then + + do mm=1,bns +c phi(mm)=.5*pi/bns+(mm-1)*pi/bns + zwei(mm)=.5*2./bns+(mm-1)*2./bns-1. +c yy(mm)=wert(mm)/nctcor + zz(mm)=cwert(mm)/nctcor + enddo + + write(cen,'(f6.1)')tecm + write(cvol,'(f6.1)')volu + + write(ifhi,'(a)') 'newpage zone 1 1 1 openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'xrange -1 1' + write(ifhi,'(a)') 'text 0 0 "xaxis cosine"' + write(ifhi,'(a)') 'text 0 0 "yaxis counts"' + write(ifhi,'(a)') 'text 0.4 0.91 "V='//cvol//'"' + write(ifhi,'(a)') 'text 0.15 0.91 "E='//cen//'"' + write(ifhi,'(a)') 'array 2' + do mm=1,bns + write(ifhi,'(2e13.5)')zwei(mm),zz(mm) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + endif + + return + end + +c---------------------------------------------------------------------- + subroutine hnbfac(faclog) +c---------------------------------------------------------------------- +c returns log of factor for phase space weight +c faclog= log{ prod[ m_i*(2*s_i+1)*volu/4/pi**3/hquer**3/(n_l+1-i) ] } +c ~~~~~~~~~~~~~~ +c corresponds to eq. 67 of micro paper : +c Cvol * Cdeg * Cident * Cmicro +c the factors partly compensate each other !! +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog +c integer ii(maxp) + common /clatt/nlattc,npmax + + faclog=0 + +c sum_i log m_i*g_i*volu/4/pi**3/hquer**3/(n_l+1-i) -> flog + flog=0 + do i=1,np + call hnbfaf(i,gg,am,ioma) + flog=flog+alog(gg*am*volu/4/pi**3/hquer**3/(nlattc+1-i)) + enddo + faclog=faclog+flog + + return + end + +c---------------------------------------------------------------------- + subroutine hnbfaf(i,gg,am,ioma) +c---------------------------------------------------------------------- +c returns degeneracy gg and mass am for factor f5 +c---------------------------------------------------------------------- + common/metr1/iospec,iocova,iopair,iozero,ioflac,iomom + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + common/drop6/tecm,volu + + ioma=5 + + hquer=0.197327 + cc=0.216416 + dd=13.773935 + + call hnbspi(ident(i),spideg) + gg=spideg + + if(ioma.eq.1)am=amass(i) + if(ioma.eq.2)am=tecm/np + if(ioma.eq.3)am=1 + if(ioma.eq.4) + *am=cc*dd*gg**(-0.25)*(tecm/volu)**(0.25)*hquer**(0.75) + if(ioma.eq.5)am=0.5 ! 1GeV / 2 (dimension energy) + if(iocova.eq.2)then + am=0.5 ! 1 / 2 (no dimension) + ioma=0 + endif + return + end + +cc---------------------------------------------------------------------- +c subroutine hnbids(jc,ids,iwts,i) +cc---------------------------------------------------------------------- +cc returns i id-codes ids() corr to jc and their weights iwts() +cc---------------------------------------------------------------------- +c parameter (mxids=200,mspecs=56,nflav=6) +c common/metr1/iospec,iocova,iopair,iozero,ioflac,iomom +c common/cflac/ifok(nflav,mspecs),ifoa(nflav) +c common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) +c integer ids(mxids),jc(nflav,2),iwts(mxids),jc1mi2(nflav) +c +c if(nspecs+1.gt.mxids)call utstop('hnbids: mxids too small&') +c +c do n=1,nflav +c jc1mi2(n)=jc(n,1)-jc(n,2) +c enddo +c +c i=0 +c +c do n=1,nflav +c if(jc1mi2(n).ne.0)goto1 +c enddo +c i=i+1 +c ids(i)=0 +c iwts(i)=iozero +c 1 continue +c +c do j=1,nspecs +c do n=1,nflav +c if(jc1mi2(n).ne.ifok(n,j))goto2 +c enddo +c i=i+1 +c ids(i)=ispecs(j) +c iwts(i)=1 +c 2 continue +c enddo +c +c return +c end +c +c---------------------------------------------------------------------- + subroutine hnbiiw(x,f,df) +c---------------------------------------------------------------------- +c returns fctn value and first derivative at x of the +c i-th integrated weight fctn minus random number +c for the asympotic phase space integral. +c input: +c x: x-value +c iii: i-value (via common/ciiw/iii,rrr) +c rrr: random number ( " ) +c output: +c f: fctn value +c df: first derivative +c---------------------------------------------------------------------- + common/ciiw/iii,rrr + i=iii + f=x**(2*i-2)*(i-(i-1)*x**2)-rrr + df=2*i*(i-1)*(x**(2*i-3)-x**(2*i-1)) + return + end + +c---------------------------------------------------------------------- + subroutine hnbini(iret) +c---------------------------------------------------------------------- +c generates initial configuration +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/crnoz/rnoz(maxp-1) + common/citer/iter,itermx + common/cfact/faclog + common/chnbin/nump,ihadro(maxp) + common /clatt/nlattc,npmax + parameter(maxit=50000) + common/count/nacc,nrej,naccit(maxit),nptot,npit(maxit) + common/ctaue/taue + if(ish.ge.7)write(ifch,*)('-',i=1,10) + *,' entry sr hnbini ',('-',i=1,30) + + iter=0 + + nlattc=8*(tecm/10)*(1/(tecm/volu))**0.2*(nspecs/3.)**0.3 + if(aspecs(1).lt.0.010)nlattc=nlattc*3 + nlattc=max(nlattc,20) + if(iternc.lt.0)iternc=1.500*nlattc + + itermx=iterma + if(itermx.le.0)then + e=tecm/volu + b=1.1*(e+0.33)**0.66 + a=13.*(e+0.13)**(-0.65) + tm=34.*(e+0.65)**(-0.61) + t=a+b*volu + taue=max(t,tm) + itermx=(-itermx)*taue + else + taue=0 + endif + if(ish.ge.5)write(ifch,*)'itermx:',itermx + + if(iternc.gt.itermx/2)iternc=itermx/2 + + if(ioinco.eq.0)then + call hnbmin(keu,ked,kes,kec) + if(iograc.eq.1)call hgcaaa + elseif(ioinco.ge.1)then + nk=keu+ked+ked+kec + if(tecm.lt.1.5.and.nk.eq.0)then + call hnbmin(keu,ked,kes,kec) + elseif(tecm.lt.2.0.and.nk.ne.0)then + call hnbmin(keu,ked,kes,kec) + else + call hgcaaa + call hgcnbi(iret) + if(iret.eq.1)then + call hnbmin(keu,ked,kes,kec) + if(ish.ge.5)then + write(ifch,*)'hadron set from hnbmin:' + write(ifch,'(10i6)')(ihadro(k),k=1,nump) + endif + endif + endif + endif + + np=nump+nadd + if(np.gt.maxp)stop'np too large' + + nlattc=max(nlattc,1+int(np*1.2)) +c print *,np,nlattc + if(nlattc-1.gt.maxp)stop'maxp too small' + + do i= 1, nlattc-1 + rnoz(i)=rangen() + enddo + + if(nadd.gt.0)then + do i=nump+1,np + ihadro(i)=110 + enddo + endif + + do i=1,np + ident(i)=ihadro(i) + amass(i)=-1 + do j=1,nspecs + if(ident(i).eq.ispecs(j))then + amass(i)=aspecs(j) + goto1 + endif + enddo + 1 continue + if(amass(i).lt.0.) + *call utstop('hnbini: invalid particle species&') + enddo + + if(iocova.eq.1)call hnbody !covariant + if(iocova.eq.2)call hnbodz !noncovariant + call hnbfac(faclog) + wtlog=wtxlog+faclog + + iret=0 + if(wtlog.le.-0.99999E+35)then + if(ish.ge.1) then + call utmsg('hnbini') + write(ifch,*)'***** wtlog for initl config < -1E+35' + write(ifch,*)'***** wtlog:',wtlog + write(ifch,*)'***** droplet mass:',tecm + write(ifch,*)'***** flavour:' + write(ifch,*)'*****',keu,ked,kes,kec,keb,ket + write(ifch,'(1x,a,1x,10i6)')'*****',(ihadro(i),i=1,nump) + call utmsgf + endif + iret=1 + goto1000 + endif + + if(ish.ge.7)then + write(ifch,*)'initial configuration:' + call hnbwri + endif + + itermx=iterma + if(itermx.le.0)then + e=tecm/volu + b=1.1*(e+0.33)**0.66 + a=13.*(e+0.13)**(-0.65) + tm=34.*(e+0.65)**(-0.61) + t=a+b*volu + taue=max(t,tm) + itermx=(-itermx)*taue + else + taue=0 + endif + if(ish.ge.5)write(ifch,*)'itermx:',itermx + + if(iternc.gt.itermx/2)iternc=itermx/2 + + nacc=0 + nrej=0 + + 1000 continue + + if(ish.ge.7)write(ifch,*)('-',i=1,30) + *,' exit sr hnbini ',('-',i=1,10) + + return + end + +cc---------------------------------------------------------------------- +c subroutine hnbint(tecmx,nevtxx,nsho) +cc---------------------------------------------------------------------- +cc calculates phase space integral of the minimal hadron configuration +cc compatibel with keu, ked, kes, kec for a total mass of tecm +cc by employing nevtxx simulations and printing results every nsho events +cc---------------------------------------------------------------------- +c include 'epos.inc' +c parameter(maxp=500) +c common/chnbin/nump,ihadro(maxp) +c common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog +c tecm=tecmx +c write(ifch,*) +c write(ifch,'(1x,a,4i3,a,f10.4)')'droplet id:',keu,ked,kes,kec +c *,' droplet mass:',tecm +c call hnbmin(keu,ked,kes,kec) +c np=nump +c if(np.gt.maxp)stop'np too large' +c do i=1,np +c id=ihadro(i) +c if(id.eq.30)then +c call idmass(2130,am) +c amass(i)=2*am-0.100 +c else +c call idmass(id,amass(i)) +c endif +c enddo +c wts=0 +c n=0 +c do ll=1,nevtxx +c n=n+1 +c if(iocova.eq.1)call hnbody +c if(iocova.eq.2)call hnbodz +c wt=exp(wtxlog) +c wts=wts+wt +c if(mod(n,nsho).eq.0) +c *write(ifch,'(a,i7,3x,a,e13.6,3x,a,e13.6,3x,a,e13.6)') +c *'n:',n,'weight:',wt,'wts/n:',wts/n,'error:',wts/n/sqrt(1.*n) +c enddo +c return +c end +cc---------------------------------------------------------------------- + subroutine hnbmet +c---------------------------------------------------------------------- +c change (or not) configuration via metropolis +c configuration=np,tecm,amass(),ident(),pcm(),volu,wtlog +c (common /confg/) +c nlattc (in /clatt/) must be set before calling this routine +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + common/crnoz/rnoz(maxp-1) + real rnozo(maxp-1) + common/cfact/faclog + dimension amasso(maxp),idento(maxp),pcmo(5,maxp) + integer jc(nflav,2),jc1(nflav,2),jc2(nflav,2) + common/citer/iter,itermx + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + parameter (literm=500) + common/cmet/kspecs(mspecs),liter,lspecs(literm,mspecs) + *,iterl(literm),iterc(literm) +c parameter (mxpair=mspecs**2*4) + common /clatt/nlattc,npmax + parameter (nhise=100) + common/chise/hise(mspecs,nhise) + integer id1old(2),id2old(2),id1new(2),id2new(2) + parameter(maxit=50000) + common/count/nacc,nrej,naccit(maxit),nptot,npit(maxit) + if(ish.ge.7)then + write(ifch,*)('-',i=1,10) + *,' entry sr hnbmet ',('-',i=1,30) + write(ifch,'(1x,a,i4)')'iteration:',iter + endif + if(mod(iter,iterpr).eq.0)write(ifmt,*)'iteration:',iter + if(maxp.gt.np)then + do n=np+1,maxp + ident(n)=0 + enddo + endif + +c for iter=1 +c ---------- + if(iter.eq.1)then + liter=1 + do i=1,nspecs + kspecs(i)=0 + nptot=0 + do li=1,literm + lspecs(li,i)=0 + enddo + enddo + do li=1,literm + iterc(li)=0 + enddo + do j=1,mspecs + do i=1,nhise + hise(j,i)=0 + enddo + enddo + call hnbzmu(-1) + endif + +c remember old configuration +c -------------------------- + wtlo=wtlog + wtlox=wtxlog + faclo=faclog + npo=np + if(np-1.gt.0)then + do i=1,np-1 + rnozo(i)=rnoz(i) + enddo + endif + if(np.gt.0)then + do i=1,np + amasso(i)=amass(i) + idento(i)=ident(i) + do j=1,5 + pcmo(j,i)=pcm(j,i) + enddo + enddo + endif + +c determine pair, construct new pair, update ident +c ------------------------------------------------ + xab=1 + xba=1 + if(iopair.eq.1)then +c (single pair method) + call hnbpad(1,n1,n2,n3,n4,mm,jc) + id1old(1)=ident(n1) + id2old(1)=ident(n2) + id1old(2)=0 + id2old(2)=0 + call hnbpaj(jc,iwpair,id1,id2) + ident(n1)=id1 + ident(n2)=id2 + call hnbrmz + id1new(1)=id1 + id2new(1)=id2 + id1new(2)=0 + id2new(2)=0 + xab=1 + xba=1 + nzold=0 + if(id1old(1).eq.0)nzold=nzold+1 + if(id2old(1).eq.0)nzold=nzold+1 + nznew=0 + if(id1new(1).eq.0)nznew=nznew+1 + if(id2new(1).eq.0)nznew=nznew+1 + +c determine 2 pairs, construct 2 new pairs, update ident +c ------------------------------------------------------ + elseif(iopair.eq.2)then +c (double pair method) + kkk=0 + 25 call hnbpad(1,n1,n2,n3,n4,mm,jc) + kkk=kkk+1 + id1old(1)=ident(n1) + id2old(1)=ident(n2) + call hnbpai(id1,id2,jc1) + ident(n1)=id1 + ident(n2)=id2 + id1new(1)=id1 + id2new(1)=id2 + do i=1,nflav + do j=1,2 + jc(i,j)=jc(i,j)-jc1(i,j) + jc2(i,j)=jc(i,j) + enddo + enddo + 2 call hnbpad(2,n1,n2,n3,n4,mm,jc1) + id1old(2)=ident(n3) + id2old(2)=ident(n4) + do i=1,nflav + do j=1,2 + jc(i,j)=jc(i,j)+jc1(i,j) + enddo + enddo + call hnbpaj(jc,iwpair,id1,id2) + if(iwpair.eq.0)then + do i=1,nflav + do j=1,2 + jc(i,j)=jc2(i,j) + enddo + enddo + if(ish.ge.7)write(ifch,*)'no pair possible' + goto2 + endif + ident(n3)=id1 + ident(n4)=id2 + id1new(2)=id1 + id2new(2)=id2 + call hnbrmz + if(ish.ge.7)write(ifch,*)'wt-sum of 2. pairs (-->):',iwpair + *,' chosen pair:',id1,id2 + call hnbpaj(jc1,iwpais,idum1,idum2) + if(ish.ge.7)write(ifch,*)'wt-sum of 2. pairs (<--):',iwpais + nzold=0 + if(id1old(1).eq.0)nzold=nzold+1 + if(id2old(1).eq.0)nzold=nzold+1 + if(id1old(2).eq.0)nzold=nzold+1 + if(id2old(2).eq.0)nzold=nzold+1 + if(ish.ge.7)write(ifch,*)'number of zeros (old):',nzold + nznew=0 + if(id1new(1).eq.0)nznew=nznew+1 + if(id2new(1).eq.0)nznew=nznew+1 + if(id1new(2).eq.0)nznew=nznew+1 + if(id2new(2).eq.0)nznew=nznew+1 + if(ish.ge.7)write(ifch,*)'number of zeros (new):',nznew + if(iorejz.eq.1.and.nzold.eq.4.and.nznew.eq.4.and.kkk.le.50)goto25 + xab=1./iwpair*iozero**nznew + xba=1./iwpais*iozero**nzold + if(ish.ge.7)write(ifch,*)'asymmetry factor:',xba/xab + else + call utstop('hnbmet: invalid choice for iopair&') + endif + +c determine masses/momenta/weight of trial configuration +c ------------------------------------------------------ + if(np.ge.2)then + do i=1,np + amass(i)=-1 + do j=1,nspecs + if(ident(i).eq.ispecs(j))then + amass(i)=aspecs(j) + goto1 + endif + enddo + 1 continue + if(amass(i).lt.0.) + *call utstop('hnbmet: invalid particle species&') + enddo + keepr=0 +c-c call hnbolo(1000) !instead of "call hnbody" for testing + keepr=1 + if(iocova.eq.1)call hnbody + if(iocova.eq.2)call hnbodz + else + wtxlog=-1e35 + endif + call hnbfac(faclog) + wtlog=wtxlog+faclog + if(ish.ge.7)then + write(ifch,*)'trial configuration:' + call hnbwri + endif + +c accept or not trial configuration (metropolis) +c ---------------------------------------------- + if(ish.ge.7)write(ifch,'(1x,a,4i5,a,4i5,a)') + *'metropolis decision for ' + *,id1old(1),id2old(1),id1old(2),id2old(2),' --> ' + *,id1new(1),id2new(1),id1new(2),id2new(2),' :' + iacc=0 + if(wtlog-wtlo.lt.30.)then + q=exp(wtlog-wtlo)*xba/xab + r=rangen() + if(r.le.q)iacc=1 + if(ish.ge.7)write(ifch,*)'new weight / old weight:',q,' ' + *,'random number:',r + else + iacc=1 + if(ish.ge.7)write(ifch,*)'log new weight / old weight:' + *,wtlog-wtlo + endif + if(iacc.eq.1)then + if(ish.ge.7)write(ifch,*)'new configuration accepted' + nacc=nacc+1 + naccit(iter)=1 + else + if(ish.ge.7)write(ifch,*)'old configuration kept' + nrej=nrej+1 + wtlog=wtlo + wtxlog=wtlox + faclog=faclo + np=npo + if(np-1.gt.0)then + do i=1,np-1 + rnoz(i)=rnozo(i) + enddo + endif + if(np.gt.0)then + do i=1,np + amass(i)=amasso(i) + ident(i)=idento(i) + do j=1,5 + pcm(j,i)=pcmo(j,i) + enddo + enddo + endif + endif + if(ioobsv.eq.0)then + npit(iter)=np + if(iter.gt.iternc)nptot=nptot+np + else + npob=0 + do i=1,np + if(ioobsv.eq.ident(i))npob=npob+1 + enddo + npit(iter)=npob + if(iter.gt.iternc)nptot=nptot+npob + endif + if(ish.ge.7)then + write(ifch,*)'actual configuration:' + call hnbwri + if(ish.eq.27)stop'change this?????????????' !call hnbcor(1) + endif + +c printout/return +c --------------- + if(iosngl.ne.nrevt+1.and.iocite.ne.1)goto1000 + npmax=max(npmax,np) + if(liter.le.literm)then + iterc(liter)=iterc(liter)+1 + do i=1,np + do j=1,nspecs + if(ident(i).eq.ispecs(j))then + lspecs(liter,j)=lspecs(liter,j)+1 + goto8 + endif + enddo + 8 continue + enddo + if(mod(iter,iterpl).eq.0)then + iterl(liter)=iter + liter=liter+1 +c if(liter.le.literm)then +c iterc(liter)=iterc(liter-1) +c do j=1,nspecs +c lspecs(liter,j)=lspecs(liter-1,j) +c enddo +c endif + endif + endif + if(iter.le.iternc)return + + do i=1,np + call hnbzen(i) !fill energy histogram + do j=1,nspecs + if(ident(i).eq.ispecs(j))then + kspecs(j)=kspecs(j)+1 + goto7 + endif + enddo + 7 continue + enddo + call hnbzmu(1) !fill multiplicity histogram + + if(iter.eq.itermx.and.npmax.ge.nlattc.and.ish.ge.1)then + call utmsg('hnbmet') + write(ifch,*)'***** nlattc too small' + write(ifch,*)'nlattc:',nlattc,' npmax:',npmax + call utmsgf + endif + +1000 continue + if(ish.ge.7)then + write(ifch,*)'accepted proposals:',nacc + *,' rejected proposals:',nrej + write(ifch,*)('-',i=1,30) + *,' exit sr hnbmet ',('-',i=1,10) + endif + return + end + +c---------------------------------------------------------------------- + subroutine hnbmin(keux,kedx,kesx,kecx) +c---------------------------------------------------------------------- +c returns min hadron set with given u,d,s,c content +c input: +c keux: net u quark number +c kedx: net d quark number +c kesx: net s quark number +c kecx: net c quark number +c output (written to /chnbin/): +c nump: number of hadrons +c ihadro(n): hadron id for n'th hadron +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(maxp=500) + common/chnbin/nump,ihadro(maxp) + logical wri + character f1*11 + wri=.false. + if(ish.ge.7)wri=.true. + if(wri)write(ifch,*)('-',i=1,10) + *,' entry sr hnbmin ',('-',i=1,30) + + nump=0 + f1='(4i3,i7,i6)' + ke=iabs(keux+kedx+kesx+kecx) + + if(keux+kedx+kesx+kecx.ge.0)then + keu=keux + ked=kedx + kes=kesx + kec=kecx + isi=1 + else + keu=-keux + ked=-kedx + kes=-kesx + kec=-kecx + isi=-1 + endif + if(wri)write(ifch,'(4i3)')keux,kedx,kesx,kecx + if(wri)write(ifch,'(4i3)')keu,ked,kes,kec + +c get rid of anti-c and c (140, 240, -140, -240) + if(kec.ne.0)then + 10 continue + if(kec.lt.0)then + kec=kec+1 + if(keu.gt.ked)then + keu=keu-1 + nump=nump+1 + ihadro(nump)=140 + if(wri)write(ifch,f1)keu,ked,kes,kec,nump,ihadro(nump) + else + ked=ked-1 + nump=nump+1 + ihadro(nump)=240 + if(wri)write(ifch,f1)keu,ked,kes,kec,nump,ihadro(nump) + endif + goto10 + endif + 11 continue + if(kec.gt.0)then + kec=kec-1 + if(keu.lt.ked)then + keu=keu+1 + nump=nump+1 + ihadro(nump)=-140 + if(wri)write(ifch,f1)keu,ked,kes,kec,nump,ihadro(nump) + else + ked=ked+1 + nump=nump+1 + ihadro(nump)=-240 + if(wri)write(ifch,f1)keu,ked,kes,kec,nump,ihadro(nump) + endif + goto11 + endif + endif + +c get rid of anti-s (130,230) + 5 continue + if(kes.lt.0)then + kes=kes+1 + if(keu.ge.ked)then + keu=keu-1 + nump=nump+1 + ihadro(nump)=130 + if(wri)write(ifch,f1)keu,ked,kes,kec,nump,ihadro(nump) + else + ked=ked-1 + nump=nump+1 + ihadro(nump)=230 + if(wri)write(ifch,f1)keu,ked,kes,kec,nump,ihadro(nump) + endif + goto5 + endif + +c get rid of anti-d (120, -230) + 6 continue + if(ked.lt.0)then + ked=ked+1 + if(keu.ge.kes)then + keu=keu-1 + nump=nump+1 + ihadro(nump)=120 + if(wri)write(ifch,f1)keu,ked,kes,kec,nump,ihadro(nump) + else + kes=kes-1 + nump=nump+1 + ihadro(nump)=-230 + if(wri)write(ifch,f1)keu,ked,kes,kec,nump,ihadro(nump) + endif + goto6 + endif + +c get rid of anti-u (-120, -130) + 7 continue + if(keu.lt.0)then + keu=keu+1 + if(ked.ge.kes)then + ked=ked-1 + nump=nump+1 + ihadro(nump)=-120 + if(wri)write(ifch,f1)keu,ked,kes,kec,nump,ihadro(nump) + else + kes=kes-1 + nump=nump+1 + ihadro(nump)=-130 + if(wri)write(ifch,f1)keu,ked,kes,kec,nump,ihadro(nump) + endif + goto7 + endif + + if(keu+ked+kes+kec.ne.ke)call utstop('hnbmin: sum_kei /= ke&') + + keq=keu+ked + +c get rid of s (3331, x330, xx30) + i=4 + 2 i=i-1 + 3 continue + if((4-i)*kes.gt.(i-1)*keq)then + kes=kes-i + keq=keq-3+i + nump=nump+1 + if(i.eq.3)ihadro(nump)=3331 + if(i.eq.2)ihadro(nump)=0330 + if(i.eq.1)ihadro(nump)=0030 + if(i.lt.3)then + do j=1,3-i + l=1+2*rangen() + if(keu.gt.ked)l=1 + if(keu.lt.ked)l=2 + if(l.eq.1)keu=keu-1 + if(l.eq.2)ked=ked-1 + ihadro(nump)=ihadro(nump)+l*10**(4-j) + enddo + endif + if(wri)write(ifch,f1)keu,ked,kes,kec,nump,ihadro(nump) + if(kes.lt.0)call utstop('hnbmin: negative kes&') + if(keq.lt.0)call utstop('hnbmin: negative keq&') + goto3 + endif + if(i.gt.1)goto2 + + if(keu+ked.ne.keq)call utstop('hnbmin: keu+ked /= keq&') + +c get rid of d (2221, 1220, 1120) + i=4 + 12 i=i-1 + 13 continue + if((4-i)*ked.gt.(i-1)*keu)then + ked=ked-i + keu=keu-3+i + if(i.eq.3)then + nump=nump+2 + ihadro(nump)=1220 + ihadro(nump-1)=-120 + else + nump=nump+1 + if(i.eq.2)ihadro(nump)=1220 + if(i.eq.1)ihadro(nump)=1120 + endif + if(wri)write(ifch,f1)keu,ked,kes,kec,nump,ihadro(nump) + if(ked.lt.0)call utstop('hnbmin: negative ked&') + if(keu.lt.0)call utstop('hnbmin: negative keu&') + goto13 + endif + if(i.gt.1)goto12 + + if(ked.ne.0)call utstop('hnbmin: ked .ne. 0&') + +c get rid of u (1111) + 9 continue + if(keu.gt.0)then + keu=keu-3 + nump=nump+2 + ihadro(nump)=1120 + ihadro(nump-1)=120 + if(wri)write(ifch,f1)keu,ked,kes,kec,nump,ihadro(nump) + if(keu.lt.0)call utstop('hnbmin: negative keu&') + goto9 + endif + + if(keu.ne.0)call utstop('hnbmin: keu .ne. 0&') + + if(isi.eq.-1)then + do i=1,nump + ihadro(i)=isi*ihadro(i) + enddo + endif + + do lo=1,2 + if(nump.lt.2)then + nump=nump+1 + ihadro(nump)=110 + if(wri)write(ifch,f1)keu,ked,kes,kec,nump,ihadro(nump) + endif + enddo + + if(wri)write(ifch,*)('-',i=1,30) + *,' exit sr hnbmin ',('-',i=1,10) + return + end + +c------------------------------------------------------------- + subroutine hnbody +c------------------------------------------------------------- +c formerly subr genbod from genlib (cernlib). +c modified by K. Werner, march 94. +c subr to generate n-body event +c according to fermi lorentz-invariant phase space. +c the phase space integral is the sum over the weights wt divided +c by the number of events (sum wt / n). +c adapted from fowl (cern w505) sept. 1974 by f. james. +c events are generated in their own center-of-mass, +c but may be transformed to any frame using loren4. +c +c input to and output from subr thru common block config. +c input: +c np=number of outgoing particles +c tecm=total energy in center-of-mass +c amass(i)=mass of ith outgoing particle +c output: +c pcm(1,i)=x-momentum if ith particle +c pcm(2,i)=y-momentum if ith particle +c pcm(3,i)=z-momentum if ith particle +c pcm(4,i)=energy of ith particle +c pcm(5,i)=momentum of ith particle +c wtxlog=log of weight of event +c-------------------------------------------------------------- + include 'epos.inc' + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + dimension emm(maxp) + dimension rno(3*maxp-4) +c !pcm1 is linear equiv. of pcm to avoid double indices + dimension em(maxp),pd(maxp),ems(maxp),sm(maxp) + *,pcm1(5*maxp) + common/cffq/ffqlog(maxp) + common/ciiw/iii,rrr + equivalence (nt,np),(amass(1),em(1)),(pcm1(1),pcm(1,1)) + logical wri + data twopi/6.2831853073/ + external hnbiiw +ctp060829 nas=5 !must be at least 3 + wri=.false. + if(ish.ge.7)wri=.true. + if(wri)then + write(ifch,*)('-',i=1,10) + *,' entry sr hnbody ',('-',i=1,30) + write(ifch,1200)np,tecm + write(ifch,*)'particle masses:' + write(ifch,'(1x,10f6.3)')(amass(n),n=1,np) + endif + +c..... initialization + + ktnbod=ktnbod + 1 + if(ktnbod.le.1)then + !... ffq(n) = pi * (twopi)**(n-2) / (n-2)! + ffqlog(1)=-1e35 + ffqlog(2)=alog(pi) + do n=3,maxp + ffqlog(n)=ffqlog(n-1)+log(twopi/(n-2)) + enddo + endif + + if(nt.lt.2) goto 1001 + if(nt.gt.maxp) goto 1002 + ntm1=nt-1 + ntm2=nt-2 + ntnm4=3*nt - 4 + emm(1)=em(1) + tm=0.0 + do 2 i=1,nt + ems(i)=em(i)**2 + tm=tm+em(i) + 2 sm(i)=tm + tecmtm=tecm-tm + if(tecmtm.le.0.0) goto 1000 + emm(nt)=tecm + wtmlog=alog(tecmtm)*ntm2 + ffqlog(nt) - alog(tecm) + +c...fill rno with 3*nt-4 random numbers, the first nt-2 being ordered + + do 3 i= 1, ntnm4 + 3 rno(i)=rangen() + if(ntm2) 9,5,4 + 4 continue + call flpsore(rno,ntm2) + +c...calculate emm().......M_i + + do 6 j=2,ntm1 + 6 emm(j)=rno(j-1)*tecmtm+sm(j) + +c...calculate wtlog + + 5 continue + wtxlog=wtmlog + ir=ntm2 + do 7 i=1,ntm1 + pd(i)=hnbpdk(emm(i+1),emm(i),em(i+1)) + if(pd(i).gt.0.)then + pdlog=alog(pd(i)) + else + pdlog=-1e35 + endif + wtxlog=wtxlog+pdlog + 7 continue + +c...complete specification of event (raubold-lynch method) + + pcm(1,1)=0.0 + pcm(2,1)=pd(1) + pcm(3,1)=0.0 + do i=2,nt + pcm(1,i)=0.0 + pcm(2,i)=-pd(i-1) + pcm(3,i)=0.0 + ir=ir+1 + bang=twopi*rno(ir) + cb=cos(bang) + sb=sin(bang) + ir=ir+1 + c=2.0*rno(ir)-1.0 + s=sqrt(1.0-c*c) + if(i.ne.nt)then + esys=sqrt(pd(i)**2+emm(i)**2) + beta=pd(i)/esys + gama=esys/emm(i) + do j=1,i + ndx=5*j - 5 + aa= pcm1(ndx+1)**2 + pcm1(ndx+2)**2 + pcm1(ndx+3)**2 + pcm1(ndx+5)=sqrt(aa) + pcm1(ndx+4)=sqrt(aa+ems(j)) + call hnbrt2(c,s,cb,sb,pcm,j) + psave=gama*(pcm(2,j)+beta*pcm(4,j)) + pcm(2,j)=psave + enddo + else !(i.eq.nt) + do j=1,i + aa=pcm(1,j)**2 + pcm(2,j)**2 + pcm(3,j)**2 + pcm(5,j)=sqrt(aa) + pcm(4,j)=sqrt(aa+ems(j)) + call hnbrt2(c,s,cb,sb,pcm,j) + enddo + endif + enddo + +c...returns + + 9 continue + goto1111 + + 1000 continue + if(wri) + *write(ifch,*)'available energy zero or negative -> wtxlog=-1e35' + wtxlog=-1e35 + goto1111 + + 1001 continue + if(wri) + *write(ifch,*)'less than 2 outgoing particles -> wtxlog=-1e35' + wtxlog=-1e35 + goto1111 + + 1002 continue + write(ifch,*)'too many outgoing particles' + write(ifch,1150) ktnbod + 1150 format(47h0 above error detected in hnbody at call number,i7) + write(ifch,1200) np,tecm + 1200 format(' np:',i6/' tecm:',f10.5) + write(ifch,*)'particle masses:' + write(ifch,'(1x,10f6.3)')(amass(jk),jk=1,np) + stop + +1111 continue + if(wri)write(ifch,*)('-',i=1,30) + *,' exit sr hnbody ',('-',i=1,10) + return + end + +c--------------------------------------------------------------------------------------------------------- + SUBROUTINE FLPSORE(A,N) +C--------------------------------------------------------------------------------------------------------- +C CERN PROGLIB# M103 FLPSOR .VERSION KERNFOR 3.15 820113 +C ORIG. 29/04/78 +C +C SORT THE ONE-DIMENSIONAL FLOATING POINT ARRAY A(1),...,A(N) BY +C INCREASING VALUES +C +C- PROGRAM M103 TAKEN FROM CERN PROGRAM LIBRARY, 29-APR-78 +C---------------------------------------------------------------------------------------------------------- + DIMENSION A(N) + COMMON /SLATE/ LT(20),RT(20) + INTEGER R,RT +C + LEVEL=1 + LT(1)=1 + RT(1)=N + 10 L=LT(LEVEL) + R=RT(LEVEL) + LEVEL=LEVEL-1 + 20 IF(R.GT.L) GO TO 200 + IF(LEVEL) 50,50,10 +C +C SUBDIVIDE THE INTERVAL L,R +C L : LOWER LIMIT OF THE INTERVAL (INPUT) +C R : UPPER LIMIT OF THE INTERVAL (INPUT) +C J : UPPER LIMIT OF LOWER SUB-INTERVAL (OUTPUT) +C I : LOWER LIMIT OF UPPER SUB-INTERVAL (OUTPUT) +C + 200 I=L + J=R + M=(L+R)/2 + X=A(M) + 220 IF(A(I).GE.X) GO TO 230 + I=I+1 + GO TO 220 + 230 IF(A(J).LE.X) GO TO 231 + J=J-1 + GO TO 230 +C + 231 IF(I.GT.J) GO TO 232 + W=A(I) + A(I)=A(J) + A(J)=W + I=I+1 + J=J-1 + IF(I.LE.J) GO TO 220 +C + 232 LEVEL=LEVEL+1 + IF((R-I).GE.(J-L)) GO TO 30 + LT(LEVEL)=L + RT(LEVEL)=J + L=I + GO TO 20 + 30 LT(LEVEL)=I + RT(LEVEL)=R + R=J + GO TO 20 + 50 continue + + do i=1,n-1 + if(a(i).gt.a(i+1))stop'FLPSORE: ERROR. ' + enddo + + RETURN + END + + + + + +c------------------------------------------------------------- + subroutine hnbodz +c------------------------------------------------------------- +c subr to generate n-body event +c according to non-invariant phase space. +c the phase space integral is the sum over the weights exp(wtxlog) +c divided by the number of events. +c ref.: hagedorn, nuov. cim. suppl ix, x (1958) 646. +c events are generated in their own center-of-mass. +c +c input to and output from subr is thru common block config. +c input: +c np=number of outgoing particles +c tecm=total energy in center-of-mass +c amass(i)=mass of ith outgoing particle +c output: +c pcm(1,i)=x-momentum of ith particle +c pcm(2,i)=y-momentum of ith particle +c pcm(3,i)=z-momentum of ith particle +c pcm(4,i)=energy of ith particle +c pcm(5,i)=momentum of ith particle +c wtxlog=log of weight of event +c-------------------------------------------------------------- + include 'epos.inc' + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + common /clatt/nlattc,npmax + common/cffq/ffqlog(maxp) + dimension ti(maxp),xi(maxp),si(maxp),zi(maxp) + common/crnoz/rnoz(maxp-1) + double precision ps(5) + + call utpri('hnbodz',ish,ishini,6) + if(ish.ge.6)write(ifch,1200)np,tecm + if(ish.ge.6)write(ifch,*)'particle masses:' + if(ish.ge.6)write(ifch,'(1x,10f6.3)')(amass(n),n=1,np) + +c initialization ktnbod=1 + ktnbod=ktnbod + 1 + if(ktnbod.gt.1) goto 1 +c !ffqlog(n) = log{ (4*pi)**n / (n-1)! } + ffqlog(1)=alog(4*pi) + do n=2,maxp + ffqlog(n)=ffqlog(n-1)+alog(4*pi/(n-1)) + enddo + 1 continue +c set wtxlog -infinity for np<2 + if(np.lt.2) goto 1001 +c special treatment for np=2 + if(np.eq.2)then + if(tecm.lt.amass(1)+amass(2)+0.00001)goto1000 + p0=utpcm(tecm,amass(1),amass(2)) + wtxlog=alog( 4*pi*p0 + */(1/sqrt(amass(1)**2+p0**2)+1/sqrt(amass(2)**2+p0**2)) ) + if(ish.ge.7) + *write(ifch,*)'wtxlog:',wtxlog,' (np=2 treatment)' + bang=2*pi*rangen() + cb=cos(bang) + sb=sin(bang) + c=2.0*rangen()-1.0 + s=sqrt(1.0-c*c) + do 9 i=1,2 + is=2*i-3 + pcm(5,i)=p0 + pcm(1,i)=is*pcm(5,i)*s*cb + pcm(2,i)=is*pcm(5,i)*s*sb + pcm(3,i)=is*pcm(5,i)*c + pcm(4,i)=sqrt(amass(i)**2+p0**2) + 9 continue + goto1111 + endif +c stop if np too large + if(np.gt.maxp) goto 1002 +c initialization all ktnbod + tm=0.0 + do 2 i=1,np + tm=tm+amass(i) + 2 continue + tt=tecm-tm + if(tt.le.0.0) goto 1000 +c prefactor + wtxlog=alog(tt)*(np-1) + ffqlog(np) + if(ish.ge.7) + *write(ifch,*)'wtxlog:',wtxlog,' (prefactor)' +c fill rnoz with np-1 random numbers + if(keepr.eq.0)then + do 3 i= 1, np-1 + 3 rnoz(i)=rangen() + else + do lo=1,iomom + j=1+rangen()*nlattc + rnoz(j)=rangen() + enddo + endif +c calculate z_i distributed as i*z*(i-1) + do i= 1, np-1 + zi(i)=rnoz(i)**(1./i) + enddo +c calculate x_i + xi(np)=1 + do i=np-1,1,-1 + xi(i)=zi(i)*xi(i+1) + enddo +c calculate t_i, e_i, p_i + if(ish.ge.9)write(ifch,*)'calculate t_i, e_i, p_i ...' + do i=1,np-1 + si(i)=xi(i)*tt + enddo + ti(1)=si(1) + if(ti(1).le.0.)ti(1)=1e-10 + ti(np)=tt-si(np-1) + if(ti(np).le.0.)ti(np)=1e-10 + do i=np-1,2,-1 + ti(i)=si(i)-si(i-1) + if(ti(i).le.0.)ti(i)=1e-10 + enddo + do i=1,np + pcm(1,i)=0 + pcm(2,i)=0 + pcm(3,i)=0 + pcm(4,i)=ti(i)+amass(i) + p52=ti(i)*(ti(i)+2*amass(i)) + if(p52.gt.0)then + pcm(5,i)=sqrt(p52) + else + pcm(5,i)=ti(i)*sqrt(1+2*amass(i)/ti(i)) + endif + enddo +c calculate wtxlog + call hnbraw(7,200,w) + if(w.gt.0.)then + wtxlog=wtxlog+alog(w) + else + wtxlog=wtxlog-1e+30 + endif + do 7 i=1,np + wtxlog=wtxlog+alog(pcm(5,i))+alog(ti(i)+amass(i)) + 7 continue + if(ish.ge.7) + *write(ifch,*)'wtxlog:',wtxlog +c print + if(ish.ge.7)then + write(ifch,*)'momenta:' + do j=1,4 + ps(j)=0 + enddo + do i=1,np + do j=1,4 + ps(j)=ps(j)+pcm(j,i) + enddo + write(ifch,'(1x,i3,5x,5f12.5)')i,(pcm(j,i),j=1,5) + enddo + ps(5)=dsqrt(ps(1)**2+ps(2)**2+ps(3)**2) + write(ifch,'(1x,a4,8x,5f12.5)')'sum:',(sngl(ps(j)),j=1,5) + endif + if(w.le.0.)goto1111 +c complete specification of event (random rotations and then deformations) + call hnbrot + if(ish.ge.7)write(ifch,*)'momenta after rotations:' + call hnbrop(96,0) + call hnbrod + if(ish.ge.7)write(ifch,*)'momenta after deformations:' + call hnbrop(96,1) + goto1111 + +c error returns + 1000 continue + if(ish.ge.6) + *write(ifch,*)'available energy zero or negative -> wtxlog=-1e35' + wtxlog=-1e35 + goto1111 + + 1001 continue + if(ish.ge.6) + *write(ifch,*)'less than 2 outgoing particles -> wtxlog=-1e35' + wtxlog=-1e35 + goto1111 + + 1002 continue + write(ifch,*)'too many outgoing particles' + write(ifch,1150) ktnbod + 1150 format(47h0 above error detected in hnbody at call number,i7) + write(ifch,1200) np,tecm + 1200 format(' np:',i6/' tecm:',f10.5) + write(ifch,*)'particle masses:' + write(ifch,'(1x,10f6.3)')(amass(jk),jk=1,np) + stop + +1111 continue + call utprix('hnbodz',ish,ishini,6) + return + end + +c----------------------------------------------------------------------- + subroutine hnbolo(loops) +c----------------------------------------------------------------------- +c loop over hnbody +c----------------------------------------------------------------------- + include 'epos.inc' + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + a=0 + k=0 + do j=1,loops +c-c if(mod(j,iterpr).eq.0)write(ifmt,*)' iteration:',iter,j + if(iocova.eq.1)call hnbody + if(iocova.eq.2)call hnbodz + if(ish.ge.8)write(ifch,*)'j:',j,' wtxlog:',wtxlog + if(wtxlog.gt.-1e30)then + k=k+1 + if(k.eq.1)c=wtxlog + if(a.gt.0.)then + if(alog(a).lt.wtxlog-c-20)then + a=0 + c=wtxlog + endif + endif + a=a+exp(wtxlog-c) + endif + if(ish.ge.8)write(ifch,*)'k:',k,' c:',c + enddo + a=a/loops + wtxlog=alog(a)+c + return + end + +c----------------------------------------------------------------------- + function hnbpdk(a,b,c) +c----------------------------------------------------------------------- +c formerly pdk from cernlib +c returns momentum p for twobody decay a --> b + c +c a, b, c are the three masses +c~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ +c this p is related to twobody phase space as R2 = pi * p /a +c----------------------------------------------------------------------- + double precision aa,bb,cc,a2,b2,c2 + aa=a + bb=b + cc=c + a2=aa*aa + b2=bb*bb + c2=cc*cc + if(a2 + (b2-c2)**2/a2-2.0*(b2+c2).le.0.)then + hnbpdk = 0 + else + hnbpdk = 0.5*dsqrt(a2 + (b2-c2)**2/a2 - 2.0*(b2+c2)) + endif + return + end + +c---------------------------------------------------------------------- + subroutine hnbpad(k,n1,n2,n3,n4,mm,jc) +c---------------------------------------------------------------------- +c k=1: determ pair indices k1,k2 +c k=2: determ pair indices k3,k4 (.ne. n1,n2) +c k=1 and k=2: mm: type of pair, jc: flavour of pair +c---------------------------------------------------------------------- + include 'epos.inc' + integer jc(nflav,2),ic(2),jc1(nflav,2),ic1(2),jc2(nflav,2),ic2(2) + common /clatt/nlattc,npmax + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + + k1=n1 + k2=n2 + +c determine n1,n2 and mm +c ---------------------- + 1 continue + n1=1+rangen()*nlattc + n1=min(n1,nlattc) + 2 continue + n2=1+rangen()*nlattc + n2=min(n2,nlattc) + if(n2.eq.n1)goto2 + if(n2.lt.n1)then + n1r=n1 + n1=n2 + n2=n1r + endif + if(k.eq.2)then + if(n1.eq.k1.or.n1.eq.k2.or.n2.eq.k1.or.n2.eq.k2)goto1 + endif + if(ident(n1).ne.0.and.ident(n2).ne.0)mm=1 ! hadron-hadron + if(ident(n1).ne.0.and.ident(n2).eq.0)mm=2 ! hadron-empty + if(ident(n1).eq.0.and.ident(n2).ne.0)mm=2 ! empty-hadron + if(ident(n1).eq.0.and.ident(n2).eq.0)mm=3 ! empty-empty + if(ish.ge.7)then + write(ifch,'(a,i2)')' mm:',mm + write(ifch,*)'to be replaced:',n1,ident(n1) + write(ifch,*)'to be replaced:',n2,ident(n2) + endif + +c flavour of n1+n2 --> jc +c ----------------------- + if(mm.eq.1)then + call idtr4(ident(n1),ic1) + call iddeco(ic1,jc1) + call idtr4(ident(n2),ic2) + call iddeco(ic2,jc2) + do i=1,nflav + do j=1,2 + jc(i,j)=jc1(i,j)+jc2(i,j) + enddo + enddo + elseif(mm.eq.2.and.ident(n1).ne.0)then + call idtr4(ident(n1),ic) + call iddeco(ic,jc) + elseif(mm.eq.2.and.ident(n2).ne.0)then + call idtr4(ident(n2),ic) + call iddeco(ic,jc) + else + do i=1,nflav + do j=1,2 + jc(i,j)=0 + enddo + enddo + endif + + if(k.eq.2)then + n3=n1 + n4=n2 + endif + + return + end + +c---------------------------------------------------------------------- + subroutine hnbpai(id1,id2,jc) +c---------------------------------------------------------------------- +c returns arbitrary hadron pair id1,id2, flavour written to jc +c---------------------------------------------------------------------- + include 'epos.inc' + integer jc(nflav,2),jc1(nflav,2),ic1(2),jc2(nflav,2),ic2(2) + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + +c construct pair id1,id2 +c ---------------------- + i1=rangen()*(nspecs+iozero)-(iozero-1) + i1=max(i1,0) + i1=min(i1,nspecs) + if(i1.eq.0)then + id1=0 + do i=1,nflav + do j=1,2 + jc1(i,j)=0 + enddo + enddo + else + id1=ispecs(i1) + call idtr4(id1,ic1) + call iddeco(ic1,jc1) + endif + if(ish.ge.7)write(ifch,'(1x,a,i3,a,i5,a,6i2,3x,6i2)') + *'i1:',i1,' id1:',id1,' jc1:',jc1 + i2=rangen()*(nspecs+iozero)-(iozero-1) + i2=max(i2,0) + i2=min(i2,nspecs) + if(i2.eq.0)then + id2=0 + do i=1,nflav + do j=1,2 + jc2(i,j)=0 + enddo + enddo + else + id2=ispecs(i2) + call idtr4(id2,ic2) + call iddeco(ic2,jc2) + endif + if(ish.ge.7)write(ifch,'(1x,a,i3,a,i5,a,6i2,3x,6i2)') + *'i2:',i2,' id2:',id2,' jc2:',jc2 + if(ish.ge.7)write(ifch,'(a,i6,i6)')' pair:',id1,id2 + +c determine jc +c ------------ + do i=1,nflav + do j=1,2 + jc(i,j)=jc1(i,j)+jc2(i,j) + enddo + enddo + do i=1,nflav + j12=jc(i,1)-jc(i,2) + if(j12.ge.0)then + jc(i,1)=j12 + jc(i,2)=0 + else + jc(i,1)=0 + jc(i,2)=-j12 + endif + enddo + if(ish.ge.7)write(ifch,'(a,6i2,3x,6i2)')' jc:',jc + + return + end + +c---------------------------------------------------------------------- + subroutine hnbpaj(jc,iwpair,id1,id2) +c---------------------------------------------------------------------- +c returns sum of weights iwpair of possible pairs +c and randomly chosen hadron pair id1,id2 for given flavour jc +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(mspecs=56,mxids=200) + parameter(mxpair=mspecs**2*4) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cspec2/jspecs(2,nflav,mspecs) + common/cspec3/lkfok(8,-3:3,-3:3,-3:3,-3:3) !-charm + common/cspec5/idpairst(2,mxpair,3**6),iwtpaist(0:mxpair,3**6) + & ,idxpair(0:2,0:2,0:2,-1:1,-1:1,-1:1),ipairst(3**6) + common/cflac/ifok(nflav,mspecs),ifoa(nflav) + dimension ids(mxids),iwts(mxids),jc(nflav,2)!,jc2(nflav,2) + dimension idpair(2,mxpair),iwtpai(mxpair) + dimension jc1mi2(nflav),jcmi(nflav) + +c nflv=nflav +c if(nflv.gt.6) +c *call utstop('hnbpaj: nflav.gt.6: modify this routine&') + +c construct possible pairs id1,id2 +c -------------------------------- + + ipair=0 + iwpair=0 + idx=0 + if(jc(1,1).gt.2)then + goto 1 + elseif(jc(1,1).lt.0)then + goto 1 + elseif(jc(2,1).gt.2)then + goto 1 + elseif(jc(2,1).lt.0)then + goto 1 + elseif(jc(3,1).gt.2)then + goto 1 + elseif(jc(3,1).lt.0)then + goto 1 + elseif(jc(1,2).gt.1)then + goto 1 + elseif(jc(1,2).lt.-1)then + goto 1 + elseif(jc(2,2).gt.1)then + goto 1 + elseif(jc(2,2).lt.-1)then + goto 1 + elseif(jc(3,2).gt.1)then + goto 1 + elseif(jc(3,2).lt.-1)then + goto 1 + elseif((abs(jc(4,1))+abs(jc(5,1))+abs(jc(6,1))+abs(jc(4,2)) + & +abs(jc(5,2))+abs(jc(6,2))).gt.0)then + goto 1 + endif + idx=idxpair(jc(1,1),jc(2,1),jc(3,1),jc(1,2),jc(2,2),jc(3,2)) + ipair=ipairst(idx) + if(ipair.eq.0)return + iwpair=iwtpaist(0,idx) + do i=1,ipair + idpair(1,i)=idpairst(1,i,idx) + idpair(2,i)=idpairst(2,i,idx) + iwtpai(i)=iwtpaist(i,idx) + enddo + goto 4 !pair fixed via table + +c id1=0: + 1 continue + if(nspecs+1.gt.mxids)call utstop('hnbpaj: mxids too small&') + + jc1mi2(1)=jc(1,1)-jc(1,2) + jc1mi2(2)=jc(2,1)-jc(2,2) + jc1mi2(3)=jc(3,1)-jc(3,2) + jc1mi2(4)=jc(4,1)-jc(4,2) + jc1mi2(5)=jc(5,1)-jc(5,2) + jc1mi2(6)=jc(6,1)-jc(6,2) + + nids=0 + + if(jc1mi2(1).ne.0)goto11 + if(jc1mi2(2).ne.0)goto11 + if(jc1mi2(3).ne.0)goto11 + if(jc1mi2(4).ne.0)goto11 + if(jc1mi2(5).ne.0)goto11 + if(jc1mi2(6).ne.0)goto11 + nids=nids+1 + ids(nids)=0 + iwts(nids)=iozero + 11 continue + + do j=1,nspecs + if(jc1mi2(1).ne.ifok(1,j))goto22 + if(jc1mi2(2).ne.ifok(2,j))goto22 + if(jc1mi2(3).ne.ifok(3,j))goto22 + if(jc1mi2(4).ne.ifok(4,j))goto22 + if(jc1mi2(5).ne.ifok(5,j))goto22 + if(jc1mi2(6).ne.ifok(6,j))goto22 + nids=nids+1 + ids(nids)=ispecs(j) + iwts(nids)=1 + 22 continue + enddo + + if(nids.eq.0)goto2 + if(nids.gt.mxpair)call utstop('hnbpaj: mxpair too small&') + do k=1,nids + ipair=ipair+1 + idpair(1,ipair)=0 + idpair(2,ipair)=ids(k) + iwtpai(ipair)=iozero*iwts(k) + iwpair=iwpair+iwtpai(ipair) +c if(ish.ge.6)write(ifch,'(a,i5,5x,a,i6,i6,5x,a,i6)')' pair nr:' +c *,ipair,'ids:',0,ids(k),'weight:',iwtpai(ipair) + enddo + 2 continue + +c id1>0: + + do i1=1,nspecs + +c if(ish.ge.6)then +c do i=1,nflav +c jc2(i,1)=jc(i,1)-jspecs(1,i,i1) +c jc2(i,2)=jc(i,2)-jspecs(2,i,i1) +c enddo +c write(ifch,'(1x,a,i3,a,i6,a,6i2,3x,6i2)') +c *'i1:',i1,' id1:',ispecs(i1),' jc1:' +c *,(jspecs(1,i,i1),i=1,6),(jspecs(2,i,i1),i=1,6) +c write(ifch,'(a,6i2,3x,6i2)')' jc2:',jc2 +c endif + + jcmi(1)=jc1mi2(1)-jspecs(1,1,i1)+jspecs(2,1,i1) + jcmi(2)=jc1mi2(2)-jspecs(1,2,i1)+jspecs(2,2,i1) + jcmi(3)=jc1mi2(3)-jspecs(1,3,i1)+jspecs(2,3,i1) + jcmi(4)=jc1mi2(4)-jspecs(1,4,i1)+jspecs(2,4,i1) + jcmi(5)=jc1mi2(5)-jspecs(1,5,i1)+jspecs(2,5,i1) + jcmi(6)=jc1mi2(6)-jspecs(1,6,i1)+jspecs(2,6,i1) +c-charm if(jcmi(4).ne.0)stop'HNBPAJ: c not treated' + if(jcmi(5).ne.0)stop'HNBPAJ: b not treated' + if(jcmi(6).ne.0)stop'HNBPAJ: t not treated' + + nids=0 + + if(abs(jcmi(1)).gt.3)goto3 + if(abs(jcmi(2)).gt.3)goto3 + if(abs(jcmi(3)).gt.3)goto3 + if(abs(jcmi(4)).gt.3)goto3 !-charm + + if(jcmi(1).ne.0)goto111 + if(jcmi(2).ne.0)goto111 + if(jcmi(3).ne.0)goto111 + if(jcmi(4).ne.0)goto111 !-charm + nids=nids+1 + ids(nids)=0 + iwts(nids)=iozero + 111 continue + + lkfok1=lkfok(1,jcmi(1),jcmi(2),jcmi(3),jcmi(4)) + if(lkfok1.gt.0)then + nids=nids+1 + ids(nids)=lkfok(2,jcmi(1),jcmi(2),jcmi(3),jcmi(4)) + iwts(nids)=1 + if(lkfok1.gt.1)then + nids=nids+1 + ids(nids)=lkfok(3,jcmi(1),jcmi(2),jcmi(3),jcmi(4)) + iwts(nids)=1 + if(lkfok1.gt.2)then + if(lkfok1.gt.7) !-charm + * stop'HNBPAJ: dimension of lkfok too small' + do ii=3,lkfok1 + nids=nids+1 + ids(nids)=lkfok(1+ii,jcmi(1),jcmi(2),jcmi(3),jcmi(4)) + iwts(nids)=1 + enddo + endif + endif + endif + +c do j=1,nspecs +c if(jcmi(1).ne.ifok(1,j))goto222 +c if(jcmi(2).ne.ifok(2,j))goto222 +c if(jcmi(3).ne.ifok(3,j))goto222 +c if(jcmi(4).ne.ifok(4,j))goto222 +c if(jcmi(5).ne.ifok(5,j))goto222 +c if(jcmi(6).ne.ifok(6,j))goto222 +c nids=nids+1 +c ids(nids)=ispecs(j) +c iwts(nids)=1 +c 222 continue +c enddo + + if(nids.eq.0)goto3 + if(ipair+nids.gt.mxpair)call utstop('hnbpaj: mxpair too small&') + do k=1,nids + ipair=ipair+1 + idpair(1,ipair)=ispecs(i1) + idpair(2,ipair)=ids(k) + iwtpai(ipair)=iwts(k) + iwpair=iwpair+iwtpai(ipair) + enddo + if(ish.ge.7)then + ipair0=ipair-nids + do k=1,nids + ipair0=ipair0+1 + write(ifch,'(a,i5,5x,a,i6,i6,5x,a,i6)')' pair nr:' + *,ipair0,'ids:',ispecs(i1),ids(k),'weight:',iwtpai(ipair0) + enddo + endif + 3 continue + + enddo + +c no pair found +c ------------- + if(ipair.eq.0)then + if(iwpair.ne.0)call utstop('hnbpaj: iwpair.ne.0&') + return + endif + + + 4 continue +c select pair +c ----------- + r=rangen() + ir=1+r*iwpair + ir=min(ir,iwpair) + is=0 + do ip=1,ipair + is=is+iwtpai(ip) + if(ir.le.is)then + id1=idpair(1,ip) + id2=idpair(2,ip) +c if(ish.ge.6)write(ifch,*)'random number:',r +c *,' --> chosen pair:',ip + goto 1000 + endif + enddo + write(ifmt,*)'hnbpaj:',jc,idx,ipair,iwpair,r,ir + call utstop('hnbpaj: no pair selected&') + +1000 continue + + return + end + +c---------------------------------------------------------------------- + subroutine hnbpajini +c---------------------------------------------------------------------- +c initialize array to speed up hnbpaj calculation +c store sum of weights iwpair of possible pairs in an array +c for any combinations of quarks +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(mspecs=56,mxids=200) + parameter(mxpair=mspecs**2*4) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cspec2/jspecs(2,nflav,mspecs) + common/cspec3/lkfok(8,-3:3,-3:3,-3:3,-3:3) !-charm + common/cspec5/idpairst(2,mxpair,3**6),iwtpaist(0:mxpair,3**6) + & ,idxpair(0:2,0:2,0:2,-1:1,-1:1,-1:1),ipairst(3**6) + common/cflac/ifok(nflav,mspecs),ifoa(nflav) + dimension ids(mxids),iwts(mxids) + dimension jc1mi2(3),jcmi(4) + + +c write(ifmt,*)' Initialize droplet decay ...' + +c construct possible pairs id1,id2 +c -------------------------------- + idx=0 + do iaqs=-1,1 + do iaqd=-1,1 + do iaqu=-1,1 + do iqs=0,2 + do iqd=0,2 + do iqu=0,2 + + idx=idx+1 + idxpair(iqu,iqd,iqs,iaqu,iaqd,iaqs)=idx + + ipair=0 + iwtpaist(0,idx)=0 + do i=1,mxids + ids(i)=0 + iwts(i)=0 + enddo + do i=1,mxpair + idpairst(1,i,idx)=0 + idpairst(2,i,idx)=0 + iwtpaist(i,idx)=0 + enddo + +c id1=0: + + if(nspecs+1.gt.mxids)call utstop('hnbpajini: mxids too small&') + + jc1mi2(1)=iqu-iaqu + jc1mi2(2)=iqd-iaqd + jc1mi2(3)=iqs-iaqs + + nids=0 + + if(jc1mi2(1).ne.0)goto11 + if(jc1mi2(2).ne.0)goto11 + if(jc1mi2(3).ne.0)goto11 + nids=nids+1 + ids(nids)=0 + iwts(nids)=iozero + 11 continue + + do j=1,nspecs + if(jc1mi2(1).ne.ifok(1,j))goto22 + if(jc1mi2(2).ne.ifok(2,j))goto22 + if(jc1mi2(3).ne.ifok(3,j))goto22 + nids=nids+1 + ids(nids)=ispecs(j) + iwts(nids)=1 + 22 continue + enddo + + if(nids.eq.0)goto2 + if(nids.gt.mxpair)call utstop('hnbpajini: mxpair too small&') + do k=1,nids + ipair=ipair+1 + idpairst(1,ipair,idx)=0 + idpairst(2,ipair,idx)=ids(k) + iwtpaist(ipair,idx)=iozero*iwts(k) + iwtpaist(0,idx)=iwtpaist(0,idx)+iwtpaist(ipair,idx) +c if(ish.ge.6)write(ifch,'(a,i5,5x,a,i6,i6,5x,a,i6)')' pair nr:' +c *,ipair,'ids:',0,ids(k),'weight:',iwtpai(ipair) + enddo + 2 continue + +c id1>0: + + do i1=1,nspecs + +c if(ish.ge.6)then +c do i=1,nflav +c jc2(i,1)=jc(i,1)-jspecs(1,i,i1) +c jc2(i,2)=jc(i,2)-jspecs(2,i,i1) +c enddo +c write(ifch,'(1x,a,i3,a,i6,a,6i2,3x,6i2)') +c *'i1:',i1,' id1:',ispecs(i1),' jc1:' +c *,(jspecs(1,i,i1),i=1,6),(jspecs(2,i,i1),i=1,6) +c write(ifch,'(a,6i2,3x,6i2)')' jc2:',jc2 +c endif + + jcmi(1)=jc1mi2(1)-jspecs(1,1,i1)+jspecs(2,1,i1) + jcmi(2)=jc1mi2(2)-jspecs(1,2,i1)+jspecs(2,2,i1) + jcmi(3)=jc1mi2(3)-jspecs(1,3,i1)+jspecs(2,3,i1) + jcmi(4)=0 + + nids=0 + + if(abs(jcmi(1)).gt.3)goto3 + if(abs(jcmi(2)).gt.3)goto3 + if(abs(jcmi(3)).gt.3)goto3 + + if(jcmi(1).ne.0)goto111 + if(jcmi(2).ne.0)goto111 + if(jcmi(3).ne.0)goto111 + nids=nids+1 + ids(nids)=0 + iwts(nids)=iozero + 111 continue + + lkfok1=lkfok(1,jcmi(1),jcmi(2),jcmi(3),jcmi(4)) + if(lkfok1.gt.0)then + nids=nids+1 + ids(nids)=lkfok(2,jcmi(1),jcmi(2),jcmi(3),jcmi(4)) + iwts(nids)=1 + if(lkfok1.gt.1)then + nids=nids+1 + ids(nids)=lkfok(3,jcmi(1),jcmi(2),jcmi(3),jcmi(4)) + iwts(nids)=1 + if(lkfok1.gt.2)then + if(lkfok1.gt.7) !-charm + * stop'HNBPAJINI: dimension of lkfok too small' + do ii=3,lkfok1 + nids=nids+1 + ids(nids)=lkfok(1+ii,jcmi(1),jcmi(2),jcmi(3),jcmi(4)) + iwts(nids)=1 + enddo + endif + endif + endif + +c do j=1,nspecs +c if(jcmi(1).ne.ifok(1,j))goto222 +c if(jcmi(2).ne.ifok(2,j))goto222 +c if(jcmi(3).ne.ifok(3,j))goto222 +c if(jcmi(4).ne.ifok(4,j))goto222 +c if(jcmi(5).ne.ifok(5,j))goto222 +c if(jcmi(6).ne.ifok(6,j))goto222 +c nids=nids+1 +c ids(nids)=ispecs(j) +c iwts(nids)=1 +c 222 continue +c enddo + + if(nids.eq.0)goto3 + if(ipair+nids.gt.mxpair) + & call utstop('hnbpajini: mxpair too small&') + do k=1,nids + ipair=ipair+1 + idpairst(1,ipair,idx)=ispecs(i1) + idpairst(2,ipair,idx)=ids(k) + iwtpaist(ipair,idx)=iwts(k) + iwtpaist(0,idx)=iwtpaist(0,idx)+iwtpaist(ipair,idx) + enddo + ipairst(idx)=ipair + 3 continue + + enddo + +c no pair found +c ------------- + if(ipair.eq.0)then + if(iwtpaist(0,idx).ne.0)call utstop('hnbpajini: iwpair.ne.0&') + endif + + + enddo + enddo + enddo + enddo + enddo + enddo + + return + end + +c-------------------------------------------------------------------- + subroutine hnbraw(npx,npy,w) +c-------------------------------------------------------------------- +c returns random walk fctn w=w(0,p_1,p_2,...,p_n) for noncovariant +c phase space integral (see hagedorn, suppl nuov cim ix(x) (1958)646) +c input: dimension np and momenta p_i=pcm(5,i) via /confg/ +c 1 < np <= npx : hagedorn method +c npx < np <= npy : integral method +c npy < np : asymptotic method +c-------------------------------------------------------------------- + include 'epos.inc' + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + integer ii(maxp),isi(maxp) + double precision ppcm(maxp),ww,ppsum,ppmax + external hnbrax + common/cepsr/nepsr + if(ish.ge.9)write(ifch,*)('-',i=1,10) + *,' entry sr hnbraw ',('-',i=1,30) + + if(np.lt.3)call utstop('hnbraw: np must be at least 3&') + + kper=5 + pi=3.1415927 + pmax=0 + do i=1,np + pmax=pmax+pcm(5,i) + enddo + wio=0 + win=0 + whd=0 + +c sum p_i - 2*p_max not positive +c ------------------------------ + px=0 + ps=0 + do i=1,np + px=max(px,pcm(5,i)) + ps=ps+pcm(5,i) + enddo + if(ps-2*px.le.0.)then + w=0 + if(ish.ge.7)write(ifch,'(1x,a,e12.5,4x)') + *'sum p_i - 2*p_max not positive --> w:',w + goto1000 + endif + +c asymptotic method +c ----------------- + was=0 + do i=1,np + was=was+pcm(5,i)**2 + enddo + was=(was*2*pi/3)**(-1.5) + if(ish.ge.7)write(ifch,'(1x,a,e12.5,4x)') + *'asymptotic method: was:',was + + if(np.gt.npy)then + w=was + goto1000 + endif + + if(np.le.npx)goto9 + +c integral method +c --------------- + if(ish.ge.9)write(ifch,*)'integral method...' + itmax=8 + it=0 + b=pi*np*kper/pmax + win=0 + nepsr=0 + 3 continue + it=it+1 + if(ish.ge.9)write(ifch,*)'it:',it + b=b*5./3. + wio=win + call uttrap(hnbrax,0.,b,win) + iok=0 + if(abs(win-wio).le.epsr*abs((win+wio)/2))iok=1 + if(it.eq.itmax)iok=1 + if(ish.ge.8.or.ish.ge.7.and.iok.eq.1) + *write(ifch,'(1x,2(a,e12.5,2x),a,i2,2x,a,i4)') + *'integral method: win:',win + *,'upper limit:',b,'it:',it,'nepsr:',nepsr + if(it.eq.itmax + *.and.abs(win-wio).gt.epsr*abs((win+wio)/2))then + nepsr=nepsr+1 + if(ish.ge.9)then + call utmsg('hnbraw') + write(ifch,*) + *'***** requested accuracy could not be achieved' + write(ifch,*)'achieved accuracy: ' + *,abs(win-wio)/abs((win+wio)/2) + write(ifch,*)'requested accuracy:',epsr + call utmsgf + endif + endif + if(it.eq.1.or.iok.eq.0)goto3 + + if(nepsr.eq.0)then + w=win + goto1000 + endif + + if(np.gt.20)then + if(ish.ge.1)then + call utmsg('hnbraw') + write(ifch,*) + * '***** requested accuracy could not be achieved' + write(ifch,*)'achieved accuracy: ' + * ,abs(win-wio)/abs((win+wio)/2) + write(ifch,*)'requested accuracy:',epsr + call utmsgf + endif + w=win + goto1000 + endif + +c hagedorn method (double) +c ------------------------ + 9 continue + ppmax=0 + do i=1,np + ppcm(i)=pcm(5,i) + ppmax=ppmax+ppcm(i) + enddo + ww=0 + do i=1,np + ii(i)=0 + isi(i)=1 + enddo + ppsum=ppmax + i=0 + iprosi=1 + ww=iprosi*(ppsum/ppmax)**(np-3) + if(ish.ge.8) + *write(ifch,'(4x,i5,12x,f7.2,i5,f11.2)')np,sngl(ppsum) + *,iprosi,sngl(ww) + 5 continue + i=i+1 + if(i.gt.np)goto6 + if(ii(i).eq.1)goto5 + iprosi=-iprosi + isi(i)=-isi(i) + ppsum=ppsum+2*isi(i)*ppcm(i) + if(ppsum.gt.0.or.ppsum.eq.0..and.isi(i).gt.0)then + ww=ww+iprosi*(ppsum/ppmax)**(np-3) + if(ish.ge.8) + *write(ifch,'(4x,2i5,2f7.2,i5,f11.2)') + *np,i,sngl(2*isi(i)*ppcm(i)),sngl(ppsum),iprosi,sngl(ww) + else + if(ish.ge.8) + *write(ifch,'(4x,2i5,2f7.2,i5,4x,a)') + *np,i,sngl(2*isi(i)*ppcm(i)),sngl(ppsum),iprosi,'not counted' + endif + ii(i)=1 + if(i.gt.1)then + do j=1,i-1 + ii(j)=0 + enddo + endif + i=0 + goto5 + 6 continue + do i=1,np + ww=ww*pmax/ppcm(i)/2./i + enddo + ww=-ww/pmax**3/pi/2.*np*(np-1)*(np-2) + whd=ww + if(ish.ge.7)write(ifch,'(1x,a,e12.5,4x,a)') + *'hagedorn method: whd:',whd,'double precision' + + w=whd + +1000 continue + if(ish.ge.9)write(ifch,*)('-',i=1,30) + *,' exit sr hnbraw ',('-',i=1,10) + return + end + +c-------------------------------------------------------------------- + function hnbrax(x) +c-------------------------------------------------------------------- +c returns integrand for random walk fctn w=w(0,p_1,p_2,...,p_n): +c 1./(2*pi**2) * x**2 * prod[sin(p_i*x)/(p_i*x)] +c input: dimension np and momenta p_i=pcm(5,i) via /confg/ +c-------------------------------------------------------------------- + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + common/cnsta/pi,pii,hquer,prom,piom,ainfin + hnbrax= pii * x**2 + do i=1,np + px=pcm(5,i)*x + if(px.ne.0.)hnbrax=hnbrax*sin(px)/px + enddo + return + end + +c---------------------------------------------------------------------- + subroutine hnbrmz +c---------------------------------------------------------------------- +c removes intermediate zeros from ident +c updates np +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog +c integer identx(maxp) + common /clatt/nlattc,npmax + if(ish.ge.9)write(ifch,*)('-',i=1,10) + *,' entry sr hnbrmz ',('-',i=1,30) + if(np.eq.0)goto1000 + +c do i=1,np +c identx(i)=ident(i) +c enddo +c npx=np + + i=0 + np=nlattc+1 + + 1 i=i+1 + if(i.gt.nlattc)then + np=nlattc + goto1000 + endif + if(ident(i).ne.0)goto1 + 2 np=np-1 + if(np.eq.0)goto1000 + if(ident(np).eq.0)goto2 + + if(ish.ge.9)then + write(ifch,*)'ident:' + write(ifch,'(1x,10i7)')(ident(j),j=1,nlattc) + write(ifch,'(1x,a,i3,3x,a,i3)')'i:',i,'np:',np + endif + + if(i.eq.np+1)goto1000 + + ident(i)=ident(np) + ident(np)=0 + goto1 + +1000 continue + if(ish.ge.9)write(ifch,*)('-',i=1,30) + *,' exit sr hnbrmz ',('-',i=1,10) + end + +c---------------------------------------------------------------------- + subroutine hnbrod +c---------------------------------------------------------------------- +c deformes polygon of a sequence of arbitrarily rotated momentum +c vectors such that the polygon gets closed +c input: pcm(1-3,i) representing polygon +c output: pcm(1-3,i) representing closed polygon +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + real x(3),y(3),z(3),w(3) + if(ish.ge.8)write(ifch,*)'sr hnbrod: polygon deformation:' + + err=0.01 + + kmax=1000 + fac=0.30 + x2max=(err*tecm)**2 + + if(ish.ge.8)write(ifch,'(a,i4,a,f12.6)') + *' kmax:',kmax,' x2max:',x2max + + x(1)=0 + x(2)=0 + x(3)=0 + do i=1,np + x(1)=x(1)+pcm(1,i) + x(2)=x(2)+pcm(2,i) + x(3)=x(3)+pcm(3,i) + enddo ! i + + k=0 + 1 continue + + x2=x(1)**2+x(2)**2+x(3)**2 + if(ish.ge.8)write(ifch,'(a,i3,a,3f9.3,a,f12.6)') + *' it',k,': x:',x,' x2:',x2 + if(x2.le.x2max)goto1000 + if(k.gt.kmax)goto1001 + + k=k+1 + ir=1+rangen()*np + ir=min(ir,np) + + z(1)=-x(1) + z(2)=-x(2) + z(3)=-x(3) + x(1)=x(1)-pcm(1,ir) + x(2)=x(2)-pcm(2,ir) + x(3)=x(3)-pcm(3,ir) + y(1)=pcm(1,ir) + y(2)=pcm(2,ir) + y(3)=pcm(3,ir) + if(ish.ge.9)write(ifch,'(a,i3,a,3f9.3,a,3f9.3,a,i4)') + *' it',k,': x:',x,' y:',y,' ir:',ir + xxx=x(1)**2+x(2)**2+x(3)**2 + yyy=y(1)**2+y(2)**2+y(3)**2 + zzz=z(1)**2+z(2)**2+z(3)**2 + if(xxx.gt.0..and.yyy.gt.0..and.zzz.gt.0.)then +c xx=sqrt(xxx) + yy=sqrt(yyy) + zz=sqrt(zzz) + a=min(fac,fac*yy/zz) + w(1)=y(1)+a*z(1) + w(2)=y(2)+a*z(2) + w(3)=y(3)+a*z(3) + www=w(1)**2+w(2)**2+w(3)**2 + if(www.gt.0.)then + ww=sqrt(www) + y(1)=yy/ww*w(1) + y(2)=yy/ww*w(2) + y(3)=yy/ww*w(3) + pcm(1,ir)=y(1) + pcm(2,ir)=y(2) + pcm(3,ir)=y(3) + endif + endif + x(1)=x(1)+y(1) + x(2)=x(2)+y(2) + x(3)=x(3)+y(3) + if(ish.ge.9)write(ifch,'(a,i3,a,3f9.3,a,3f9.3,a,i4)') + *' it',k,': x:',x,' y:',y,' ir:',ir + + goto1 + + 1001 continue + call utmsg('hnbrod') + write(ifch,*)'***** total 3-momentum nonzero' + write(ifch,'(3f12.5,5x,2f12.5)')(x(j),j=1,3),x2,x2max + call utmsgf + + 1000 continue + return + + end + +c---------------------------------------------------------------------- + subroutine hnbrop(ishx,ichk) +c---------------------------------------------------------------------- +c prints momenta of configuration (essentially to check rotation procedure) +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + double precision ps(5) + err=0.01 + do j=1,4 + ps(j)=0 + enddo + do i=1,np + do j=1,4 + ps(j)=ps(j)+pcm(j,i) + enddo + if(ish.ge.ishx)write(ifch,'(1x,i3,5x,5f12.5)')i,(pcm(j,i),j=1,3) + *,sqrt(pcm(1,i)**2+pcm(2,i)**2+pcm(3,i)**2),pcm(5,i) + enddo + ps(5)=dsqrt(ps(1)**2+ps(2)**2+ps(3)**2) + if(ish.ge.ishx)write(ifch,'(1x,a4,8x,5f12.5)') + *'sum:',(sngl(ps(j)),j=1,5) + if(ichk.eq.1)then + if(dabs(ps(1)).gt.err*tecm.or.dabs(ps(2)).gt.err*tecm + *.or.dabs(ps(3)).gt.err*tecm)then + call utmsg('hnbrop') + write(ifch,*)'***** total 3-momentum nonzero' + write(ifch,'(9x,5f12.5)')(sngl(ps(j)),j=1,5) + call utmsgf + endif + endif + return + end + +c---------------------------------------------------------------------- + subroutine hnbrot +c---------------------------------------------------------------------- +c rotates momenta of /confg/ randomly +c input: pcm(5,i) +c output: pcm(1-3,i) +c---------------------------------------------------------------------- + common/cnsta/pi,pii,hquer,prom,piom,ainfin + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + real u(3) + + do i=1,np + u(3)=2.*rangen()-1. + phi=2.*pi*rangen() + u(1)=sqrt(1.-u(3)**2)*cos(phi) + u(2)=sqrt(1.-u(3)**2)*sin(phi) + pcm(1,i)=pcm(5,i)*u(1) + pcm(2,i)=pcm(5,i)*u(2) + pcm(3,i)=pcm(5,i)*u(3) + enddo + + return + end + +cc------------------------------------------------------------------- +c subroutine hnbrt2old(c,s,c2,s2,pr,i) +cc------------------------------------------------------------------- +cc formerly subr rotes2 from cernlib +cc this subr now does two rotations (xy and xz) +cc------------------------------------------------------------------- +c parameter(maxp=500) +c dimension pr(5*maxp) +c k1 = 5*i - 4 +c k2 = k1 + 1 +c sa = pr(k1) +c sb = pr(k2) +c a = sa*c - sb*s +c pr(k2) = sa*s + sb*c +c k2 = k2 + 1 +c b = pr(k2) +c pr(k1) = a*c2 - b*s2 +c pr(k2) = a*s2 + b*c2 +c return +c end +c +c------------------------------------------------------------------- + subroutine hnbrt2(c,s,c2,s2,pr,i) +c------------------------------------------------------------------- +c formerly subr rotes2 from cernlib +c this subr now does two rotations (xy and xz) +c------------------------------------------------------------------- + parameter(maxp=500) + dimension pr(5,maxp) + k1 = 5*i - 4 + k2 = k1 + 1 + sa = pr(1,i) + sb = pr(2,i) + a = sa*c - sb*s + pr(2,i) = sa*s + sb*c + k2 = k2 + 1 + b = pr(3,i) + pr(1,i) = a*c2 - b*s2 + pr(3,i) = a*s2 + b*c2 + return + end + +cc----------------------------------------------------------------------- +c subroutine hnbsor(a,n) +cc----------------------------------------------------------------------- +cc cern proglib# m103 flpsor .version kernfor 3.15 820113 +cc orig. 29/04/78 +cc----------------------------------------------------------------------- +cc sort the one-dimensional floating point array a(1),...,a(n) by +cc increasing values +cc----------------------------------------------------------------------- +c dimension a(*) +c common /slate/ lt(20),rt(20) +c integer r,rt +cc +c level=1 +c lt(1)=1 +c rt(1)=n +c 10 l=lt(level) +c r=rt(level) +c level=level-1 +c 20 if(r.gt.l) go to 200 +c if(level) 50,50,10 +cc +cc subdivide the interval l,r +cc l : lower limit of the interval (input) +cc r : upper limit of the interval (input) +cc j : upper limit of lower sub-interval (output) +cc i : lower limit of upper sub-interval (output) +cc +c 200 i=l +c j=r +c m=(l+r)/2 +c x=a(m) +c 220 if(a(i).ge.x) go to 230 +c i=i+1 +c go to 220 +c 230 if(a(j).le.x) go to 231 +c j=j-1 +c go to 230 +cc +c 231 if(i.gt.j) go to 232 +c w=a(i) +c a(i)=a(j) +c a(j)=w +c i=i+1 +c j=j-1 +c if(i.le.j) go to 220 +cc +c 232 level=level+1 +c if(level.gt.20)stop'level too large' +c if((r-i).ge.(j-l)) go to 30 +c lt(level)=l +c rt(level)=j +c l=i +c go to 20 +c 30 lt(level)=i +c rt(level)=r +c r=j +c go to 20 +c 50 return +c end +c +c----------------------------------------------------------------------- + subroutine hnbspd(iopt) +c----------------------------------------------------------------------- +c defines particle species and masses and degeneracies. +c input: +c iopt=odd number: massless +c iopt=even number: same as iopt-1, but massive +c iopt= 1: pi0 (massless) +c iopt= 2: pi0 +c iopt= 3: pi-,pi0,pi+ (massless) +c iopt= 4: pi-,pi0,pi+ +c iopt= 5: pi-,pi0,pi+,prt,aprt,ntr,antr (massless) +c iopt= 6: pi-,pi0,pi+,prt,aprt,ntr,antr +c iopt= 7: 25 hadrons (massless) +c iopt= 8: 25 hadrons +c iopt= 9: 54 hadrons (massless) +c iopt=10: 54 hadrons +c iopt=11: 3 quarks (massless) +c iopt=12: 3 quarks +c iopt=13: 54 hadrons + J/psi (massless) +c iopt=14: 54 hadrons + J/psi +c iopt=15: 54 hadrons + J/psi + H (massless) +c iopt=16: 54 hadrons + J/psi + H +c output: +c nspecs: nr of species +c ispecs: id's +c aspecs: masses +c----------------------------------------------------------------------- + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + parameter (nflav=6) + integer jc(nflav,2),ic(2) + common/cflac/ifok(nflav,mspecs),ifoa(nflav) + common/cspec2/jspecs(2,nflav,mspecs) + common/cspec3/lkfok(8,-3:3,-3:3,-3:3,-3:3) !-charm + common/cspec4/lkfoi(8,-3:3,-3:3,-3:3,-3:3) !-charm + parameter(nspe01=1,nspe03=3,nspe05=7,nspe07=25,nspe09=54) + parameter(nspe11=6,nspe13=55,nspe15=56) + real jspe01(nspe01),jspe03(nspe03),jspe05(nspe05),jspe07(nspe07) + *,jspe09(nspe09),jspe11(nspe11),jspe13(nspe13),jspe15(nspe15) + data jspe01/ 110 / + data jspe03/ 110, 120, -120 / + data jspe05/ 110, 120, -120, 1120,-1120, 1220,-1220 / + data jspe07/ + * 110, 120, -120, 130, -130, 230, -230, 220, 330 + *, 1120,-1120, 1220,-1220, 1130,-1130, 2130,-2130 + *, 1230,-1230, 2230,-2230, 1330,-1330, 2330,-2330 / + data jspe09/ + * 110, 120, -120, 130, -130, 230, -230, 220, 330 + *, 111, 121, -121, 131, -131, 231, -231, 221, 331 + *, 1120,-1120, 1220,-1220, 1130,-1130, 2130,-2130 + *, 1230,-1230, 2230,-2230, 1330,-1330, 2330,-2330 + *, 1111,-1111, 1121,-1121, 1221,-1221, 2221,-2221, 1131,-1131 + *, 1231,-1231, 2231,-2231, 1331,-1331, 2331,-2331, 3331,-3331 / + data jspe11/ + * 1, -1, 2, -2, 3, -3 / + data jspe13/ + * 110, 120, -120, 130, -130, 230, -230, 220, 330 + *, 111, 121, -121, 131, -131, 231, -231, 221, 331 + *, 1120,-1120, 1220,-1220, 1130,-1130, 2130,-2130 + *, 1230,-1230, 2230,-2230, 1330,-1330, 2330,-2330 + *, 1111,-1111, 1121,-1121, 1221,-1221, 2221,-2221, 1131,-1131 + *, 1231,-1231, 2231,-2231, 1331,-1331, 2331,-2331, 3331,-3331 + *, 441 / + data jspe15/ + * 110, 120, -120, 130, -130, 230, -230, 220, 330 + *, 111, 121, -121, 131, -131, 231, -231, 221, 331 + *, 1120,-1120, 1220,-1220, 1130,-1130, 2130,-2130 + *, 1230,-1230, 2230,-2230, 1330,-1330, 2330,-2330 + *, 1111,-1111, 1121,-1121, 1221,-1221, 2221,-2221, 1131,-1131 + *, 1231,-1231, 2231,-2231, 1331,-1331, 2331,-2331, 3331,-3331 + *, 441 , 30 / + + if(iopt.gt.16)call utstop('hnbspd: invalid option&') + ioptx=(1+iopt)/2*2-1 + + if(ioptx.eq.1)nspecs=nspe01 + if(ioptx.eq.3)nspecs=nspe03 + if(ioptx.eq.5)nspecs=nspe05 + if(ioptx.eq.7)nspecs=nspe07 + if(ioptx.eq.9)nspecs=nspe09 + if(ioptx.eq.11)nspecs=nspe11 + if(ioptx.eq.13)nspecs=nspe13 + if(ioptx.eq.15)nspecs=nspe15 + do i=1,nspecs + if(ioptx.eq.1)ispecs(i)=jspe01(i) + if(ioptx.eq.3)ispecs(i)=jspe03(i) + if(ioptx.eq.5)ispecs(i)=jspe05(i) + if(ioptx.eq.7)ispecs(i)=jspe07(i) + if(ioptx.eq.9)ispecs(i)=jspe09(i) + if(ioptx.eq.11)ispecs(i)=jspe11(i) + if(ioptx.eq.13)ispecs(i)=jspe13(i) + if(ioptx.eq.15)ispecs(i)=jspe15(i) + if(ioptx.eq.iopt)then + aspecs(i)=0 + else + id=ispecs(i) + call idmass(id,am) + aspecs(i)=am + endif + call hnbspi(ispecs(i),gg) + gspecs(i)=gg + enddo + + do nf=1,nflav + ifoa(nf)=0 + enddo + do iic=-3, 3 !-charm + do iis=-3, 3 + do iid=-3, 3 + do iiu=-3, 3 + do ii=1,7 + lkfok(ii,iiu,iid,iis,iic)=0 !-charm + lkfoi(ii,iiu,iid,iis,iic)=0 !-charm + enddo + enddo + enddo + enddo + enddo + do i=1,nspecs + id=ispecs(i) + call idtr4(id,ic) + call iddeco(ic,jc) + do nf=1,nflav + ifok(nf,i)=jc(nf,1)-jc(nf,2) + ifoa(nf)=ifoa(nf)+iabs(ifok(nf,i)) + jspecs(1,nf,i)=jc(nf,1) + jspecs(2,nf,i)=jc(nf,2) + enddo + iiu=ifok(1,i) + iid=ifok(2,i) + iis=ifok(3,i) + iic=ifok(4,i) !-charm + if(abs(iiu).gt.3)stop'HNBSPD: u-dimension of lkfok too small' + if(abs(iid).gt.3)stop'HNBSPD: d-dimension of lkfok too small' + if(abs(iis).gt.3)stop'HNBSPD: s-dimension of lkfok too small' + if(abs(iic).gt.3)stop'HNBSPD: c-dimension of lkfok too small' !-charm +c-charm if(ifok(4,i).ne.0)stop'HNBSPD: lkfok needs index for c' + if(ifok(5,i).ne.0)stop'HNBSPD: lkfok needs index for b' + if(ifok(6,i).ne.0)stop'HNBSPD: lkfok needs index for t' + lkfok(1,iiu,iid,iis,iic)=lkfok(1,iiu,iid,iis,iic)+1 !-charm + lkfoi(1,iiu,iid,iis,iic)=lkfoi(1,iiu,iid,iis,iic)+1 !-charm + ii=lkfok(1,iiu,iid,iis,iic) !-charm + if(ii.gt.7)stop'HNBSPD: ii-dimension of lkfok too small' + lkfok(1+ii,iiu,iid,iis,iic)=id !-charm + lkfoi(1+ii,iiu,iid,iis,iic)=i !-charm +c write(6,'(i5,5x,3i5,5x,i5,5x,6i5)') +c * id,iiu,iid,iis,(lkfok(iiu,iid,iis,kk),kk=1,7) + enddo + + return + end + +c------------------------------------------------------------- + subroutine hnbspf(ku,kd,ks,kc,kb,kt,j,n,spelog) +c------------------------------------------------------------- +c returns spelog = log of factor for consid. different species +c spelog is double precision +c option ioflac determines the method: +c ioflac=1: ignore flavour conservation +c ioflac=2: flavour conservation implemented straightforward +c (only for nspecs=3,7) +c ioflac=3: flavour conservation via generating fctn +c further input: +c ku,...,kt (integer) : flavour +c j (integer) : excluded species +c n (integer) : multiplicity +c------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cflac/ifok(nflav,mspecs),ifoa(nflav) + integer m(7),l(7),ifot(nflav) + common/csph/ifox(nflav),ifoy(nflav),jx,nx,ifom(nflav,mspecs) + parameter(mxfacu=200) + double precision faci(0:mxfacu) + double precision utgam2,spelog,spe +c parameter(numax=100,kqmax=100) +c parameter(mxhh=200) + if(ish.ge.9)write(ifch,*)('-',i=1,10) + *,' entry sr hnbspf ',('-',i=1,30) + if(ish.ge.9)write(ifch,'(1x,a,9x,a,4x,a)') + *' ku kd ks kc kb kt','j','n' + if(ish.ge.9)write(ifch,'(1x,6i3,5x,2i5)') + *ku,kd,ks,kc,kb,kt,j,n + k=nspecs + jx=j + nx=n + ifot(1)=ku + ifot(2)=kd + ifot(3)=ks + ifot(4)=kc + ifot(5)=kb + ifot(6)=kt + + if(ioflac.eq.1)then + + if(ish.ge.9)write(ifch,'(1x,a,i1)')'ioflac=',ioflac + g=0 + do i=1,nspecs + if(i.ne.j)g=g+gspecs(i) + enddo + spelog=n*dlog(1.d0*g) + + elseif(ioflac.eq.2)then + + if(ish.ge.9)write(ifch,'(1x,a,i2)')'ioflac:',ioflac + if(k.eq.3)then + if(ish.ge.9)write(ifch,'(1x,a,i2)')'nspecs:',nspecs + spe=0d0 + if(j.lt.1.or. j.gt.k)then + do 1 n1=0,n + do 2 n2=0,n-n1 + n3=n-n1-n2 + do 5 nf=1,nflav + if(ifoa(nf).eq.0.and.ifot(nf).eq.0)goto5 + if(n1*ifok(nf,1)+n2*ifok(nf,2)+n3*ifok(nf,3).ne.ifot(nf))goto2 + 5 continue + spe=spe+utgam2(1.d0+n) + &/utgam2(1.d0+n1)/utgam2(1.d0+n2)/utgam2(1.d0+n3) + &*gspecs(1)**n1*gspecs(2)**n2*gspecs(3)**n3 + 2 continue + 1 continue + else + do 3 i1=0,n + i2=n-i1 + m(1)=0 + m(2)=i1 + m(3)=i2 + do i=1,3 + ii=1+mod(j-2+i,3) + l(ii)=m(i) + enddo + n1=l(1) + n2=l(2) + n3=l(3) + do 6 nf=1,nflav + if(ifoa(nf).eq.0.and.ifot(nf).eq.0)goto6 + if(n1*ifok(nf,1)+n2*ifok(nf,2)+n3*ifok(nf,3).ne.ifot(nf))goto3 + 6 continue + spe=spe+utgam2(1.d0+n) + &/utgam2(1.d0+n1)/utgam2(1.d0+n2)/utgam2(1.d0+n3) + &*gspecs(1)**n1*gspecs(2)**n2*gspecs(3)**n3 + 3 continue + endif + if(ish.ge.9)write(ifch,*)'spe:',spe + spelog=-1000 + if(spe.gt.0.d0)spelog=dlog(spe) + if(ish.ge.9)write(ifch,*)'spelog:',spelog + elseif(k.eq.7)then + if(ish.ge.9)write(ifch,'(1x,a,i2)')'nspecs:',nspecs + if(n.gt.mxfacu)call utstop('hnbspf: mxfacu too small&') + do lf=0,n + faci(lf)=1.d0/utgam2(1d0+lf) + enddo + spe=0 + if(j.lt.1.or. j.gt.k)then + do n1=0,n + do n2=0,n-n1 + do n3=0,n-n1-n2 + do n4=0,n-n1-n2-n3 + do n5=0,n-n1-n2-n3-n4 + do 12 n6=0,n-n1-n2-n3-n4-n5 + n7=n-n1-n2-n3-n4-n5-n6 + do 15 nf=1,nflav + if(ifoa(nf).eq.0.and.ifot(nf).eq.0)goto15 + if(n1*ifok(nf,1)+n2*ifok(nf,2)+n3*ifok(nf,3)+n4*ifok(nf,4) + *+n5*ifok(nf,5)+n6*ifok(nf,6)+n7*ifok(nf,7).ne.ifot(nf))goto12 + 15 continue + spe=spe+1d0/faci(n)*faci(n1)*faci(n2)*faci(n3)*faci(n4) + &*faci(n5)*faci(n6)*faci(n7) + &*gspecs(1)**n1*gspecs(2)**n2*gspecs(3)**n3*gspecs(4)**n4 + &*gspecs(5)**n5*gspecs(6)**n6*gspecs(7)**n7 + 12 continue + enddo + enddo + enddo + enddo + enddo + else + do i1=0,n + do i2=0,n-i1 + do i3=0,n-i1-i2 + do i4=0,n-i1-i2-i3 + do 13 i5=0,n-i1-i2-i3-i4 + i6=n-i1-i2-i3-i4-i5 + m(1)=0 + m(2)=i1 + m(3)=i2 + m(4)=i3 + m(5)=i4 + m(6)=i5 + m(7)=i6 + do i=1,7 + ii=1+mod(j-2+i,7) + l(ii)=m(i) + enddo + n1=l(1) + n2=l(2) + n3=l(3) + n4=l(4) + n5=l(5) + n6=l(6) + n7=l(7) + do 16 nf=1,nflav + if(ifoa(nf).eq.0.and.ifot(nf).eq.0)goto16 + if(n1*ifok(nf,1)+n2*ifok(nf,2)+n3*ifok(nf,3)+n4*ifok(nf,4) + *+n5*ifok(nf,5)+n6*ifok(nf,6)+n7*ifok(nf,7).ne.ifot(nf))goto13 + 16 continue + spe=spe+1d0/faci(n)*faci(n1)*faci(n2)*faci(n3)*faci(n4) + &*faci(n5)*faci(n6)*faci(n7) + &*gspecs(1)**n1*gspecs(2)**n2*gspecs(3)**n3*gspecs(4)**n4 + &*gspecs(5)**n5*gspecs(6)**n6*gspecs(7)**n7 + 13 continue + enddo + enddo + enddo + enddo + endif + if(ish.ge.9)write(ifch,*)'spe:',spe + spelog=-1000 + if(spe.gt.0.d0)spelog=dlog(spe) + if(ish.ge.9)write(ifch,*)'spelog:',spelog + else + call utstop('hnbspf: ioflac=2 only for nspecs=3,7&') + endif + + elseif(ioflac.eq.3)then + + call utstop('hnbspf: ioflac must be 1 or 2&') + + endif + + if(ish.ge.9)write(ifch,*)('-',i=1,30) + *,' exit sr hnbspf ',('-',i=1,10) + return + end + +c------------------------------------------------------------- + subroutine hnbspg(ku,kd,ks,kc,kb,kt,j,n,spelog) +c------------------------------------------------------------- + include 'epos.inc' + double precision spelog,spalog + if(ioflac.ne.0)return + ioflac=2 + call hnbspf(ku,kd,ks,kc,kb,kt,j,n,spalog) + ioflac=3 + call hnbspf(ku,kd,ks,kc,kb,kt,j,n,spelog) + ioflac=0 + write(ifch,*)'ioflac=2/3:',spalog,spelog + return + end + +c---------------------------------------------------------------------- + subroutine hnbspi(id,spideg) +c---------------------------------------------------------------------- +c returns spin degeneracy spideg for particle id-code id +c---------------------------------------------------------------------- + include 'epos.inc' + parameter (nspec=62) + dimension ispec(nspec),spid(nspec) + data ispec/ + * 1, -1, 2, -2, 3, -3 + *, 110, 120, -120, 220, 130, -130, 230, -230, 330 + *, 111, 121, -121, 221, 131, -131, 231, -231, 331 + *, 1120, 1220, 1130, 2130, 1230, 2230, 1330, 2330 + *, 1111, 1121, 1221, 2221, 1131, 1231, 2231, 1331, 2331, 3331 + *,-1120,-1220,-1130,-2130,-1230,-2230,-1330,-2330 + *,-1111,-1121,-1221,-2221,-1131,-1231,-2231,-1331,-2331,-3331 + *,441,30/ + data spid/ + * 6*6. + *, 9*1. + *, 9*3. + *, 8*2. + *,10*4. + *, 8*2. + *,10*4. + *,1*3 + *,1*3/ + do i=1,nspec + if(id.eq.ispec(i))then + spideg=spid(i) + fac=1 + !factb ... not used + !factq ... not used + call idflav(id,ifl1,ifl2,ifl3,jspin,index) + ifls=0 + if(abs(ifl1).eq.3)ifls=ifls+1 + if(abs(ifl2).eq.3)ifls=ifls+1 + if(abs(ifl3).eq.3)ifls=ifls+1 + if(iLHC.eq.1)then + if(ifls.ge.1)then + if(abs(id).gt.1000)then + fac=fac*(1+facts) + elseif(abs(id).lt.1000)then + fac=fac*(1-facts) + endif + elseif(abs(id).gt.1000)then + fac=fac*(1+factb) + endif + else + if(ifls.ge.1)then + if(abs(id).gt.1000)then + fac=fac*(1+facts) + elseif(abs(id).lt.1000)then + fac=fac*(1-facts) + endif + endif + endif + spideg=spideg*fac + goto1 + endif + enddo + call utstop('hnbspi: id not found&') + 1 continue + return + end + +c---------------------------------------------------------------------- + subroutine hnbtst(iof12) +c---------------------------------------------------------------------- +c calculates logs of prefactors and phase space integral +c for ultrarelativistic limit (massless particles) and (2*s_i+1)=1 +c f12log and w15log=w35log+f12log not calculated calculated for iof12=0 +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + common/ctst/psulog,wtulog + integer ii(maxp) + common /clatt/nlattc,npmax + + pi=3.1415927 + hquer=0.197327 + ish0=ish + if(ishsub/100.eq.23)ish=mod(ishsub,100) + do i=1,np + ii(i)=1 + enddo + + if(ish.ge.7)write(ifch,*)('-',i=1,10) + *,' entry sr hnbtst ',('-',i=1,30) + if(ish.ge.7)write(ifch,*)'configuration:' + if(ish.ge.7)write(ifch,*)(ident(i),i=1,np) + if(ish.ge.7)write(ifch,*)'n_l:',nlattc,' n_0:',nlattc-np + +c log of prod m_i*volu/4/pi**3/hquer**3 -> f5log + f5log=0 + do i=1,np + call hnbfaf(i,gg,am,ioma) + f5log=f5log+alog(gg*am*volu/4/pi**3/hquer**3) + enddo + if(ish.ge.7)write(ifch,*)'log(f5):',f5log + +c log f4log=0 + f4log=0 + if(ish.ge.7)write(ifch,*)'log(f4):',f4log + +c log of 1/prod n_alpha! -> f3log + dbllog=0 + n1=1 + nx=1 + 1 continue + i=0 + x=0 + do n2=n1,np + if(ident(n2).eq.ident(n1))then + ii(n2)=0 + i=i+1 + x=x+alog(i*1.) + endif + if(ii(n2).ne.0.and.n2.gt.n1.and.nx.eq.n1 + *.and.ident(n2).ne.ident(n1))nx=n2 + enddo + dbllog=dbllog+x + if(nx.gt.n1)then + n1=nx + goto1 + endif + f3log=-dbllog + if(ish.ge.7)write(ifch,*)'log(f3):' + *,f3log + +c log of f3 * f4 * f5 + f35log=f5log+f4log+f3log + if(ish.ge.7)write(ifch,*)'log(f3*f4*f5):',f35log + +c log of phase space integral --> psilog + if(iocova.eq.1)then + psilog=alog(2.*np*np*(np-1)/tecm**4/pi) + do i=1,np + psilog=psilog+alog(tecm**2*pi/2./i/i) + enddo + elseif(iocova.eq.2)then + psilog=-alog(2.*np-1) + psilog=psilog+(np-1)*alog(pi/2.) + do i=1,2*np-2 + psilog=psilog+alog((2.*np+i-2)/i) + enddo + do i=1,3*np-4 + psilog=psilog+alog(tecm/i) + enddo + endif + if(ish.ge.7)write(ifch,*)'log(psi):',psilog + +c log of phase space integral * f3 * f4 * f5 + w35log=f35log+psilog + if(ish.ge.7)write(ifch,*)'log(f35*psi):',w35log + + if(iof12.ne.0)then + +c log of macro/micro factor (f1*f2) --> f12log + deglog=0 + do i=1,np + deglog=deglog+alog(1.*i) + enddo + deglog=deglog+f3log + do i=1,np + deglog=deglog+alog(nlattc+1.-i)-alog(1.*i) + enddo + f12log=-deglog + + w15log=w35log+f12log + if(ish.ge.7)then + write(ifch,*)'log(f1*f2):',f12log + write(ifch,*)'log(f15*psi):',w15log + write(ifch,'(1x,4(a,3x))') + *'log(fac):','log(psi):',' log(wt):','log(wta):' + write(ifch,'(1x,4(f9.3,3x))') + *f12log+f35log,psilog,w15log,w15log-f12log + endif + + endif + + psulog=psilog + wtulog=w35log + + if(ish.ge.7)write(ifch,*)('-',i=1,30) + *,' exit sr hnbtst ',('-',i=1,10) + ish=ish0 + return + end + +cc---------------------------------------------------------------------- +c subroutine hnbuex(x,e) +cc---------------------------------------------------------------------- +cc x --> x*10.**e with x.lt.10.**10. +cc---------------------------------------------------------------------- +c if(x.eq.0.)then +c e=0. +c else +c e=int(alog10(abs(x)))/10*10 +c x=x/10.**e +c endif +c return +c end +c +cc---------------------------------------------------------------------- +c subroutine hnbwin(n,w,q,i) +cc---------------------------------------------------------------------- +cc returns random index i according to weight w(i) +cc---------------------------------------------------------------------- +c real w(n),q(n) +c q(1)=w(1) +c do k=2,n +c q(k)=q(k-1)+w(k) +c enddo +c y=rangen()*q(n) +c do k=1,n +c i=k +c if(q(k).ge.y)goto1000 +c enddo +c i=n +c1000 return +c end +c +c---------------------------------------------------------------------- + subroutine hnbwri +c---------------------------------------------------------------------- +c writes (to ifch) an configuration +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + common/cfact/faclog + write(ifch,'(1x,a,i5)')'np:',np + write(ifch,'(1x,3(a,3x))') + *'log(fac):','log(psi):',' log(wt):' + if(wtlog.gt.-1e30.and.wtxlog.gt.-1e30)then + write(ifch,'(1x,3(f9.3,3x))')faclog,wtxlog,wtlog + else + write(ifch,*)faclog,wtxlog,wtlog + endif + if(np.le.1)return + call hnbtst(1) + write(ifch,*)'particle id codes:' + write(ifch,'(1x,10i6)')(ident(n),n=1,np) + write(ifch,*)'particle masses:' + write(ifch,'(1x,10f6.3)')(amass(n),n=1,np) + end + +c---------------------------------------------------------------------- + subroutine hnbzen(iii) +c---------------------------------------------------------------------- +c analysis of events. energy spectra. +c for iii>0: filling histogram considering ptl iii +c---------------------------------------------------------------------- + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + parameter (nhise=100) + common/chise/hise(mspecs,nhise) + de=2./nhise/2. + + j=0 + + if(iii.gt.0)then + + i=iii + do l=1,nspecs + if(ident(i).eq.ispecs(l))then + j=l + goto1 + endif + enddo + 1 continue + am=aspecs(j) + e=pcm(4,i) + ke=1+int((e-am)/(2*de)) + if(ke.ge.1.and.ke.le.nhise)hise(j,ke)=hise(j,ke)+1 + return + + else + + stop'STOP in hnbzen: iii=0' + + endif + + end + +c---------------------------------------------------------------------- + subroutine hnbzmu(iii) +c---------------------------------------------------------------------- +c analysis of events. multiplicity spectra. +c for iii<0: settting histograms to zero (should be first call) +c for iii>0: filling histogram considering ptl iii +c---------------------------------------------------------------------- + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + parameter (nhismu=500) + common/chismu/hismu(mspecs,0:nhismu),hismus(nhismu) + + if(iii.lt.0)then + + do i=1,nhismu + hismus(i)=0 + enddo + do j=1,nspecs + do i=0,nhismu + hismu(j,i)=0 + enddo + enddo + goto1000 + + elseif(iii.gt.0)then + + if(np.ge.1.and.np.le.nhismu)hismus(np)=hismus(np)+1 + do j=1,nspecs + mu=0 + do i=1,np + if(ident(i).eq.ispecs(j))mu=mu+1 + enddo + if(mu.ge.0.and.mu.le.nhismu)hismu(j,mu)=hismu(j,mu)+1 + enddo + goto1000 + + else + + stop'STOP in sr hnbzmu: iii must not be 0' + + endif + +1000 continue + return + end + +c----------------------------------------------------------------------- + subroutine xhgcam(amt,iii) +c----------------------------------------------------------------------- +c creates unnormalized histogram for total mass of grand +c canonically generated sample +c xpar1: nr. of bins +c xpar2: m_1 (lower boundary) +c xpar3: m_2 (upper boundary) +c----------------------------------------------------------------------- + include 'epos.inc' + parameter(nbmx=200) + common/camdat/data(nbmx),datb(nbmx) + parameter(mxclu=10000) + real am(mxclu) + character cen*6,cvol*6 + + if(iii.eq.0)then + + am(nrclu)=amt + + return + + elseif(iii.lt.0)then + + nbin=nint(xpar3) + x1=xpar1 + x2=xpar2 + dam=(x2-x1)/nbin + write(cen,'(f6.1)')tecm + write(cvol,'(f6.1)')volu + + do i=1,nbin + data(i)=x1+(i-1)*dam + datb(i)=0.0 + enddo + + do i=1,nrclu + xnb=(am(i)-x1)/dam+1. + nb=nint(xnb) + if(nb.le.nbin.and.nb.ge.1)datb(nb)=datb(nb)+1 + enddo + + write(ifhi,'(a)') 'newpage zone 1 2 1' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp his' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'text 0 0 "xaxis total mass"' + write(ifhi,'(a)') 'text 0 0 "yaxis N"' + write(ifhi,'(a,a)') 'text 0.4 0.91 "V='//cvol//'"' + write(ifhi,'(a,a)') 'text 0.15 0.91 "E='//cen//'"' + write(ifhi,'(a)') 'array 2' + + do j=1,nbin + write(ifhi,'(2e13.5)')data(j),datb(j) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + + return + + endif + + end + +c----------------------------------------------------------------------- + subroutine xhgccc(chi) +c----------------------------------------------------------------------- +c creates unnormalized histogram for chi-squared test of initial +c configuration (grand-canonical results are used) +c for chi>0: chi-squared for each droplet configuration is written +c to /cchi/ +c for chi<0: creates histogram +c xpar1 specifies lower limit +c xpar2 specifies upper limit +c xpar3 specifies bin width +c newpage, zone and plot commands not included !!! +c----------------------------------------------------------------------- + include 'epos.inc' + parameter(nbin=200) + common/chidat/data(nbin),datb(nbin) + parameter(mxclu=10000) + common/cchi/chi2(mxclu) + character cnu*2,cinco*1,cen*6,cvol*6 + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + + if(chi.ge.0.0)then + + nrclu=nrclu+1 + chi2(nrclu)=chi + + return + + elseif(chi.lt.0.0)then + + x1=nint(xpar1) + x2=nint(xpar2) + da=xpar3 + write(cnu,'(i2)')nspecs + write(cinco,'(i1)')ioinco + write(cen,'(f6.1)')tecm + write(cvol,'(f6.1)')volu + + if(x2.eq.0)x2=50.0 + da=max(0.1,da) + a0=x1 + + do i=1,nbin + data(i)=a0+(i-1)*da + datb(i)=0.0 + enddo + + do i=1,nrclu + nb=(chi2(i)+da/2.-a0)/da + if(nb.le.nbin.and.nb.ge.1)datb(nb)=datb(nb)+1 + enddo + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp his' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'text 0 0 "xaxis [V]^2"' + write(ifhi,'(a)') 'text 0 0 "yaxis f([V]^2,n?eff!)"' + if(iappl.eq.4)write(ifhi,'(a,a)')'text 0.4 0.91 "V='//cvol//'"' + if(iappl.eq.4)write(ifhi,'(a,a)')'text 0.15 0.91 "E='//cen//'"' + write(ifhi,'(a)') 'array 2' + + do j=1,nbin + dat=datb(j)/nevent/da + write(ifhi,'(2e13.5)')data(j),dat + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + return + + endif + + end + +c----------------------------------------------------------------------- + subroutine xhgcen +c----------------------------------------------------------------------- +c creates energy spectrum plot for decayed QM-droplet +c using grand canonical results +c input: +c xpar1 specifies particle species by paige id, 0 for all +c xpar2 and xpar3 specify xrange of plot +c xpar4 specifies line type : dashed (0), dotted (1), full (2) dado (3) +c xpar5 specifies statistics to be used ,(0) same as iostat +c (1) boltzmann +c output: +c histo-file +c newpage, zone and plot commands not included !!! +c----------------------------------------------------------------------- + include 'epos.inc' + common/citer/iter,itermx + parameter (nbin=200) + real datx(nbin),daty(nbin) + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cbol/rmsbol(mspecs),ptlbol(mspecs),chebol(mspecs),tembol + character ctem*5,cit*5,cen*6,cvo*6,chem*5 + + idpa=nint(xpar1) + x1=xpar2 + x2=xpar3 + ltyp=nint(xpar4) + ist=nint(xpar5) + if(ist.eq.0.and.iostat.eq.1)ist=1 + + id=0 + jx=100 + do i=1,nspecs + if(ispecs(i).eq.idpa)id=i + enddo + + dx=(x2-x1)/2./jx + x0=x1+dx + + do j=1,jx + datx(j)=x0+(j-1)*dx*2. + daty(j)=0.0 + + if(id.eq.0)then + + do 10 i=1,nspecs + dnde=0.0 + if(datx(j).ge.aspecs(i))then + x=100. + if(tem.ne.0.0.and.ist.eq.0)x=(datx(j)-chemgc(i))/tem + if(tem.ne.0.0.and.ist.eq.1)x=(datx(j)-chebol(i))/tembol + igsp=gspecs(i) + if(x.ge.60)goto10 + if(mod(igsp,2).eq.0.and.ist.eq.0)then + dnde=1./(exp(x)+1.) + elseif(x.le.1.e-7.and.ist.eq.0)then + dnde=1.e7 + elseif(ist.eq.0)then + dnde=1./(exp(x)-1.) + elseif(ist.eq.1)then + dnde=exp(-x) + endif + endif + daty(j)=daty(j)+dnde*gspecs(i)*volu/hquer**3/8./pi**3 +10 continue + + else + + dnde=0.0 + if(datx(j).ge.aspecs(id))then + x=100. + if(tem.ne.0.0.and.ist.eq.0)x=(datx(j)-chemgc(id))/tem + if(tem.ne.0.0.and.ist.eq.1)x=(datx(j)-chebol(id))/tembol + igsp=gspecs(id) + if(x.ge.60)goto11 + if(mod(igsp,2).eq.0.and.ist.eq.0)then + dnde=1./(exp(x)+1.) + elseif(x.le.1.e-7.and.ist.eq.0)then + dnde=1.e7 + elseif(ist.eq.0)then + dnde=1./(exp(x)-1.) + elseif(ist.eq.1)then + dnde=exp(-x) + endif + endif +11 daty(j)=dnde*gspecs(id)*volu/hquer**3/8./pi**3 + + endif + + enddo + + ctem=' ' + chem=' ' + if(tem.gt.0.)write(ctem,'(f5.3)')tem + write(cen,'(f6.1)')tecm + write(cvo,'(f6.1)')volu + if(id.gt.0)write(chem,'(f5.3)')chemgc(id) + write(cit,'(i5)')itermx + write(ifhi,'(a)') 'openhisto' + if(ltyp.eq.0)then + write(ifhi,'(a)') 'htyp lda' + elseif(ltyp.eq.1)then + write(ifhi,'(a)') 'htyp ldo' + elseif(ltyp.eq.2)then + write(ifhi,'(a)') 'htyp lfu' + elseif(ltyp.eq.3)then + write(ifhi,'(a)') 'htyp ldd' + endif + write(ifhi,'(a)') 'xmod lin ymod log' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'text 0 0 "xaxis E?[n]! (GeV)"' + write(ifhi,'(a)') 'text 0 0 "yaxis dN?[n]!/d^3!p"' + write(ifhi,'(a,a)') 'text 0.3 0.10 "T='//ctem//'"' + write(ifhi,'(a,a)') 'text 0.3 0.20 "[m]?[n]!='//chem//'"' + write(ifhi,'(a,a)') 'text 0.3 0.20 "i?max!='//cit//'"' + if(iocite.ne.1)then + write(ifhi,'(a,a)') 'text 0.4 0.91 "V='//cvo//'"' + write(ifhi,'(a,a)') 'text 0.15 0.91 "E='//cen//'"' + endif + write(ifhi,'(a)') 'array 2' + + do j=1,jx + write(ifhi,'(2e12.4)')datx(j),daty(j) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + return + end + +c----------------------------------------------------------------------- + subroutine xhgcfl(u,d,s,iii) +c----------------------------------------------------------------------- +c creates unnormalized histogram for net flavor content of grand +c canonically generated sample +c xpar1: specifies width of plot, netflavor centered +c----------------------------------------------------------------------- + include 'epos.inc' + parameter(nb=200) + common/cfldat/data(nb),datb(nb),datc(nb),datu(nb) + *,datd(nb),dats(nb) + parameter(mxclu=10000) + integer ku(mxclu),kd(mxclu),ks(mxclu) + character cfl*3,cen*6,cvol*6 + + if(iii.eq.0)then + + ku(nrclu)=u + kd(nrclu)=d + ks(nrclu)=s + + return + + elseif(iii.lt.0)then + + kwid=nint(xpar1) + nbin=2*kwid+1 + x1u=keu-kwid + x2u=keu+kwid + x1d=ked-kwid + x2d=ked+kwid + x1s=kes-kwid + x2s=kes+kwid + write(cen,'(f6.1)')tecm + write(cvol,'(f6.1)')volu + + do i=1,nbin + data(i)=x1u+(i-1) + datb(i)=x1d+(i-1) + datc(i)=x1s+(i-1) + datu(i)=0.0 + datd(i)=0.0 + dats(i)=0.0 + enddo + + do i=1,nrclu + nbu=(ku(i)-x1u+1) + nbd=(kd(i)-x1d+1) + nbs=(ks(i)-x1s+1) + if(nbu.le.nbin.and.nbu.ge.1)datu(nbu)=datu(nbu)+1 + if(nbd.le.nbin.and.nbd.ge.1)datd(nbd)=datd(nbd)+1 + if(nbs.le.nbin.and.nbs.ge.1)dats(nbs)=dats(nbs)+1 + enddo + + write(ifhi,'(a)') 'newpage zone 1 3 1' + + write(cfl,'(i3)')keu + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp his' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',x1u,x2u + write(ifhi,'(a)') 'text 0 0 "xaxis net u content"' + write(ifhi,'(a)') 'text 0 0 "yaxis N"' + write(ifhi,'(a,a)') 'text 0.4 0.91 "V='//cvol//'"' + write(ifhi,'(a,a)') 'text 0.15 0.91 "E='//cen//'"' + write(ifhi,'(a,a)') 'text 0.65 0.91 "N?u!='//cfl//'"' + write(ifhi,'(a)') 'array 2' + + do j=1,nbin + write(ifhi,'(2e13.5)')data(j),datu(j) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + write(cfl,'(i3)')ked + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp his' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',x1d,x2d + write(ifhi,'(a)') 'text 0 0 "xaxis net d content"' + write(ifhi,'(a)') 'text 0 0 "yaxis N"' + write(ifhi,'(a,a)') 'text 0.4 0.91 "V='//cvol//'"' + write(ifhi,'(a,a)') 'text 0.15 0.91 "E='//cen//'"' + write(ifhi,'(a,a)') 'text 0.65 0.91 "N?d!='//cfl//'"' + write(ifhi,'(a)') 'array 2' + + do j=1,nbin + write(ifhi,'(2e13.5)')datb(j),datd(j) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + write(cfl,'(i3)')kes + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp his' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',x1s,x2s + write(ifhi,'(a)') 'text 0 0 "xaxis net s content"' + write(ifhi,'(a)') 'text 0 0 "yaxis N"' + write(ifhi,'(a,a)') 'text 0.4 0.91 "V='//cvol//'"' + write(ifhi,'(a,a)') 'text 0.15 0.91 "E='//cen//'"' + write(ifhi,'(a,a)') 'text 0.65 0.91 "N?s!='//cfl//'"' + write(ifhi,'(a)') 'array 2' + + do j=1,nbin + write(ifhi,'(2e13.5)')datc(j),dats(j) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + return + + endif + + end + +c----------------------------------------------------------------------- + subroutine xhgcmt +c----------------------------------------------------------------------- +c creates transverse mass spectrum for QM-droplet decay +c according to grand canonical results +c input: +c xpar1 specifies particle species by paige id, 0 for all +c xpar2 and xpar3 specify xrange of plot +c xpar4 specifies line type : dashed (0), dotted (1), full (2) +c output: +c histo-file +c newpage, zone and plot commands not included !!! +c----------------------------------------------------------------------- + include 'epos.inc' + common/citer/iter,itermx + parameter (nbin=200) + real datx(nbin),daty(nbin) + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + character cen*6,cvo*6,cit*5,ctem*5 + + idpa=nint(xpar1) + x1=xpar2 + x2=xpar3 + ltyp=nint(xpar4) + + id=0 + jx=100 + do i=1,nspecs + if(ispecs(i).eq.idpa)id=i + enddo + + dx=(x2-x1)/2./jx + x0=x1+dx + + do j=1,jx + datx(j)=x0+(j-1)*dx*2. + daty(j)=0.0 + + if(id.eq.0)then + + do 10 i=1,nspecs + dndmt=0.0 + if(datx(j).ge.aspecs(i))then + x=100. + xx=100. + if(tem.ne.0.)x=datx(j)/tem + if(tem.ne.0.)xx=chemgc(i)/tem + if(abs(xx).le.60)dndmt=gspecs(i)*volu/hquer**3*exp(xx)*datx(j) + */4./pi**3*hgcbk1(x) + endif + daty(j)=daty(j)+dndmt +10 continue + + else + + dndmt=0.0 + if(datx(j).ge.aspecs(id))then + x=100. + xx=100. + if(tem.ne.0.)x=datx(j)/tem + if(tem.ne.0.)xx=chemgc(id)/tem + if(abs(xx).le.60)dndmt=gspecs(id)*volu/hquer**3*exp(xx)*datx(j) + */4./pi**3*hgcbk1(x) + endif + daty(j)=dndmt + + endif + + enddo + + write(cit,'(i5)')itermx + write(cen,'(f6.1)')tecm + write(cvo,'(f6.1)')volu + write(ctem,'(f5.3)')tem + write(ifhi,'(a)') 'openhisto' + if(ltyp.eq.0)then + write(ifhi,'(a)') 'htyp lda' + elseif(ltyp.eq.1)then + write(ifhi,'(a)') 'htyp ldo' + elseif(ltyp.eq.2)then + write(ifhi,'(a)') 'htyp lfu' + endif + write(ifhi,'(a)') 'xmod lin ymod log' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'text 0 0 "xaxis m?t! (GeV)"' + write(ifhi,'(a)') 'text 0 0 "yaxis dN?[n]!/d^2!m?t! "' + write(ifhi,'(a,a)') 'text 0.3 0.10 "T='//ctem//'"' + write(ifhi,'(a,a)') 'text 0.3 0.20 "i?max!='//cit//'"' + write(ifhi,'(a,a)') 'text 0.4 0.91 "V='//cvo//'"' + write(ifhi,'(a,a)') 'text 0.15 0.91 "E='//cen//'"' + write(ifhi,'(a)') 'array 2' + + do j=1,jx + write(ifhi,'(2e12.4)')datx(j),daty(j) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + return + end + +c----------------------------------------------------------------------- + subroutine xhgcmu +c----------------------------------------------------------------------- +c creates multiplicity plot for decayed QM-droplet +c according to grand canonical results +c input: +c xpar1 specifies species by paige id, 0 for total multiplicity +c xpar2 specifies xrange to be set automatically (0) or by hand (1) +c xpar3 and xpar4 xrange if xpar2 ne 0 +c xpar5 xrange = average+-sigma*xpar5 +c xpar6 specifies line type : dashed (0), dotted (1), full (2) +c xpar7 specifies statistics : same as iostat (0) +c boltzmann (1) +c output: +c histo-file +c newpage, zone and plot commands not included !!! +c----------------------------------------------------------------------- + include 'epos.inc' + parameter (nbin=200) + real datx(nbin),daty(nbin) + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cbol/rmsbol(mspecs),ptlbol(mspecs),chebol(mspecs),tembol + common/cgctot/rmstot,ptltot + character cyield*8,cen*6,cvo*6,cinco*1 + + + idpa=nint(xpar1) + ixra=nint(xpar2) + iwid=nint(xpar5) + ltyp=nint(xpar6) + ist=nint(xpar7) + if(ist.eq.0.and.iostat.eq.1)ist=1 + + + pn=0.0 + id=0 + jx=100 + ymin=1./nevent/10. + if(nevent.le.10)ymin=ymin/10. + do i=1,nspecs + if(ispecs(i).eq.idpa)id=i + enddo + + if(ixra.eq.1)then + x1=anint(xpar3) + x2=anint(xpar4) + else + if(id.eq.0)then + x1=anint(ptltot-iwid*rmstot) + x2=anint(ptltot+iwid*rmstot) + else + x1=anint(ptlngc(id)-iwid*rmsngc(id)) + x2=anint(ptlngc(id)+iwid*rmsngc(id)) + endif + x2=max(x2,3.0) + endif + + x1=max(x1,0.0) + dx=(x2-x1)/2./jx + x0=x1+dx + pn=0.0 + + do j=1,jx + datx(j)=x0+(j-1)*dx*2. + if(id.eq.0)then + +c total multiplicity +c ------------------ + x=100. + if(rmstot.ge.1.e-10)x=(datx(j)-ptltot)**2/rmstot**2/2. + + if(x.ge.60)then + pn=0.0 + else + pn=exp(-x)/rmstot/sqrt(2.*pi) + endif + + daty(j)=pn + + else + +c one species (specified by id) +c ------------------------------ + x=100. + if(rmsngc(id).ge.1.e-10.and.ist.eq.0) + *x=(datx(j)-ptlngc(id))**2/rmsngc(id)**2/2. + if(rmsbol(id).ge.1.e-10.and.ist.eq.1) + *x=(datx(j)-ptlbol(id))**2/rmsbol(id)**2/2. + + if(x.ge.60)then + pn=0.0 + else + if(ist.eq.0)pn=exp(-x)/rmsngc(id)/sqrt(2*pi) + if(ist.eq.1)pn=exp(-x)/rmsbol(id)/sqrt(2*pi) + endif + + daty(j)=pn + + endif + enddo + + if(id.eq.0)then + write(cyield,'(f8.3)')ptltot + else + write(cyield,'(f8.3)')ptlngc(id) + endif + write(cinco,'(i1)')ioinco + write(cen,'(f6.1)')tecm + write(cvo,'(f6.1)')volu + write(ifhi,'(a)') 'openhisto' + if(ltyp.eq.0)then + write(ifhi,'(a)') 'htyp lda' + elseif(ltyp.eq.1)then + write(ifhi,'(a)') 'htyp ldo' + elseif(ltyp.eq.2)then + write(ifhi,'(a)') 'htyp lfu' + elseif(ltyp.eq.3)then + write(ifhi,'(a)') 'htyp ldd' + endif + write(ifhi,'(a)') 'xmod lin ymod log' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a,e11.3,a)')'yrange',ymin,' auto' + write(ifhi,'(a)') 'text 0 0 "xaxis N?[n]!"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(N?[n]!)"' + write(ifhi,'(a,a)')'text 0.3 0.10 "" "L#N?[n]!"G#='//cyield//'""' + write(ifhi,'(a,a)') 'text 0.3 0.2 "conf?in!='//cinco//'"' + if(iocite.ne.1)then + write(ifhi,'(a,a)') 'text 0.4 0.91 "V='//cvo//'"' + write(ifhi,'(a,a)') 'text 0.15 0.91 "E='//cen//'"' + endif + write(ifhi,'(a)') 'array 2' + + do j=1,jx + write(ifhi,'(2e12.4)')datx(j),daty(j) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + + return + end + + +c----------------------------------------------------------------------- + subroutine xhgcmx +c----------------------------------------------------------------------- +c creates multiplicity plot for decayed QM-droplet +c according to grand canonical results POISSON DISTRIB.!!!! +c input: +c xpar1 specifies species by paige id, 0 for total multiplicity +c xpar2 specifies xrange to be set automatically (0) or by hand (1) +c xpar3 and xpar4 xrange if xpar2 ne 0 +c xpar5 xrange = average+-sigma*xpar5 +c xpar6 specifies line type : dashed (0), dotted (1), full (2) dado (3) +c xpar7 specifies statistics : same as iostat (0) +c boltzmann (1) +c output: +c histo-file +c newpage, zone and plot commands not included !!! +c----------------------------------------------------------------------- + include 'epos.inc' + parameter (nbin=200) + real datx(nbin),daty(nbin) + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cbol/rmsbol(mspecs),ptlbol(mspecs),chebol(mspecs),tembol + common/cgctot/rmstot,ptltot + character cyield*8,cen*6,cvo*6,cinco*1 + + + idpa=nint(xpar1) + ixra=nint(xpar2) + iwid=nint(xpar5) + ltyp=nint(xpar6) + ist=nint(xpar7) + if(ist.eq.0.and.iostat.eq.1)ist=1 + pn=0. + + + id=0 + ymin=1./nevent/10. + if(nevent.le.10)ymin=ymin/10. + do i=1,nspecs + if(ispecs(i).eq.idpa)id=i + enddo + + if(ixra.eq.1)then + n1=nint(xpar3) + n2=nint(xpar4) + else + if(id.eq.0)then + n1=nint(ptltot-iwid*rmstot) + n2=nint(ptltot+iwid*rmstot) + else + n1=nint(ptlngc(id)-iwid*rmsngc(id)) + n2=nint(ptlngc(id)+iwid*rmsngc(id)) + endif + n2=max(n2,3) + endif + + n1=max(n1,0) + jx=n2+1 + + do j=1,jx + datx(j)=j-1 + jf=1 + if(j.gt.1)then + do i=1,j-1 + jf=jf*i + enddo + endif + if(id.eq.0)then + +c total multiplicity +c ------------------ + + daty(j)=1./jf*ptltot**(j-1)*exp(-ptltot) + + else + +c one species (specified by id) +c ------------------------------ + + if(ist.eq.0)pn=1./jf*ptlngc(id)**(j-1)*exp(-ptlngc(id)) + if(ist.eq.1)pn=1./jf*ptlbol(id)**(j-1)*exp(-ptlbol(id)) + + daty(j)=pn + + endif + enddo + + if(id.eq.0)then + write(cyield,'(f8.3)')ptltot + else + write(cyield,'(f8.3)')ptlngc(id) + endif + write(cinco,'(i1)')ioinco + write(cen,'(f6.1)')tecm + write(cvo,'(f6.1)')volu + write(ifhi,'(a)') 'openhisto' + if(ltyp.eq.0)then + write(ifhi,'(a)') 'htyp lda' + elseif(ltyp.eq.1)then + write(ifhi,'(a)') 'htyp ldo' + elseif(ltyp.eq.2)then + write(ifhi,'(a)') 'htyp lfu' + elseif(ltyp.eq.3)then + write(ifhi,'(a)') 'htyp ldd' + endif + write(ifhi,'(a)') 'xmod lin ymod log' + write(ifhi,'(a,2i3)')'xrange',n1,n2 + write(ifhi,'(a,e11.3,a)')'yrange',ymin,' auto' + write(ifhi,'(a)') 'text 0 0 "xaxis N?[n]!"' + write(ifhi,'(a)') 'text 0 0 "yaxis P(N?[n]!)"' + write(ifhi,'(a,a)')'text 0.3 0.10 "" "L#N?[n]!"G#='//cyield//'""' + write(ifhi,'(a,a)') 'text 0.3 0.2 "conf?in!='//cinco//'"' + if(iocite.ne.1)then + write(ifhi,'(a,a)') 'text 0.4 0.91 "V='//cvo//'"' + write(ifhi,'(a,a)') 'text 0.15 0.91 "E='//cen//'"' + endif + write(ifhi,'(a)') 'array 2' + + do j=1,jx + write(ifhi,'(2e12.4)')datx(j),daty(j) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + + return + end + +c----------------------------------------------------------------------- + subroutine xhgcpt +c----------------------------------------------------------------------- +c creates transverse momentum spectrum for decayed QM-droplet +c according to grand canonical results +c input: +c xpar1 specifies particle species by paige id, 0 for all +c xpar2 rapidity window +c xpar3 and xpar4 specify xrange of plot +c xpar5 specifies line type : dashed (0), dotted (1), full (2) +c output: +c histo-file +c newpage, zone and plot commands not included !!! +c----------------------------------------------------------------------- + include 'epos.inc' + common/citer/iter,itermx + parameter (nbin=200) + real datx(nbin),daty(nbin) + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + character crap*5,cen*6,cvo*6,cit*5 + + idpa=nint(xpar1) + y=xpar2 + x1=xpar3 + x2=xpar4 + ltyp=xpar5 + + write(crap,'(f5.1)')y + id=0 + jx=100 + do i=1,nspecs + if(ispecs(i).eq.idpa)id=i + enddo + + dx=(x2-x1)/2./jx + x0=x1+dx + + do j=1,jx + datx(j)=x0+(j-1)*dx*2. + daty(j)=0.0 + + if(id.eq.0)then + + do 10 i=1,nspecs + x=100. + if(tem.ne.0.) + *x=(sqrt(aspecs(i)**2+datx(j)**2)*cosh(y)-chemgc(i))/tem + if(x.ge.60)then + dndpt=0.0 + else + dndpt=exp(-x) + endif + dndpt=dndpt*gspecs(i)*volu/hquer**3*cosh(y) + **sqrt(aspecs(i)**2+datx(j)**2)/8./pi**3 + daty(j)=daty(j)+dndpt +10 continue + + else + + x=100. + if(tem.ne.0.) + *x=(sqrt(aspecs(id)**2+datx(j)**2)*cosh(y)-chemgc(id))/tem + if(x.ge.60)then + dndpt=0.0 + else + dndpt=exp(-x) + endif + dndpt=dndpt*gspecs(id)*volu/hquer**3*cosh(y) + **sqrt(aspecs(id)**2+datx(j)**2)/8./pi**3 + daty(j)=dndpt + + endif + + enddo + + write(cit,'(i5)')itermx + write(cen,'(f6.1)')tecm + write(cvo,'(f6.1)')volu + write(ifhi,'(a)') 'openhisto' + if(ltyp.eq.0)then + write(ifhi,'(a)') 'htyp lda' + elseif(ltyp.eq.1)then + write(ifhi,'(a)') 'htyp ldo' + elseif(ltyp.eq.2)then + write(ifhi,'(a)') 'htyp lfu' + endif + write(ifhi,'(a)') 'xmod lin ymod log' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'text 0 0 "xaxis p?t! (GeV/c)"' + write(ifhi,'(a)') 'text 0 0 "yaxis dN?[n]!/dyd^2!p?t!"' + write(ifhi,'(a)') 'text 0.10 0.10 "y = '//crap//'"' + write(ifhi,'(a)') 'text 0.10 0.30 "i?max! = '//cit//'"' + write(ifhi,'(a,a)') 'text 0.4 0.91 "V='//cvo//'"' + write(ifhi,'(a,a)') 'text 0.15 0.91 "E='//cen//'"' + write(ifhi,'(a)') 'array 2' + + do j=1,jx + write(ifhi,'(2e12.4)')datx(j),daty(j) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + return + end + +c----------------------------------------------------------------------- + subroutine xhgcra +c----------------------------------------------------------------------- +c creates rapidity distribution for decayed QM-droplet +c according to grand canonical results +c input: +c xpar1 specifies particle species by paige id, 0 for all +c xpar2 and xpar3 specify xrange of plot +c xpar4 specifies line type : dashed (0), dotted (1), full (2) +c output: +c histo-file +c newpage, zone and plot commands not included !!! +c----------------------------------------------------------------------- + include 'epos.inc' + parameter (nbin=200) + real datx(nbin),daty(nbin) + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cgctot/rmstot,ptltot + character cen*6,cvo*6,cng*8 + + idpa=nint(xpar1) + x1=nint(xpar2) + x2=nint(xpar3) + ltyp=nint(xpar4) + + id=0 + jx=100 + ymin=1./nevent/10. + if(nevent.le.10)ymin=ymin/10. + do i=1,nspecs + if(ispecs(i).eq.idpa)id=i + enddo + + dx=(x2-x1)/2./jx + x0=x1+dx + + do j=1,jx + + datx(j)=x0+(j-1)*dx*2. + daty(j)=0.0 + y=datx(j) + if(ish.ge.9)write(ifch,*)'cosh y:',cosh(y) + + if(id.eq.0)then + + do 10 i=1,nspecs + dndy=0.0 + sum=aspecs(i)**2*tem+2.*aspecs(i)*tem**2/cosh(y) + *+2.*tem**3/cosh(y)**2 + x=100. + if(tem.ne.0.0) + *x=(aspecs(i)*cosh(y)-chemgc(i))/tem + + if(x.ge.60.)then + pro=0.0 + else + pro=exp(-x) + endif + + pro=pro*gspecs(i)*volu/hquer**3/4./pi**2 + + if(pro.ge.(1.e-30).and.sum.ge.(1.e-30))then + che=alog(pro)+alog(sum) + else + che=-61.0 + endif + if(che.le.60.0.and.che.ge.(-60.0))dndy=pro*sum +c if(che.le.60.0.and.che.ge.(-60.0))dndy=exp(che) + + daty(j)=daty(j)+dndy + +10 continue + + else + + dndy=0.0 + sum=aspecs(id)**2*tem+2.*aspecs(id)*tem**2/cosh(y) + *+2.*tem**3/cosh(y)**2 + x=100. + if(tem.ne.0.0) + *x=(aspecs(id)*cosh(y)-chemgc(id))/tem + + if(x.ge.60.)then + pro=0.0 + else + pro=exp(-x) + endif + + pro=pro*gspecs(id)*volu/hquer**3/4./pi**2 + + if(pro.ge.(1.e-30).and.sum.ge.(1.e-30))then + che=alog(pro)+alog(sum) + else + che=-61.0 + endif + if(che.le.60..and.che.ge.-60.)dndy=pro*sum + + daty(j)=dndy + + endif + + enddo + + write(cen,'(f6.1)')tecm + write(cvo,'(f6.1)')volu + if(id.eq.0)then + write(cng,'(f8.3)')ptltot + else + write(cng,'(f8.3)')ptlngc(id) + endif + write(ifhi,'(a)') 'openhisto' + if(ltyp.eq.0)then + write(ifhi,'(a)') 'htyp lda' + elseif(ltyp.eq.1)then + write(ifhi,'(a)') 'htyp ldo' + elseif(ltyp.eq.2)then + write(ifhi,'(a)') 'htyp lfu' + endif + + write(ifhi,'(a)') 'xmod lin ymod log' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a,e11.3,a)')'yrange',ymin,' auto' + write(ifhi,'(a)') 'text 0 0 "xaxis y"' + write(ifhi,'(a)') 'text 0 0 "yaxis dN?[n]!/dy"' + write(ifhi,'(a,a)') 'text 0.4 0.91 "V='//cvo//'"' + write(ifhi,'(a,a)') 'text 0.15 0.91 "E='//cen//'"' + write(ifhi,'(a,a)') 'text 0.3 0.10 "N?[n]!='//cng//'"' + write(ifhi,'(a)') 'array 2' + + do j=1,jx + write(ifhi,'(2e12.4)')datx(j),daty(j) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + return + end + +c----------------------------------------------------------------------- + subroutine xhnben +c----------------------------------------------------------------------- +c produces histogram of energy spectrum (after metropolis run) +c complete histogram: openhisto ... closehisto +c iocite=1 required +c----------------------------------------------------------------------- +c xpar1: particle species (venus id-code) +c xpar2: 1: actual spectrum 2: fit +c xpar3: 1: de/d3p 2: ede/d3e +c----------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + parameter (nhise=100) + common/chise/hise(mspecs,nhise) + parameter (literm=500) + common/cmet/kspecs(mspecs),liter,lspecs(literm,mspecs) + *,iterl(literm),iterc(literm) + real datx(nhise),daty(nhise),dats(nhise) + common/citer/iter,itermx + character ch*1,chid*5,cyield*9,ctem*5 + de=2./nhise/2. + + if(iocite.ne.1)stop'STOP: xhnben: iocite=1 required' + + idcode=nint(xpar1) + mode=nint(xpar2) + kind=nint(xpar3) + + do j=1,nspecs + if(idcode.eq.ispecs(j))then + + id=idcode + am=aspecs(j) + yield=1.*kspecs(j)/(itermx-iternc) + if(kind.eq.1)ch=' ' + if(kind.eq.2)ch='e' + ll=kind-1 + e0=am+de + nebins=0 + do i=1,nhise + e=e0+(i-1)*2*de + p1=sqrt((e-de)**2-am**2) + p2=sqrt((e+de)**2-am**2) + d3p=4*pi*(p2**3-p1**3)/3 + datx(i)=e + y=(1-ll+ll*e)*hise(j,i)/(itermx-iternc)/d3p + if(y.gt.0.)then + nebins=nebins+1 + daty(i)=alog(y) + d=y/sqrt(hise(j,i)) + dats(i)=1e10 + if(y-d.gt.0.)dats(i)=alog(y+d)-alog(y-d) + else + daty(i)=-100 + dats(i)=1e10 + endif +c-c if(e.lt.0.2)dats(i)=1e10 + enddo + a=0. + b=0. + if(nebins.ge.3)then + call utfit(datx,daty,nhise,dats,1,a,b,siga,sigb,chi2,q) + tem=-1./b + if(tem.lt.0.050.or.tem.gt.10.)then + tem=0. + a=0. + b=0. + endif + endif + do i=1,nhise + daty(i)=exp(daty(i)) + enddo + write(chid,'(i5)')id + write(cyield,'(f9.4)')yield + ctem=' ' + if(tem.gt.0.)write(ctem,'(f5.3)')tem + write(ifhi,'(a)') 'openhisto xrange 0 3' + write(ifhi,'(a)') 'htyp lin xmod lin ymod log' + write(ifhi,'(a,a)') 'text 0 0 "title id='//chid + * ,' N='//cyield//' T='//ctem//'"' + write(ifhi,'(a)') 'text 0 0 "xaxis energy (GeV)"' + write(ifhi,'(a)') 'text 0 0 "yaxis '//ch//' dn/d3p (GeV-3)"' + write(ifhi,'(a)') 'array 2' + do i=1,nhise + if(mode.eq.1)write(ifhi,'(2e12.4)')datx(i),daty(i) + if(mode.eq.2)write(ifhi,'(2e12.4)')datx(i),exp(a+b*datx(i)) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + endif + enddo + + return + end + +c----------------------------------------------------------------------- + subroutine xhnbit +c----------------------------------------------------------------------- +c produces histogram of multiplicity versus iterations (after metropolis run) +c complete histogram: openhisto ... closehisto +c iocite=1 required +c----------------------------------------------------------------------- +c xpar1: particle species (0=all, else venus id-code) +c xpar2: 1:actual multiplicity 2:average multiplicity 3:grand canonical +c----------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + parameter (literm=500) + common/cmet/kspecs(mspecs),liter,lspecs(literm,mspecs) + *,iterl(literm),iterc(literm) + real datlx(literm),datly(literm) + common/citer/iter,itermx + character chid*5,ctecm*5,cvolu*6 + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + common/cgctot/rmstot,ptltot + + if(iocite.ne.1)stop'STOP: xhnbit: iocite=1 required' + + idcode=nint(xpar1) + mode=nint(xpar2) + + if(idcode.eq.0)then + + yield=0 + do j=1,nspecs + yield=yield+1.*kspecs(j)/(itermx-iternc) + enddo + datlx(1)=(iterl(1)+1)/2. + do li=2,liter-1 + datlx(li)=(iterl(li)+iterl(li-1)+1)/2. + enddo + x1=0 + x2=iterl(liter-1) + do li=1,liter-1 + y=0 + do j=1,nspecs + y=y+lspecs(li,j) + enddo + if(mode.eq.1)datly(li)=y/iterc(li) + if(mode.eq.2)datly(li)=yield + if(mode.eq.3)datly(li)=ptltot + enddo + write(ctecm,'(f5.1)')tecm + write(cvolu,'(f6.1)')volu + write(ifhi,'(a,2e11.3)')'openhisto xrange',x1,x2 + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a,a)') 'text 0 0 "title E = '//ctecm//' V = ' + * ,cvolu//'"' + write(ifhi,'(a)') 'text 0 0 "xaxis iterations"' + write(ifhi,'(a)') 'text 0 0 "yaxis multiplicity"' + write(ifhi,'(a)') 'array 2' + do i=1,liter-1 + write(ifhi,'(2e12.4)') datlx(i),datly(i) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + else + + do j=1,nspecs + if(idcode.eq.ispecs(j))then + + yield=1.*kspecs(j)/(itermx-iternc) + write(chid,'(i5)')idcode + do li=1,liter-1 + datlx(li)=iterl(li) + enddo + x1=0 + x2=datlx(liter-1) + do li=1,liter-1 + if(mode.eq.1)datly(li)=lspecs(li,j)*1./iterc(li) + if(mode.eq.2)datly(li)=yield + if(mode.eq.3)datly(li)=ptlngc(j) + enddo + write(ifhi,'(a,2e11.3)')'openhisto xrange',x1,x2 + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "title id='//chid//'"' + write(ifhi,'(a)') 'text 0 0 "xaxis iterations "' + write(ifhi,'(a)') 'text 0 0 "yaxis multiplicity"' + write(ifhi,'(a)') 'array 2' + do i=1,liter-1 + write(ifhi,'(2e12.4)') datlx(i),datly(i) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + endif + enddo + + endif + + return + end + +c----------------------------------------------------------------------- + subroutine xhnbmu +c----------------------------------------------------------------------- +c produces histogram of multiplicity distribution (after metropolis run) +c complete histogram: openhisto ... closehisto +c iocite=1 required +c----------------------------------------------------------------------- +c xpar1: particle species (0=all, else venus id-code) +c xpar2: xrange automatic (0) or given via xpar3,4 (else) +c xpar3,4: xrange +c----------------------------------------------------------------------- + include 'epos.inc' + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + parameter (nhismu=500) + common/chismu/hismu(mspecs,0:nhismu),hismus(nhismu) + parameter (literm=500) + common/cmet/kspecs(mspecs),liter,lspecs(literm,mspecs) + *,iterl(literm),iterc(literm) + real datx(nhismu),daty(nhismu) + common/citer/iter,itermx + common /clatt/nlattc,npmax + character chid*5,cyield*9,ctecm*5,cvolu*6 + + if(iocite.ne.1)stop'STOP: xhnbmu: iocite=1 required' + + idcode=nint(xpar1) + ixr=nint(xpar2) + xx1=xpar3 + xx2=xpar4 + + write(ctecm,'(f5.1)')tecm + write(cvolu,'(f6.1)')volu + + if(idcode.eq.0)then + + yield=0 + do j=1,nspecs + yield=yield+1.*kspecs(j)/(itermx-iternc) + enddo + write(cyield,'(f9.4)')yield + i1=0 + i2=nlattc + mus=0 + do i=1,nhismu + if(i1.eq.0.and.nint(hismus(i)).gt.0)i1=i + if(nint(hismus(i)).gt.0)i2=i + mus=mus+hismus(i) + enddo + ij=0.5*(i1+i2)*0.20 + if(itermx.le.1000)ij=0.5*(i1+i2)*0.40 + if(itermx.le.100)ij=0.5*(i1+i2)*0.80 + i1=i1-ij + i1=max(i1,2) + i2=i2+ij + ii=10 + if(i1.le.50)ii=5 + if(i1.le.20)ii=2 + i1=i1/ii*ii + i2=i2/ii*ii+ii + do i=i1,i2 + l=1+i-i1 + datx(l)=i + daty(l)=hismus(i)/mus + enddo + jx=1+i2-i1 + if(ixr.eq.0)then + x1=i1 + x2=i2 + else + x1=xx1 + x2=xx2 + endif + write(ifhi,'(a,2e11.3)')'openhisto xrange',x1,x2 + write(ifhi,'(a)') 'htyp lin xmod lin ymod log' + write(ifhi,'(a,a)') 'text 0 0 "title E = '//ctecm//' V = ' + * ,cvolu//'"' + write(ifhi,'(a)') 'text 0 0 "xaxis multiplicity n "' + write(ifhi,'(a)') 'text 0 0 "yaxis dN/dn"' + write(ifhi,'(a)') 'text 0.30 0.25 "N?MC!='//cyield//'"' + write(ifhi,'(a)') 'array 2' + do i=1,jx + write(ifhi,'(2e12.4)') datx(i),daty(i) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + else + + do j=1,nspecs + if(idcode.eq.ispecs(j))then + + yield=1.*kspecs(j)/(itermx-iternc) + write(cyield,'(f9.4)')yield + write(chid,'(i5)')idcode + i1=0 + i2=nlattc + mus=0 + do i=0,nhismu + if(i1.eq.0.and.nint(hismu(j,i)).gt.0)i1=i + if(nint(hismu(j,i)).gt.0)i2=i + mus=mus+hismu(j,i) + enddo + ij=0.5*(i1+i2)*0.30 + if(itermx.le.1000)ij=0.5*(i1+i2)*0.60 + if(itermx.le.100)ij=0.5*(i1+i2)*1.20 + i1=i1-ij + i1=max(i1,0) + i2=i2+ij + ii=10 + if(i1.le.50)ii=5 + if(i1.le.20)ii=2 + i1=i1/ii*ii + i2=i2/ii*ii+ii + do i=i1,i2 + l=1+i-i1 + datx(l)=i + daty(l)=hismu(j,i)/mus + enddo + jx=1+i2-i1 + if(ixr.eq.0)then + x1=i1 + x2=i2 + else + x1=xx1 + x2=xx2 + endif + write(ifhi,'(a,2e11.3)')'openhisto xrange',x1,x2 + write(ifhi,'(a)') 'htyp lin xmod lin ymod log' + write(ifhi,'(a)') 'text 0 0 "title id='//chid//'"' + write(ifhi,'(a)') 'text 0 0 "xaxis multiplicity n "' + write(ifhi,'(a)') 'text 0 0 "yaxis dN/dn"' + write(ifhi,'(a)') 'text 0.30 0.25 "N?MC!='//cyield//'"' + write(ifhi,'(a)') 'array 2' + do i=1,jx + write(ifhi,'(2e12.4)') datx(i),daty(i) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + endif + enddo + + endif + + return + end + +c----------------------------------------------------------------------- + subroutine xhnbmz +c----------------------------------------------------------------------- +c produces histogram of multiplicity distribution from droplet decay +c or average multiplicity versus iterations +c for massless hadrons +c complete histogram: openhisto ... closehisto +c----------------------------------------------------------------------- +c xpar1: particle species (0=all, else venus id-code) +c xpar2: lower limit multiplicity +c xpar3: upper limit multiplicity +c xpar4: lower limit total multiplicity (also necc for xpar1.ne.0) +c xpar5: upper limit " " (also necc for xpar1.ne.0) +c xpar6: sets htyp: 1->lfu, 2->ldo, 3->lda, 4->ldd +c xpar7: 0: multiplicity distribution +c >0: av multiplicity vs iterations (itermx=xpar7) +c----------------------------------------------------------------------- + include 'epos.inc' + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + common/ctst/psulog,wtulog + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + parameter (nhismu=500) + common/cflac/ifok(nflav,mspecs),ifoa(nflav) + real datx(nhismu),datyu(nhismu) + character cyieur*9 + real pzlog(nhismu) + double precision spelog,cc,bb,dsu + common/cyield/yield + character*3 htyp + + idcode=nint(xpar1) + x1=xpar2 + x2=xpar3 + i1=nint(xpar2) + i2=nint(xpar3) + ii1=nint(xpar4) + ii2=nint(xpar5) + ih=nint(xpar6) + htyp='lin' + if(ih.eq.1)htyp='lfu' + if(ih.eq.2)htyp='ldo' + if(ih.eq.3)htyp='lda' + if(ih.eq.4)htyp='ldd' + itmax=nint(xpar7) + + wtrlog=-1e30 + do i=ii1,ii2 + if(i.ge.2)then + np=i + do k=1,np + ident(k)=110 + enddo + call hnbtst(0) + wtzlog=wtulog + if(ioflac.eq.0)call hnbspg(keu,ked,kes,kec,keb,ket,0,np,spelog) + if(ioflac.ne.0)call hnbspf(keu,ked,kes,kec,keb,ket,0,np,spelog) + wtulog=wtulog+spelog + else + wtzlog=-1000 + wtulog=-1000 + endif + pzlog(1+i-ii1)=wtzlog + datyu(1+i-ii1)=wtulog + wtrlog=max(wtrlog,wtulog) + enddo + yield=0 + su=0 + do i=ii1,ii2 + l=1+i-ii1 + pzlog(l)=pzlog(l)-wtrlog + datyu(l)=datyu(l)-wtrlog + if(datyu(l).gt.-50.)then + datyu(l)=exp(datyu(l)) + else + datyu(l)=exp(-50.) + endif + yield=yield+i*datyu(l) + su=su+datyu(l) + enddo + yield=yield/su + do i=ii1,ii2 + l=1+i-ii1 + datx(l)=i + datyu(l)=datyu(l)/su + enddo + jx=1+ii2-ii1 + write(cyieur,'(f9.4)')yield +c --- + if(idcode.eq.0.and.itmax.eq.0)then + write(ifhi,'(a,2e11.3)')'openhisto xrange',x1,x2 + write(ifhi,'(a)') 'htyp '//htyp//' xmod lin ymod log' + write(ifhi,'(a)') 'text 0.30 0.15 "N?ana!='//cyieur//'"' + write(ifhi,'(a)') 'array 2' + do i=1,jx + write(ifhi,'(2e12.4)') datx(i),datyu(i) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + elseif(idcode.eq.0)then + write(ifhi,'(a,2e11.3)')'openhisto xrange',0.,itmax*1. + write(ifhi,'(a)') 'htyp '//htyp//' xmod lin ymod lin' + write(ifhi,'(a)') 'array 2' + itm=20 + do i=1,itm + write(ifhi,'(2e12.4)') (i-1.)*itmax/(itm-1.),yield + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + endif +c --- + if(idcode.eq.0)return + + do j=1,nspecs + if(idcode.eq.ispecs(j))then + + wtrlog=-1e30 + do i=i1,i2 + l=1+i-i1 + datx(l)=i + enddo + yield=0 + suj=0 + dsu=su + do i=i1,i2 + l=1+i-i1 + bb=0 + nfi=0 + do ntot=max(i+1,ii1),min(i2*nspecs,ii2) + nfi=nfi+1 + cc=1d0 + do kc=1,i + cc=cc*(1.+ntot-kc)/kc*gspecs(j) + enddo + ku=keu-i*ifok(1,j) + kd=ked-i*ifok(2,j) + ks=kes-i*ifok(3,j) + kc=kec-i*ifok(4,j) + kb=keb-i*ifok(5,j) + kt=ket-i*ifok(6,j) + if(ioflac.eq.0)call hnbspg(ku,kd,ks,kc,kb,kt,j,ntot-i,spelog) + if(ioflac.ne.0)call hnbspf(ku,kd,ks,kc,kb,kt,j,ntot-i,spelog) + cc=cc*dexp(spelog) + bb=bb+cc*dexp(1.d0*pzlog(1+ntot-ii1))/dsu + enddo + datyu(l)=bb + yield=yield+i*datyu(l) + suj=suj+datyu(l) + enddo + yield=yield/suj + jx=1+i2-i1 + write(cyieur,'(f9.4)')yield +c --- + if(itmax.eq.0)then + write(ifhi,'(a,2e11.3)')'openhisto xrange',x1,x2 + write(ifhi,'(a)') 'htyp '//htyp//' xmod lin ymod log' + write(ifhi,'(a)') 'text 0.30 0.15 "N?ana!='//cyieur//'"' + write(ifhi,'(a)') 'array 2' + do i=1,jx + write(ifhi,'(2e12.4)') datx(i),datyu(i) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + else + write(ifhi,'(a,2e11.3)')'openhisto xrange',0.,itmax*1. + write(ifhi,'(a)') 'htyp '//htyp//' xmod lin ymod lin' + write(ifhi,'(a)') 'array 2' + itm=20 + do i=1,itm + write(ifhi,'(2e12.4)') (i-1.)*itmax/(itm-1.),yield + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + endif +c --- + return + + endif + enddo + + end + +c----------------------------------------------------------------------- + subroutine xhnbte(iii) +c----------------------------------------------------------------------- +c fills histograms (iii>=0) or writes histogram to histo-file (iii<0) +c regarding exponential autocorrelation time and acceptance rate +c +c input: +c requires complete run with application hadron (iappl=1) +c or application metropolis (iappl=4) +c ioceau=1 necessary +c +c output: +c for iii=0 (only valid for iappl=4): +c data(nrevt): nrevt (event number) /cdat/ +c datb(nrevt): taui (calculated corr time) /cdat/ +c datc(nrevt): accrat (acceptance rate) /cdat/ +c datd(nrevt): taue (parametrized corr time) /cdat/ +c for iii>0 (only valid for iappl=1): +c nrclu=nrclu+1 /cnrclu/ +c data(nrclu): nrclu (droplet number) /cdat/ +c datb(nrclu): taui-taue (calc - param corr time) /cdat/ +c datc(nrclu): accrat (acceptance rate) /cdat/ +c datd(nrclu): avnp (average particle number) /cdat/ +c for iii<0: +c writes complete histogram (openhisto ... closehisto) to histofile +c for iappl=4: for iappl=1: +c xpar1=1: (data,datb,datd) xpar1=1: (data,datb) +c xpar1=2: (data,datc) xpar1=2: (data,datd) +c xpar1=3: (data,datc) +c----------------------------------------------------------------------- + include 'epos.inc' + parameter(maxit=50000) + common/count/nacc,nrej,naccit(maxit),nptot,npit(maxit) + common/citer/iter,itermx + common /clatt/nlattc,npmax + common/cgctot/rmstot,ptltot + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + parameter (nbin=500) + common/cdat/ data(nbin),datb(nbin),datc(nbin),datd(nbin) + real dev(maxit) + character cobs*5,cnc*5,cdz*5,czer*5 + *,cmom*5,cnp*7,cen*7,cvol*7,clatt*5,cit*5 + common/ctaue/taue + + if(ioceau.ne.1)stop'STOP: ioceau=1 required' + if(iii.eq.0.and.iappl.ne.4)stop'STOP: iappl=4 required' + if(iii.gt.0.and.iappl.ne.1)stop'STOP: iappl=1 required' + + if(iii.lt.0)jjj=nint(xpar1) + + id=0 + ish0=ish +c ish=98 + +c ---------------- + if(iii.ge.0)then +c ---------------- + + if(iii.gt.0)nrclu=nrclu+1 + if(nrclu.gt.500)return + +c mean +c ---- + xnptot=nptot + avnp=xnptot/(itermx-iternc) + if(ish.ge.9)write(ifch,*)'event:',nrevt,' droplet:',nrclu + *,' avnp:',avnp + +c calculate corfct_0 +c ------------------ + corzer=0.0 + do i=iternc+1,itermx + dev(i)=npit(i)-avnp + corzer=corzer+dev(i)**2 + enddo + corzer=corzer/(itermx-iternc) + if(ish.ge.9)write(ifch,*)'c_0:',corzer + +c calculate corfct_1 +c ------------------ + corone=0.0 + do i=iternc+1,itermx-1 + corone=corone+dev(i)*dev(i+1) + enddo + corone=corone/(itermx-iternc-1) + +c calculate initial autocorrelation time +c ----------------------------------------- + if(corone.gt.1.e-30.and.corzer.gt.1.e-30)then + r=alog(corone)-alog(corzer) + if(ish.ge.9)write(ifch,*)'log rho_1:',r + taui=(-1.)/r + else + taui=0. + endif + if(ish.ge.9)write(ifch,*)'tau_init:',taui + +c calculate parametrized autocorrelation time (if necessary) +c ---------------------------------------------------------- + if(taue.eq.0.0)then + e=tecm/volu + b=1.1*(e+0.33)**0.66 + a=13.*(e+0.13)**(-0.65) + tm=34.*(e+0.65)**(-0.61) + t=a+b*volu + taue=max(t,tm) + endif + +c calculate acceptance rate +c ------------------------- + xa=nacc + ya=itermx + accrat=xa/ya + +c write to data/b/c/d +c ------------------- + if(iii.eq.0)then + if(iozevt.gt.0)then + data(nrevt)=iozero + else + data(nrevt)=nrevt + endif + datb(nrevt)=taui + datc(nrevt)=accrat + datd(nrevt)=taue + else + data(nrclu)=nrclu + datb(nrclu)=taui-taue + datc(nrclu)=accrat + datd(nrclu)=avnp + endif + +c ----------------------------------- + elseif(iii.lt.0.and.iappl.eq.4)then +c ----------------------------------- + + write(cmom,'(i3)')iomom + write(cen,'(f7.3)')tecm + if(ioobsv.eq.0)then + write(cnp,'(f7.3)')ptltot + else + do i=1,nspecs + if(ioobsv.eq.ispecs(i))id=i + enddo + write(cnp,'(f7.3)')ptlngc(id) + endif + write(cvol,'(f7.3)')volu + write(clatt,'(i3)')nlattc + write(cit,'(i5)')itermx + if(ioobsv.eq.0)then + write(cobs,'(a)')'all' + else + write(cobs,'(i5)')ioobsv + endif + write(cnc,'(i5)')iternc + if(iozevt.eq.0)write(czer,'(i5)')iozero + if(iozevt.gt.0)write(cdz,'(i5)')iozinc + + x1=1 + x2=nevent + + if(jjj.eq.1)then + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + if(iozevt.gt.0)then + write(ifhi,'(a)') 'text 0 0 "xaxis iozero"' + else + write(ifhi,'(a)') 'text 0 0 "xaxis event"' + endif + write(ifhi,'(a)') 'text 0 0 "yaxis [t]?exp!"' + write(ifhi,'(a)') 'text 0.05 0.95 "E='//cen//'"' + write(ifhi,'(a)') 'text 0.2 0.95 "V='//cvol//'"' + write(ifhi,'(a)') 'text 0.35 0.95 "N?g!='//cnp//'"' + write(ifhi,'(a)') 'text 0.55 0.95 "observable '//cobs//'"' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'array 2' + do j=1,nevent + write(ifhi,'(2e12.4)')data(j),datb(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'array 2' + do j=1,nevent + write(ifhi,'(2e12.4)')data(j),datd(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + elseif(jjj.eq.2)then + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + if(iozevt.gt.0)then + write(ifhi,'(a)') 'text 0 0 "xaxis iozero"' + else + write(ifhi,'(a)') 'text 0 0 "xaxis event"' + endif + write(ifhi,'(a)') 'text 0 0 "yaxis acceptence rate"' + write(ifhi,'(a)') 'text 0.05 0.95 "iomom= '//cmom//'"' + write(ifhi,'(a)') 'text 0.2 0.95 "nlattc= '//clatt//'"' + if(iozevt.eq.0) + *write(ifhi,'(a)') 'text 0.35 0.95 "iozero= '//czer//'"' + write(ifhi,'(a)') 'text 0.55 0.95 "itermx= '//cit//'"' + write(ifhi,'(a)') 'text 0.75 0.95 "iternc= '//cnc//'"' + if(iozevt.gt.0) + *write(ifhi,'(a)') 'text 0.35 0.95 "dzero= '//cdz//'"' + if(iorejz.eq.1) + *write(ifhi,'(a)') 'text 0.25 0.05 "zeros rejected !"' + if(ioinco.ge.1)then + write(ifhi,'(a)') 'text 0.05 0.05 "hot start"' + else + write(ifhi,'(a)') 'text 0.05 0.05 "cold start"' + endif + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'array 2' + do j=1,nevent + write(ifhi,'(2e12.4)')data(j),datc(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + endif + +c ----------------------------------- + elseif(iii.lt.0.and.iappl.eq.1)then +c ----------------------------------- + + if(ioobsv.eq.0)then + write(cobs,'(a)')'all' + else + write(cobs,'(i5)')ioobsv + endif + + x1=1 + x2=nrclu + + if(jjj.eq.1)then + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis droplet"' + write(ifhi,'(a)') 'text 0 0 "yaxis [D][t]?exp!"' + write(ifhi,'(a)') 'text 0.05 0.91 "[D][t]?exp!=[t]?measured! + *-[t]?parametrized"' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a,a,a)')'yrange',' auto',' auto' + write(ifhi,'(a)') 'array 2' + do j=1,nrclu + write(ifhi,'(2e12.4)')data(j),datb(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + elseif(jjj.eq.2)then + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis droplet"' + write(ifhi,'(a)') 'text 0 0 "yaxis N?obs!"' + write(ifhi,'(a)') 'text 0.05 0.95 "observable '//cobs//'"' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'array 2' + do j=1,nrclu + write(ifhi,'(2e12.4)')data(j),datd(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + elseif(jjj.eq.3)then + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis droplet"' + write(ifhi,'(a)') 'text 0 0 "yaxis accep. rate"' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'array 2' + do j=1,nrclu + write(ifhi,'(2e12.4)')data(j),datc(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + endif + +c ----- + endif +c ----- + + ish=ish0 + return + end + +c------------------------------------------------------------------------- + subroutine xhnbti(iii) +c------------------------------------------------------------------------- +c fills histograms (iii=0) or writes histogram to histo-file (iii<0) +c regarding integrated autocorrelation time and corresponding multiplicity +c and variance +c +c input: +c requires complete run with application metropolis (iappl=4) +c iociau=1 necessary +c iompar (parameter for windowing algorithm by a.d.sokal) must +c be set to 3 < c_M < 11 +c +c output: +c for iii=0 (only valid for iappl=4): +c data(nrevt): nrevt (event number) /cdat/ +c datb(nrevt): tau (calculated int corr time) /cdat/ +c datc(nrevt): stau (variance tau) /cdat/ +c datd(nrevt): avnp (multiplicity) /cdat/ +c date(nrevt): sobs (variance multiplicity) /cdat/ +c datf(nrevt): (gc multiplicity) /cdat/ +c for iii=0 and iosngl>0: +c writes complete set of histograms (newpage zone 1 3 1 +c openhisto ... closehisto plot0 ... openhisto ... closehisto plot 0) +c concerning acceptance rate, rejection rate, correlation function +c for specific event, specified by value of iosngl (=nrevt+1) +c for iii<0: +c writes complete histogram (openhisto ... closehisto) to histofile +c xpar1=1: (data,datb,datc) +c xpar1=2: (data,datd,date,datf) +c------------------------------------------------------------------------ + include 'epos.inc' + parameter(maxit=50000) + common/count/nacc,nrej,naccit(maxit),nptot,npit(maxit) + common/citer/iter,itermx + parameter(maxp=500) + common/confg/np,amass(maxp),ident(maxp),pcm(5,maxp),wtxlog,wtlog + common /clatt/nlattc,npmax + common/cgctot/rmstot,ptltot + parameter (mspecs=56) + common/cspecs/nspecs,ispecs(mspecs),aspecs(mspecs),gspecs(mspecs) + common/cgchg/rmsngc(mspecs),ptlngc(mspecs),chemgc(mspecs),tem + parameter (nbin=500) + common/cdat2/data(nbin),datb(nbin),datc(nbin),datd(nbin) + *,date(nbin),datf(nbin),datg(nbin),dath(nbin) + common/cdat3/datx(nbin),daty(nbin),datz(nbin),datr(nbin) + *,dats(nbin) + real corfct(maxit),dev(maxit) + character cobs*5,cdz*5,ccuev*5,cmpar*3,ctau*7 + character cmom*5,cnp*7,cen*7,cvol*7,clatt*5,cit*5,cavnp*7 + character cnacc*10,cnrej*10,caver*10,cioz*5,ciom*3,cnlat*5 + + if(iociau.ne.1)stop'STOP: iociau=1 required' + if(iii.eq.0.and.iappl.ne.4)stop'STOP: iappl=4 required' + if(iii.gt.0)stop'STOP: iii>0 not supported' + + jjj=nint(xpar1) + id=0 + +c ---------------- + if(iii.eq.0)then +c ---------------- + +c mean +c ---- + xnptot=nptot + avnp=xnptot/(itermx-iternc) + if(ish.ge.9)write(ifch,*)'event:',nrevt,' avnp:',avnp + +c normalization of corfct_i +c ------------------------- + corzer=0.0 + do i=iternc+1,itermx + dev(i)=npit(i)-avnp + if(ish.ge.9)write(ifch,*)'i:',i,' dev_i:',dev(i) + corzer=corzer+dev(i)**2 + enddo + corzer=corzer/(itermx-iternc) + if(ish.ge.9)write(ifch,*)'c_0:',corzer + +c calculate corfct_i +c ------------------ + nt=itermx-iternc-1 + do it=1,nt + corfct(it)=0.0 + do i=iternc+1,itermx-it + corfct(it)=corfct(it)+dev(i)*dev(i+it) + enddo + corfct(it)=corfct(it)/(itermx-iternc-it) + if(it.le.10.and.ish.ge.9) + *write(ifch,*)'t:',it,' c_t:',corfct(it) + enddo + +c calculate initial autocorrelation time +c ----------------------------------------- + if(corfct(1).gt.1.e-30.and.corzer.gt.1.e-30)then + r=alog(corfct(1))-alog(corzer) + if(ish.ge.9)write(ifch,*)'log rho_1:',r + taui=(-1.)/r + else + taui=0. + endif + if(ish.ge.9)write(ifch,*)'tau_init:',taui + +c calculate integrated autocorrelation time +c ----------------------------------------- + k=1 + mpar=iompar + tau=taui + taux=taui + taum=0.0 + if(ish.ge.9)write(ifch,*)'initial tau:',tau,' c_M:',mpar + + if(corzer.gt.1.e-30)then + +5 mcut=mpar*abs(taux) + tauo=tau + tau=.5 + do it=1,mcut + tau=tau+corfct(it)/corzer + enddo + taum=taum+tau + taux=taum/k + if(ish.ge.9)write(ifch,*)'iteration:',k,' M:',mcut,' tau:',tau + if(mcut.lt.(mpar*tau).or.mcut.gt.(10.*tau))then + dt=abs(tau-tauo) + if(k.lt.20.and.dt.gt.0.2)then + k=k+1 + goto5 + endif + endif + mcut=mpar*abs(taux) + if(ish.ge.9)write(ifch,*)'tau_mean:',taux,' M:',mcut + tau=0.5 + do it=1,mcut + tau=tau+corfct(it)/corzer + enddo + + endif + + vtau=(2.*mcut+1.)*2./(itermx-iternc)*tau**2 + stau=0.0 + if(vtau.ge.0.0)stau=sqrt(vtau) + if(ish.ge.9) + *write(ifch,*)'tau_int:',tau,' var:',vtau,' sig:',stau + +c calculate variance of observable +c -------------------------------- + vobs=2.*tau*corzer/(itermx-iternc) + sobs=0.0 + if(vobs.ge.0.0)sobs=sqrt(vobs) + +c write to data-f +c --------------- + if(ioobsv.eq.0)then + datf(nrevt)=ptltot + else + do j=1,np + if(ioobsv.eq.ispecs(j))id=j + enddo + datf(nrevt)=ptlngc(id) + endif + datb(nrevt)=tau + datc(nrevt)=stau + date(nrevt)=sobs + datd(nrevt)=avnp + if(iozevt.gt.0)then + data(nrevt)=iozero + else + data(nrevt)=nrevt + endif + +c ------------------------- + if(iosngl.eq.nrevt+1)then +c ------------------------- + + nb=itermx/iterpl + if(nb.gt.nbin)nb=nbin + + datx(1)=iterpl/2 + daty(1)=naccit(1) + datz(1)=1-naccit(1) + if(iterpl.ge.2)then + do j=1,iterpl-1 + daty(1)=daty(1)+naccit(1+j) + datz(1)=datz(1)+1-naccit(1+j) + enddo + endif + datr(1)=daty(1)/iterpl + dats(1)=datz(1)/iterpl + do i=2,nb + datx(i)=datx(i-1)+iterpl + daty(i)=daty(i-1) + datz(i)=datz(i-1) + do j=1,iterpl + daty(i)=daty(i)+naccit((i-1)*iterpl+j) + datz(i)=datz(i)+1-naccit((i-1)*iterpl+j) + enddo + datr(i)=daty(i)/i/iterpl + dats(i)=datz(i)/i/iterpl + enddo + b=nacc + c=itermx + avrate=b/c + write(cnacc,'(i6)')nacc + write(cnrej,'(i6)')nrej + write(caver,'(f5.3)')avrate + write(cioz,'(i5)')iozero + write(ciom,'(i3)')iomom + write(cnlat,'(i5)')nlattc + x1=datx(1) + x2=datx(nb) + + write(ifhi,'(a)') 'newpage zone 1 3 1 openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis iterations"' + write(ifhi,'(a)') 'text 0 0 "yaxis acceptence rate"' + write(ifhi,'(a)') 'text 0.6 0.5 "accepted '//cnacc//'"' + write(ifhi,'(a)') 'text 0.6 0.4 "rejected '//cnrej//'"' + write(ifhi,'(a)') 'text 0.6 0.3 "aver. rate '//caver//'"' + write(ifhi,'(a)') 'text 0.4 0.5 "nlattc='//cnlat//'"' + write(ifhi,'(a)') 'text 0.4 0.4 "iozero='//cioz//'"' + write(ifhi,'(a)') 'text 0.4 0.3 "iomom='//ciom//'"' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'array 2' + do j=1,nb + write(ifhi,'(2e12.4)')datx(j),datr(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'array 2' + do j=1,nb + write(ifhi,'(2e12.4)')datx(j),dats(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + m=min(mcut,500) + do i=1,m + datg(i)=i + dath(i)=1000. + if(corzer.gt.1.e-30)dath(i)=corfct(i)/corzer + enddo + write(ccuev,'(i5)')nrevt+1 + write(cmpar,'(i3)')mpar + write(ctau,'(i7)')tau + x1=1. + x2=m + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis t"' + write(ifhi,'(a)') 'text 0 0 "yaxis correl. func."' + write(ifhi,'(a)') 'text 0.8 0.95 "event '//ccuev//'"' + write(ifhi,'(a)')'text 0.05 0.95 "window parameter= '//cmpar//'"' + write(ifhi,'(a)') 'text 0.35 0.95 "tau= '//ctau//'"' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a,a,a)')'yrange',' auto',' auto' + write(ifhi,'(a)') 'array 2' + do j=1,m + write(ifhi,'(2e12.4)')datg(j),dath(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + +c ----- + endif +c ----- + +c -------------------- + elseif(iii.lt.0)then +c -------------------- + + write(cmom,'(i3)')iomom + if(ioobsv.eq.0)then + write(cnp,'(f7.3)')ptltot + else + do j=1,np + if(ioobsv.eq.ispecs(j))id=j + enddo + write(cnp,'(f7.3)')ptlngc(id) + endif + write(cen,'(f7.3)')tecm + write(cvol,'(f7.3)')volu + write(clatt,'(i3)')nlattc + write(cit,'(i5)')itermx + write(cavnp,'(f7.3)')avnp + if(iozevt.gt.0) + *write(cdz,'(i5)')iozinc + write(cmpar,'(i3)')mpar + if(ioobsv.eq.0)then + write(cobs,'(a)')'all' + else + write(cobs,'(i5)')ioobsv + endif + + x1=data(1) + x2=data(nevent) + + if(jjj.eq.1)then + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp pnt xmod lin ymod lin' + if(iozevt.gt.0)then + write(ifhi,'(a)') 'text 0 0 "xaxis iozero"' + else + write(ifhi,'(a)') 'text 0 0 "xaxis event"' + endif + write(ifhi,'(a)') 'text 0 0 "yaxis [t]?int!"' + write(ifhi,'(a)')'text 0.05 0.95 "window parameter '//cmpar//'"' + if(iozevt.gt.0) + *write(ifhi,'(a)') 'text 0.8 0.95 "dzero= '//cdz//'"' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a)') 'array 3' + do j=1,nevent + write(ifhi,'(3e12.4)')data(j),datb(j),datc(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + elseif(jjj.eq.2)then + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp pnt xmod lin ymod lin' + if(iozevt.gt.0)then + write(ifhi,'(a)') 'text 0 0 "xaxis iozero"' + else + write(ifhi,'(a)') 'text 0 0 "xaxis event"' + endif + write(ifhi,'(a)') 'text 0 0 "yaxis multiplicity"' + write(ifhi,'(a)') 'text 0.05 0.95 "E='//cen//'"' + write(ifhi,'(a)') 'text 0.2 0.95 "V='//cvol//'"' + write(ifhi,'(a)') 'text 0.35 0.95 "N?g!='//cnp//'"' + write(ifhi,'(a)') 'text 0.55 0.95 "observable '//cobs//'"' + write(ifhi,'(a,2e11.3)')'xrange',x1,x2 + write(ifhi,'(a,a,a)')'yrange',' auto',' auto' + write(ifhi,'(a)') 'array 3' + do j=1,nevent + write(ifhi,'(3e12.4)')data(j),datd(j),date(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lda xmod lin ymod lin' + write(ifhi,'(a)') 'array 2' + do j=1,nevent + write(ifhi,'(2e12.4)')data(j),datf(j) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + + endif + +c ----- + endif +c ----- + + return + end + diff --git a/modules/epos/epos-ico-lhc.f b/modules/epos/epos-ico-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..7dd98081da4c98f7d47dfce9ce8390bc0755507c --- /dev/null +++ b/modules/epos/epos-ico-lhc.f @@ -0,0 +1,461 @@ +c----------------------------------------------------------------------- +c activate making inicon table by the follwing commands in optns file: +c----------------------------------------------------------------------- +c set nevent 1 +c set bminim 3 (for example) +c set bmaxim 5 (for example) +c set ninicon 1000 (for example) +c set icocore 1 !or 2 +c make icotable +c switch splitting on +c switch fusion on +c switch clusterdecay off +c----------------------------------------------------------------------- +c inicon table means storage of IcoE, IcoV, IcoF +c IcoE ... energy density in the comoving frame +c IcoV ... flow velocity in hyperbolic coordinates +c v=(vx,vy,veta=vz/tau) +c with the velocity in the frame moving with rapidity eta +c IcoV ... net flavor density in the comoving frame +c the indices of these fields ix,iy,iz also refer to hyperbolic coordinates +c (x,y,eta) at given tau +c the corresponding grid is defined in epos.incico +c----------------------------------------------------------------------- + +c----------------------------------------------------------------------- + subroutine IniCon(nin) +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incico' + double precision seedf + character*80 fn + logical table + + ii=index(fnhi(1:nfnhi),".histo")-1 + fn=fnhi(1:ii)//".ico" + inquire(file=fn(1:ii+4),exist=table) + + if(icotabr.eq.1)then !read from file + + if(.not.table)then + write(ifmt,'(//10x,3a//)')'STOP: file ' + * ,fn(1:ii+4),' not found !!!' + stop + endif + write(ifmt,'(3a)')'read from ',fn(1:ii+4),' ...' + open(97,file=fn,status='old') + read(97,*) iversn + read(97,*) laprojx,maprojx,latargx,matargx + read(97,*) engyx + read(97,*) bminimx,bmaximx + read(97,*) tauicox + read(97,*) iabs_ninicon_dum + read(97,*) nxicox,nyicox,nzicox + read(97,*)xminicox,xmaxicox,yminicox,ymaxicox,zminicox,zmaxicox + if(laprojx.ne.laproj.or.maprojx.ne.maproj + * .or.latargx.ne.latarg.or.matargx.ne.matarg)stop'(1)' + if(engyx.ne.engy) stop'variables dont match (2) ' + if(bminimx.ne.bminim.or.bmaximx.ne.bmaxim) + * stop'variables dont match (3) ' + if(tauicox.ne.tauico)stop'variables dont match (4) ' + if(nxicox.ne.nxico.or.nyicox.ne.nyico + * .or.nzicox.ne.nzico)stop'(5)' + if( xminicox.ne.xminico.or.xmaxicox.ne.xmaxico + * .or.yminicox.ne.yminico.or.ymaxicox.ne.ymaxico + * .or.zminicox.ne.zminico.or.zmaxicox.ne.zmaxico)stop'(6)' + read(97,*) IcoE,IcoV,IcoF + close(97) + + elseif(icotabr.eq.0)then ! calculate + + !if(icotabm.eq.1.and.table)then + !write(ifmt,'(//10x,3a//)')'STOP: file ' + !* ,fn(1:ii+4),' already exists !!!' + !stop + !endif + + if(nin.eq.1)then + write(ifmt,'(2a,i7,a)')' calculate inicon table ', + & 'based on',iabs(ninicon),' ico-events ...' + call IcoStr(1) + endif + + call ranfgt(seedf) + if(nin.le.iabs(ninicon).and.mod(nin,modsho).eq.0) + & write(ifmt,'(a,i7,a,f6.2,a,d27.16)')' ico-event ',nin + & ,' bimevt:',bimevt,' seedf:',seedf + if(nin.le.iabs(ninicon).and.jwseed.eq.1)then + open(unit=1,file=fnch(1:nfnch-5)//'see',status='unknown') + write(1,'(a,i7,a,f6.2,a,d27.16)')' ico-event ',nin + & ,' bimevt:',bimevt,' seedf:',seedf + close(1) + endif + !if(nin.le.iabs(ninicon).and.mod(nin,modsho).eq.0) + !& print*,'+++++ time: ',timefin-timeini + seedc=seedf + call IcoStr(2) + + if(nin.eq.iabs(ninicon))then + write(ifmt,*)'normalize and diagonalize engy-mom tensor' + call IcoStr(3) + + if(icotabm.eq.1)then ! make table + write(ifmt,'(2a)')' write inicon table into ',fn(1:ii+4) + open(97,file=fn,status='unknown') + write(97,*) iversn + write(97,*) laproj,maproj,latarg,matarg + write(97,*) engy + write(97,*) bminim,bmaxim + write(97,*) tauico + write(97,*) iabs(ninicon) + write(97,*) nxico,nyico,nzico + write(97,*) xminico,xmaxico,yminico,ymaxico,zminico,zmaxico + write(97,*) IcoE,IcoV,IcoF + close(97) + endif + endif + + else + + stop'IniCon: wrong choice' + + endif + + end + +c----------------------------------------------------------------------- + subroutine IcoStr(iflag) +c----------------------------------------------------------------------- +c energy momentum tensor and flavor current +c and corresponding contractions from string method +c +c iflag = 1 initialization +c = 2 sum up density +c = 3 normalization +c +c output: common blocks /Ico3/ /Ico4/ /Ico5/ +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incico' + double precision IcoT(4,4,nxico,nyico,nzico) + * ,IcoC(3,4,nxico,nyico,nzico) + common/cxyzt/xptl(mxptl),yptl(mxptl),zptl(mxptl),tptl(mxptl) + *,optl(mxptl),uptl(mxptl),sptl(mxptl),rptl(mxptl,3) + common /Ico10/ntot,ish0,irs + double precision p(4),v(4),u(4),eps,T(4,4),gamma,rap,rapx + integer ic(2),jc(nflav,2) + common/cranphi/ranphi + logical ok + goto (1,10,100),iflag + return + +c...................................................................... +c initialization +c...................................................................... + + 1 do ix=1,nxico + do iy=1,nyico + do iz=1,nzico + IcoE(ix,iy,iz)=0. + do i=1,3 + IcoV(i,ix,iy,iz)=0. + enddo + do i=1,3 + IcoF(i,ix,iy,iz)=0. + enddo + do i=1,4 + do j=1,4 + IcoT(i,j,ix,iy,iz)=0. + enddo + enddo + do i=1,3 + do j=1,4 + IcoC(i,j,ix,iy,iz)=0. + enddo + enddo + enddo + enddo + enddo + ntot=0 + return + +c...................................................................... +c fill arrays +c...................................................................... + + 10 ntot=ntot+1 + dxico=(xmaxico-xminico)/nxico + dyico=(ymaxico-yminico)/nyico + dzico=(zmaxico-zminico )/nzico + phinll=phievt+ranphi + + do j=1,nptl + ok=.true. + if(icocore.eq.2 + . .and.(ityptl(j).lt.20.or.ityptl(j).ge.40))ok=.false. + if(ok + . .and.dezptl(j).lt.1e3.and.j.le.maxfra.and.istptl(j).eq.2)then + aa=cos(phinll) + bb=sin(phinll) + x=xptl(j)*aa+yptl(j)*bb + cc=-sin(phinll) + dd=cos(phinll) + y=xptl(j)*cc+yptl(j)*dd + z=dezptl(j) + ix=1+(x-xminico)/dxico + iy=1+(y-yminico)/dyico + iz=1+(z-zminico)/dzico + if(ix.ge.1.and.ix.le.nxico.and. + . iy.ge.1.and.iy.le.nyico.and. + . iz.ge.1.and.iz.le.nzico)then + !~~~~~~~~~~~~ + ! T^i^k = \int d3p p^i p^k /E f(\vec x,\vec p) + ! N^k = \int d3p p^k /E f_net(\vec x,\vec p) + !~~~~~~~~~~~~ + rapx=zminico+(iz-0.5)*dzico + amt2=pptl(5,j)**2+pptl(1,j)**2+pptl(2,j)**2 + pp=pptl(4,j)+abs(pptl(3,j)) + if(amt2.gt.0..and.pp.gt.0.)then + amt=sqrt(amt2) + rap=sign(1.,pptl(3,j))*alog(pp/amt) + p(1)=pptl(1,j) + p(2)=pptl(2,j) + p(3)=amt*sinh(rap-rapx) + p(4)=amt*cosh(rap-rapx) + do i=1,4 + do k=1,4 + IcoT(i,k,ix,iy,iz)=IcoT(i,k,ix,iy,iz)+p(i)*p(k)/p(4) + enddo + enddo + id=idptl(j) + ida=iabs(id/10) + ids=id/iabs(id) + if(ida.ne.111.and.ida.ne.222.and.ida.ne.333)id=id/10*10 + if(ida.eq.111.or. ida.eq.222.or. ida.eq.333)id=id/10*10+ids + if(ida.eq.213)id=1230*ids + ic(1)=idtrai(1,id,1) + ic(2)=idtrai(2,id,1) + call iddeco(ic,jc) + do i=1,3 + fi=jc(i,1)-jc(i,2) + do k=1,4 + IcoC(i,k,ix,iy,iz)=IcoC(i,k,ix,iy,iz)+p(k)/p(4)*fi + enddo + enddo + endif + !~~~~~~~~~~~~ + endif + endif + enddo + + return + +c............................................................................ +c normalization and diagonalization +c............................................................................ + + 100 continue + + !~~~normalize + + vol= (xmaxico-xminico)/nxico + . *(ymaxico-yminico)/nyico + . *(zmaxico-zminico)/nzico *tauico + fac=1./ntot/vol + + do ix=1,nxico + do iy=1,nyico + do iz=1,nzico + do i=1,4 + do k=1,4 + IcoT(i,k,ix,iy,iz)=IcoT(i,k,ix,iy,iz)*fac + enddo + enddo + do i=1,3 + do k=1,4 + IcoC(i,k,ix,iy,iz)=IcoC(i,k,ix,iy,iz)*fac + enddo + enddo + enddo + enddo + enddo + + !~~~diagonalize T + + do ix=1,nxico + do iy=1,nyico + do iz=1,nzico + do i=1,4 + do k=1,4 + T(i,k)=IcoT(i,k,ix,iy,iz) + enddo + enddo + call DiagTmunu(T,u,v,gamma,eps,nonz,ix,iy,iz) + if(nonz.eq.1)then + IcoE(ix,iy,iz)=eps + IcoV(1,ix,iy,iz)=v(1) + IcoV(2,ix,iy,iz)=v(2) + !rapx=zminico+(iz-0.5)*dzico + !rap=rapx+log(gamma*(1+v(3))) + !IcoV(3,ix,iy,iz)=tanh(rap) + IcoV(3,ix,iy,iz)=v(3) / tauico + do i=1,3 + IcoF(i,ix,iy,iz)=IcoC(i,4,ix,iy,iz)*u(4) + do k=1,3 + IcoF(i,ix,iy,iz)=IcoF(i,ix,iy,iz) + . -IcoC(i,k,ix,iy,iz)*u(k) + enddo + enddo + endif + enddo + enddo + enddo + + return + end + +c------------------------------------------------------------------------------------ + subroutine DiagTmunu(Tmunu,u,v,gamma,eps,nonz,ix,iy,iz) +c------------------------------------------------------------------------------------ + ! solve lambda * T * lambda = diag(eps,P,P,P), for symmetric T + ! + ! lambda = g g*vx g*vy g*vz =symmetric! + ! g*vx a*vx*vx+1 a*vy*vx a*vz*vx + ! g*vy a*vx*vy a*vy*vy+1 a*vz*vy + ! g*vz a*vx*vz a*vy*vz a*vz*vz+1 + ! with g=gamma, a=g*g/(g+1) + ! + ! so T*lambda(v)=lambda(-v)*diag(eps,P,P,P) + ! first column: four equations + ! eps=T00+T0k*vk + ! -eps*vi=Ti0+Tik*vk + ! solved iteratively to get eps, vi + ! returns u,v,eps if nonz=1 (otherwise zero tensor) + ! (by T.Kodama) + ! (K. Werner: modifs) + + include 'epos.incico' + double precision Tmunu(4,4), u(4),eps,gamma,g,a, Lor(4,4),w(4),sum + double precision v(4),vx(3),tt(4,4),err,sg(4) + + sg(4)=1d0 + v(4)=1d0 + do i=1,3 + sg(i)=-1d0 + enddo + sum=0d0 + do i=1,4 + do k=1,4 + sum=sum+dabs(Tmunu(i,k)) + end do + end do + nonz=0 + if(sum.eq.0.0d0)return + nonz=1 + + do k=1,3 + v(k)=0. + end do + eps=0 + + do lrep=1,100 + epsx=eps + do i=1,3 + vx(i)=v(i) + end do + eps=Tmunu(4,4) + do k=1,3 + eps=eps-Tmunu(4,k)*vx(k) + end do + if(eps.le.0d0)then + print*,'DiagTmunu: sum(abs(Tmunu))=',sum,' eps=',eps + print*,'Tmunu(4,nu):',(Tmunu(4,nu),nu=1,4) + if(eps.gt.-1e-5)then + nonz=0 + return + else + print*,'STOP in DiagTmunu: negative energy density. ' + stop'(3003200808)' + endif + endif + do i=1,3 + Tv=0d0 + do k=1,3 + Tv=Tv+Tmunu(i,k)*vx(k) + end do + v(i)=(Tmunu(i,4)-Tv)/eps + end do + if(lrep.gt.60)then + do i=1,3 + v(i)=0.5d0*(vx(i)+v(i)) + enddo + endif + !print*,'Tmunu: ',lrep,abs(eps-epsx),(abs(v(i)-vx(i)),i=1,3) + err=1d-6 + if(lrep.gt.50)err=1d-5 + if(lrep.gt.89)err=1d-4 + if(abs(eps-epsx).lt.err.and.abs(v(1)-vx(1)).lt.err + . .and.abs(v(2)-vx(2)).lt.err.and.abs(v(3)-vx(3)).lt.err)goto1 + do i=1,4 + w(i)=0 + do k=1,4 + w(i)=w(i)+Tmunu(i,k)*v(k)*sg(k) + enddo + w(i)=w(i)-eps*v(i) + enddo + if(lrep.gt.95 + ..and.w(1)*w(1)+w(2)*w(2)+w(3)*w(3)+w(4)*w(4).lt.err)goto1 + end do + + 1 v2=0.d0 + do i=1,3 + v2=v2+v(i)**2 + end do + if(v2.ge.1.)stop'DiagTmunu: v2 ge 1. ' + gamma=1./sqrt(abs(1.-v2)) + u(4)=gamma + u(1)=v(1)*gamma + u(2)=v(2)*gamma + u(3)=v(3)*gamma + + !~~~check + g=gamma + a=g*g/(g+1d0) + Lor(4,4)=g + do k=1,3 + Lor(4,k)=-g*v(k) + Lor(k,4)=Lor(4,k) + enddo + do i=1,3 + do k=1,3 + Lor(i,k)=a*v(i)*v(k) + enddo + enddo + do k=1,3 + Lor(k,k)=Lor(k,k)+1 + enddo + do i=1,4 + do k=1,4 + tt(i,k)=0d0 + do m=1,4 + do n=1,4 + tt(i,k)=tt(i,k)+Lor(i,m)*Tmunu(m,n)*Lor(n,k) + enddo + enddo + enddo + enddo + err=err*1d2 + if(tt(1,4).gt.err.or.tt(2,4).gt.err.or.tt(3,4).gt.err)then + print*,'************** DiagTmunu: nonzero T14 or T24 or T34' + . ,' after ',lrep,' iterations' + print*,'d_eps or d_v(i): ',abs(eps-epsx),(abs(v(i)-vx(i)),i=1,3) + print*,'Tmunu ( ix=',ix-nxico/2-1,' iy=',iy-nyico/2-1,' ) :' + . ,' iz=',iz-nzico/2-1 + do i=1,4 + write(*,'(4f10.5,2x,4f10.5)') + . (sngl(tmunu(i,k)),k=1,4),(sngl(tt(i,k)),k=1,4) + enddo + endif + + end + diff --git a/modules/epos/epos-ids-lhc.f b/modules/epos/epos-ids-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..4bfe8f9569c822169855986bffa07fd9ec3009a3 --- /dev/null +++ b/modules/epos/epos-ids-lhc.f @@ -0,0 +1,2500 @@ +c----------------------------------------------------------------------- + subroutine iclass(id,icl) +c----------------------------------------------------------------------- +c determines hadron class +c----------------------------------------------------------------------- + ida=iabs(id) + if(ida.eq.0.or.(ida.ge.17.and.ida.le.19))then + icl=2 + elseif(ida.eq.130.or.ida.eq.230.or.ida.eq.20)then + icl=3 + elseif(ida.eq.140.or.ida.eq.240.or.ida.eq.340.or.ida/10.eq.44)then + icl=4 + elseif(ida.ge.100.and.ida.le.999)then + icl=1 + elseif(ida.ge.1000.and.ida.le.9999)then + icl=2 + else + stop'iclass: id not known' + endif + end + +c----------------------------------------------------------------------- + subroutine idchrg(id,chrg) +c computes charge of particle with ident code id +c ichrg must be dimensioned nqlep+12 +c----------------------------------------------------------------------- + dimension ichrg(53),ifl(3) + data ichrg/0,2,-1,-1,2,-1,2,-1,2,0,0,0,-3,0,-3,0,-3,1,1,2,2*0 + *,2,-1,-1,2,-1,2,-1,2,0,0,0,-3,0,-3,0,-3,0,-3,3,0 + *,3,0,0,0,3,3,3,6,6,6,0/ + idabs=iabs(id) + call idflav(id,ifl(1),ifl(2),ifl(3),jspin,ind) + if(idabs.lt.100) goto 200 + isum=0 + do 100 i=1,3 + if(abs(ifl(i)).gt.52)goto 100 + isum=isum+ichrg(iabs(ifl(i))+1)*isign(1,ifl(i)) + 100 continue + chrg=isum/3. + return +200 chrg=ichrg(ind+1)*isign(1,id) + chrg=chrg/3. + return + end + +c----------------------------------------------------------------------- + subroutine idspin(id,iso,jspin,istra) +c computes iso (isospin), jspin and istra (strangeness) of particle +c with ident code id +c----------------------------------------------------------------------- + include 'epos.inc' + dimension ifl(3) + iso=0 + jspin=0 + istra=0 + idabs=abs(id) + if(idabs.le.nflav)then + iso=isospin(idabs)*sign(1,id) + if(idabs.ge.3)istra=sign(1,id) + return + endif + call idflav(id,ifl(1),ifl(2),ifl(3),jspin,ind) + iq1=abs(ifl(1)) + iq2=abs(ifl(2)) + iq3=abs(ifl(3)) + if(iq1.ge.3)istra=istra+sign(1,ifl(1)) + if(iq2.ge.3)istra=istra+sign(1,ifl(2)) + if(iq3.ge.3)istra=istra+sign(1,ifl(3)) + if(iq1.ne.0)then !baryon + iso=(isospin(iq1)+isospin(iq2)+isospin(iq3))*sign(1,iq1) + else + iso=isospin(iq2)*sign(1,ifl(2)) + iso=iso+isospin(iq3)*sign(1,ifl(3)) + endif + return + end + +c----------------------------------------------------------------------- + subroutine idcomk(ic) +c compactifies ic +c----------------------------------------------------------------------- + parameter (nflav=6) + integer ic(2),icx(2),jc(nflav,2) + call idcomp(ic,icx,jc,1) + ic(1)=icx(1) + ic(2)=icx(2) + return + end + +cc----------------------------------------------------------------------- +c subroutine idcomi(ic,icx) +cc compactifies ic +cc----------------------------------------------------------------------- +c parameter (nflav=6) +c integer ic(2),icx(2),jc(nflav,2) +c call idcomp(ic,icx,jc,1) +c return +c end +c +c----------------------------------------------------------------------- + subroutine idcomj(jc) +c compactifies jc +c----------------------------------------------------------------------- + parameter (nflav=6) + integer ic(2),icx(2),jc(nflav,2) + call idcomp(ic,icx,jc,2) + return + end + +c----------------------------------------------------------------------- + subroutine idcomp(ic,icx,jc,im) +c----------------------------------------------------------------------- +c compactifies ic,jc +c input: im (1 or 2) +c ic (if im=1) +c jc (if im=2) +c output: icx (if im=1) +c jc +c----------------------------------------------------------------------- + parameter (nflav=6) + integer ic(2),icx(2),jc(nflav,2) + if(im.eq.1)call iddeco(ic,jc) + icx(1)=0 + icx(2)=0 + do n=1,nflav + do j=1,2 + if(jc(n,j).ne.0)goto1 + enddo + enddo + return +1 continue + nq=0 + na=0 + do n=1,nflav + nq=nq+jc(n,1) + na=na+jc(n,2) + enddo + l=0 + do n=1,nflav + k=min0(jc(n,1),jc(n,2)) + if(nq.eq.1.and.na.eq.1)k=0 + jc(n,1)=jc(n,1)-k + jc(n,2)=jc(n,2)-k + if(jc(n,1).lt.0.or.jc(n,2).lt.0) + *call utstop('idcomp: jc negative&') + l=l+jc(n,1)+jc(n,2) + enddo + if(l.eq.0)then + jc(1,1)=1 + jc(1,2)=1 + endif + if(im.eq.1)then + call idenco(jc,icx,ireten) + if(ireten.eq.1)call utstop('idcomp: idenco ret code = 1&') + endif + return + end + +c----------------------------------------------------------------------- + subroutine iddeco(ic,jc) +c decode particle id +c----------------------------------------------------------------------- + parameter (nflav=6) + integer jc(nflav,2),ic(2) + ici=ic(1) + jc(6,1)=mod(ici,10) + jc(5,1)=mod(ici/10,10) + jc(4,1)=mod(ici/100,10) + jc(3,1)=mod(ici/1000,10) + jc(2,1)=mod(ici/10000,10) + jc(1,1)=mod(ici/100000,10) + ici=ic(2) + jc(6,2)=mod(ici,10) + jc(5,2)=mod(ici/10,10) + jc(4,2)=mod(ici/100,10) + jc(3,2)=mod(ici/1000,10) + jc(2,2)=mod(ici/10000,10) + jc(1,2)=mod(ici/100000,10) + return + end + +c----------------------------------------------------------------------- + subroutine idenco(jc,ic,ireten) +c encode particle id +c----------------------------------------------------------------------- + parameter (nflav=6) + integer jc(nflav,2),ic(2) + ireten=0 + ic(1)=0 + do 20 i=1,nflav + if(jc(i,1).ge.10)goto22 +20 ic(1)=ic(1)+jc(i,1)*10**(nflav-i) + ic(2)=0 + do 21 i=1,nflav + if(jc(i,2).ge.10)goto22 +21 ic(2)=ic(2)+jc(i,2)*10**(nflav-i) + return +22 ireten=1 + ic(1)=0 + ic(2)=0 + return + end + +c----------------------------------------------------------------------- + subroutine idenct(jc,id,ib1,ib2,ib3,ib4) +c encode particle id +c----------------------------------------------------------------------- + parameter (nflav=6) + integer jc(nflav,2),ic(2) + + do 40 nf=1,nflav + do 40 ij=1,2 + if(jc(nf,ij).ge.10)id=7*10**8 +40 continue + if(id/10**8.ne.7)then + call idenco(jc,ic,ireten) + if(ireten.eq.1)call utstop('idenct: idenco ret code = 1&') + if(mod(ic(1),100).ne.0.or.mod(ic(2),100).ne.0)then + id=9*10**8 + else + id=8*10**8+ic(1)*100+ic(2)/100 + endif + else + call idtrbi(jc,ib1,ib2,ib3,ib4) + id=id + *+mod(jc(1,1)+jc(2,1)+jc(3,1)+jc(4,1),10**4)*10**4 + *+mod(jc(1,2)+jc(2,2)+jc(3,2)+jc(4,2),10**4) + endif + return + end + +c----------------------------------------------------------------------- + subroutine idflav(id,ifl1,ifl2,ifl3,jspin,index) +c unpacks the ident code id=+/-ijkl +c +c mesons-- +c i=0, j<=k, +/- is sign for j +c id=110 for pi0, id=220 for eta, etc. +c +c baryons-- +c i<=j<=k in general +c j<i<k for second state antisymmetric in (i,j), eg. l = 2130 +c +c other-- +c id=1,...,6 for quarks +c id=9 for gluon +c id=10 for photon +c id=11,...,16 for leptons +c i=17 for deuteron +c i=18 for triton +c i=19 for alpha +c id=20 for ks, id=-20 for kl +c +c i=21...26 for scalar quarks +c i=29 for gluino +c +c i=30 for h-dibaryon +c +c i=31...36 for scalar leptons +c i=39 for wino +c i=40 for zino +c +c id=80 for w+ +c id=81,...,83 for higgs mesons (h0, H0, A0, H+) +c id=84,...,87 for excited bosons (Z'0, Z''0, W'+) +c id=90 for z0 +c +c diquarks-- +c id=+/-ij00, i<j for diquark composed of i,j. +c +c +c index is a sequence number used internally +c (index=-1 if id doesn't exist) +c +c----------------------------------------------------------------------- + parameter ( nqlep=41,nmes=2) + ifl1=0 + ifl2=0 + ifl3=0 + jspin=0 + idabs=iabs(id) + i=idabs/1000 + j=mod(idabs/100,10) + k=mod(idabs/10,10) + jspin=mod(idabs,10) + if(id.ge.10000) goto 400 + if(id.ne.0.and.mod(id,100).eq.0) goto 300 + if(j.eq.0) goto 200 + if(i.eq.0) goto 100 +c baryons +c only x,y baryons are qqx, qqy, q=u,d,s. + ifl1=isign(i,id) + ifl2=isign(j,id) + ifl3=isign(k,id) + if(k.le.6) then + index=max0(i-1,j-1)**2+i+max0(i-j,0)+(k-1)*k*(2*k-1)/6 + 1 +109*jspin+36*nmes+nqlep+11 + else + index=max0(i-1,j-1)**2+i+max0(i-j,0)+9*(k-7)+91 + 1 +109*jspin+36*nmes+nqlep+11 + endif + return +c mesons +100 continue + ifl1=0 + ifl2=isign(j,id) + ifl3=isign(k,-id) + index=j+k*(k-1)/2+36*jspin+nqlep + index=index+11 + return +c quarks, leptons, etc +200 continue + ifl1=0 + ifl2=0 + ifl3=0 + jspin=0 + index=idabs + if(idabs.lt.20) return +c define index=20 for ks, index=21 for kl + index=idabs+1 + if(id.eq.20) index=20 +c index=nqlep+1,...,nqlep+11 for w+, higgs, z0 + if(idabs.lt.80) return + index=nqlep+idabs-79 + return +300 ifl1=isign(i,id) + ifl2=isign(j,id) + ifl3=0 + jspin=0 + index=0 + return + 400 index=-1 + return + end + +c----------------------------------------------------------------------- + subroutine idqufl(n,id,nqu,nqd,nqs) +c unpacks the ident code of particle (n) and give the number of +c quarks of each flavour(only u,d,s) +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + integer jc(nflav,2),ic(2) + + nqu=0 + nqd=0 + nqs=0 + if(iabs(id).ge.7.and.iabs(id).lt.100.and.iabs(id).ne.20)return + if(iabs(id)/10.eq.11.or.iabs(id)/10.eq.22)return + if(iabs(id).eq.20)then + if(iorptl(n).gt.0)then + if(idptl(iorptl(n)).gt.0)then + nqd=1 + nqs=-1 + else + nqd=-1 + nqs=1 + endif + else + if(ish.ge.4)write(ifch,*)'Cannot count the number of quark' + endif + return + endif + if(id.ne.0.and.mod(id,100).eq.0.and.id.le.10**8) goto 300 + if(id/10**8.ne.7)then + call idtr4(id,ic) + call iddeco(ic,jc) + else + call idtrb(ibptl(1,n),ibptl(2,n),ibptl(3,n),ibptl(4,n),jc) + endif + nqu=jc(1,1)-jc(1,2) + nqd=jc(2,1)-jc(2,2) + nqs=jc(3,1)-jc(3,2) + return + 300 i=iabs(id)/1000 + j=mod(iabs(id)/100,10) + ifl1=isign(i,id) + ifl2=isign(j,id) + if(iabs(ifl1).eq.1)nqu=isign(1,ifl1) + if(iabs(ifl1).eq.2)nqd=isign(1,ifl1) + if(iabs(ifl1).eq.3)nqs=isign(1,ifl1) + if(iabs(ifl2).eq.1)nqu=nqu+isign(1,ifl2) + if(iabs(ifl2).eq.2)nqd=nqd+isign(1,ifl2) + if(iabs(ifl2).eq.3)nqs=nqs+isign(1,ifl2) +c write(ifch,*)'id',id,ifl1,ifl2,nqu,nqd,nqs + return + end + +c----------------------------------------------------------------------- + function idlabl(id) +c returns the character*8 label for the particle id +c----------------------------------------------------------------------- + parameter ( nqlep=41,nmes=2) +c + character*8 idlabl + character*8 llep,lmes0,lmes1,lbar0,labar0,lbar1,labar1 + character*8 lqq,laqq + dimension llep(104) + dimension lmes0(64),lmes1(64) + dimension lbar0(109),labar0(109),lbar1(109),labar1(109) + dimension lqq(21),laqq(21) +c diquark labels + data lqq/ + 1'uu0. ','ud0. ','dd0. ','us0. ','ds0. ','ss0. ','uc0. ','dc0. ', + 2'sc0. ','cc0. ','ub0. ','db0. ','sb0. ','cb0. ','bb0. ','ut0. ', + 3'dt0. ','st0. ','ct0. ','bt0. ','tt0. '/ + data laqq/ + 1'auu0.','aud0.','add0.','aus0.','ads0.','ass0.','auc0.','adc0.', + 2'asc0.','acc0.','aub0.','adb0.','asb0.','acb0.','abb0.','aut0.', + 3'adt0.','ast0.','act0.','abt0.','att0.'/ +c quark and lepton labels + data llep/ + *' ','up ','ub ','dn ','db ','st ','sb ','ch ', + *'cb ','bt ','bb ','tp ','tb ','y ','yb ','x ', + *'xb ','gl ','err ','gm ','err ','nue ','anue ','e- ', + *'e+ ','num ','anum ','mu- ','mu+ ','nut ','anut ','tau- ', + *'tau+ ','deut ','adeut','trit ','atrit','alph ','aalph','ks ', + *'err ','err ','kl ', + *'upss ','ubss ','dnss ','dbss ','stss ','sbss ','chss ','cbss ', + *'btss ','bbss ','tpss ','tbss ','err ','err ','err ','err ', + *'glss ','err ','hdiba','err ','ness ','aness','e-ss ','e+ss ', + *'nmss ','anmss','mu-ss','mu+ss','ntss ','antss','t-ss ','t+ss ', + *'err ','err ','err ','err ','w+ss ','w-ss ','z0ss ','err ', + *'w+ ','w- ','h0 ','ah0 ','H0 ','aH0 ','A0 ','aA0 ', + *'H+ ','H- ','Zp0 ','aZp0 ','Zpp0 ','aZpp0','Wp+ ','Wp- ', + *'err ','err ','err ','err ','z0 '/ +c 0- meson labels + data lmes0/ + 1'pi0 ','pi+ ','eta ','pi- ','k+ ','k0 ','etap ','ak0 ', + 2'k- ','ad0 ','d- ','f- ','etac ','f+ ','d+ ','d0 ', + 2'ub. ','db. ','sb. ','cb. ','bb. ','bc. ','bs. ','bd. ', + 3'bu. ','ut. ','dt. ','st. ','ct. ','bt. ','tt. ','tb. ', + 4'tc. ','ts. ','td. ','tu. ','uy. ','dy. ','sy. ','cy. ', + 5'by. ','ty. ','yy. ','yt. ','yb. ','yc. ','ys. ','yd. ', + 6'yu. ','ux. ','dx. ','sx. ','cx. ','bx. ','tx. ','yx. ', + 7'xx. ','xy. ','xt. ','xb. ','xc. ','xs. ','xd. ','xu. '/ +c 1- meson labels + data lmes1/ + 1'rho0 ','rho+ ','omeg ','rho- ','k*+ ','k*0 ','phi ','ak*0 ', + 2'k*- ','ad*0 ','d*- ','f*- ','jpsi ','f*+ ','d*+ ','d*0 ', + 3'ub* ','db* ','sb* ','cb* ','upsl ','bc* ','bs* ','bd* ', + 4'bu* ','ut* ','dt* ','st* ','ct* ','bt* ','tt* ','tb* ', + 5'tc* ','ts* ','td* ','tu* ','uy* ','dy* ','sy* ','cy* ', + 6'by* ','ty* ','yy* ','yt* ','yb* ','yc* ','ys* ','yd* ', + 7'yu* ','ux* ','dx* ','sx* ','cx* ','bx* ','tx* ','yx* ', + 8'xx* ','xy* ','xt* ','xb* ','xc* ','xs* ','xd* ','xu* '/ +c 1/2+ baryon labels + data lbar0/ + 1'err ','p ','n ','err ','err ','s+ ','s0 ','s- ', + 2'l ','xi0 ','xi- ','err ','err ','err ','sc++ ','sc+ ', + 3'sc0 ','lc+ ','usc. ','dsc. ','ssc. ','sdc. ','suc. ','ucc. ', + 4'dcc. ','scc. ','err ','err ','err ','err ','uub. ','udb. ', + 5'ddb. ','dub. ','usb. ','dsb. ','ssb. ','sdb. ','sub. ','ucb. ', + 6'dcb. ','scb. ','ccb. ','csb. ','cdb. ','cub. ','ubb. ','dbb. ', + 7'sbb. ','cbb. ','err ','err ','err ','err ','err ','utt. ', + 8'udt. ','ddt. ','dut. ','ust. ','dst. ','sst. ','sdt. ','sut. ', + 9'uct. ','dct. ','sct. ','cct. ','cst. ','cdt. ','cut. ','ubt. ', + 1'dbt. ','sbt. ','cbt. ','bbt. ','bct. ','bst. ','bdt. ','but. ', + 2'utt. ','dtt. ','stt. ','ctt. ','btt. ','err ','err ','err ', + 3'err ','err ','err ','uuy. ','udy. ','ddy. ','duy. ','usy. ', + 4'dsy. ','ssy. ','sdy. ','suy. ','uux. ','udx. ','ddx. ','dux. ', + 5'usx. ','dsx. ','ssx. ','sdx. ','sux. '/ + data labar0/ + 1'err ','ap ','an ','err ','err ','as- ','as0 ','as+ ', + 2'al ','axi0 ','axi+ ','err ','err ','err ','asc--','asc- ', + 3'asc0 ','alc- ','ausc.','adsc.','assc.','asdc.','asuc.','aucc.', + 4'adcc.','ascc.','err ','err ','err ','err ','auub.','audb.', + 5'addb.','adub.','ausb.','adsb.','assb.','asdb.','asub.','aucb.', + 6'adcb.','ascb.','accb.','acsb.','acdb.','acub.','aubb.','adbb.', + 7'asbb.','acbb.','err ','err ','err ','err ','err ','autt.', + 8'audt.','addt.','adut.','aust.','adst.','asst.','asdt.','asut.', + 9'auct.','adct.','asct.','acct.','acst.','acdt.','acut.','aubt.', + 1'adbt.','asbt.','acbt.','abbt.','abct.','abst.','abdt.','abut.', + 2'autt.','adtt.','astt.','actt.','abtt.','err ','err ','err ', + 3'err ','err ','err ','auuy.','audy.','addy.','aduy.','ausy.', + 4'adsy.','assy.','asdy.','asuy.','auux.','audx.','addx.','adux.', + 5'ausx.','adsx.','assx.','asdx.','asux.'/ +c 3/2+ baryon labels + data lbar1/ + 1'dl++ ','dl+ ','dl0 ','dl- ','err ','s*+ ','s*0 ','s*- ', + 2'err ','xi*0 ','xi*- ','om- ','err ','err ','uuc* ','udc* ', + 3'ddc* ','err ','usc* ','dsc* ','ssc* ','err ','err ','ucc* ', + 4'dcc* ','scc* ','ccc* ','err ','err ','err ','uub* ','udb* ', + 5'ddb* ','err ','usb* ','dsb* ','ssb* ','err ','err ','ucb* ', + 6'dcb* ','scb* ','ccb* ','err ','err ','err ','ubb* ','dbb* ', + 7'sbb* ','cbb* ','bbb* ','err ','err ','err ','err ','utt* ', + 8'udt* ','ddt* ','err ','ust* ','dst* ','sst* ','err ','err ', + 9'uct* ','dct* ','sct* ','cct* ','err ','err ','err ','ubt* ', + 1'dbt* ','sbt* ','cbt* ','bbt* ','err ','err ','err ','err ', + 2'utt* ','dtt* ','stt* ','ctt* ','btt* ','ttt* ','err ','err ', + 3'err ','err ','err ','uuy* ','udy* ','ddy* ','err ','usy* ', + 4'dsy* ','ssy* ','err ','err ','uux* ','udx* ','ddx* ','err ', + 5'usx* ','dsx* ','ssx* ','err ','err '/ + data labar1/ + 1'adl--','adl- ','adl0 ','adl+ ','err ','as*- ','as*0 ','as*+ ', + 2'err ','axi*0','axi*+','aom+ ','err ','err ','auuc*','audc*', + 3'addc*','err ','ausc*','adsc*','assc*','err ','err ','aucc*', + 4'adcc*','ascc*','accc*','err ','err ','err ','auub*','audb*', + 5'addb*','err ','ausb*','adsb*','assb*','err ','err ','aucb*', + 6'adcb*','ascb*','accb*','err ','err ','err ','aubb*','adbb*', + 7'asbb*','acbb*','abbb*','err ','err ','err ','err ','autt*', + 8'audt*','addt*','err ','aust*','adst*','asst*','err ','err ', + 9'auct*','adct*','asct*','acct*','err ','err ','err ','aubt*', + 1'adbt*','asbt*','acbt*','abbt*','err ','err ','err ','err ', + 2'autt*','adtt*','astt*','actt*','abtt*','attt*','err ','err ', + 3'err ','err ','err ','auuy*','audy*','addy*','err ','ausy*', + 4'adsy*','assy*','err ','err ','auux*','audx*','addx*','err ', + 5'ausx*','adsx*','assx*','err ','err '/ +c entry + call idflav(id,ifl1,ifl2,ifl3,jspin,ind) + if(iabs(id).lt.100) goto200 + if(iabs(id).lt.1000) goto100 + if(id.ne.0.and.mod(id,100).eq.0) goto300 +c baryons + ind=ind-109*jspin-36*nmes-nqlep + ind=ind-11 + if(jspin.eq.0.and.id.gt.0) idlabl=lbar0(ind) + if(jspin.eq.0.and.id.lt.0) idlabl=labar0(ind) + if(jspin.eq.1.and.id.gt.0) idlabl=lbar1(ind) + if(jspin.eq.1.and.id.lt.0) idlabl=labar1(ind) + return +c mesons +100 continue + i=max0(ifl2,ifl3) + j=-min0(ifl2,ifl3) + ind=max0(i-1,j-1)**2+i+max0(i-j,0) + if(jspin.eq.0) idlabl=lmes0(ind) + if(jspin.eq.1) idlabl=lmes1(ind) + return +c quarks, leptons, etc. +200 continue + ind=2*ind + if(id.le.0) ind=ind+1 + idlabl=llep(ind) + return +300 i=iabs(ifl1) + j=iabs(ifl2) + ind=i+j*(j-1)/2 + if(id.gt.0) idlabl=lqq(ind) + if(id.lt.0) idlabl=laqq(ind) + return + end + +c----------------------------------------------------------------------- + subroutine idmass(idi,amass) +c returns the mass of the particle with ident code id. +c (deuteron, triton and alpha mass come from Gheisha ???) +c----------------------------------------------------------------------- + dimension ammes0(15),ammes1(15),ambar0(30),ambar1(30) + dimension amlep(52) + parameter ( nqlep=41,nmes=2) +c-c data amlep/.3,.3,.5,1.6,4.9,30.,-1.,-1.,0.,0., + data amlep/.005,.009,.180,1.6,4.9,170.,-1.,-1.,0.,0.,0. + * ,.5109989e-3,0.,.105658,0.,1.777,1.87656,2.8167,3.755,.49767 + * ,.49767,100.3,100.3,100.5,101.6,104.9,130.,2*-1.,100.,0., + * 100.,100.005,100.,100.1,100.,101.8,2*-1.,100.,100., + * 11*0./ +c 0- meson mass table + data ammes0/.1349766,.13957018,.547853 !pi0,pi+-,eta + * ,.493677,.497614,.95778 !K+-, K0,eta' + * ,1.86483,1.86960,1.96847,2.9803 !D0,D+-,Ds,etac + 1 ,5.27917,5.27950,5.3663,6.277,9.390/ !B+-,B0,Bs,Bc,etab +c 1- meson mass table + data ammes1/.77549,.77549,.78265 !rho0,rho+-,omega + * ,.889166,.89594,1.019455 !K*+-,K0*,phi + 1 ,2.00693,2.01022,2.1123,3.096916 !D0*,D*+-,D*s,j/psi + * ,5.3251,5.3251,5.4154,6.610,9.46030/ !B*+-,B0*,B*s,B*c,upsilon +c 1/2+ baryon mass table + data ambar0/-1.,.93828,.93957,2*-1.,1.1894,1.1925,1.1974 + 1 ,1.1156,1.3149,1.3213,3*-1. + $ ,2.453 !15 sigma_c++! + $ ,2.454 ! sigma_c+ + $ ,2.452 ! sigma_c0 + $ ,2.286 ! lambda_c+ + 2 ,2.576 !19 1340 !Xi'_c+ + $ ,2.578 !20 2340 !Xi'_c0 + $ ,2.695 !21 3340 !omegac0 + $ ,2.471 !22 3240 !Xi_c0 + $ ,2.468 !23 3140 !Xi_c+ + $ ,3.55 !24 1440 + $ ,3.55 !25 2440 + $ ,3.70 !26 3440 + $ ,4*-1./ +c 3/2+ baryon mass table + data ambar1/1.232,1.232,1.232,1.232,-1.,1.3823,1.3820 + 1 ,1.3875,-1.,1.5318,1.5350,1.6722,2*-1. + 2 ,2.519 !15 sigma_c++ + $ ,2.52 ! sigma_c+ + $ ,2.517 ! sigma_c0 + $ ,-1. + $ ,2.645 + $ ,2.644 + $ ,2.80 + $ ,2*-1. + $ ,3.75 + $ ,3.75 + 3 ,3.90 + $ ,4.80 + $ ,3*-1./ +c entry + id=idi + amass=0. +ctp060829 if(iabs(id).eq.30)then +ctp060829 amass=amhdibar +ctp060829 return +ctp060829 endif + if(idi.eq.0)then + id=1120 !for air target + elseif(abs(idi).ge.1000000000)then + goto 500 !nucleus + endif + if(idi.gt.10000)return + call idflav(id,ifl1,ifl2,ifl3,jspin,ind) + if(id.ne.0.and.mod(id,100).eq.0) goto400 + if(iabs(ifl1).ge.5.or.iabs(ifl2).ge.5.or.iabs(ifl3).ge.5) + 1 goto300 + if(ifl2.eq.0) goto200 + if(ifl1.eq.0) goto100 +c baryons + ind=ind-109*jspin-36*nmes-nqlep + ind=ind-11 + amass=(1-jspin)*ambar0(ind)+jspin*ambar1(ind) + return +c mesons +100 continue + ind=ind-36*jspin-nqlep + ind=ind-11 + amass=(1-jspin)*ammes0(ind)+jspin*ammes1(ind) + return +c quarks and leptons (+deuteron, triton, alpha, Ks and Kl) +200 continue + amass=amlep(ind) + return +c b and t particles +300 continue + amass=amlep(iabs(ifl2))+amlep(iabs(ifl3))+1.07+.045*jspin + if(ifl1.ne.0) amass=amass+amlep(iabs(ifl1)) + return +c diquarks +400 amass=amlep(iabs(ifl1))+amlep(iabs(ifl2)) + return +c nuclei +500 nbrpro=mod(abs(id/10000),1000) + nbrneu=mod(abs(id/10),1000)-nbrpro + amass=nbrpro*ambar0(2)+nbrneu*ambar0(3) + return + end + +cc----------------------------------------------------------------------- +c subroutine idmix(ic,jspin,icm,idm) +cc accounts for flavour mixing +cc----------------------------------------------------------------------- +c parameter (nflav=6) +c real pmix1(3,2),pmix2(3,2) +c integer ic(2),icm(2) +c data pmix1/.25,.25,.5,0.,.5,1./,pmix2/.5,.5,1.,0.,0.,1./ +c icm(1)=0 +c icm(2)=0 +c idm=0 +c i=ic(1) +c if(i.ne.ic(2))return +c id=0 +c if(i.eq.100000)id=1 +c if(i.eq. 10000)id=2 +c if(i.eq. 1000)id=3 +c if(id.eq.0)return +c rnd=rangen() +c idm=int(pmix1(id,jspin+1)+rnd)+int(pmix2(id,jspin+1)+rnd)+1 +c icm(1)=10**(nflav-idm) +c icm(2)=ic(1) +c idm=idm*100+idm*10+jspin +c return +c end +c +cc----------------------------------------------------------------------- +c subroutine idcleanjc(jc) +cc----------------------------------------------------------------------- +c parameter (nflav=6) +c integer jc(nflav,2) +c ns=0 +c do n=1,nflav +c jj=min(jc(n,1),jc(n,2)) +c jc(n,1)=jc(n,1)-jj +c jc(n,2)=jc(n,2)-jj +c ns=ns+jc(n,1)+jc(n,2) +c enddo +c if(ns.eq.0)then +c jc(1,1)=1 +c jc(1,2)=1 +c endif +c end +c +c----------------------------------------------------------------------- + subroutine idquacjc(jc,nqu,naq) +c returns quark content of jc +c jc(nflav,2) = jc-type particle identification code. +c nqu = # quarks +c naq = # antiquarks +c----------------------------------------------------------------------- + parameter (nflav=6) + integer jc(nflav,2) + nqu=0 + naq=0 + do 53 n=1,nflav + nqu=nqu+jc(n,1) +53 naq=naq+jc(n,2) + return + end + +c----------------------------------------------------------------------- + subroutine idquacic(ic,nqu,naq) +c returns quark content of ic +c ic(2) = ic-type particle identification code. +c nqu = # quarks +c naq = # antiquarks +c----------------------------------------------------------------------- + parameter (nflav=6) + integer jc(nflav,2),ic(2) + nqu=0 + naq=0 + call iddeco(ic,jc) + do 53 n=1,nflav + nqu=nqu+jc(n,1) +53 naq=naq+jc(n,2) + return + end + +c----------------------------------------------------------------------- + subroutine idquac(i,nq,ns,na,jc) +c returns quark content of ptl i from /cptl/ . +c nq = # quarks - # antiquarks +c ns = # strange quarks - # strange antiquarks +c na = # quarks + # antiquarks +c jc(nflav,2) = jc-type particle identification code. +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + integer jc(nflav,2),ic(2) + + + if(iabs(idptl(i)).eq.20)then + idptl(i)=230 + if(rangen().lt..5)idptl(i)=-230 + goto9999 + endif + + if(iabs(idptl(i)).lt.100)then + nq=0 + ns=0 + do 1 n=1,nflav + jc(n,1)=0 +1 jc(n,2)=0 + return + endif +9999 if(idptl(i)/10**8.ne.7)then + call idtr4(idptl(i),ic) + call iddeco(ic,jc) + else + call idtrb(ibptl(1,i),ibptl(2,i),ibptl(3,i),ibptl(4,i),jc) + endif + na=0 + nq=0 + do 53 n=1,nflav + na=na+jc(n,1)+jc(n,2) +53 nq=nq+jc(n,1)-jc(n,2) + ns= jc(3,1)-jc(3,2) + return + end + +cc----------------------------------------------------------------------- +c subroutine idquad(i,nq,na,jc) +cc----------------------------------------------------------------------- +cc returns quark content of ptl i from /cptl/ . +cc nq = # quarks - # antiquarks +cc na = # quarks + # antiquarks +cc jc(nflav,2) = jc-type particle identification code. +cc----------------------------------------------------------------------- +c include 'epos.inc' +c integer jc(nflav,2),ic(2) +c +c id=idptl(i) +c if(iabs(id).eq.20)then +c id=230 +c if(rangen().lt..5)id=-230 +c goto9999 +c endif +c +c if(iabs(id).lt.100)then +c nq=0 +cc ns=0 +c do 1 n=1,nflav +c jc(n,1)=0 +c1 jc(n,2)=0 +c return +c endif +c +c9999 if(id/10**8.ne.7)then +c call idtr4(id,ic) +c call iddeco(ic,jc) +c else +c call idtrb(ibptl(1,i),ibptl(2,i),ibptl(3,i),ibptl(4,i),jc) +c endif +c na=0 +c nq=0 +c do 53 n=1,nflav +c na=na+jc(n,1)+jc(n,2) +c53 nq=nq+jc(n,1)-jc(n,2) +cc ns= jc(3,1)-jc(3,2) +c return +c end +c +c----------------------------------------------------------------------- + integer function idraflx(proba,xxx,qqs,icl,jc,jcval,j,iso,c) +c----------------------------------------------------------------------- +c returns random flavor, according to jc and GRV structure function +c for x(=xxx) and Q2(=qqs) for valence quark (jcval) and sea quarks +c and update jc with quark-antiquark cancellation +c jc : quark content of remnant +c j=1 quark, j=2 antiquark, +c iso : isospin +c proba : probability of the selected quark (output) +c c : "v" is to choose a valence quark, "s" a sea or valence quark +c----------------------------------------------------------------------- + include 'epos.inc' + integer jc(nflav,2),jcval(nflav,2) + double precision s,puv,pdv,psv,pcv,pus,pds,pss,pcs,piso,proba + character c*1 + + if(ish.ge.8)then + write(ifch,10)c,j,xxx,qqs,jc,jcval + endif + 10 format('entry idraflx, j,x,q: ',a1,i2,2g13.5,/ + & ,15x,'jc :',2(1x,6i2),/,14x,'jcv :',2(1x,6i2)) + + puv=dble(jcval(1,j)) + pdv=dble(jcval(2,j)) + psv=dble(jcval(3,j)) + pcv=dble(jcval(4,j)) + if(c.eq."v")then + pus=0d0 + pds=0d0 + pss=0d0 + pcs=0d0 + else + pus=dble(jc(1,j))-puv + pds=dble(jc(2,j))-pdv + pss=dble(jc(3,j))-psv + pcs=dble(jc(4,j))-pcv + endif + + if(ish.ge.8)then + write(ifch,'(a,4f6.3)')'idraflx valence:',puv,pdv,psv,pcv + write(ifch,'(a,4f6.3)')'idraflx sea:',pus,pds,pss,pcs + endif + + qq=0. + if(iso.gt.0)then + if(icl.eq.2)puv=puv*0.5d0 !because GRV already take into account the fact that there is 2 u quark in a proton + puv=puv*dble(psdfh4(xxx,qqs,qq,icl,1)) + pus=pus*dble(psdfh4(xxx,qqs,qq,icl,-1)) + pdv=pdv*dble(psdfh4(xxx,qqs,qq,icl,2)) + pds=pds*dble(psdfh4(xxx,qqs,qq,icl,-2)) + elseif(iso.lt.0)then + puv=puv*dble(psdfh4(xxx,qqs,qq,icl,2)) + pus=pus*dble(psdfh4(xxx,qqs,qq,icl,-2)) + if(icl.eq.2)pdv=pdv*0.5d0 + pdv=pdv*dble(psdfh4(xxx,qqs,qq,icl,1)) + pds=pds*dble(psdfh4(xxx,qqs,qq,icl,-1)) + else + piso=(dble(psdfh4(xxx,qqs,qq,icl,1)) + & +dble(psdfh4(xxx,qqs,qq,icl,2))) + if(icl.eq.2)then !3 quarks + piso=piso/3d0 + else !2 quarks + piso=piso/2d0 + endif + puv=puv*piso + pdv=pdv*piso + piso=0.5d0*(dble(psdfh4(xxx,qqs,qq,icl,-1)) + & +dble(psdfh4(xxx,qqs,qq,icl,-2))) + pus=pus*piso + pds=pds*piso + endif + psv=psv*dble(psdfh4(xxx,qqs,qq,icl,3)) + pss=pss*dble(psdfh4(xxx,qqs,qq,icl,-3)) + if(nrflav.ge.4)then + pcv=pcv*dble(psdfh4(xxx,qqs,qq,icl,4)) + pcs=pcs*dble(psdfh4(xxx,qqs,qq,icl,-4)) + else + pcv=0d0 + pcs=0d0 + endif + + if(ish.ge.8)then + write(ifch,'(a,4f6.3)')'idraflx P(valence):',puv,pdv,psv,pcv + write(ifch,'(a,4f6.3)')'idraflx P(sea):',pus,pds,pss,pcs + endif + + s=puv+pdv+psv+pcv+pus+pds+pss+pcs + if(s.gt.0.)then + r=rangen()*s + if(r.gt.(pdv+pus+pds+pss+psv+pcv+pcs).and.puv.gt.0.)then + i=1 + jcval(i,j)=jcval(i,j)-1 + proba=puv + elseif(r.gt.(pus+pds+pss+psv+pcv+pcs).and.pdv.gt.0.)then + i=2 + jcval(i,j)=jcval(i,j)-1 + proba=pdv + elseif(r.gt.(pds+pss+psv+pcv+pcs).and.pus.gt.0.)then + i=1 + proba=pus + elseif(r.gt.(pss+psv+pcv+pcs).and.pds.gt.0.)then + i=2 + proba=pds + elseif(r.gt.(psv+pcv+pcs).and.pss.gt.0.)then + i=3 + proba=pss + elseif(r.gt.(pcv+pcs).and.psv.gt.0.)then + i=3 + jcval(i,j)=jcval(i,j)-1 + proba=psv + elseif(r.gt.pcs.and.pcv.gt.0.)then + i=4 + jcval(i,j)=jcval(i,j)-1 + proba=pcv + elseif(pcs.gt.0.)then + i=4 + proba=pcs + else + call utstop("Problem in idraflx, should not be !&") + endif + else + i=idrafl(icl,jc,j,"v",0,iretso) !no update of jc here + if(jc(i,j)-jcval(i,j).lt.1)jcval(i,j)=jcval(i,j)-1 + proba=0d0 + endif + idraflx=i + + if(ish.ge.8)then + write(ifch,'(a,2(1x,6i2))')'jc before updating:',jc + write(ifch,20)i,j,jcval,proba + endif + 20 format('i,j|jcval|P:',2i3,' |',2(1x,6i2),' |',g15.3) + + call idsufl3(i,j,jc) + + if(ish.ge.8) + & write(ifch,'(a,2(1x,6i2))')'jc after updating:',jc + + return + end + +c----------------------------------------------------------------------- + integer function idrafl(icl,jc,j,c,imod,iretso) +c----------------------------------------------------------------------- +c returns random flavor, +c if : c='v' : according to jc +c c='s' : from sea +c c='r' : from sea (always without c quarks) +c c='d' : from sea for second quark in diquark +c c='c' : take out c quark first +c jc : quark content of remnant +c j=1 quark, j=2 antiquark, +c imod=0 : returns random flavor of a quark +c imod=1 : returns random flavor of a quark and update jc +c (with quark-antiquark cancellation) +c imod=2 : returns random flavor of a quark and update jc +c (without quark-antiquak cancellation -> accumulate quark) +c imod=3 : returns random flavor of a quark and update jc with +c the corresponding quark-antiquark pair +c (without quark-antiquak cancellation -> accumulate quark) +c +c iretso=0 : ok +c =1 : more than 9 quarks of same flavor attempted +c----------------------------------------------------------------------- + include 'epos.inc' + integer jc(nflav,2),ic(2) + character c*1 + +c write(ifch,*)'entry idrafl, j,imod,c: ',j,imod,' ',c + + pui=1. + if(c.eq.'s')then + pu=pui + pd=pui*exp(-pi*difud/fkappa) + ps=pui*exp(-pi*difus/fkappa) + pc=pui*exp(-pi*difuc/fkappa) + pu=rstrau(icl)*pu + pd=rstrad(icl)*pd + ps=rstras(icl)*ps + pc=rstrac(icl)*pc + elseif(c.eq.'d')then + pu=pui*exp(-pi*difuuu/fkappa) + pd=pui*exp(-pi*difudd/fkappa) + ps=pui*exp(-pi*difuss/fkappa) + pc=pui*exp(-pi*difucc/fkappa) + pu=pu*rstrau(icl) + pd=pd*rstrad(icl) + ps=ps*rstras(icl) + pc=pc*rstrac(icl) + elseif(c.eq.'v')then + pu=float(jc(1,j)) + pd=float(jc(2,j)) + ps=float(jc(3,j)) + pc=float(jc(4,j)) + elseif(c.eq.'r')then + pu=1. + pd=1. + ps=1. + pc=0. + pu=rstrau(icl)*pu + pd=rstrad(icl)*pd + ps=rstras(icl)*ps + elseif(c.eq.'c')then + pu=0. + pd=0. + ps=0. + pc=1. + else + stop'idrafl: dunnowhatodo' + endif + +c write(ifch,*)'idrafl',pu,pd,ps + + s=pu+pd+ps+pc + if(s.gt.0.)then + r=rangen()*s + if(r.gt.(pu+pd+ps).and.pc.gt.0d0)then + i=4 + elseif(r.gt.(pu+pd).and.ps.gt.0d0)then + i=3 + elseif(r.gt.pu.and.pd.gt.0d0)then + i=2 + else + i=1 + endif + elseif(iremn.le.1.or.c.ne.'v')then + i=1+min(2,int((2.+rstras(icl))*rangen())) + else + idrafl=0 + return + endif + idrafl=i + +c write(ifch,*)'jc before updating',jc +c write(ifch,*)'i,j,jc',i,j,jc + + if(imod.eq.1)then + if(iLHC.eq.0.and.iremn.eq.2)then + call idsufl3(i,j,jc) +c be sure that jc is not empty + if(jc(i,j).eq.0)then + call idenco(jc,ic,iret) + if(iret.eq.0.and.ic(1).eq.0.and.ic(2).eq.0)then + jc(i,j)=jc(i,j)+1 + jc(i,3-j)=jc(i,3-j)+1 + iretso=1 + endif + endif + elseif(iremn.ge.2)then + call idsufl3(i,j,jc) + else + call idsufl(i,j,jc,iretso) + if(iretso.ne.0.and.ish.ge.2)then + call utmsg('idrafl') + write(ifmt,*)'iret none 0 in idrafl',iretso + write(ifch,*)'iret none 0 in idrafl',iretso + call utmsgf + endif + endif + elseif(imod.eq.2)then + call idsufl2(i,j,jc) !do not cancel antiquarks with quarks + elseif(imod.eq.3)then + call idsufl2(i,1,jc) !do not cancel antiquarks with quarks + call idsufl2(i,2,jc) !do not cancel antiquarks with quarks + endif + + +c write(ifch,*)'jc after updating',jc + + return + end + + +c----------------------------------------------------------------------- + integer function idraflz(jc,j) +c----------------------------------------------------------------------- + include 'epos.inc' + integer jc(nflav,2) + + pu=float(jc(1,j)) + pd=float(jc(2,j)) + ps=float(jc(3,j)) + pc=float(jc(4,j)) + + s=pu+pd+ps+pc + if(s.gt.0.)then + r=rangen()*s + if(r.gt.(pu+pd+ps).and.pc.gt.0d0)then + i=4 + elseif(r.gt.(pu+pd).and.ps.gt.0d0)then + i=3 + elseif(r.gt.pu.and.pd.gt.0d0)then + i=2 + else + i=1 + endif + else + stop'in idraflz (1) ' + endif + idraflz=i + + if(jc(i,j).lt.1)stop'in idraflz (2) ' + jc(i,j)=jc(i,j)-1 + + end + +c----------------------------------------------------------------------- + subroutine idsufl(i,j,jc,iretso) +c----------------------------------------------------------------------- +c subtract flavor i, j=1 quark, j=2 antiquark +c add antiflavor if jc(i,j)=0 +c iretso=0 ok +c =1 : more than 9 quarks of same flavor attempted +c----------------------------------------------------------------------- + integer jc(6,2),ic(2) + + if(jc(i,j).gt.0)then + jc(i,j)=jc(i,j)-1 + call idenco(jc,ic,iret) + if(ic(1).eq.0.and.ic(2).eq.0)then + jc(i,j)=jc(i,j)+1 + if(jc(i,3-j).lt.9.and.iret.eq.0)then + jc(i,3-j)=jc(i,3-j)+1 + else + iretso=1 + endif + endif + else + if(j.eq.1)then + if(jc(i,2).lt.9)then + jc(i,2)=jc(i,2)+1 + else + iretso=1 + endif + else + if(jc(i,1).lt.9)then + jc(i,1)=jc(i,1)+1 + else + iretso=1 + endif + endif + endif + + return + end + +c----------------------------------------------------------------------- + subroutine idsufl2(i,j,jc) +c----------------------------------------------------------------------- +c substract flavor i, by adding antiquark i, j=1 quark, j=2 antiquark +c Can replace idsufl if we don't want to cancel quarks and antiquarks +c +c Warning : No protection against jc(i,j)>9 ! should not encode jc without test +c +c----------------------------------------------------------------------- + parameter(nflav=6) + integer jc(nflav,2) + + jc(i,3-j)=jc(i,3-j)+1 + + return + end + +c----------------------------------------------------------------------- + subroutine idsufl3(i,j,jc) +c----------------------------------------------------------------------- +c subtract flavor i, j=1 quark, j=2 antiquark +c add antiflavor if jc(i,j)=0 +c +c Warning : No protection against jc(i,j)>9 ! should not encode jc without test +c +c----------------------------------------------------------------------- + parameter(nflav=6) + integer jc(nflav,2) + + if(jc(i,j).gt.0)then + jc(i,j)=jc(i,j)-1 + else + jc(i,3-j)=jc(i,3-j)+1 + endif + + return + end + +cc----------------------------------------------------------------------- +c subroutine idchfl(jc1,jc2,iret) +cc----------------------------------------------------------------------- +cc checks whether jc1 and jc2 have the same number of quarks and antiquarks +cc if yes: iret=0, if no: iret=1 +cc----------------------------------------------------------------------- +c integer jc1(6,2),jc2(6,2) +c +c iret=0 +c +c do j=1,2 +c n1=0 +c n2=0 +c do i=1,6 +c n1=n1+jc1(i,j) +c n2=n2+jc2(i,j) +c enddo +c if(n1.ne.n2)then +c iret=1 +c return +c endif +c enddo +c +c end +c +c +c----------------------------------------------------------------------- + subroutine idres(idi,am,idr,iadj) +c returns resonance id idr corresponding to mass am. +c performs mass adjustment, if necessary (if so iadj=1, 0 else) +c (only for mesons and baryons, error (stop) otherwise) +c----------------------------------------------------------------------- + include 'epos.inc' + parameter (mxindx=1000,mxre=100,mxma=11,mxmx=6) + common/crema/indx(mxindx),rema(mxre,mxma),rewi(mxre,mxma) + *,idmx(mxma,mxmx),icre1(mxre,mxma),icre2(mxre,mxma) + character cad*10 + + write(cad,'(i10)')idi + iadj=0 + idr=0 + if(abs(idi).lt.20)then + idr=idi + return + endif + if(abs(am).lt.1.e-5)am=1e-5 + id=idi + ami=am + if(am.lt.0.)then + call idmass(id,am) + iadj=1 + if(am.le.0.)then + write(ifch,*)'***** warning in idres (0): ' + *,'neg mass returned from idmass' + write(ifch,*)'id,am(input):',idi,ami + am=1e-5 + endif + endif + + if(id.eq.0)goto 9999 + if(abs(id).eq.20)id=sign(230,idi) + m1=1 + if(iabs(id).ge.1000)m1=3 + m2=2 + if(iabs(id).ge.1000)m2=mxmx + do 3 k=m1,m2 + do 3 m=2,mxma + if(iabs(id).eq.idmx(m,k)) then + id=idmx(1,k)*10*id/iabs(id) + goto 43 + endif + 3 continue + 43 continue + ix=iabs(id)/10 + if(ix.lt.1.or.ix.gt.mxindx)then + call utstop('idres: ix out of range. id='//cad//'&') + endif + i=indx(ix) + if(i.lt.1.or.i.gt.mxre)then + write(ifch,*)'idres problem',id,am + call utstop('idres: particle not in table&') + endif + do 1 j=1,mxma-1 + if(am.ge.rema(i,j).and.am.le.rema(i,j+1))then + if(j-1.gt.9)call utstop('idres: spin > 9&') + idr=id/10*10+(j-1)*id/iabs(id) + goto 2 + endif +1 continue + goto 9999 +2 continue + + do 4 k=1,mxmx + if(ix.eq.idmx(1,k))then + if(j.lt.1.or.j.gt.mxma-1) + *call utstop('idres: index j out of range&') + if(idmx(j+1,k).ne.0)idr=idmx(j+1,k)*id/iabs(id) + endif +4 continue + + iy=mod(iabs(idr),10) + if(iy.gt.maxres)then + iadj=0 + idr=0 + goto 9999 + endif + + if(iy.ne.0.and.iy.ne.1)goto 9999 + + call idmass(idr,am) + if(am.lt.0.)then + write(ifch,*)'***** error in idres: ' + *,'neg mass returned from idmass' + write(ifch,*)'id,am(input):',idi,ami + write(ifch,*)'idr,am:',idr,am + call utstop('idres: neg mass returned from idmass&') + endif + del=max(1.e-3,2.*rewi(i,j)) + if(abs(ami-am).gt.del)iadj=1 +c write(ifch,*)'res:',id,idr,ami,am,rewi(i,j),iadj + +9999 if(.not.(ish.ge.8))return + write(ifch,*)'return from idres. id,ami,am,idr,iadj:' + write(ifch,*)idi,ami,am,idr,iadj + return + end + +c----------------------------------------------------------------------- + subroutine idresi +c----------------------------------------------------------------------- +c initializes /crema/ +c masses are limit between stable state (so the average between 2 mass states) +c width=hbar(6.582e-25 GeV.s)/tau for 151, 251, 351, 451 arbitrary +c (no data found) !!!!!!!!!!! +c----------------------------------------------------------------------- + + parameter (mxindx=1000,mxre=100,mxma=11,mxmx=6) + common/crema/indx(mxindx),rema(mxre,mxma),rewi(mxre,mxma) + *,idmx(mxma,mxmx),icre1(mxre,mxma),icre2(mxre,mxma) + parameter (n=35) + dimension remai(n,mxma),rewii(n,mxma),idmxi(mxma,mxmx) + *,icrei(n,2*mxma) + + data (idmxi(j,1),j=1,mxma)/ 11, 110, 111, 0, 0, 0, 0, 4*0/ + data (idmxi(j,2),j=1,mxma)/ 22, 220, 330, 331, 0, 0, 0, 4*0/ + data (idmxi(j,3),j=1,mxma)/123,2130,1230,1231,1233,1234,1235, 4*0/ + data (idmxi(j,4),j=1,mxma)/124,2140,1240,1241, 0, 0, 0, 4*0/ + data (idmxi(j,5),j=1,mxma)/134,3140,1340,1341, 0, 0, 0, 4*0/ + data (idmxi(j,6),j=1,mxma)/234,3240,2340,2341, 0, 0, 0, 4*0/ + + data ((icrei(k,m),m=1,2*mxma),k=1,10)/ + *111,000000, 9*300000, 11*0, + *222,000000, 9*030000, 11*0, + *112, 10*210000, 11*0, + *122, 10*120000, 11*0, + *113, 10*201000, 11*0, + *223, 10*021000, 11*0, + *123, 10*111000, 11*0, + *133, 10*102000, 11*0, + *233, 10*012000, 11*0, + *333,000000, 9*003000, 11*0/ + data ((icrei(k,m),m=1,2*mxma),k=11,20)/ + *114, 10*200100, 11*0, + *124, 10*110100, 11*0, + *224, 10*020100, 11*0, + *134, 10*101100, 11*0, + *234, 10*011100, 11*0, + *334, 10*002100, 11*0, + *144, 10*100200, 11*0, + *244, 10*010200, 11*0, + *344, 10*001200, 11*0, + *444,000000, 9*000300, 11*0/ + data ((icrei(k,m),m=1,2*mxma),k=21,29)/ + * 11, 10*100000, 0, 10*100000, + * 22, 10*001000, 0, 10*001000, + * 12, 10*100000, 0, 10*010000, + * 13, 10*100000, 0, 10*001000, + * 23, 10*010000, 0, 10*001000, + * 14, 10*100000, 0, 10*000100, + * 24, 10*010000, 0, 10*000100, + * 34, 10*001000, 0, 10*000100, + * 44, 10*000100, 0, 10*000100/ + data ((icrei(k,m),m=1,2*mxma),k=30,35)/ + * 15, 10*100000, 0, 10*000010, + * 25, 10*010000, 0, 10*000010, + * 35, 10*001000, 0, 10*000010, + * 45, 10*000100, 0, 10*000010, + * 55, 10*000010, 0, 10*000010, + * 3, 10*222000, 0, 10*000010/ + + data ((remai(k,m),m=1,mxma),k=1,10)/ + *111.,0.000,1.425,1.660,1.825,2.000,0.000,0.000,0.000,0.000,0.000, + *222.,0.000,1.425,1.660,1.825,2.000,0.000,0.000,0.000,0.000,0.000, + *112.,1.080,1.315,1.485,1.575,1.645,1.685,1.705,1.825,2.000,0.000, + *122.,1.080,1.315,1.485,1.575,1.645,1.685,1.705,1.825,2.000,0.000, + *113.,1.300,1.500,1.700,1.850,2.000,0.000,0.000,0.000,0.000,0.000, + *223.,1.300,1.500,1.700,1.850,2.000,0.000,0.000,0.000,0.000,0.000, + *123.,1.117,1.300,1.395,1.465,1.540,1.655,1.710,1.800,1.885,2.000, +c *123.,1.154,1.288,1.395,1.463,1.560,1.630,1.710,1.800,1.885,2.000, + *133.,1.423,2.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + *233.,1.428,2.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, +c *133.,1.423,1.638,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, +c *233.,1.427,1.634,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + *333.,0.000,2.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000/ + data ((remai(k,m),m=1,mxma),k=11,20)/ + *114.,2.530,2.730,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + *124.,2.345,2.530,2.730,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + *224.,2.530,2.730,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + *134.,2.450,2.600,2.800,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + *234.,2.450,2.600,2.800,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + *334.,2.700,2.900,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + *144.,3.650,3.850,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + *244.,3.650,3.850,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + *344.,3.800,4.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + *444.,0.000,5.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000/ + data ((remai(k,m),m=1,mxma),k=21,29)/ + * 11.,0.450,0.950,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + * 22.,0.750,0.965,1.500,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + * 12.,0.450,0.950,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + * 13.,0.500,1.075,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + * 23.,0.500,1.075,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + * 14.,1.900,2.250,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + * 24.,1.900,2.250,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + * 34.,2.050,2.500,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + * 44.,3.037,3.158,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000/ + data ((remai(k,m),m=1,mxma),k=30,35)/ + * 15.,5.300,5.400,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + * 25.,5.300,5.400,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + * 35.,5.396,5.500,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + * 45.,6.450,7.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + * 55.,9.660,9.999,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000, + * 3.,2.230,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000,0.000/ + + data ((rewii(k,m),m=1,mxma),k=1,5)/ + *111.,0.000e+00,0.115e+00,0.140e+00,0.250e+00,0.250e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + *222.,0.000e+00,0.115e+00,0.140e+00,0.250e+00,0.250e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + *112.,0.000e+00,0.115e+00,0.200e+00,0.140e+00,0.140e+00, + * 0.145e+00,0.250e+00,0.140e+00,0.250e+00,0.000e+00, + *122.,7.451e-28,0.115e+00,0.200e+00,0.140e+00,0.140e+00, + * 0.145e+00,0.250e+00,0.140e+00,0.250e+00,0.000e+00, + *113.,0.824e-14,0.036e+00,0.080e+00,0.100e+00,0.170e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00/ + data ((rewii(k,m),m=1,mxma),k=6,10)/ + *223.,0.445e-14,0.039e+00,0.080e+00,0.100e+00,0.170e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + *123.,0.250e-14,0.890e-05,0.036e+00,0.040e+00,0.016e+00, + * 0.090e+00,0.080e+00,0.100e+00,0.145e+00,0.170e+00, + *133.,0.227e-14,0.009e+00,0.000e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + *233.,0.400e-14,0.010e+00,0.000e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + *333.,0.000e+00,0.800e-14,0.000e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00/ + data ((rewii(k,m),m=1,mxma),k=11,15)/ + *114.,0.400e-11,0.010e+00,0.000e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + *124.,0.400e-11,0.400e-11,0.010e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + *224.,0.400e-11,0.010e+00,0.010e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + *134.,0.150e-11,0.400e-11,0.010e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + *234.,0.150e-11,0.400e-11,0.010e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00/ + data ((rewii(k,m),m=1,mxma),k=16,20)/ + *334.,0.400e-11,0.010e+00,0.010e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + *144.,0.400e-11,0.010e+00,0.010e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + *244.,0.400e-11,0.010e+00,0.010e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + *344.,0.400e-11,0.010e+00,0.010e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + *444.,0.400e-11,0.010e+00,0.010e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00/ + data ((rewii(k,m),m=1,mxma),k=21,25)/ + * 11.,7.849e-09,0.153e+00,0.057e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + * 22.,0.130e-05,0.210e-03,0.034e+00,0.004e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + * 12.,2.524e-17,0.153e+00,0.057e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + * 13.,5.307e-17,0.051e+00,0.000e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + * 23.,0.197e-02,0.051e+00,0.000e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00/ + data ((rewii(k,m),m=1,mxma),k=26,29)/ + * 14.,0.154e-11,0.002e+00,0.000e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + * 24.,0.615e-12,0.002e+00,0.000e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + * 34.,0.133e-11,0.002e+00,0.000e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + * 44.,0.010e+00,0.068e-03,0.000e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00/ + data ((rewii(k,m),m=1,mxma),k=30,35)/ + * 15.,0.402e-12,0.010e+00,0.000e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + * 25.,0.430e-12,0.010e+00,0.000e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + * 35.,0.448e-12,0.010e+00,0.000e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + * 45.,0.143e-13,0.010e+00,0.000e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + * 55.,0.525e-04,0.010e+00,0.000e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + * 3.,0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00, + * 0.000e+00,0.000e+00,0.000e+00,0.000e+00,0.000e+00/ + + do 3 i=1,mxindx +3 indx(i)=0 + do 4 k=1,mxre + do 4 m=1,mxma +4 rema(k,m)=0 + + do 2 j=1,mxma + do 2 i=1,mxmx +2 idmx(j,i)=idmxi(j,i) + + ntec=n + if(ntec.gt.mxre)call utstop('idresi: dimension mxre too small&') + do 1 k=1,n + ix=nint(remai(k,1)) + ix2=nint(rewii(k,1)) + ix3=icrei(k,1) + if(ix.ne.ix2)call utstop('idresi: ix /= ix2&') + if(ix.ne.ix3)call utstop('idresi: ix /= ix3&') + if(ix.lt.1.or.ix.gt.mxindx) + *call utstop('idresi: ix out of range.&') + indx(ix)=k + rema(k,1)=0. + rewi(k,1)=0. + icre1(k,1)=0 + icre2(k,1)=0 + do 1 m=2,mxma + rema(k,m)=remai(k,m) + rewi(k,m)=rewii(k,m) + icre1(k,m)=icrei(k,m) +1 icre2(k,m)=icrei(k,mxma+m) + + indx(33) =indx(22) + indx(213)=indx(123) + indx(214)=indx(124) + indx(314)=indx(134) + indx(324)=indx(234) + + return + end + +cc----------------------------------------------------------------------- +c integer function idsgl(ic,gen,cmp) +cc returns 1 for singlets (qqq or qqbar) 0 else. +cc----------------------------------------------------------------------- +c parameter (nflav=6) +c integer ic(2),jcx(nflav,2),icx(2) +c character gen*6,cmp*6 +c idsgl=0 +c if(cmp.eq.'cmp-ys')then +c call idcomi(ic,icx) +c else +c icx(1)=ic(1) +c icx(2)=ic(2) +c endif +c call iddeco(icx,jcx) +c nq=0 +c na=0 +c do 1 i=1,nflav +c nq=nq+jcx(i,1) +c1 na=na+jcx(i,2) +c if(nq.eq.0.and.na.eq.0)return +c if(gen.eq.'gen-no')then +c if(nq.eq.3.and.na.eq.0.or.nq.eq.1.and.na.eq.1 +c *.or.nq.eq.0.and.na.eq.3)idsgl=1 +c elseif(gen.eq.'gen-ys')then +c if(mod(nq-na,3).eq.0)idsgl=1 +c endif +c return +c end +c +c----------------------------------------------------------------------- + subroutine idtau(id,p4,p5,taugm) +c returns lifetime(c*tau(fm))*gamma for id with energy p4, mass p5 +c----------------------------------------------------------------------- + include 'epos.inc' + parameter (mxindx=1000,mxre=100,mxma=11,mxmx=6) + common/crema/indx(mxindx),rema(mxre,mxma),rewi(mxre,mxma) + *,idmx(mxma,mxmx),icre1(mxre,mxma),icre2(mxre,mxma) + if(iabs(id).eq.14)then + wi=.197/658.654e15 + elseif(iabs(id).eq.16)then + wi=.197/87.11e9 + elseif(id.eq.-20)then + wi=.197/15.34e15 + elseif(id.eq.20)then + wi=.197/2.6842e13 + elseif((iabs(id).lt.100.and.id.ne.20) + * .or.id.gt.1e9)then + wi=0 + elseif(iabs(id).lt.1e8)then + ix=iabs(id)/10 + if(ix.lt.1.or.ix.gt.mxindx)then + write(ifch,*)'id:',id + call utstop('idtau: ix out of range.&') + endif + ii=indx(ix) + jj=mod(iabs(id),10)+2 + + m1=1 + if(iabs(id).ge.1000)m1=3 + m2=2 + if(iabs(id).ge.1000)m2=mxmx + do 75 imx=m1,m2 + do 75 ima=2,mxma + if(iabs(id).eq.idmx(ima,imx))then + jj=ima + goto 75 + endif +75 continue + if(ii.lt.1.or.ii.gt.mxre.or.jj.lt.1.or.jj.gt.mxma)then + write(ifch,*)'id,ii,jj:',id,' ',ii,jj + call utstop('idtau: ii or jj out of range&') + endif + wi=rewi(ii,jj) + else + tauz=taunll +c-c tauz=amin1(9./p5**2,tauz) +c-c tauz=amax1(.2,tauz) + wi=.197/tauz + endif + if(wi.eq.0.)then + tau=ainfin + else + tau=.197/wi + endif + if(p5.ne.0.)then + gm=p4/p5 + else + gm=ainfin + endif + if(tau.ge.ainfin.or.gm.ge.ainfin)then + taugm=ainfin + else + taugm=tau*gm + endif + return + end + +c----------------------------------------------------------------------- + subroutine idtr4(id,ic) +c transforms generalized paige_id -> werner_id (for < 4 flv) +c----------------------------------------------------------------------- + include 'epos.inc' + parameter (mxindx=1000,mxre=100,mxma=11,mxmx=6) + common/crema/indx(mxindx),rema(mxre,mxma),rewi(mxre,mxma) + * ,idmx(mxma,mxmx),icre1(mxre,mxma),icre2(mxre,mxma) + integer ic(2) + + ic(1)=000000 + ic(2)=000000 + if(mod(abs(id),100).eq.99)return !not a particle + if(iabs(id).lt.20)then + if(id.eq.1)then + ic(1)=100000 + ic(2)=000000 + elseif(id.eq.-1)then + ic(1)=000000 + ic(2)=100000 + elseif(id.eq.2)then + ic(1)=010000 + ic(2)=000000 + elseif(id.eq.-2)then + ic(1)=000000 + ic(2)=010000 + elseif(id.eq.3)then + ic(1)=001000 + ic(2)=000000 + elseif(id.eq.-3)then + ic(1)=000000 + ic(2)=001000 + elseif(id.eq.4)then + ic(1)=000100 + ic(2)=000000 + elseif(id.eq.-4)then + ic(1)=000000 + ic(2)=000100 + elseif(id.eq.5)then + ic(1)=000010 + ic(2)=000000 + elseif(id.eq.-5)then + ic(1)=000000 + ic(2)=000010 + elseif(id.eq.17)then + ic(1)=330000 + ic(2)=000000 + elseif(id.eq.-17)then + ic(1)=000000 + ic(2)=330000 + elseif(id.eq.18)then + ic(1)=450000 + ic(2)=000000 + elseif(id.eq.-18)then + ic(1)=000000 + ic(2)=450000 + elseif(id.eq.19)then + ic(1)=660000 + ic(2)=000000 + elseif(id.eq.-19)then + ic(1)=000000 + ic(2)=660000 + endif + return + endif + if(id.eq.30)then + ic(1)=222000 + ic(2)=000000 + return + endif + if(iabs(id).lt.1e8)then + ix=iabs(id)/10 + if(ix.lt.1.or.ix.gt.mxindx)goto9999 + ii=indx(ix) + if(ii.eq.0)goto9998 + jj=mod(iabs(id),10)+2 + do 27 imx=1,mxmx + do 27 ima=2,mxma + if(iabs(id).eq.idmx(ima,imx))jj=ima + 27 continue + if(id.gt.0)then + ic(1)=icre1(ii,jj) + ic(2)=icre2(ii,jj) + else + ic(2)=icre1(ii,jj) + ic(1)=icre2(ii,jj) + endif + if(ic(1).eq.100000.and.ic(2).eq.100000.and.rangen().lt.0.5) + $ then + ic(1)=010000 + ic(2)=010000 + endif + elseif(mod(id/10**8,10).eq.8)then + ic(1)=mod(id,10**8)/10000*100 + ic(2)=mod(id,10**4)*100 + elseif(id/10**9.eq.1.and.mod(id,10).eq.0)then !nuclei + nstr=mod(id,10**8)/10000000 + npro=mod(id,10**7)/10000 + nneu=mod(id,10**4)/10 + ic(1)=(2*npro+nneu)*10**5+(2*nneu+npro)*10**4+nstr*10**3 + ic(2)=0 + else + write(ifch,*)'***** id: ',id + call utstop('idtr4: unrecognized id&') + endif + return + + 9998 continue + write(ifch,*)'id: ',id + call utstop('idtr4: indx=0.&') + + 9999 continue + write(ifch,*)'id: ',id + call utstop('idtr4: ix out of range.&') + end + +c----------------------------------------------------------------------- + integer function idtra(ic,ier,ires,imix) +c----------------------------------------------------------------------- +c tranforms from werner-id to paige-id +c ier .... error message (1) or not (0) in case of problem +c ires ... dummy variable, not used any more !!!! +c imix ... 1 not supported any more +c 2 010000 010000 -> 110, 001000 000100 -> 110 +c 3 010000 010000 -> 110, 001000 000100 -> 220 +c----------------------------------------------------------------------- + include 'epos.inc' + parameter (nidt=54) + integer idt(3,nidt),ic(2)!,icm(2) + data idt/ + * 100000,100000, 110 ,100000,010000, 120 ,010000,010000, 220 + *,100000,001000, 130 ,010000,001000, 230 ,001000,001000, 330 + *,100000,000100, 140 ,010000,000100, 240 ,001000,000100, 340 + *,000100,000100, 440 + *,100000,000010, 150 ,010000,000010, 250 ,001000,000010, 350 + *,000100,000010, 450 ,000010,000010, 550 ,100000,000000, 1 + *,010000,000000, 2 ,001000,000000, 3 ,000100,000000, 4 + *,000010,000000, 5 + *,200000,000000,1100 ,110000,000000,1200 ,020000,000000,2200 + *,101000,000000,1300 ,011000,000000,2300 ,002000,000000,3300 + *,100100,000000,1400 ,010100,000000,2400 ,001100,000000,3400 + *,000200,000000,4400 + *,330000,000000, 17 ,450000,000000, 18 ,660000,000000, 19 + *,300000,000000,1111 ,210000,000000,1120 ,120000,000000,1220 + *,030000,000000,2221 ,201000,000000,1130 ,111000,000000,1230 + *,000001,000000, 6 + *,021000,000000,2230 ,102000,000000,1330 ,012000,000000,2330 + *,003000,000000,3331 ,200100,000000,1140 ,110100,000000,1240 + *,020100,000000,2240 ,101100,000000,1340 ,011100,000000,2340 + *,002100,000000,3340 + *,100200,000000,1440 ,010200,000000,2440 ,001200,000000,3440 + *,000300,000000,4441/ + + idtra=0 + if(ic(1).eq.0.and.ic(2).eq.0)return + i=1 + do while(i.le.nidt.and.idtra.eq.0) + if(ic(2).eq.idt(1,i).and.ic(1).eq.idt(2,i))idtra=-idt(3,i) + if(ic(1).eq.idt(1,i).and.ic(2).eq.idt(2,i))idtra=idt(3,i) + i=i+1 + enddo + isi=1 + if(idtra.ne.0)isi=idtra/iabs(idtra) + + jspin=0 + + if(imix.eq.1)stop'imix=1 no longer supported' + if(imix.eq.2)then + if(idtra.eq.220)idtra=110 + if(idtra.eq.330)idtra=110 + elseif(imix.eq.3)then + if(idtra.eq.220)idtra=110 + if(idtra.eq.330)idtra=220 + endif + + if(idtra.ne.0)idtra=idtra+jspin*isi + + if(idtra.ne.0)return + if(ier.ne.1)return + write(ifch,*)'idtra: ic = ',ic,ires + call utstop('idtra: unknown code&') + + entry idtrai(num,id,ier) + idtrai=0 + if(iabs(id).eq.20)then + j=5 + elseif(iabs(id).eq.110.or.iabs(id).eq.220)then + j=1+2*int(2.*rangen()) + else + j=0 + do i=1,nidt + if(iabs(id).eq.idt(3,i))then + j=i + goto 2 + endif + enddo + 2 continue + endif + if(j.ne.0)then + if(id.lt.0)then + idtrai=idt(3-num,j) + else + idtrai=idt(num,j) + endif + return + endif + if(ier.ne.1)return + write(ifch,*)'idtrai: id = ',id + call utstop('idtrai: unknown code&') + end + +c----------------------------------------------------------------------- + subroutine idtrb(ib1,ib2,ib3,ib4,jc) +c id transformation ib -> jc +c----------------------------------------------------------------------- + parameter (nflav=6) + integer jc(nflav,2) + jc(1,1)=ib1/10**4 + jc(2,1)=ib2/10**4 + jc(3,1)=ib3/10**4 + jc(4,1)=ib4/10**4 + jc(5,1)=0 + jc(6,1)=0 + jc(1,2)=mod(ib1,10**4) + jc(2,2)=mod(ib2,10**4) + jc(3,2)=mod(ib3,10**4) + jc(4,2)=mod(ib4,10**4) + jc(5,2)=0 + jc(6,2)=0 + return + end + +c----------------------------------------------------------------------- + subroutine idtrbi(jc,ib1,ib2,ib3,ib4) +c id transformation jc -> ib +c----------------------------------------------------------------------- + include 'epos.inc' + integer jc(nflav,2) + ib1=jc(1,1)*10**4+jc(1,2) + ib2=jc(2,1)*10**4+jc(2,2) + ib3=jc(3,1)*10**4+jc(3,2) + ib4=jc(4,1)*10**4+jc(4,2) + ib5=jc(5,1)*10**4+jc(5,2) + ib6=jc(6,1)*10**4+jc(6,2) + if(ib5.ne.0.or.ib6.ne.0)then + write(ifch,*)'***** error in idtrbi: bottom or top quarks' + write(ifch,*)'jc:' + write(ifch,*)jc + call utstop('idtrbi: bottom or top quarks&') + endif + return + end + +c------------------------------------------------------------------------------ + integer function idtrafo(code1,code2,idi) +c------------------------------------------------------------------------------ +c.....tranforms id of code1 (=idi) into id of code2 (=idtrafo) +c.....supported codes: +c.....'nxs' = epos +c.....'pdg' = PDG 1996 +c.....'qgs' = QGSJet +c.....'ghe' = Gheisha +c.....'sib' = Sibyll +c.....'cor' = Corsika (GEANT) +c.....'flk' = Fluka + +C --- ighenex(I)=EPOS CODE CORRESPONDING TO GHEISHA CODE I --- + + common /ighnx/ ighenex(35) + data ighenex/ + $ 10, 11, -12, 12, -14, 14, 120, 110, + $ -120, 130, 20, -20, -130, 1120, -1120, 1220, + $ -1220, 2130, -2130, 1130, 1230, 2230, -1130, -1230, + $ -2230, 1330, 2330, -1330, -2330, 17, 18, 19, + $ 3331, -3331, 30/ + +C --- DATA STMTS. FOR GEANT/GHEISHA PARTICLE CODE CONVERSIONS --- +C --- KIPART(I)=GHEISHA CODE CORRESPONDING TO GEANT CODE I --- +C --- IKPART(I)=GEANT CODE CORRESPONDING TO GHEISHA CODE I --- + DIMENSION KIPART(48)!,IKPART(35) + DATA KIPART/ + $ 1, 3, 4, 2, 5, 6, 8, 7, + $ 9, 12, 10, 13, 16, 14, 15, 11, + $ 35, 18, 20, 21, 22, 26, 27, 33, + $ 17, 19, 23, 24, 25, 28, 29, 34, + $ 35, 35, 35, 35, 35, 35, 35, 35, + $ 35, 35, 35, 35, 30, 31, 32, 35/ + +c DATA IKPART/ +c $ 1, 4, 2, 3, 5, 6, 8, 7, +c $ 9, 11, 16, 10, 12, 14, 15, 13, +c $ 25, 18, 26, 19, 20, 21, 27, 28, +c $ 29, 22, 23, 30, 31, 45, 46, 47, +c $ 24, 32, 48/ + INTEGER ICFTABL(200),IFCTABL(-6:100) +C ICTABL CONVERTS CORSIKA PARTICLES INTO FLUKA PARTICLES +C FIRST TABLE ONLY IF CHARMED PARTICLES CAN BE TREATED + DATA ICFTABL/ + * 7, 4, 3, 0, 10, 11, 23, 13, 14, 12, ! 10 + * 15, 16, 8, 1, 2, 19, 0, 17, 21, 22, ! 20 + * 20, 34, 36, 38, 9, 18, 31, 32, 33, 34, ! 30 + * 37, 39, 24, 25, 6*0, + * 0, 0, 0, 0, -3, -4, -6, -5, 0, 0, ! 50 + * 10*0, + * 0, 0, 0, 0, 0, 5, 6, 27, 28, 0, ! 70 + * 10*0, + * 10*0, + * 10*0, !100 + * 10*0, + * 0, 0, 0, 0, 0, 47, 45, 46, 48, 49, !120 + * 50, 0, 0, 0, 0, 0, 0, 0, 0, 0, !130 + * 41, 42, 43, 44, 0, 0, 51, 52, 53, 0, !140 + * 0, 0, 54, 55, 56, 0, 0, 0, 57, 58, !150 + * 59, 0, 0, 0, 60, 61, 62, 0, 0, 0, !160 + * 40*0/ +C IFCTABL CONVERTS FLUKA PARTICLES INTO CORSIKA PARTICLES + DATA IFCTABL/ + * 402, 302, 301, 201, 0, 0, 0, + * 14, 15, 3, 2, 66, 67, 1, 13, 25, 5, + * 6, 10, 8, 9, 11, 12, 18, 26, 16, 21, + * 19, 20, 7, 33, 34, 0, 68, 69, 0, 0, + * 27, 28, 29, 22, 30, 23, 31, 24, 32, 0, + * 131, 132, 133, 134, 117, 118, 116, 119, 120, 121, + * 137, 138, 139, 143, 144, 145, 149, 150, 151, 155, + * 156, 157, 0, 0, 36*0/ +c------------------------------------------------------------------------------- + + character*3 code1,code2 + parameter (ncode=5,nidt=338) + integer idt(ncode,nidt) + double precision drangen,dummy + +c nxs|pdg|qgs|cor|sib + data ((idt(i,j),i=1,ncode),j= 1,68)/ + * 1,2,99,99,99 !u quark + * , 2,1,99,99,99 !d + * , 3,3,99,99,99 !s + * , 4,4,99,99,99 !c + * , 5,5,99,99,99 !b + * , 6,6,99,99,99 !t + * , 10,22,99,1,1 !gamma + * , 9 ,21,99,99,99 !gluon + * , 12,11,11,3,3 !e- + * , -12,-11,-11,2,2 !e+ + * , 11,12,99,66,15 !nu_e- + * , -11,-12,99,67,16 !nu_e+ + * , 14,13,99,6,5 !mu- + * , -14,-13,99,5,4 !mu+ + * , 13,14,99,68,17 !nu_mu- + * , -13,-14,99,69,18 !nu_mu+ + * , 16,15,99,132,19 !tau- + * , -16,-15,99,131,-19 !tau+ + * , 15,16,99,133,20 !nu_tau- + * , -15,-16,99,134,-20 !nu_tau+ + * , 110,111,0,7,6 !pi0 + * , 120,211,1,8,7 !pi+ + * , -120,-211,-1,9,8 !pi- + * , 220,221,10,17,23 !eta + * , 130,321,4,11,9 !k+ + * , -130,-321,-4,12,10 !k- + * , 230,311,5,33,21 !k0 + * , -230,-311,-5,34,22 !k0b + * , 20,310,5,16,12 !kshort + * , -20,130,-5,10,11 !klong + * , 330,331,99,99,24 !etaprime + * , 111,113,19,51,27 !rho0 + * , 121,213,99,52,25 !rho+ + * , -121,-213,99,53,26 !rho- + * , 221,223,99,50,32 !omega + * , 131,323,99,63,28 !k*+ + * , -131,-323,99,64,29 !k*- + * , 231,313,99,62,30 !k*0 + * , -231,-313,99,65,31 !k*0b + * , 331,333,99,99,33 !phi + * , -140,421,8,116,99 !D0(1.864) + * , 140,-421,8,119,99 !D0b(1.864) + * , -240,411,7,117,99 !D(1.869)+ + * , 240,-411,7,118,99 !Db(1.869)- + * , 1120,2212,2,14,13 !proton + * , 1220,2112,3,13,14 !neutron + * , 2130,3122,6,18,39 !lambda + * , 1130,3222,99,19,34 !sigma+ + * , 1230,3212,99,20,35 !sigma0 + * , 2230,3112,99,21,36 !sigma- + * , 1330,3322,99,22,37 !xi0 + * , 2330,3312,99,23,38 !xi- + * , 1111,2224,99,54,40 !delta++ + * , 1121,2214,99,55,41 !delta+ + * , 1221,2114,99,56,42 !delta0 + * , 2221,1114,99,57,43 !delta- + * , 1131,3224,99,99,44 !sigma*+ + * , 1231,3214,99,99,45 !sigma*0 + * , 2231,3114,99,99,46 !sigma*- + * , 1331, 3324,99,99,47 !xi*0 + * , 2331, 3314,99,99,48 !xi*- + * , 3331, 3334,99,24,49 !omega- + * , 2140, 4122,9,137,99 !LambdaC(2.285)+ + * ,17,1000010020,99,201,1002 ! Deuteron + * ,18,1000010030,99,301,1003 ! Triton + * ,19,1000020040,99,402,1004 ! Alpha + * ,0,0,99,0,0 ! Air + * ,99,99,99,99,99 / ! unknown + data ((idt(i,j),i=1,ncode),j= 69,89)/ + $ -340,431,99,120,99 ! Ds+ + $ ,340,-431,99,121,99 ! Ds- + $ ,-241,413,99,124,99 ! D*+ + $ ,241,-413,99,125,99 ! D*- + $ ,-141,423,99,123,99 ! D*0 + $ ,141,-423,99,126,99 ! D*0b + $ ,-341,433,99,127,99 ! Ds*+ + $ ,341,-433,99,128,99 ! Ds*- + $ ,440,441,99,122,99 ! etac + $ ,441,443,99,130,99 ! J/psi + $ ,2240,4112,99,142,99 ! sigmac0 + $ ,1240,4212,99,141,99 ! sigmac+ + $ ,1140,4222,99,140,99 ! sigmac++ + $ ,2241,4114,99,163,99 ! sigma*c0 + $ ,1241,4214,99,162,99 ! sigma*c+ + $ ,1141,4224,99,161,99 ! sigma*c++ + $ ,3240,4132,99,139,99 ! Xic0 + $ ,2340,4312,99,144,99 ! Xi'c0 + $ ,3140,4232,99,138,99 ! Xic+ + $ ,1340,4322,99,143,99 ! Xi'c+ + $ ,3340,4332,99,145,99 / ! omegac0 + data ((idt(i,j),i=1,ncode),j= 90,nidt)/ + $ 1112,32224,99,99,99 ! Delta(1600)++ + $ , 1112, 2222,99,99,99 ! Delta(1620)++ + $ , 1113,12224,99,99,99 ! Delta(1700)++ + $ , 1114,12222,99,99,99 ! Delta(1900)++ + $ , 1114, 2226,99,99,99 ! Delta(1905)++ + $ , 1114,22222,99,99,99 ! Delta(1910)++ + $ , 1114,22224,99,99,99 ! Delta(1920)++ + $ , 1114,12226,99,99,99 ! Delta(1930)++ + $ , 1114, 2228,99,99,99 ! Delta(1950)++ + $ , 2222,31114,99,99,99 ! Delta(1600)- + $ , 2222, 1112,99,99,99 ! Delta(1620)- + $ , 2223,11114,99,99,99 ! Delta(1700)- + $ , 2224,11112,99,99,99 ! Delta(1900)- + $ , 2224, 1116,99,99,99 ! Delta(1905)- + $ , 2224,21112,99,99,99 ! Delta(1910)- + $ ,2224,21114,99,99,99 ! Delta(1920)- + $ ,2224,11116,99,99,99 ! Delta(1930)- + $ ,2224, 1118,99,99,99 ! Delta(1950)- + $ ,1122,12212,99,99,99 ! N(1440)+ + $ ,1123, 2124,99,99,99 ! N(1520)+ + $ ,1123,22212,99,99,99 ! N(1535)+ + $ ,1124,32214,99,99,99 ! Delta(1600)+ + $ ,1124, 2122,99,99,99 ! Delta(1620)+ + $ ,1125,32212,99,99,99 ! N(1650)+ + $ ,1125, 2216,99,99,99 ! N(1675)+ + $ ,1125,12216,99,99,99 ! N(1680)+ + $ ,1126,12214,99,99,99 ! Delta(1700)+ + $ ,1127,22124,99,99,99 ! N(1700)+ + $ ,1127,42212,99,99,99 ! N(1710)+ + $ ,1127,32124,99,99,99 ! N(1720)+ + $ ,1128,12122,99,99,99 ! Delta(1900)+ + $ ,1128, 2126,99,99,99 ! Delta(1905)+ + $ ,1128,22122,99,99,99 ! Delta(1910)+ + $ ,1128,22214,99,99,99 ! Delta(1920)+ + $ ,1128,12126,99,99,99 ! Delta(1930)+ + $ ,1128, 2218,99,99,99 ! Delta(1950)+ + $ ,1222,12112,99,99,99 ! N(1440)0 + $ ,1223, 1214,99,99,99 ! N(1520)0 + $ ,1223,22112,99,99,99 ! N(1535)0 + $ ,1224,32114,99,99,99 ! Delta(1600)0 + $ ,1224, 1212,99,99,99 ! Delta(1620)0 + $ ,1225,32112,99,99,99 ! N(1650)0 + $ ,1225, 2116,99,99,99 ! N(1675)0 + $ ,1225,12116,99,99,99 ! N(1680)0 + $ ,1226,12114,99,99,99 ! Delta(1700)0 + $ ,1227,21214,99,99,99 ! N(1700)0 + $ ,1227,42112,99,99,99 ! N(1710)0 + $ ,1227,31214,99,99,99 ! N(1720)0 + $ ,1228,11212,99,99,99 ! Delta(1900)0 + $ ,1228, 1216,99,99,99 ! Delta(1905)0 + $ ,1228,21212,99,99,99 ! Delta(1910)0 + $ ,1228,22114,99,99,99 ! Delta(1920)0 + $ ,1228,11216,99,99,99 ! Delta(1930)0 + $ ,1228, 2118,99,99,99 ! Delta(1950)0 + $ ,1233,13122,99,99,99 ! Lambda(1405)0 + $ ,1234, 3124,99,99,99 ! Lambda(1520)0 + $ ,1235,23122,99,99,99 ! Lambda(1600)0 + $ ,1235,33122,99,99,99 ! Lambda(1670)0 + $ ,1235,13124,99,99,99 ! Lambda(1690)0 + $ ,1236,13212,99,99,99 ! Sigma(1660)0 + $ ,1236,13214,99,99,99 ! Sigma(1670)0 + $ ,1237,23212,99,99,99 ! Sigma(1750)0 + $ ,1237, 3216,99,99,99 ! Sigma(1775)0 + $ ,1238,43122,99,99,99 ! Lambda(1800)0 + $ ,1238,53122,99,99,99 ! Lambda(1810)0 + $ ,1238, 3126,99,99,99 ! Lambda(1820)0 + $ ,1238,13126,99,99,99 ! Lambda(1830)0 + $ ,1238,23124,99,99,99 ! Lambda(1890)0 + $ ,1239,13216,99,99,99 ! Sigma(1915)0 + $ ,1239,23214,99,99,99 ! Sigma(1940)0 + $ ,1132,13222,99,99,99 ! Sigma(1660)+ + $ ,1132,13224,99,99,99 ! Sigma(1670)+ + $ ,1133,23222,99,99,99 ! Sigma(1750)+ + $ ,1133,3226,99,99,99 ! Sigma(1775)+ + $ ,1134,13226,99,99,99 ! Sigma(1915)+ + $ ,1134,23224,99,99,99 ! Sigma(1940)+ + $ ,2232,13112,99,99,99 ! Sigma(1660)- + $ ,2232,13114,99,99,99 ! Sigma(1670)- + $ ,2233,23112,99,99,99 ! Sigma(1750)- + $ ,2233,3116,99,99,99 ! Sigma(1775)- + $ ,2234,13116,99,99,99 ! Sigma(1915)- + $ ,2234,23114,99,99,99 ! Sigma(1940)- + $ ,5,7,99,99,99 ! quark b' + $ ,6,8,99,99,99 ! quark t' + $ ,16,17,99,99,99 ! lepton tau' + $ ,15,18,99,99,99 ! lepton nu' tau + $ ,90,23,99,99,99 ! Z0 + $ ,80,24,99,99,99 ! W+ + $ ,81,25,99,99,99 ! h0 + $ ,85,32,99,99,99 ! Z'0 + $ ,86,33,99,99,99 ! Z''0 + $ ,87,34,99,99,99 ! W'+ + $ ,82,35,99,99,99 ! H0 + $ ,83,36,99,99,99 ! A0 + $ ,84,37,99,99,99 ! H+ + $ ,1200,2101,99,99,99 ! diquark ud_0 + $ ,2300,3101,99,99,99 ! diquark sd_0 + $ ,1300,3201,99,99,99 ! diquark su_0 + $ ,2400,4101,99,99,99 ! diquark cd_0 + $ ,1400,4201,99,99,99 ! diquark cu_0 + $ ,3400,4301,99,99,99 ! diquark cs_0 + $ ,2500,5101,99,99,99 ! diquark bd_0 + $ ,1500,5201,99,99,99 ! diquark bu_0 + $ ,3500,5301,99,99,99 ! diquark bs_0 + $ ,4500,5401,99,99,99 ! diquark bc_0 + $ ,2200,1103,99,99,99 ! diquark dd_1 + $ ,1200,2103,99,99,99 ! diquark ud_1 + $ ,1100,2203,99,99,99 ! diquark uu_1 + $ ,2300,3103,99,99,99 ! diquark sd_1 + $ ,1300,3203,99,99,99 ! diquark su_1 + $ ,3300,3303,99,99,99 ! diquark ss_1 + $ ,2400,4103,99,99,99 ! diquark cd_1 + $ ,1400,4203,99,99,99 ! diquark cu_1 + $ ,3400,4303,99,99,99 ! diquark cs_1 + $ ,4400,4403,99,99,99 ! diquark cc_1 + $ ,2500,5103,99,99,99 ! diquark bd_1 + $ ,1500,5203,99,99,99 ! diquark bu_1 + $ ,3500,5303,99,99,99 ! diquark bs_1 + $ ,4500,5403,99,99,99 ! diquark bc_1 + $ ,5500,5503,99,99,99 ! diquark bb_1 + $ ,800000091,91,99,99,99 ! parton system in cluster fragmentation (pythia) + $ ,800000092,92,99,99,99 ! parton system in string fragmentation (pythia) + $ ,800000093,93,99,99,99 ! parton system in independent system (pythia) + $ ,800000094,94,99,99,99 ! CMshower (pythia) + $ ,250,511,99,99,99 ! B0 + $ ,150,521,99,99,99 ! B+ + $ ,350,531,99,99,99 ! B0s+ + $ ,450,541,99,99,99 ! Bc+ + $ ,251,513,99,99,99 ! B*0 + $ ,151,523,99,99,99 ! B*+ + $ ,351,533,99,99,99 ! B*0s+ + $ ,451,543,99,99,99 ! B*c+ + $ ,550,551,99,99,99 ! etab + $ ,551,553,99,99,99 ! Upsilon + $ ,2341,4314,99,99,99 ! Xi*c0 + $ ,1341,4324,99,99,99 ! Xi*c+ + $ ,3341,4334,99,99,99 ! omega*c0 + $ ,2440,4412,99,99,99 ! dcc + $ ,2441,4414,99,99,99 ! dcc* + $ ,1440,4422,99,99,99 ! ucc + $ ,1441,4424,99,99,99 ! ucc* + $ ,3440,4432,99,99,99 ! scc + $ ,3441,4434,99,99,99 ! scc* + $ ,4441,4444,99,99,99 ! ccc* + $ ,2250,5112,99,99,99 ! sigmab- + $ ,2150,5122,99,99,99 ! lambdab0 + $ ,3250,5132,99,99,99 ! sdb + $ ,4250,5142,99,99,99 ! cdb + $ ,1250,5212,99,99,99 ! sigmab0 + $ ,1150,5222,99,99,99 ! sigmab+ + $ ,3150,5232,99,99,99 ! sub + $ ,4150,5242,99,99,99 ! cub + $ ,2350,5312,99,99,99 ! dsb + $ ,1350,5322,99,99,99 ! usb + $ ,3350,5332,99,99,99 ! ssb + $ ,4350,5342,99,99,99 ! csb + $ ,2450,5412,99,99,99 ! dcb + $ ,1450,5422,99,99,99 ! ucb + $ ,3450,5432,99,99,99 ! scb + $ ,4450,5442,99,99,99 ! ccb + $ ,2550,5512,99,99,99 ! dbb + $ ,1550,5522,99,99,99 ! ubb + $ ,3550,5532,99,99,99 ! sbb + $ ,3550,5542,99,99,99 ! scb + $ ,2251,5114,99,99,99 ! sigma*b- + $ ,1251,5214,99,99,99 ! sigma*b0 + $ ,1151,5224,99,99,99 ! sigma*b+ + $ ,2351,5314,99,99,99 ! dsb* + $ ,1351,5324,99,99,99 ! usb* + $ ,3351,5334,99,99,99 ! ssb* + $ ,2451,5414,99,99,99 ! dcb* + $ ,1451,5424,99,99,99 ! ucb* + $ ,3451,5434,99,99,99 ! scb* + $ ,4451,5444,99,99,99 ! ccb* + $ ,2551,5514,99,99,99 ! dbb* + $ ,1551,5524,99,99,99 ! ubb* + $ ,3551,5534,99,99,99 ! sbb* + $ ,4551,5544,99,99,99 ! cbb* + $ ,5551,5554,99,99,99 ! bbb* + $ ,123,10213,99,99,99 ! b1 + $ ,122,10211,99,99,99 ! a0+ + $ ,233,10313,99,99,99 ! K0_1 + $ ,232,10311,99,99,99 ! K*0_1 + $ ,133,10323,99,99,99 ! K+_1 + $ ,132,10321,99,99,99 ! K*+_1 + $ ,143,10423,99,99,99 ! D0_1 + $ ,132,10421,99,99,99 ! D*0_1 + $ ,243,10413,99,99,99 ! D+_1 + $ ,242,10411,99,99,99 ! D*+_1 + $ ,343,10433,99,99,99 ! D+s_1 + $ ,342,10431,99,99,99 ! D*0s+_1 + $ ,223,10113,99,99,99 ! b_10 + $ ,222,10111,99,99,99 ! a_00 + $ ,113,10223,99,99,99 ! h_10 + $ ,112,10221,99,99,99 ! f_00 + $ ,333,10333,99,99,99 ! h'_10 + $ ,332,10331,99,99,99 ! f'_00 + $ ,443,10443,99,99,99 ! h_1c0 + $ ,442,10441,99,99,99 ! Xi_0c0 + $ ,444,10443,99,99,99 ! psi' + $ ,253,10513,99,99,99 ! db_10 + $ ,252,10511,99,99,99 ! db*_00 + $ ,153,10523,99,99,99 ! ub_10 + $ ,152,10521,99,99,99 ! ub*_00 + $ ,353,10533,99,99,99 ! sb_10 + $ ,352,10531,99,99,99 ! sb*_00 + $ ,453,10543,99,99,99 ! cb_10 + $ ,452,10541,99,99,99 ! cb*_00 + $ ,553,10553,99,99,99 ! Upsilon' + $ ,552,10551,99,99,99 ! Upsilon'* + $ ,124,20213,99,99,99 ! a_1+ + $ ,125,215,99,99,99 ! a_2+ + $ ,234,20313,99,99,99 ! K*0_1 + $ ,235,315,99,99,99 ! K*0_2 + $ ,134,20323,99,99,99 ! K*+_1 + $ ,135,325,99,99,99 ! K*+_2 + $ ,144,20423,99,99,99 ! D*_10 + $ ,135,425,99,99,99 ! D*_20 + $ ,244,20413,99,99,99 ! D*_1+ + $ ,245,415,99,99,99 ! D*_2+ + $ ,344,20433,99,99,99 ! D*_1s+ + $ ,345,435,99,99,99 ! D*_2s+ + $ ,224,20113,99,99,99 ! a_10 + $ ,225,115,99,99,99 ! a_20 + $ ,114,20223,99,99,99 ! f_10 + $ ,115,225,99,99,99 ! f_20 + $ ,334,20333,99,99,99 ! f'_10 + $ ,335,335,99,99,99 ! f'_20 + $ ,444,20443,99,99,99 ! Xi_1c0 + $ ,445,445,99,99,99 ! Xi_2c0 + $ ,254,20513,99,99,99 ! db*_10 + $ ,255,515,99,99,99 ! db*_20 + $ ,154,20523,99,99,99 ! ub*_10 + $ ,155,525,99,99,99 ! ub*_20 + $ ,354,20533,99,99,99 ! sb*_10 + $ ,355,535,99,99,99 ! sb*_20 + $ ,454,20543,99,99,99 ! cb*_10 + $ ,455,545,99,99,99 ! cb*_20 + $ ,554,20553,99,99,99 ! bb*_10 + $ ,555,555,99,99,99 ! bb*_20 + $ ,11099,9900110,99,99,99 ! diff pi0 state + $ ,12099,9900210,99,99,99 ! diff pi+ state + $ ,22099,9900220,99,99,99 ! diff omega state + $ ,33099,9900330,99,99,99 ! diff phi state + $ ,44099,9900440,99,99,99 ! diff J/psi state + $ ,112099,9902210,99,99,99 ! diff proton state + $ ,122099,9902110,99,99,99 ! diff neutron state + $ ,800000110,110,99,99,99 ! Reggeon + $ ,800000990,990,99,99,99 / ! Pomeron + + +c print *,'idtrafo',' ',code1,' ',code2,idi + + nidtmx=68 + id1=idi + if(code1.eq.'nxs')then + i=1 + elseif(code1.eq.'pdg')then + i=2 + elseif(code1.eq.'qgs')then + i=3 + if(id1.eq.-10)id1=19 + elseif(code1.eq.'cor')then + i=4 + elseif(code1.eq.'sib')then + i=5 + elseif(code1.eq.'ghe')then + id1=ighenex(id1) + i=1 + elseif(code1.eq.'flk')then + id1=IFCTABL(id1) !convert to corsika code + i=4 + else + stop "unknown code in idtrafo" + endif + if(code2.eq.'nxs')then + j=1 + ji=j + if(i.eq.2.and.id1.gt.1000000000)then !nucleus from PDG + idtrafo=id1 + return + elseif(i.eq.4.and.id1.gt.402)then !nucleus from Corsika + idtrafo=1000000000+mod(id1,100)*10000+(id1/100)*10 + return + elseif(i.eq.5.and.id1.gt.1004)then !nucleus from Sibyll + id1=(id1-1000) + idtrafo=1000000000+id1/2*10000+id1*10 + return + elseif(id1.eq.130.and.i.eq.2)then + idtrafo=-20 + return + endif + if(i.eq.2) nidtmx=nidt + if(i.eq.4) nidtmx=89 + elseif(code2.eq.'pdg')then + j=2 + ji=j + if(i.eq.1.and.id1.gt.1000000000)then !nucleus from NEXUS + idtrafo=id1 + return + elseif(i.eq.4.and.id1.gt.402)then !nucleus from Corsika + idtrafo=1000000000+mod(id1,100)*10000+(id1/100)*10 + return + elseif(i.eq.5.and.id1.gt.1004)then !nucleus from Sibyll + id1=(id1-1000) + idtrafo=1000000000+id1/2*10000+id1*10 + return + elseif(id1.eq.-20.and.i.eq.1)then + idtrafo=130 + return + endif + if(i.eq.1) nidtmx=nidt + if(i.eq.4) nidtmx=89 + elseif(code2.eq.'qgs')then + j=3 + ji=j + elseif(code2.eq.'cor')then + j=4 + ji=j + elseif(code2.eq.'sib')then + j=5 + ji=j + elseif(code2.eq.'ghe')then + j=4 + ji=6 + elseif(code2.eq.'flk')then + j=4 + ji=7 + if(i.le.2) nidtmx=89 + else + stop "unknown code in idtrafo" + endif + if(i.eq.4)then !corsika id always >0 so convert antiparticles + iadtr=id1 + if(iadtr.eq.25)then + id1=-13 + elseif(iadtr.eq.15)then + id1=-14 + elseif(iadtr.ge.26.and.iadtr.le.32)then + id1=-iadtr+8 + elseif(iadtr.ge.58.and.iadtr.le.61)then + id1=-iadtr+4 + elseif(iadtr.ge.149.and.iadtr.le.157)then + id1=-iadtr+12 + elseif(iadtr.ge.171.and.iadtr.le.173)then + id1=-iadtr+10 + endif + endif + iad1=abs(id1) + isi=sign(1,id1) + + if(i.ne.j)then + do n=1,nidtmx + if(iad1.eq.abs(idt(i,n)))then + m=1 + if(n+m.lt.nidt)then + do while(abs(idt(i,n+m)).eq.iad1) + m=m+1 + enddo + endif + mm=0 + if(m.gt.1)then + if(m.eq.2.and.idt(i,n)*idt(i,n+1).lt.0)then + if(id1.eq.idt(i,n+1))mm=1 + isi=1 + else + mm=int(drangen(dummy)*dble(m)) + endif + endif + idtrafo=idt(j,n+mm)*isi + if(abs(idtrafo).eq.99)call utstop('New particle not allowed ') + if(idtrafo.lt.0.and.j.eq.4)then !corsika id always >0 + iadtr=abs(idtrafo) + if(iadtr.eq.13)then + idtrafo=25 + elseif(iadtr.eq.14)then + idtrafo=15 + elseif(iadtr.ge.18.and.iadtr.le.24)then + idtrafo=iadtr+8 + elseif(iadtr.ge.54.and.iadtr.le.57)then + idtrafo=iadtr+4 + elseif(iadtr.ge.137.and.iadtr.le.145)then + idtrafo=iadtr+12 + elseif(iadtr.ge.161.and.iadtr.le.163)then + idtrafo=iadtr+10 + else + idtrafo=iadtr + endif + elseif(idtrafo.eq.19.and.j.eq.3)then + idtrafo=-10 + endif + if(j.ne.ji)goto 100 + return + endif + enddo + else + idtrafo=id1 + if(j.ne.ji)goto 100 + return + endif + + print *, 'idtrafo: ',code1,' -> ', code2,id1,' not found. ' + stop +c idtrafocx=0 +c return + + 100 if(j.eq.4)then !corsika + if(idtrafo.eq.201)then + idtrafo=45 + elseif(idtrafo.eq.301)then + idtrafo=46 + elseif(idtrafo.eq.402)then + idtrafo=47 + elseif(idtrafo.eq.302)then + idtrafo=48 + endif + if(idtrafo.ne.0)then !air + if(ji.eq.6)then + idtrafo=kipart(idtrafo) + elseif(ji.eq.7)then + idtrafo=ICFTABL(idtrafo) + endif + endif + return + else + call utstop('Should not happen in idtrafo !&') + endif + + end + diff --git a/modules/epos/epos-int-lhc.f b/modules/epos/epos-int-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..1f508ccfaa53db5dc8973f153c81f96b768aca38 --- /dev/null +++ b/modules/epos/epos-int-lhc.f @@ -0,0 +1,5341 @@ +c----------------------------------------------------------------------- + subroutine bjinta(ier) +c----------------------------------------------------------------------- +c fin. state interactions and decays +c----------------------------------------------------------------------- + include 'epos.inc' + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat + common/cttaus/tpro,zpro,ttar,ztar,ttaus,detap,detat /ctimel/ntc + common/col3/ncol,kolpt + double precision ttaun,ttau0,rcproj,rctarg + common/cttaun/ttaun /cttau0/ttau0 /geom1/rcproj,rctarg + logical go,lclean + + call utpri('bjinta',ish,ishini,4) + + ier=0 + + if(ncol.eq.0.and.iappl.eq.2)goto1000 + if(nevt.ne.1.or.ifrade.eq.0)goto1000 + + if(iappl.eq.4.or.iappl.eq.9)then + goto5000 + endif + + !if(iappl.eq.1)then + ! tauxx=0.7+0.94*max(radnuc(maproj),radnuc(matarg))/(0.5*engy) + !else + ! tauxx=0. + !endif + !tauzz=max(taumin,tauxx) + !print*,'====',taumin,tauxx,tauzz + !ttaus=dble(tauzz) + ttaus=taumin + ttau0=dsqrt(rcproj*rctarg) + call jtauin ! initialize hyperbola + + if(iappl.ne.1)goto 5000 + + +c no-secondary-interactions or parton-ladder-fusion +c ------------------------------------------------- + if(iorsce.eq.0.and.iorsdf.eq.0.and.iorshh.eq.0 + & .or.iorsdf.eq.3)then + if(iorsdf.eq.3)then + lclean=.false. + if(nclean.gt.0.and.nptl.gt.mxptl/5)then + ! if nptl already very big, clean up useless particles in cptl list. + !(do not use it when gakstr() is called (some information lost) + nptli=maproj+matarg+1 + do iii=nptli,nptl + go=.true. + if(nclean.eq.1.and.istptl(iii).le.istmax)go=.false. + if(go.and.mod(istptl(iii),10).ne.0)istptl(iii)=99 + enddo + nptl0=nptl + call utclea(nptli,nptl0) + lclean=.true. + endif + nptlbpo=nptl + call jintpo(lclean,iret) !parton-ladder-fusion + if(ish.ge.2)call alist('parton-ladder-fusion&',nptlbpo+1,nptl) + if(iret.eq.1)goto 1001 + endif + goto 5000 + else + stop'bjinta: not supported any more (310305). ' + endif + +5000 continue + + nptlbd=nptl + + call xSpaceTime + + if(ifrade.eq.0)goto779 !skip decay + if(idecay.eq.0)goto779 !skip decay + + + if(ish.ge.2)call alist('final decay&',0,0) + if(iappl.eq.4.or.iappl.eq.7.or.iappl.eq.9)then + nptli=1 + else + nptli=maproj+matarg+1 + endif + np1=nptli +41 np2=nptl + nptli=np1 + ip=np1-1 + do while (ip.lt.np2) + ip=ip+1 + if(istptl(ip).eq.0)then + call hdecas(ip,iret) + if(iret.eq.1)goto 1001 + if(iret.eq.-1)goto 42 +c remove useless particles if not enough space + if(nclean.gt.0.and.nptl.gt.mxptl/2)then + nnnpt=0 + do iii=nptli,ip + go=.true. + if(nclean.eq.1.and.istptl(iii).le.istmax)go=.false. + if(go.and.mod(istptl(iii),10).ne.0)then + istptl(iii)=99 + nnnpt=nnnpt+1 + endif + enddo + if(nnnpt.gt.mxptl-nptl)then + nptl0=nptl + call utclea(nptli,nptl0) + np2=np2-nnnpt + ip=ip-nnnpt + nptli=ip + endif + endif + endif +42 continue + enddo + nptli=max(nptli,np1) + np1=np2+1 + if(np1.le.nptl)then + if(ish.ge.2)then + if(ish.ge.3)call alist('partial list&',0,0) + do 6 ip=np1,nptl + call alist('&',ip,ip) +6 continue + endif + goto 41 + endif + 779 continue + +c if(ish.ge.2)call alist('complete list&',1,nptl) + +c on shell check +c -------------- +c if(iappl.eq.1)call jresc + +1000 continue + call utprix('bjinta',ish,ishini,4) + return + +1001 continue + ier=1 + goto 1000 + + end + +cc---------------------------------------------------------------------- +c subroutine jintcs(i,j,ecm,bij,nq,jc,ics) +cc---------------------------------------------------------------------- +cc compare hadron distance with energy dependent cross section +cc data taken from particle data group, durham and juelich +cc input: +cc i,j: particle indices +cc ecm: center-of-mass energy +cc bij: impact parameter +cc nq: net quark number of fused object +cc jc: jc of fused object +cc output: +cc ics=0 if distance larger than sqrt(sig(E_CMS)/pi) +cc ics=1 else +cc The data are from HEPDATA, +cc the formulas from Rev. Particle Properties 1995 +cc---------------------------------------------------------------------- +c include 'epos.inc' +c integer jci(nflav,2),jcj(nflav,2),jc(nflav,2),kc(nflav) +c *,kci(nflav),kcj(nflav) +c common/cxyzt/xptl(mxptl),yptl(mxptl),zptl(mxptl),tptl(mxptl) +c *,optl(mxptl),uptl(mxptl),sptl(mxptl),rptl(mxptl,3) +c parameter(npp=249,napp=205,npn=411,napn=31,npip=441) +c parameter(npim=578,nkmp=299,nkmn=41,nkpp=172,nkpn=91) +cc parameter(npim=578,nkmp=299,nkmn=41,nkpp=172,nkpn=91,nlp=35) +c parameter(npi1=12,npi2=12,npi3=18,npi4=21,npi5=9) +cc real ppecm(npp) +c real ppbmx(npp) +c real appecm(napp),appbmx(napp) +c real pnecm(npn),pnbmx(npn) +c real apnecm(napn),apnbmx(napn) +c real pipecm(npip),pipbmx(npip) +c real pimecm(npim),pimbmx(npim) +c real kmpecm(nkmp),kmpbmx(nkmp) +c real kmnecm(nkmn),kmnbmx(nkmn) +c real kppecm(nkpp),kppbmx(nkpp) +c real kpnecm(nkpn),kpnbmx(nkpn) +cc real lpecm(nlp),lpbmx(nlp) +c real pi1ecm(npi1),pi1bmx(npi1) +c real pi2ecm(npi2),pi2bmx(npi2) +c real pi3ecm(npi3),pi3bmx(npi3) +c real pi4ecm(npi4),pi4bmx(npi4) +c real pi5ecm(npi5),pi5bmx(npi5) +c +cc data ppecm/ +cc * 1.8812, 1.8855, 1.8910, 1.8963, 1.9073 +cc *, 1.9108, 1.9145, 1.9224, 1.9244, 1.9352 +cc *, 1.9466, 1.9468, 1.9542, 1.9592, 1.9636 +cc *, 1.9772, 1.9860, 1.9945, 2.0032, 2.0052 +cc *, 2.0070, 2.0272, 2.0275, 2.0302, 2.0333 +cc *, 2.0402, 2.0427, 2.0586, 2.0608, 2.0692 +cc *, 2.0702, 2.0708, 2.0715, 2.0718, 2.0751 +cc *, 2.0797, 2.0813, 2.0829, 2.0843, 2.0846 +cc *, 2.0935, 2.1062, 2.1113, 2.1123, 2.1170 +cc *, 2.1173, 2.1184, 2.1268, 2.1289, 2.1357 +cc *, 2.1467, 2.1511, 2.1522, 2.1553, 2.1618 +cc *, 2.1639, 2.1726, 2.1771, 2.1795, 2.1799 +cc *, 2.1802, 2.1813, 2.1868, 2.2152, 2.2184 +cc *, 2.2212, 2.2254, 2.2395, 2.2405, 2.2532 +cc *, 2.2606, 2.2613, 2.2861, 2.2889, 2.2914 +cc *, 2.2988, 2.3101, 2.3136, 2.3228, 2.3348 +cc *, 2.3490, 2.3525, 2.3529, 2.3800, 2.3842 +cc *, 2.3912, 2.4088, 2.4130, 2.4193, 2.4298 +cc *, 2.4315, 2.4392, 2.4472, 2.4573, 2.5034 +cc *, 2.5131, 2.5268, 2.5743, 2.5848, 2.5916 +cc *, 2.6327, 2.6620, 2.6700, 2.6984, 2.7080 +cc *, 2.7205, 2.7534, 2.7573, 2.7651, 2.7670 +cc *, 2.7844, 2.8024, 2.8092, 2.8127, 2.8533 +cc *, 2.8556, 2.8638, 2.9079, 2.9395, 2.9500 +cc *, 2.9776, 2.9961, 3.0495, 3.0769, 3.0879 +cc *, 3.1358, 3.1547, 3.2251, 3.2371, 3.3020 +cc *, 3.3527, 3.3620, 3.4221, 3.4967, 3.5019 +cc *, 3.5035, 3.5814, 3.5829, 3.6266, 3.8549 +cc *, 3.8742, 4.0503, 4.0663, 4.0698, 4.0732 +cc *, 4.0778, 4.1074, 4.1300, 4.4976, 4.5183 +cc *, 4.5389, 4.5410, 4.5615, 4.6808, 4.9146 +cc *, 4.9336, 5.0088, 5.2993, 5.3011, 5.4731 +cc *, 5.6083, 5.6416, 5.6465, 5.9171, 5.9502 +cc *, 5.9644, 6.1697, 6.1803, 6.2706, 6.3034 +cc *, 6.3390, 6.5627, 6.7040, 6.8424, 6.9105 +cc *, 6.9780, 7.1111, 7.1662, 7.6202, 7.8624 +cc *, 8.2124, 8.7647, 9.0282, 9.2843, 9.5825 +cc *, 9.7763, 9.9851, 10.2447, 10.6927, 10.8926 +cc *, 11.4549, 11.5365, 11.7779, 11.8519, 13.6241 +cc *, 13.6883, 13.7611, 13.8968, 15.0628, 15.1868 +cc *, 16.6595, 16.8275, 17.9077, 18.0121, 18.1677 +cc *, 19.2213, 19.4156, 19.6556, 19.7002, 21.2604 +cc *, 22.9574, 23.3624, 23.4057, 23.4965, 23.4967 +cc *, 23.5964, 23.7605, 23.8787, 24.1521, 25.2904 +cc *, 26.3796, 27.5960, 30.5240, 30.5954, 30.5957 +cc *, 30.6555, 30.6954, 30.7954, 35.1947, 44.6933 +cc *, 44.6937, 44.6938, 44.7706, 44.8228, 44.8933 +cc *, 45.1933, 52.6798, 52.7090, 52.7921, 52.7921 +cc *, 52.7927, 52.8927, 53.1921, 62.2907, 62.3914 +cc *, 62.4907, 62.6907, 62.6913, 62.7906 +cc */ +c data ppbmx/ +c * 3.1615, 2.2212, 1.7113, 1.4927, 1.1631 +c *, 1.0911, 1.0388, .9525, .9390, .8885 +c *, .8019, .8956, .9115, .8593, .8840 +c *, .9062, .8444, .8444, .8482, .8713 +c *, .8575, .8795, .8795, .8759, .8630 +c *, .8822, .8593, .8813, .9036, .9150 +c *, .8740, .9219, .8740, .9253, .8722 +c *, .8795, .9288, .8704, .9398, .9271 +c *, .9407, .9373, .9756, .9926, 1.0357 +c *, 1.0037, 1.0408, .9739, 1.0108, 1.0479 +c *, 1.0645, 1.0705, 1.1113, 1.0794, 1.0955 +c *, 1.1085, 1.1256, 1.1535, 1.1731, 1.1424 +c *, 1.0794, 1.1480, 1.1590, 1.1888, 1.2218 +c *, 1.2164, 1.2087, 1.2296, 1.2231, 1.2335 +c *, 1.2322, 1.2309, 1.2114, 1.2296, 1.2293 +c *, 1.2489, 1.2303, 1.2322, 1.2322, 1.2127 +c *, 1.2192, 1.2295, 1.2399, 1.2290, 1.2374 +c *, 1.2205, 1.2278, 1.2284, 1.2061, 1.2296 +c *, 1.2296, 1.2540, 1.2008, 1.2260, 1.2229 +c *, 1.2257, 1.2188, 1.2118, 1.2078, 1.1982 +c *, 1.2039, 1.2012, 1.1991, 1.1808, 1.1969 +c *, 1.1959, 1.1922, 1.1902, 1.1897, 1.1878 +c *, 1.1888, 1.1860, 1.1856, 1.1850, 1.2244 +c *, 1.1782, 1.1790, 1.1718, 1.1696, 1.1726 +c *, 1.1576, 1.1656, 1.1606, 1.1603, 1.1581 +c *, 1.1590, 1.1530, 1.1576, 1.1487, 1.1476 +c *, 1.1447, 1.1794, 1.1448, 1.1507, 1.1507 +c *, 1.1407, 1.1403, 1.1507, 1.1581, 1.1645 +c *, 1.1616, 1.1507, 1.1332, 1.1294, 1.1284 +c *, 1.1227, 1.1284, 1.1298, 1.1261, 1.1199 +c *, 1.1365, 1.1438, 1.1284, 1.1424, 1.1230 +c *, 1.1218, 1.1142, 1.1156, 1.1202, 1.1198 +c *, 1.1099, 1.1099, 1.1175, 1.1241, 1.1168 +c *, 1.1099, 1.1128, 1.1241, 1.1103, 1.1149 +c *, 1.1155, 1.1083, 1.1197, 1.1127, 1.1185 +c *, 1.1113, 1.1128, 1.1113, 1.1083, 1.1056 +c *, 1.1067, 1.1070, 1.1059, 1.1063, 1.1070 +c *, 1.1028, 1.0979, 1.1060, 1.1062, 1.1774 +c *, 1.0805, 1.1039, 1.0940, 1.0955, 1.0940 +c *, 1.0955, 1.1082, 1.1128, 1.1082, 1.0852 +c *, 1.1003, 1.1097, 1.1118, 1.0911, 1.1227 +c *, 1.1070, 1.1206, 1.1142, 1.1213, 1.1174 +c *, 1.1199, 1.1142, 1.1185, 1.1180, 1.1113 +c *, 1.1099, 1.1297, 1.1142, 1.1226, 1.1240 +c *, 1.1251, 1.1368, 1.1403, 1.1319, 1.1296 +c *, 1.1333, 1.1303, 1.1284, 1.1343, 1.1516 +c *, 1.1521, 1.1549, 1.1641, 1.1631, 1.1562 +c *, 1.1631, 1.1697, 1.1726, 1.1756, 1.1659 +c *, 1.1660, 1.1617, 1.1686, 1.1774, 1.1713 +c *, 1.1744, 1.1810, 1.1694, 1.1848 +c */ +c data appecm/ +c * 1.9002, 1.9050, 1.9072, 1.9078, 1.9091 +c *, 1.9129, 1.9157, 1.9162, 1.9174, 1.9176 +c *, 1.9180, 1.9195, 1.9201, 1.9224, 1.9226 +c *, 1.9246, 1.9252, 1.9255, 1.9257, 1.9271 +c *, 1.9282, 1.9293, 1.9301, 1.9310, 1.9319 +c *, 1.9328, 1.9334, 1.9345, 1.9359, 1.9370 +c *, 1.9372, 1.9384, 1.9393, 1.9398, 1.9407 +c *, 1.9426, 1.9430, 1.9433, 1.9452, 1.9454 +c *, 1.9473, 1.9485, 1.9495, 1.9500, 1.9510 +c *, 1.9515, 1.9547, 1.9559, 1.9562, 1.9579 +c *, 1.9610, 1.9615, 1.9644, 1.9680, 1.9718 +c *, 1.9755, 1.9788, 1.9829, 1.9871, 1.9911 +c *, 1.9954, 1.9994, 2.0813, 2.0979, 2.1146 +c *, 2.1180, 2.1316, 2.1487, 2.1660, 2.1834 +c *, 2.1868, 2.1938, 2.1991, 2.2008, 2.2184 +c *, 2.2226, 2.2359, 2.2500, 2.2606, 2.2712 +c *, 2.2889, 2.2995, 2.3066, 2.3243, 2.3419 +c *, 2.3490, 2.3511, 2.3596, 2.3701, 2.3772 +c *, 2.3860, 2.3877, 2.3947, 2.4035, 2.4123 +c *, 2.4298, 2.4472, 2.4629, 2.4820, 2.4993 +c *, 2.5165, 2.5268, 2.5337, 2.5508, 2.5678 +c *, 2.5848, 2.5950, 2.6017, 2.6186, 2.6353 +c *, 2.6377, 2.6520, 2.6654, 2.6687, 2.6852 +c *, 2.7017, 2.7182, 2.7345, 2.7508, 2.7670 +c *, 2.7832, 2.7896, 2.7992, 2.8152, 2.8312 +c *, 2.8439, 2.8470, 2.8565, 2.8628, 2.9377 +c *, 2.9561, 2.9745, 3.0351, 3.0769, 3.0828 +c *, 3.1648, 3.2507, 3.2788, 3.3620, 3.4568 +c *, 3.5492, 3.6266, 3.7893, 3.8501, 3.8597 +c *, 3.8742, 3.9455, 4.1074, 4.3499, 4.3926 +c *, 4.5389, 4.5799, 4.6808, 4.7991, 4.9336 +c *, 4.9901, 5.1742, 5.2993, 5.3520, 5.4731 +c *, 5.6416, 5.6911, 5.8534, 5.9644, 6.0113 +c *, 6.2706, 6.3153, 6.7040, 6.9780, 7.3061 +c *, 7.6202, 7.7422, 7.8624, 7.8743, 8.0393 +c *, 8.2124, 8.4930, 8.7647, 9.0282, 9.2843 +c *, 9.5335, 9.7763, 11.5365, 13.7611, 13.8630 +c *, 15.0628, 16.8275, 17.9077, 19.4156, 21.2604 +c *, 22.9574, 30.4098, 30.5943, 30.6861, 52.5843 +c *, 52.7979, 52.7979, 62.2853, 62.4957, 62.6905 +c *, 539.9198, 546.9191, 899.8658, 900.0000,1803.0007 +c */ +c data appbmx/ +c * 2.7553, 2.6857, 2.6732, 2.6517, 2.6306 +c *, 2.5376, 2.4398, 2.4779, 2.5212, 2.5143 +c *, 2.4573, 2.4799, 2.4495, 2.4286, 2.4521 +c *, 2.3683, 2.4463, 2.4240, 2.4489, 2.3743 +c *, 2.4162, 2.3561, 2.3903, 2.3796, 2.3221 +c *, 2.3689, 2.4181, 2.3221, 2.3823, 2.2987 +c *, 2.3337, 2.3568, 2.3487, 2.2911, 2.3344 +c *, 2.2701, 2.3097, 2.3207, 2.2631, 2.2603 +c *, 2.2666, 2.2412, 2.2319, 2.3097, 2.2327 +c *, 2.2104, 2.2104, 2.2645, 2.2369, 2.1880 +c *, 2.1756, 2.2162, 2.1491, 2.1484, 2.1365 +c *, 2.1320, 2.1027, 2.1065, 2.0913, 2.0776 +c *, 2.0668, 2.0883, 1.9333, 1.9098, 1.8851 +c *, 1.8932, 1.8721, 1.8623, 1.8520, 1.8409 +c *, 1.8678, 1.8575, 1.8325, 1.8429, 1.8088 +c *, 1.7698, 1.7941, 1.7864, 1.7814, 1.7736 +c *, 1.7645, 1.7623, 1.7576, 1.7523, 1.7445 +c *, 1.7419, 1.7019, 1.7342, 1.7311, 1.7271 +c *, 1.7210, 1.7182, 1.7161, 1.7119, 1.7054 +c *, 1.6947, 1.6816, 1.6780, 1.6678, 1.6599 +c *, 1.6509, 1.6328, 1.6449, 1.6396, 1.6319 +c *, 1.6270, 1.5761, 1.6043, 1.6120, 1.6069 +c *, 1.5978, 1.6018, 1.5891, 1.5948, 1.5905 +c *, 1.5849, 1.5778, 1.5736, 1.5679, 1.5785 +c *, 1.5583, 1.5476, 1.5519, 1.5467, 1.5416 +c *, 1.5233, 1.5368, 1.5492, 1.5313, 1.4895 +c *, 1.5579, 1.5107, 1.4680, 1.4725, 1.4586 +c *, 1.3889, 1.4799, 1.4472, 1.4371, 1.3576 +c *, 1.4228, 1.3922, 1.3762, 1.3854, 1.3669 +c *, 1.4161, 1.3623, 1.3638, 1.3530, 1.3762 +c *, 1.3273, 1.2866, 1.2989, 1.3159, 1.2828 +c *, 1.3086, 1.2797, 1.2704, 1.2940, 1.2741 +c *, 1.2514, 1.2540, 1.2803, 1.2653, 1.2603 +c *, 1.2386, 1.2192, 1.2283, 1.2231, 1.2140 +c *, 1.2048, 1.2114, 1.2099, 1.2052, 1.2048 +c *, 1.1984, 1.1928, 1.1901, 1.1902, 1.1888 +c *, 1.1848, 1.1769, 1.1706, 1.1579, 1.1608 +c *, 1.1521, 1.1534, 1.1520, 1.1495, 1.1549 +c *, 1.1550, 1.1580, 1.1672, 1.1562, 1.1743 +c *, 1.1859, 1.1950, 1.1851, 1.1821, 1.1987 +c *, 1.4740, 1.4037, 1.4483, 1.4417, 1.5149 +c */ +c data pnecm/ +c * 1.87867, 1.87869, 1.87872, 1.87875, 1.87878 +c *, 1.87881, 1.87884, 1.87887, 1.87890, 1.87893 +c *, 1.87896, 1.87899, 1.87902, 1.87906, 1.87909 +c *, 1.87913, 1.87916, 1.87920, 1.87923, 1.87927 +c *, 1.87931, 1.87934, 1.87938, 1.87942, 1.87946 +c *, 1.87950, 1.87954, 1.87958, 1.87962, 1.87966 +c *, 1.87970, 1.87975, 1.87979, 1.87983, 1.87988 +c *, 1.87992, 1.87997, 1.88001, 1.88006, 1.88011 +c *, 1.88015, 1.88020, 1.88025, 1.88030, 1.88035 +c *, 1.88040, 1.88045, 1.88050, 1.88055, 1.88061 +c *, 1.88066, 1.88071, 1.88077, 1.88082, 1.88087 +c *, 1.88093, 1.88099, 1.88104, 1.88110, 1.88116 +c *, 1.88121, 1.88127, 1.88133, 1.88139, 1.88145 +c *, 1.88151, 1.88157, 1.88163, 1.88170, 1.88176 +c *, 1.88182, 1.88189, 1.88195, 1.88202, 1.88208 +c *, 1.88215, 1.88221, 1.88228, 1.88235, 1.88241 +c *, 1.88248, 1.88255, 1.88262, 1.88269, 1.88276 +c *, 1.88283, 1.88290, 1.88297, 1.88305, 1.88312 +c *, 1.88319, 1.88327, 1.88334, 1.88342, 1.88349 +c *, 1.88357, 1.88364, 1.88372, 1.88380, 1.88388 +c *, 1.88396, 1.88403, 1.88411, 1.88419, 1.88428 +c *, 1.88436, 1.88444, 1.88452, 1.88460, 1.88469 +c *, 1.88477, 1.88485, 1.88494, 1.88502, 1.88511 +c *, 1.88519, 1.88528, 1.88537, 1.88546, 1.88554 +c *, 1.88563, 1.88572, 1.88581, 1.88590, 1.88599 +c *, 1.88608, 1.88618, 1.88627, 1.88636, 1.88645 +c *, 1.88655, 1.88664, 1.88674, 1.88683, 1.88693 +c *, 1.88702, 1.88712, 1.88722, 1.88731, 1.88741 +c *, 1.88751, 1.88761, 1.88771, 1.88781, 1.88791 +c *, 1.88801, 1.88811, 1.88822, 1.88832, 1.88842 +c *, 1.88852, 1.88863, 1.88873, 1.88884, 1.88894 +c *, 1.88905, 1.88916, 1.88926, 1.88937, 1.88948 +c *, 1.88959, 1.88970, 1.88980, 1.88991, 1.89003 +c *, 1.89014, 1.89025, 1.89036, 1.89047, 1.89058 +c *, 1.89070, 1.89081, 1.89093, 1.89104, 1.89116 +c *, 1.89127, 1.89139, 1.89150, 1.89162, 1.89174 +c *, 1.89186, 1.89198, 1.89209, 1.89221, 1.89233 +c *, 1.89245, 1.89258, 1.89270, 1.89282, 1.89294 +c *, 1.89306, 1.89319, 1.89331, 1.89344, 1.89356 +c *, 1.89369, 1.89381, 1.89394, 1.89406, 1.89419 +c *, 1.89432, 1.89445, 1.89458, 1.89496, 1.89549 +c *, 1.89602, 1.89615, 1.89656, 1.89697, 1.89724 +c *, 1.89766, 1.89780, 1.89850, 1.89893, 1.89922 +c *, 1.89995, 1.90068, 1.90098, 1.90143, 1.90174 +c *, 1.90235, 1.90250, 1.90312, 1.90407, 1.90503 +c *, 1.90519, 1.90616, 1.90732, 1.90749, 1.90833 +c *, 1.90936, 1.91216, 1.91379, 1.91545, 1.91714 +c *, 1.91905, 1.91924, 1.92100, 1.92160, 1.92179 +c *, 1.92259, 1.92319, 1.92421, 1.92502, 1.92543 +c *, 1.92605, 1.92646, 1.92792, 1.93046, 1.93241 +c *, 1.93306, 1.93570, 1.93704, 1.93953, 1.94021 +c *, 1.94183, 1.94699, 1.94723, 1.95206, 1.95329 +c *, 1.95452, 1.95651, 1.96029, 1.96080, 1.97927 +c *, 1.98533, 1.99806, 2.00884, 2.01269, 2.02779 +c *, 2.02963, 2.04329, 2.04643, 2.05915, 2.05947 +c *, 2.05979, 2.07207, 2.07337, 2.07533, 2.09178 +c *, 2.10847, 2.11385, 2.12061, 2.12536, 2.14243 +c *, 2.15308, 2.15343, 2.15964, 2.17072, 2.17698 +c *, 2.18185, 2.19442, 2.21193, 2.21369, 2.22353 +c *, 2.22846, 2.22952, 2.24715, 2.25597, 2.28851 +c *, 2.29134, 2.29382, 2.31293, 2.31328, 2.32673 +c *, 2.34935, 2.35501, 2.36207, 2.38251, 2.39729 +c *, 2.41135, 2.41591, 2.42817, 2.44006, 2.45995 +c *, 2.48220, 2.49952, 2.50643, 2.52951, 2.56750 +c *, 2.58756, 2.63546, 2.64719, 2.66487, 2.67285 +c *, 2.71088, 2.72336, 2.75178, 2.75634, 2.76802 +c *, 2.76867, 2.76996, 2.78741, 2.80542, 2.81567 +c *, 2.85639, 2.85860, 2.86681, 2.91102, 2.94265 +c *, 2.96543, 3.05273, 3.08729, 3.09115, 3.15805 +c *, 3.16821, 3.22857, 3.24053, 3.29551, 3.35628 +c *, 3.42580, 3.50727, 3.55297, 3.58520, 3.58675 +c *, 3.59580, 3.63049, 3.72425, 3.75633, 4.05460 +c *, 4.06219, 4.07412, 4.11175, 4.37426, 4.52314 +c *, 4.54378, 4.74537, 4.93885, 5.12513, 5.30495 +c *, 5.40999, 5.47892, 5.61424, 5.64757, 5.93444 +c *, 5.97071, 6.27732, 6.42517, 6.51227, 6.56970 +c *, 6.71114, 6.87703, 6.98545, 7.18446, 7.23904 +c *, 7.24942, 7.62830, 8.10603, 8.22114, 8.54948 +c *, 8.77406, 9.29418, 9.78673, 10.15712, 10.25566 +c *, 10.70407, 11.13446, 11.54882, 12.33587, 13.77577 +c *, 15.07880, 15.74960, 16.84544, 17.92675, 18.18703 +c *, 18.44365, 19.43624, 20.14863, 21.28302, 22.69375 +c *, 22.98187 +c */ +c data pnbmx/ +c * 10.7613, 10.6195, 10.5290, 10.4010, 10.2901 +c *, 10.1970, 10.1029, 10.0088, 9.9009, 9.7973 +c *, 9.7125, 9.6198, 9.5613, 9.4281, 9.3628 +c *, 9.2801, 9.2068, 9.1103, 9.0239, 8.9609 +c *, 8.8562, 8.8011, 8.7574, 8.6332, 8.5487 +c *, 8.4788, 8.4157, 8.3606, 8.2746, 8.2604 +c *, 8.1583, 8.0778, 8.0127, 7.9567, 7.8691 +c *, 7.8176, 7.8190, 7.7028, 7.6634, 7.5956 +c *, 7.5808, 7.4956, 7.4144, 7.3600, 7.3071 +c *, 7.2947, 7.1947, 7.1389, 7.1333, 7.0404 +c *, 6.9856, 6.9468, 6.9171, 6.8369, 6.7869 +c *, 6.7829, 6.6804, 6.6483, 6.5982, 6.5464 +c *, 6.5060, 6.4541, 6.4539, 6.3684, 6.3219 +c *, 6.2777, 6.2832, 6.1881, 6.1494, 6.1048 +c *, 6.0642, 6.0207, 6.0255, 5.9756, 5.9161 +c *, 5.8717, 5.8276, 5.7878, 5.7481, 5.7319 +c *, 5.6977, 5.6492, 5.6142, 5.5796, 5.5428 +c *, 5.4939, 5.4659, 5.4549, 5.3933, 5.3601 +c *, 5.3311, 5.3037, 5.2760, 5.2429, 5.2381 +c *, 5.2384, 5.1470, 5.1112, 5.0812, 5.0483 +c *, 5.0350, 5.0330, 4.9640, 4.9410, 4.9050 +c *, 4.8714, 4.8408, 4.8482, 4.8518, 4.7611 +c *, 4.7157, 4.7049, 4.6834, 4.6939, 4.6206 +c *, 4.5931, 4.5723, 4.5498, 4.5210, 4.5337 +c *, 4.4726, 4.4898, 4.4251, 4.4013, 4.3784 +c *, 4.3514, 4.3264, 4.3530, 4.2846, 4.2567 +c *, 4.2339, 4.2171, 4.1919, 4.1757, 4.1503 +c *, 4.1329, 4.0924, 4.0797, 4.0624, 4.0446 +c *, 4.0210, 4.0010, 3.9812, 3.9627, 3.9402 +c *, 3.9221, 3.9029, 3.8925, 3.8680, 3.8439 +c *, 3.8244, 3.8094, 3.7816, 3.7719, 3.7396 +c *, 3.7271, 3.7011, 3.6849, 3.6804, 3.6640 +c *, 3.6496, 3.5954, 3.6042, 3.5697, 3.5552 +c *, 3.5463, 3.5265, 3.5212, 3.4992, 3.1432 +c *, 3.4630, 3.4483, 3.4484, 3.4240, 3.4127 +c *, 3.3595, 3.3767, 3.3582, 3.3059, 3.3258 +c *, 3.3182, 3.2582, 3.2740, 3.2621, 3.1984 +c *, 3.2408, 3.2043, 3.2087, 3.1652, 3.1720 +c *, 3.1476, 3.0754, 3.1236, 3.1494, 3.0653 +c *, 3.0757, 3.1030, 3.0692, 3.0466, 3.0392 +c *, 3.0346, 2.9933, 3.0146, 2.8774, 2.7972 +c *, 2.6463, 2.8068, 2.6869, 2.6643, 2.6673 +c *, 2.6684, 2.6409, 2.5520, 2.4341, 2.4978 +c *, 2.4534, 2.4417, 2.4293, 2.3283, 2.4978 +c *, 2.3042, 2.3111, 2.1996, 2.1996, 2.1960 +c *, 2.1469, 2.1223, 2.0791, 2.0599, 1.9891 +c *, 2.0027, 1.8678, 1.7850, 1.7868, 1.7362 +c *, 1.6478, 1.6254, 1.6166, 1.6478, 1.6516 +c *, 1.5554, 1.5727, 1.5656, 1.5290, 1.5149 +c *, 1.5554, 1.5615, 1.5522, 1.4863, 1.4745 +c *, 1.4745, 1.3991, 1.4139, 1.1686, 1.3458 +c *, 1.3587, 1.2425, 1.3171, 1.2828, 1.2153 +c *, 1.2679, 1.2766, 1.1410, 1.2514, 1.0852 +c *, 1.1445, 1.1672, 1.0624, 1.1089, 1.0899 +c *, 1.0171, 1.0399, 1.0645, 1.0417, .9934 +c *, 1.0403, 1.0029, 1.0357, 1.0388, 1.0337 +c *, 1.0428, 1.0555, 1.0663, 1.0546, 1.0626 +c *, 1.0013, 1.0705, 1.0711, 1.0852, 1.0830 +c *, 1.1119, 1.0940, 1.0976, 1.0675, 1.1205 +c *, 1.0464, 1.0995, .9508, 1.0972, 1.1170 +c *, 1.1015, 1.1251, 1.1296, 1.1027, 1.1028 +c *, .9271, 1.1363, 1.1120, 1.1455, 1.1192 +c *, 1.1498, 1.1491, 1.0108, 1.1282, 1.1550 +c *, 1.1617, 1.1354, 1.1586, 1.1631, 1.1378 +c *, 1.1656, 1.1684, 1.1389, 1.1694, 1.1690 +c *, 1.1702, 1.1705, 1.1390, 1.1714, 1.1716 +c *, 1.1326, 1.1517, 1.1697, 1.1731, 1.1716 +c *, 1.0867, 1.1537, 1.1698, 1.1642, 1.1638 +c *, 1.1199, 1.1635, 1.1713, 1.1631, 1.1601 +c *, 1.1340, 1.0823, 1.1598, 1.1754, 1.1572 +c *, 1.1565, 1.1567, 1.1631, 1.1538, 1.0852 +c *, 1.0342, 1.1645, 1.1452, 1.1099, 1.0940 +c *, 1.1185, 1.1470, 1.1388, 1.1424, 1.0705 +c *, 1.1374, 1.1199, 1.1262, 1.1142, 1.1205 +c *, 1.0867, 1.1095, 1.0734, 1.1234, 1.0925 +c *, 1.1135, 1.1076, 1.1070, 1.0955, 1.1027 +c *, 1.1073, 1.0630, 1.1007, 1.1185, 1.1133 +c *, 1.1128, 1.1028, 1.1033, 1.1086, 1.1120 +c *, 1.1013, 1.0991, 1.1086, 1.1028, 1.1027 +c *, 1.1064, 1.1036, 1.1135, 1.1139, 1.1136 +c *, 1.1145, 1.1166, 1.1152, 1.1168, 1.1172 +c *, 1.1230, 1.1187, 1.1254, 1.1224, 1.1329 +c *, 1.1216 +c */ +c data apnecm/ +c * 2.1288, 2.2007, 2.2500, 2.3044, 2.3529 +c *, 2.9284, 3.5136, 3.6305, 3.7933, 4.1117 +c *, 4.5438, 4.9389, 5.1797, 5.3049, 5.4789 +c *, 5.6476, 6.2773, 6.9855, 7.6283, 8.2211 +c *, 8.7741, 9.2942, 9.7867, 11.5488, 13.7758 +c *, 15.0788, 16.8454, 17.9267, 19.4362, 21.2830 +c *, 22.9819 +c */ +c data apnbmx/ +c * 1.9462, 1.7481, 1.8881, 1.8019, 1.8627 +c *, 1.4745, 1.3231, 1.3762, 1.3351, 1.3505 +c *, 1.2841, 1.3086, 1.2565, 1.3038, 1.2218 +c *, 1.2952, 1.2127, 1.2035, 1.1968, 1.1951 +c *, 1.1604, 1.1794, 1.1747, 1.1724, 1.1595 +c *, 1.1637, 1.1477, 1.1520, 1.1510, 1.1478 +c *, 1.1466 +c */ +c data pipecm/ +c * 1.1050, 1.1154, 1.1165, 1.1256, 1.1273 +c *, 1.1333, 1.1370, 1.1382, 1.1394, 1.1438 +c *, 1.1495, 1.1579, 1.1592, 1.1677, 1.1691 +c *, 1.1697, 1.1757, 1.1771, 1.1777, 1.1784 +c *, 1.1798, 1.1838, 1.1892, 1.1906, 1.1926 +c *, 1.1933, 1.1953, 1.1960, 1.1967, 1.1981 +c *, 1.1994, 1.2008, 1.2015, 1.2022, 1.2028 +c *, 1.2056, 1.2063, 1.2069, 1.2097, 1.2104 +c *, 1.2111, 1.2124, 1.2131, 1.2138, 1.2152 +c *, 1.2166, 1.2172, 1.2193, 1.2200, 1.2214 +c *, 1.2221, 1.2255, 1.2262, 1.2269, 1.2276 +c *, 1.2283, 1.2303, 1.2310, 1.2317, 1.2352 +c *, 1.2358, 1.2365, 1.2372, 1.2400, 1.2407 +c *, 1.2421, 1.2434, 1.2462, 1.2476, 1.2503 +c *, 1.2517, 1.2524, 1.2538, 1.2545, 1.2565 +c *, 1.2613, 1.2627, 1.2696, 1.2716, 1.2730 +c *, 1.2751, 1.2799, 1.2819, 1.2833, 1.2860 +c *, 1.2867, 1.2915, 1.2922, 1.2929, 1.2990 +c *, 1.3010, 1.3024, 1.3119, 1.3126, 1.3180 +c *, 1.3200, 1.3220, 1.3254, 1.3261, 1.3321 +c *, 1.3382, 1.3388, 1.3415, 1.3422, 1.3449 +c *, 1.3469, 1.3522, 1.3608, 1.3615, 1.3622 +c *, 1.3655, 1.3661, 1.3767, 1.3786, 1.3813 +c *, 1.3898, 1.3917, 1.3950, 1.4047, 1.4080 +c *, 1.4112, 1.4157, 1.4163, 1.4176, 1.4208 +c *, 1.4215, 1.4285, 1.4298, 1.4304, 1.4336 +c *, 1.4349, 1.4425, 1.4470, 1.4495, 1.4526 +c *, 1.4539, 1.4652, 1.4677, 1.4702, 1.4764 +c *, 1.4777, 1.4857, 1.4863, 1.4870, 1.4882 +c *, 1.4919, 1.4993, 1.4999, 1.5030, 1.5097 +c *, 1.5103, 1.5121, 1.5146, 1.5212, 1.5249 +c *, 1.5285, 1.5327, 1.5351, 1.5429, 1.5435 +c *, 1.5465, 1.5513, 1.5531, 1.5548, 1.5566 +c *, 1.5637, 1.5655, 1.5673, 1.5708, 1.5720 +c *, 1.5732, 1.5761, 1.5790, 1.5849, 1.5866 +c *, 1.5965, 1.5977, 1.5994, 1.6023, 1.6063 +c *, 1.6121, 1.6133, 1.6144, 1.6264, 1.6287 +c *, 1.6327, 1.6344, 1.6406, 1.6417, 1.6429 +c *, 1.6502, 1.6519, 1.6536, 1.6625, 1.6664 +c *, 1.6670, 1.6676, 1.6687, 1.6692, 1.6714 +c *, 1.6792, 1.6825, 1.6853, 1.6913, 1.6935 +c *, 1.6941, 1.6963, 1.6985, 1.6990, 1.7012 +c *, 1.7170, 1.7175, 1.7208, 1.7240, 1.7267 +c *, 1.7391, 1.7417, 1.7423, 1.7428, 1.7503 +c *, 1.7535, 1.7609, 1.7635, 1.7651, 1.7714 +c *, 1.7735, 1.7767, 1.7793, 1.7798, 1.7908 +c *, 1.7923, 1.7949, 1.7960, 1.8032, 1.8063 +c *, 1.8099, 1.8197, 1.8207, 1.8238, 1.8253 +c *, 1.8289, 1.8304, 1.8320, 1.8386, 1.8436 +c *, 1.8497, 1.8507, 1.8537, 1.8643, 1.8673 +c *, 1.8678, 1.8703, 1.8713, 1.8738, 1.8777 +c *, 1.8792, 1.8812, 1.8827, 1.8881, 1.8911 +c *, 1.8916, 1.8936, 1.8980, 1.9039, 1.9073 +c *, 1.9108, 1.9151, 1.9161, 1.9181, 1.9186 +c *, 1.9249, 1.9283, 1.9317, 1.9331, 1.9350 +c *, 1.9384, 1.9423, 1.9519, 1.9571, 1.9614 +c *, 1.9652, 1.9681, 1.9756, 1.9780, 1.9804 +c *, 1.9893, 1.9921, 1.9968, 1.9987, 2.0034 +c *, 2.0085, 2.0196, 2.0344, 2.0358, 2.0385 +c *, 2.0545, 2.0636, 2.0654, 2.0704, 2.0816 +c *, 2.0839, 2.0933, 2.1106, 2.1151, 2.1257 +c *, 2.1279, 2.1388, 2.1545, 2.1606, 2.1761 +c *, 2.1770, 2.1804, 2.1817, 2.1920, 2.2022 +c *, 2.2060, 2.2187, 2.2480, 2.2646, 2.2934 +c *, 2.3056, 2.3339, 2.3499, 2.3535, 2.3538 +c *, 2.3737, 2.3894, 2.4050, 2.4128, 2.4283 +c *, 2.4398, 2.4513, 2.4703, 2.4892, 2.5080 +c *, 2.5266, 2.5451, 2.5561, 2.5634, 2.5816 +c *, 2.5997, 2.6069, 2.6177, 2.6355, 2.6568 +c *, 2.6708, 2.6987, 2.7057, 2.7195, 2.7401 +c *, 2.7469, 2.7606, 2.7741, 2.7977, 2.8010 +c *, 2.8077, 2.8343, 2.8409, 2.8672, 2.8769 +c *, 2.8997, 2.9093, 2.9350, 2.9414, 2.9636 +c *, 2.9731, 3.0013, 3.0045, 3.0107, 3.0355 +c *, 3.0570, 3.0662, 3.0876, 3.0967, 3.1268 +c *, 3.1328, 3.1566, 3.1862, 3.2067, 3.2155 +c *, 3.2445, 3.2733, 3.3018, 3.3216, 3.3329 +c *, 3.3609, 3.3887, 3.4163, 3.4190, 3.4327 +c *, 3.4436, 3.4707, 3.4869, 3.4976, 3.5244 +c *, 3.5509, 3.6033, 3.6550, 3.7059, 3.7462 +c *, 3.9247, 3.9887, 3.9981, 4.4001, 4.4341 +c *, 4.8193, 4.8387, 5.2120, 5.2246, 5.3889 +c *, 5.5535, 5.5603, 5.7265, 5.8880, 5.8912 +c *, 5.9671, 6.1984, 6.2421, 6.5084, 6.6369 +c *, 6.9138, 7.5617, 8.1584, 8.7144, 8.9794 +c *, 9.2369, 9.7314, 9.9412, 10.2020, 10.6517 +c *, 11.4987, 13.7295, 15.0339, 16.6334, 16.8018 +c *, 17.8835, 18.1439, 21.2400, 22.9386, 24.1342 +c *, 25.2733 +c */ +c data pipbmx/ +c * .4424, .5585, .6180, .7485, .7092 +c *, .8058, .7777, .9113, .8974, .9934 +c *, 1.0896, 1.2653, 1.3078, 1.5076, 1.5472 +c *, 1.5656, 1.7019, 1.7504, 1.7934, 1.7626 +c *, 1.8168, 1.9706, 2.0163, 2.1140, 2.1749 +c *, 2.0576, 2.1851, 2.1148, 2.1924, 2.1851 +c *, 2.3104, 2.3480, 2.2883, 2.1924, 2.3602 +c *, 2.4570, 2.3262, 2.2708, 2.4722, 2.3296 +c *, 2.5124, 2.3194, 2.4476, 2.4033, 2.5497 +c *, 2.5313, 2.5514, 2.5181, 2.5125, 2.5156 +c *, 2.5105, 2.4398, 2.4201, 2.5074, 2.4978 +c *, 2.4463, 2.4863, 2.4856, 2.4469, 2.5231 +c *, 2.3534, 2.5357, 2.4482, 2.3796, 2.3823 +c *, 2.3582, 2.3650, 2.3870, 2.1705, 2.1185 +c *, 2.2341, 2.2057, 2.2284, 2.1178, 2.1705 +c *, 2.0622, 2.0490, 2.0122, 1.9041, 1.8873 +c *, 1.9091, 1.7897, 1.7499, 1.7535, 1.8797 +c *, 1.8455, 1.6087, 1.6381, 1.6361, 1.6737 +c *, 1.5329, 1.5327, 1.4879, 1.4351, 1.4461 +c *, 1.3854, 1.3517, 1.3334, 1.3695, 1.2741 +c *, 1.2989, 1.2183, 1.2361, 1.2074, 1.1456 +c *, 1.1997, 1.1439, 1.1381, 1.0786, 1.1185 +c *, 1.0693, 1.1339, .9958, 1.0077, 1.0491 +c *, .9997, .9611, .9452, .9141, .9190 +c *, .8806, .8885, .9200, .8618, .9680 +c *, .8702, .8643, .8263, .8234, .7150 +c *, .8412, .8101, .8704, .7767, .8766 +c *, .7722, .7694, .7956, .7590, .7128 +c *, .7159, .6894, .6894, .7139, .6898 +c *, .7412, .6784, .7181, .6947, .7695 +c *, .6704, .7110, .6910, .6699, .7199 +c *, .6935, .6759, .6843, .6933, .7190 +c *, .7159, .6865, .6958, .7017, .6794 +c *, .7081, .7004, .7128, .7569, .7269 +c *, .7356, .7230, .7332, .7548, .7464 +c *, .7695, .7703, .7707, .8288, .8117 +c *, .8170, .8054, .7990, .7878, .8556 +c *, .8423, .8917, .8664, .8253, .8649 +c *, .8627, .8813, .8461, .8938, .9288 +c *, .8759, .8345, .8972, .8625, .8818 +c *, .8983, .8953, .9080, .9277, .9117 +c *, .9080, .8579, .8974, .8970, .9184 +c *, .9267, .9184, .9092, .8704, .9146 +c *, .9184, .9591, .8649, .9296, .9071 +c *, .9449, .9407, .9536, .9721, .9608 +c *, .9837, .9233, .9542, 1.0004, .9853 +c *, .9934, 1.0005, 1.0061, .9358, 1.0180 +c *, 1.0280, 1.0573, .9982, 1.0357, 1.0555 +c *, .9877, 1.0682, 1.0694, 1.0817, 1.0720 +c *, 1.1046, 1.1041, 1.0596, 1.1013, 1.1217 +c *, 1.1217, 1.1291, 1.1113, 1.1270, 1.1354 +c *, 1.0799, 1.1199, 1.1439, 1.1459, 1.1213 +c *, 1.0907, 1.1368, 1.1488, 1.1008, 1.1500 +c *, 1.1156, 1.1502, 1.0947, 1.1410, 1.1427 +c *, 1.1480, 1.0729, 1.1634, 1.1319, 1.1480 +c *, 1.1295, 1.1213, 1.0783, 1.1044, 1.1027 +c *, 1.1217, 1.0998, 1.0418, 1.1031, 1.0712 +c *, 1.0720, 1.0600, 1.0540, 1.1180, 1.0490 +c *, 1.0464, 1.0380, 1.0124, 1.0202, .9821 +c *, 1.0013, .9945, .9997, 1.0187, .9805 +c *, .9873, .9796, .9608, 1.0045, .9756 +c *, .9695, .9674, .9646, .9662, .9659 +c *, .9654, .9491, .9643, .9566, .9654 +c *, .9636, .9619, .9676, .9774, .9747 +c *, .9916, .9843, .9950, .9932, .9641 +c *, .9895, .9861, .9871, .9905, .9916 +c *, .9657, .9872, .9770, .9796, .9751 +c *, .9637, .9689, .9633, .9635, .9601 +c *, .9580, .9707, .9581, .9540, .9505 +c *, .9509, .9422, .9494, .9657, .9478 +c *, .9513, .9541, .9472, .9439, .9640 +c *, .9452, .9397, .9440, .9390, .9416 +c *, .9424, .9394, .9334, .9366, .9348 +c *, .9338, .9414, .9312, .9115, .9286 +c *, .9373, .9287, .9190, .9248, .9232 +c *, .9339, .9214, .9201, .9183, .9181 +c *, .9170, .9150, .9138, .9071, .9117 +c *, .9106, .9092, .9084, .9253, .9053 +c *, .9061, .9052, .9132, .9032, .9029 +c *, .9008, .8973, .8954, .8928, .9115 +c *, .9021, .8938, .8997, .8907, .8921 +c *, .8834, .8831, .8795, .8774, .8755 +c *, .8745, .8682, .8849, .8649, .8705 +c *, .8616, .8684, .8691, .8634, .8687 +c *, .8636, .8616, .8581, .8571, .8575 +c *, .8582, .8551, .8575, .8582, .8618 +c *, .8597, .8619, .8634, .8693, .8645 +c *, .8682, .8538, .8759, .8818, .8831 +c *, .8853/ +c data (pimecm(i),i=1,400)/ +c * 1.1046, 1.1133, 1.1394, 1.1425, 1.1495 +c *, 1.1579, 1.1585, 1.1592, 1.1598, 1.1677 +c *, 1.1691, 1.1731, 1.1777, 1.1784, 1.1798 +c *, 1.1831, 1.1858, 1.1879, 1.1892, 1.1906 +c *, 1.1940, 1.1967, 1.1994, 1.2008, 1.2015 +c *, 1.2028, 1.2069, 1.2076, 1.2090, 1.2097 +c *, 1.2111, 1.2124, 1.2131, 1.2159, 1.2166 +c *, 1.2179, 1.2186, 1.2200, 1.2214, 1.2234 +c *, 1.2269, 1.2283, 1.2296, 1.2303, 1.2317 +c *, 1.2324, 1.2352, 1.2358, 1.2365, 1.2372 +c *, 1.2407, 1.2421, 1.2441, 1.2462, 1.2476 +c *, 1.2510, 1.2517, 1.2524, 1.2545, 1.2551 +c *, 1.2579, 1.2586, 1.2593, 1.2607, 1.2613 +c *, 1.2627, 1.2634, 1.2641, 1.2662, 1.2668 +c *, 1.2682, 1.2696, 1.2710, 1.2716, 1.2730 +c *, 1.2758, 1.2778, 1.2806, 1.2819, 1.2826 +c *, 1.2833, 1.2847, 1.2888, 1.2915, 1.2922 +c *, 1.2929, 1.2963, 1.3004, 1.3024, 1.3038 +c *, 1.3058, 1.3065, 1.3072, 1.3112, 1.3119 +c *, 1.3126, 1.3146, 1.3180, 1.3187, 1.3200 +c *, 1.3207, 1.3220, 1.3227, 1.3254, 1.3261 +c *, 1.3301, 1.3308, 1.3321, 1.3335, 1.3362 +c *, 1.3375, 1.3388, 1.3415, 1.3422, 1.3455 +c *, 1.3482, 1.3515, 1.3522, 1.3555, 1.3562 +c *, 1.3615, 1.3628, 1.3641, 1.3655, 1.3681 +c *, 1.3694, 1.3760, 1.3773, 1.3786, 1.3898 +c *, 1.3917, 1.3963, 1.3995, 1.4002, 1.4015 +c *, 1.4047, 1.4099, 1.4112, 1.4163, 1.4176 +c *, 1.4183, 1.4196, 1.4208, 1.4228, 1.4234 +c *, 1.4272, 1.4292, 1.4298, 1.4304, 1.4393 +c *, 1.4425, 1.4470, 1.4476, 1.4489, 1.4507 +c *, 1.4539, 1.4589, 1.4596, 1.4608, 1.4652 +c *, 1.4658, 1.4683, 1.4727, 1.4739, 1.4758 +c *, 1.4764, 1.4777, 1.4795, 1.4808, 1.4833 +c *, 1.4851, 1.4857, 1.4876, 1.4882, 1.4894 +c *, 1.4901, 1.4919, 1.4925, 1.4938, 1.4968 +c *, 1.4974, 1.4981, 1.4993, 1.5030, 1.5054 +c *, 1.5060, 1.5066, 1.5072, 1.5097, 1.5103 +c *, 1.5109, 1.5146, 1.5152, 1.5182, 1.5206 +c *, 1.5212, 1.5224, 1.5231, 1.5249, 1.5309 +c *, 1.5327, 1.5345, 1.5357, 1.5387, 1.5405 +c *, 1.5411, 1.5429, 1.5435, 1.5441, 1.5465 +c *, 1.5489, 1.5507, 1.5513, 1.5519, 1.5548 +c *, 1.5590, 1.5614, 1.5637, 1.5655, 1.5673 +c *, 1.5702, 1.5708, 1.5761, 1.5802, 1.5825 +c *, 1.5831, 1.5843, 1.5849, 1.5866, 1.5890 +c *, 1.5936, 1.5948, 1.5977, 1.5994, 1.6017 +c *, 1.6052, 1.6058, 1.6087, 1.6092, 1.6138 +c *, 1.6173, 1.6178, 1.6190, 1.6236, 1.6258 +c *, 1.6276, 1.6287, 1.6298, 1.6315, 1.6327 +c *, 1.6367, 1.6372, 1.6378, 1.6400, 1.6406 +c *, 1.6423, 1.6480, 1.6513, 1.6519, 1.6525 +c *, 1.6547, 1.6553, 1.6614, 1.6631, 1.6637 +c *, 1.6648, 1.6653, 1.6659, 1.6681, 1.6692 +c *, 1.6703, 1.6720, 1.6726, 1.6731, 1.6742 +c *, 1.6792, 1.6798, 1.6803, 1.6820, 1.6825 +c *, 1.6853, 1.6858, 1.6864, 1.6875, 1.6935 +c *, 1.6957, 1.6963, 1.6979, 1.6990, 1.7067 +c *, 1.7072, 1.7121, 1.7127, 1.7132, 1.7186 +c *, 1.7202, 1.7208, 1.7213, 1.7224, 1.7235 +c *, 1.7240, 1.7267, 1.7278, 1.7294, 1.7342 +c *, 1.7348, 1.7391, 1.7407, 1.7428, 1.7476 +c *, 1.7503, 1.7535, 1.7545, 1.7609, 1.7614 +c *, 1.7667, 1.7714, 1.7735, 1.7741, 1.7767 +c *, 1.7772, 1.7798, 1.7824, 1.7835, 1.7871 +c *, 1.7929, 1.7960, 1.8001, 1.8032, 1.8058 +c *, 1.8130, 1.8182, 1.8212, 1.8218, 1.8238 +c *, 1.8253, 1.8258, 1.8289, 1.8320, 1.8370 +c *, 1.8386, 1.8436, 1.8446, 1.8507, 1.8512 +c *, 1.8557, 1.8588, 1.8638, 1.8678, 1.8713 +c *, 1.8762, 1.8777, 1.8792, 1.8807, 1.8827 +c *, 1.8857, 1.8881, 1.8886, 1.8936, 1.8975 +c *, 1.9010, 1.9063, 1.9132, 1.9186, 1.9205 +c *, 1.9249, 1.9254, 1.9273, 1.9283, 1.9317 +c *, 1.9326, 1.9374, 1.9423, 1.9451, 1.9495 +c *, 1.9519, 1.9538, 1.9614, 1.9709, 1.9733 +c *, 1.9747, 1.9799, 1.9884, 1.9903, 1.9987 +c *, 2.0034, 2.0117, 2.0164, 2.0182, 2.0196 +c *, 2.0330, 2.0335, 2.0358, 2.0540, 2.0581 +c *, 2.0636, 2.0654, 2.0798, 2.0812, 2.0816 +c */ +c data (pimecm(i),i=401,578)/ +c * 2.0933, 2.1013, 2.1075, 2.1221, 2.1261 +c *, 2.1305, 2.1375, 2.1445, 2.1588, 2.1658 +c *, 2.1740, 2.1804, 2.1877, 2.2026, 2.2119 +c *, 2.2166, 2.2187, 2.2305, 2.2510, 2.2626 +c *, 2.2688, 2.2717, 2.3040, 2.3121, 2.3315 +c *, 2.3483, 2.3538, 2.3737, 2.3744, 2.3925 +c *, 2.4050, 2.4105, 2.4128, 2.4267, 2.4302 +c *, 2.4513, 2.4627, 2.4892, 2.5069, 2.5266 +c *, 2.5561, 2.5634, 2.5802, 2.5925, 2.5997 +c *, 2.6284, 2.6355, 2.6557, 2.6708, 2.6987 +c *, 2.7057, 2.7401, 2.7673, 2.7741, 2.7966 +c *, 2.8077, 2.8343, 2.8409, 2.8672, 2.8769 +c *, 2.8997, 2.9093, 2.9318, 2.9341, 2.9414 +c *, 2.9636, 2.9731, 3.0045, 3.0262, 3.0355 +c *, 3.0570, 3.0656, 3.0662, 3.0876, 3.0967 +c *, 3.1268, 3.1566, 3.1774, 3.1862, 3.2067 +c *, 3.2155, 3.2445, 3.2733, 3.3018, 3.3216 +c *, 3.3329, 3.3609, 3.3887, 3.4163, 3.4190 +c *, 3.4436, 3.4675, 3.4707, 3.4869, 3.4976 +c *, 3.5509, 3.6033, 3.6550, 3.6575, 3.7059 +c *, 3.7312, 3.7462, 3.8402, 3.8935, 3.9887 +c *, 4.0004, 4.3873, 4.4341, 4.6811, 4.7210 +c *, 4.7408, 4.8387, 4.8406, 5.0288, 5.0844 +c *, 5.2120, 5.2353, 5.3889, 5.4254, 5.5603 +c *, 5.6123, 5.7265, 5.7787, 5.8880, 5.9451 +c *, 5.9671, 5.9953, 6.0792, 6.1984, 6.2241 +c *, 6.3479, 6.5070, 6.6369, 6.8140, 6.9138 +c *, 7.0734, 7.2450, 7.3962, 7.5617, 7.7092 +c *, 7.9841, 7.9865, 8.1584, 8.1814, 8.3628 +c *, 8.4410, 8.6582, 8.6593, 8.7144, 8.9794 +c *, 9.2369, 9.2845, 9.4874, 9.7314, 9.7775 +c *, 9.9694, 10.2020, 10.3580, 10.4293, 10.5988 +c *, 10.6517, 10.8697, 11.0833, 11.4987, 13.7295 +c *, 15.0339, 16.6334, 16.8018, 17.8835, 18.1439 +c *, 19.3933, 19.6336, 21.2400, 22.9386, 24.1342 +c *, 25.2733, 26.0050, 26.3632 +c */ +c data (pimbmx(i),i=1,400)/ +c * .5314, .5314, .6580, .7092, .7506 +c *, .8215, .8579, .8406, .8349, .9441 +c *, .9657, 1.0363, 1.0686, 1.1085, 1.1185 +c *, 1.1899, 1.1658, 1.2218, 1.2322, 1.2653 +c *, 1.3273, 1.2374, 1.3611, 1.3716, 1.3267 +c *, 1.3986, 1.4150, 1.3399, 1.4701, 1.4516 +c *, 1.4723, 1.4955, 1.4494, 1.4161, 1.4558 +c *, 1.4625, 1.5006, 1.5128, 1.5160, 1.4584 +c *, 1.4991, 1.4791, 1.4217, 1.4799, 1.4799 +c *, 1.4588, 1.4844, 1.4172, 1.4273, 1.4439 +c *, 1.4166, 1.4127, 1.3739, 1.3624, 1.3971 +c *, 1.3297, 1.3231, 1.3285, 1.2878, 1.2952 +c *, 1.2679, 1.2641, 1.2976, 1.2386, 1.2463 +c *, 1.3025, 1.2489, 1.2239, 1.1902, 1.2114 +c *, 1.1955, 1.2083, 1.1658, 1.1686, 1.1603 +c *, 1.1424, 1.1185, 1.1160, 1.1013, 1.1070 +c *, 1.1041, 1.0823, 1.0645, 1.0779, 1.0295 +c *, 1.0311, .9950, 1.0155, .9950, 1.0029 +c *, .9767, 1.0249, .9853, .9657, .9906 +c *, .9608, .9591, .9805, .9458, .9575 +c *, .9422, .9407, .9558, .9473, .9271 +c *, .9132, .9236, .9219, .9219, .9575 +c *, .9097, .9224, .9094, .9202, .8903 +c *, .9224, .9160, .9122, .9094, .8956 +c *, .9167, .9271, .9398, .9184, .9277 +c *, .9310, .9184, .9354, .9219, .9300 +c *, .9303, .9508, .9451, .9680, .9399 +c *, .9420, .9387, .9667, .9248, .9915 +c *, .9698, .9626, 1.0187, .9659, .9441 +c *, .9766, .9694, 1.0061, .9789, .9757 +c *, .9803, 1.0495, 1.0218, 1.0026, 1.0706 +c *, 1.0277, 1.0302, 1.0690, 1.0552, 1.0406 +c *, 1.0801, 1.0522, 1.1284, 1.1226, 1.1270 +c *, 1.0934, 1.0968, 1.1381, 1.0915, 1.1543 +c *, 1.1775, 1.2101, 1.1247, 1.1506, 1.1781 +c *, 1.1546, 1.1968, 1.1604, 1.1697, 1.2072 +c *, 1.2058, 1.2489, 1.1912, 1.2141, 1.1928 +c *, 1.1986, 1.1978, 1.2256, 1.2565, 1.2029 +c *, 1.2127, 1.1997, 1.2035, 1.1791, 1.1853 +c *, 1.1914, 1.1927, 1.2616, 1.2303, 1.1848 +c *, 1.1507, 1.2399, 1.1510, 1.1898, 1.1499 +c *, 1.1337, 1.1433, 1.1089, 1.1517, 1.2008 +c *, 1.1598, 1.1030, 1.0798, 1.1165, 1.1213 +c *, 1.1190, 1.0861, 1.0776, 1.0653, 1.0730 +c *, 1.1106, 1.0908, 1.0945, 1.0650, 1.0882 +c *, 1.0720, 1.0540, 1.0925, 1.0718, 1.1377 +c *, 1.0867, 1.0802, 1.1090, 1.0936, 1.0915 +c *, 1.1316, 1.1575, 1.1202, 1.1275, 1.0908 +c *, 1.1142, 1.1507, 1.1890, 1.1863, 1.2114 +c *, 1.1142, 1.2001, 1.1312, 1.1930, 1.2563 +c *, 1.2489, 1.2919, 1.2652, 1.2425, 1.2149 +c *, 1.2386, 1.2616, 1.3207, 1.3299, 1.2816 +c *, 1.3296, 1.3562, 1.2957, 1.3831, 1.3028 +c *, 1.3806, 1.3704, 1.3202, 1.4082, 1.3482 +c *, 1.3730, 1.3351, 1.3886, 1.3348, 1.3957 +c *, 1.3929, 1.3790, 1.3791, 1.3946, 1.3641 +c *, 1.3877, 1.3566, 1.3564, 1.3762, 1.3253 +c *, 1.3739, 1.3252, 1.3234, 1.3423, 1.3159 +c *, 1.2643, 1.2700, 1.2584, 1.2466, 1.2841 +c *, 1.2191, 1.2052, 1.2794, 1.2835, 1.2374 +c *, 1.2061, 1.1936, 1.1947, 1.2476, 1.1481 +c *, 1.1496, 1.2187, 1.1427, 1.2101, 1.1192 +c *, 1.1445, 1.1371, 1.1613, 1.0994, 1.1020 +c *, 1.1233, 1.1041, 1.0896, 1.0890, 1.0880 +c *, 1.0802, 1.0946, 1.0940, 1.0670, 1.0761 +c *, 1.0817, 1.0702, 1.0723, 1.0779, 1.0789 +c *, 1.0733, 1.0771, 1.0767, 1.0710, 1.0705 +c *, 1.0720, 1.0729, 1.0472, 1.0959, 1.0788 +c *, 1.0739, 1.0645, 1.0681, 1.0749, 1.0789 +c *, 1.0799, 1.0795, 1.0763, 1.0588, 1.0805 +c *, 1.0724, 1.0660, 1.0663, 1.0801, 1.0988 +c *, 1.0797, 1.0816, 1.0687, 1.0690, 1.0724 +c *, 1.0721, 1.0777, 1.0650, 1.0715, 1.0617 +c *, 1.0690, 1.0678, 1.0714, 1.0323, 1.0672 +c *, 1.0630, 1.0564, 1.0600, 1.0636, 1.0499 +c *, 1.0479, 1.0481, 1.0463, 1.0510, 1.0450 +c *, 1.0171, 1.0517, 1.0498, 1.0510, 1.0412 +c *, 1.0374, 1.0501, 1.0388, 1.0449, 1.0449 +c *, 1.0311, 1.0510, 1.0505, 1.0449, 1.0567 +c *, 1.0572, 1.0495, 1.0632, 1.0461, 1.0403 +c */ +c data (pimbmx(i),i=401,578)/ +c * 1.0629, 1.0642, 1.0525, 1.0709, 1.0585 +c *, 1.0612, 1.0717, 1.0731, 1.0660, 1.0761 +c *, 1.0696, 1.0767, 1.0755, 1.0720, 1.0615 +c *, 1.0665, 1.0660, 1.0714, 1.0670, 1.0650 +c *, 1.0627, 1.0621, 1.0499, 1.0499, 1.0457 +c *, 1.0405, 1.0372, 1.0412, 1.0331, 1.0299 +c *, 1.0299, 1.0241, 1.0321, 1.0306, 1.0232 +c *, 1.0252, 1.0171, 1.0211, 1.0226, 1.0178 +c *, 1.0083, 1.0157, 1.0138, .9918, 1.0140 +c *, 1.0028, 1.0120, 1.0077, 1.0088, .9979 +c *, 1.0052, 1.0025, .9876, .9987, .9990 +c *, .9944, .9845, .9918, .9777, .9892 +c *, .9754, .9856, .9812, .9816, .9831 +c *, .9674, .9800, .9781, .9679, .9756 +c *, .9805, .9759, .9739, .9672, .9718 +c *, .9701, .9682, .9632, .9664, .9538 +c *, .9647, .9628, .9613, .9596, .9449 +c *, .9585, .9572, .9553, .9540, .9624 +c *, .9527, .9468, .9513, .9525, .9503 +c *, .9479, .9459, .9438, .9424, .9422 +c *, .9407, .9457, .9399, .9385, .9368 +c *, .9409, .9248, .9209, .9034, .8974 +c *, .9150, .9089, .9145, .9146, .9080 +c *, .9044, .9082, .9069, .9062, .8938 +c *, .9034, .9045, .9011, .8921, .8979 +c *, .8925, .8982, .8975, .8976, .8947 +c *, .8962, .8932, .8916, .8913, .8888 +c *, .8889, .8892, .8880, .8881, .8842 +c *, .8815, .8826, .8832, .8813, .8826 +c *, .8791, .8835, .8831, .8833, .8782 +c *, .8789, .8813, .8797, .8780, .8744 +c *, .8782, .8842, .8777, .8777, .8789 +c *, .8815, .8800, .8839, .8740, .8732 +c *, .8751, .8784, .8757, .8779, .8630 +c *, .8802, .8775, .8851, .8874, .8903 +c *, .8935, .8965, .8965 +c */ +c data kmpecm/ +c * 1.4691, 1.4720, 1.4750, 1.4780, 1.4811 +c *, 1.4837, 1.4843, 1.4860, 1.4876, 1.4910 +c *, 1.4944, 1.4979, 1.5014, 1.5032, 1.5050 +c *, 1.5087, 1.5091, 1.5124, 1.5132, 1.5162 +c *, 1.5170, 1.5200, 1.5220, 1.5239, 1.5278 +c *, 1.5318, 1.5354, 1.5358, 1.5362, 1.5378 +c *, 1.5399, 1.5440, 1.5523, 1.5607, 1.5654 +c *, 1.5688, 1.5775, 1.5784, 1.5863, 1.5916 +c *, 1.5947, 1.6023, 1.6050, 1.6055, 1.6086 +c *, 1.6145, 1.6159, 1.6172, 1.6191, 1.6236 +c *, 1.6319, 1.6328, 1.6332, 1.6420, 1.6461 +c *, 1.6466, 1.6522, 1.6563, 1.6582, 1.6614 +c *, 1.6642, 1.6694, 1.6712, 1.6717, 1.6768 +c *, 1.6806, 1.6811, 1.6839, 1.6843, 1.6867 +c *, 1.6885, 1.6961, 1.6965, 1.7003, 1.7022 +c *, 1.7083, 1.7087, 1.7172, 1.7177, 1.7181 +c *, 1.7229, 1.7243, 1.7276, 1.7342, 1.7374 +c *, 1.7436, 1.7459, 1.7483, 1.7539, 1.7610 +c *, 1.7629, 1.7633, 1.7718, 1.7770, 1.7789 +c *, 1.7793, 1.7817, 1.7840, 1.7873, 1.7892 +c *, 1.8028, 1.8037, 1.8075, 1.8135, 1.8140 +c *, 1.8219, 1.8247, 1.8261, 1.8308, 1.8369 +c *, 1.8401, 1.8406, 1.8410, 1.8475, 1.8480 +c *, 1.8489, 1.8540, 1.8559, 1.8605, 1.8647 +c *, 1.8721, 1.8744, 1.8767, 1.8785, 1.8836 +c *, 1.8951, 1.8955, 1.8983, 1.9001, 1.9029 +c *, 1.9065, 1.9184, 1.9202, 1.9243, 1.9348 +c *, 1.9393, 1.9411, 1.9434, 1.9483, 1.9547 +c *, 1.9628, 1.9637, 1.9659, 1.9699, 1.9798 +c *, 1.9838, 1.9923, 1.9958, 2.0047, 2.0127 +c *, 2.0149, 2.0162, 2.0255, 2.0277, 2.0308 +c *, 2.0417, 2.0430, 2.0487, 2.0579, 2.0653 +c *, 2.0679, 2.0713, 2.0813, 2.0882, 2.0925 +c *, 2.1028, 2.1105, 2.1126, 2.1211, 2.1232 +c *, 2.1258, 2.1351, 2.1444, 2.1507, 2.1528 +c *, 2.1654, 2.1675, 2.1687, 2.1737, 2.1837 +c *, 2.1862, 2.1937, 2.2044, 2.2131, 2.2143 +c *, 2.2274, 2.2356, 2.2478, 2.2546, 2.2659 +c *, 2.2756, 2.2836, 2.2976, 2.2996, 2.3162 +c *, 2.3166, 2.3296, 2.3335, 2.3363, 2.3535 +c *, 2.3562, 2.3725, 2.3729, 2.3748, 2.3887 +c *, 2.3918, 2.3933, 2.4006, 2.4109, 2.4174 +c *, 2.4223, 2.4299, 2.4352, 2.4488, 2.4518 +c *, 2.4675, 2.4705, 2.4861, 2.4887, 2.4936 +c *, 2.5046, 2.5230, 2.5412, 2.5593, 2.5701 +c *, 2.5773, 2.5952, 2.6023, 2.6059, 2.6130 +c *, 2.6306, 2.6447, 2.6482, 2.6656, 2.6795 +c *, 2.6829, 2.7002, 2.7173, 2.7848, 2.8540 +c *, 2.9216, 2.9407, 2.9878, 3.0096, 3.0250 +c *, 3.0526, 3.1783, 3.2191, 3.2993, 3.3887 +c *, 3.5239, 3.6924, 3.7800, 3.9967, 4.0200 +c *, 4.1348, 4.4617, 4.4826, 4.7663, 4.8636 +c *, 4.9779, 5.1080, 5.1263, 5.2349, 5.3237 +c *, 5.4110, 5.5479, 5.5816, 5.8281, 5.9080 +c *, 6.0801, 6.2173, 6.3664, 6.6545, 6.9306 +c *, 7.2610, 7.5770, 7.7605, 7.8207, 7.9985 +c *, 8.1725, 8.2297, 8.4546, 8.7275, 8.9922 +c *, 9.2493, 9.4994, 9.7431, 9.9809, 10.2131 +c *, 11.5086, 13.7378, 15.0415, 16.8085, 17.8898 +c *, 19.3991, 21.2453, 22.9435, 24.1389 +c */ +c data kmpbmx/ +c * 1.9033, 1.7662, 1.7298, 1.7544, 1.5461 +c *, 1.6991, 1.6205, 1.5898, 1.5817, 1.5023 +c *, 1.5554, 1.5086, 1.5065, 1.4948, 1.4799 +c *, 1.4927, 1.4854, 1.6136, 1.6017, 1.7312 +c *, 1.4884, 1.7075, 1.5574, 1.5260, 1.5002 +c *, 1.4571, 1.3991, 1.3219, 1.3434, 1.3635 +c *, 1.3315, 1.2966, 1.2213, 1.1604, 1.1930 +c *, 1.1382, 1.1354, 1.1583, 1.1185, 1.1156 +c *, 1.0645, 1.0247, 1.0969, 1.0779, 1.1083 +c *, 1.0749, 1.0155, 1.0464, 1.0754, 1.0202 +c *, 1.0470, 1.0615, 1.0540, 1.0357, 1.0605 +c *, 1.0428, 1.0265, 1.0187, 1.0611, 1.0615 +c *, 1.0295, 1.0651, 1.0823, 1.0077, 1.0764 +c *, 1.1298, 1.1013, 1.1080, 1.1070, 1.1368 +c *, 1.1382, 1.1410, 1.1418, 1.1312, 1.1466 +c *, 1.1378, 1.1241, 1.0896, 1.1264, 1.0720 +c *, 1.1368, 1.1013, 1.1442, 1.1466, 1.1612 +c *, 1.1726, 1.1755, 1.1576, 1.1726, 1.1848 +c *, 1.1617, 1.2029, 1.1686, 1.2274, 1.2252 +c *, 1.1726, 1.2256, 1.2244, 1.2008, 1.2332 +c *, 1.2828, 1.2548, 1.2412, 1.2887, 1.2853 +c *, 1.2653, 1.2540, 1.2527, 1.2449, 1.2118 +c *, 1.1781, 1.1902, 1.1767, 1.1859, 1.1410 +c *, 1.1594, 1.1800, 1.1185, 1.1256, 1.1354 +c *, 1.1131, 1.1562, 1.1143, 1.1382, 1.0841 +c *, 1.0587, 1.0632, 1.0311, 1.0617, 1.0150 +c *, 1.0309, 1.0174, 1.0110, 1.0171, .9961 +c *, .9719, .9938, .9869, .9953, .9966 +c *, 1.0189, .9977, .9918, .9948, 1.0034 +c *, .9737, 1.0066, 1.0137, 1.0041, 1.0171 +c *, 1.0303, 1.0223, 1.0322, .9751, 1.0331 +c *, 1.0118, 1.0403, 1.0399, 1.0429, 1.0171 +c *, 1.0279, 1.0467, 1.0414, 1.0217, 1.0432 +c *, 1.0379, 1.0280, 1.0351, 1.0171, 1.0278 +c *, 1.0314, 1.0213, 1.0133, 1.0240, 1.0080 +c *, 1.0018, .9964, .9984, .9889, .9910 +c *, .9903, .9801, .9852, .9853, .9847 +c *, .9800, .9832, .9770, .9749, .9754 +c *, .9723, .9741, .9744, .9738, .9751 +c *, .9780, .9738, .9738, .9684, .9712 +c *, .9669, .9680, .9671, .9576, .9619 +c *, .9624, .9585, .9588, .9586, .9525 +c *, .9253, .9518, .9503, .9491, .9463 +c *, .9476, .9420, .9458, .9434, .9341 +c *, .9444, .9412, .9393, .9395, .9210 +c *, .9370, .9358, .8974, .9400, .9342 +c *, .9305, .9141, .9271, .9267, .9228 +c *, .9233, .9219, .9247, .9296, .9253 +c *, .9089, .8992, .8946, .8992, .9062 +c *, .9069, .8874, .9219, .8746, .8795 +c *, .8740, .8704, .8785, .8795, .8667 +c *, .8849, .8510, .8463, .8612, .8292 +c *, .8292, .8387, .8273, .8273, .8292 +c *, .8292, .8349, .8234, .8349, .8176 +c *, .8292, .8180, .8193, .8154, .8130 +c *, .8121, .8145, .8078, .7959, .8088 +c *, .8075, .8064, .8056, .8086, .8048 +c *, .8080, .8068, .8050, .8042, .8050 +c *, .8054, .8064, .8096, .8095, .8107 +c *, .8135, .8234, .8238, .8263 +c */ +c data kmnecm/ +c * 1.6212, 1.6781, 1.7053, 1.7863, 1.7882 +c *, 1.8271, 1.9025, 2.0152, 2.1237, 2.2157 +c *, 2.4252, 2.6054, 2.6160, 2.9441, 3.5279 +c *, 3.6965, 4.0245, 4.4666, 4.8690, 5.1136 +c *, 5.2406, 5.4169, 5.5877, 5.9144, 6.2241 +c *, 6.9381, 7.5852, 8.1813, 8.7369, 9.2592 +c *, 9.7536, 10.2241, 11.5209, 13.7525, 15.0575 +c *, 16.8264, 17.9089, 19.4198, 21.2680, 22.9680 +c *, 24.1646 +c */ +c data kmnbmx/ +c * .9132, .9966, .9772, .9966, 1.1382 +c *, 1.0794, .9674, .9167, .8795, .8500 +c *, .8482, .8444, .8330, .8078, .8349 +c *, .8368, .7919, .8146, .8019, .8156 +c *, .7999, .7961, .8038, .8038, .7949 +c *, .7868, .7864, .7910, .7850, .7870 +c *, .7906, .7885, .7945, .7971, .8011 +c *, .8003, .8029, .8082, .8088, .8156 +c *, .8189 +c */ +c data kppecm/ +c * 1.4447, 1.4516, 1.4522, 1.4585, 1.4663 +c *, 1.4750, 1.5036, 1.5050, 1.5091, 1.5239 +c *, 1.5378, 1.5523, 1.5654, 1.5784, 1.5916 +c *, 1.5929, 1.6014, 1.6037, 1.6050, 1.6150 +c *, 1.6159, 1.6191, 1.6259, 1.6264, 1.6268 +c *, 1.6328, 1.6378, 1.6461, 1.6517, 1.6587 +c *, 1.6605, 1.6652, 1.6792, 1.6843, 1.6853 +c *, 1.6928, 1.7073, 1.7101, 1.7210, 1.7294 +c *, 1.7374, 1.7422, 1.7483, 1.7539, 1.7643 +c *, 1.7662, 1.7704, 1.7789, 1.7793, 1.7864 +c *, 1.7897, 1.8028, 1.8070, 1.8135, 1.8191 +c *, 1.8327, 1.8355, 1.8373, 1.8517, 1.8587 +c *, 1.8605, 1.8679, 1.8725, 1.8813, 1.8836 +c *, 1.9038, 1.9070, 1.9289, 1.9298, 1.9321 +c *, 1.9524, 1.9533, 1.9749, 1.9807, 1.9950 +c *, 1.9972, 1.9994, 2.0074, 2.0193, 2.0435 +c *, 2.0492, 2.0635, 2.0653, 2.0851, 2.1040 +c *, 2.1066, 2.1083, 2.1279, 2.1296, 2.1490 +c *, 2.1507, 2.1717, 2.1908, 2.1924, 2.2110 +c *, 2.2131, 2.2213, 2.2319, 2.2335, 2.2538 +c *, 2.2724, 2.2740, 2.2940, 2.3123, 2.3138 +c *, 2.3375, 2.3531, 2.3725, 2.3903, 2.3918 +c *, 2.4109, 2.4197, 2.4299, 2.4413, 2.4488 +c *, 2.4675, 2.4861, 2.5046, 2.5230, 2.5266 +c *, 2.5412, 2.5521, 2.5593, 2.5773, 2.5952 +c *, 2.6130, 2.6306, 2.6482, 2.6656, 2.6829 +c *, 2.7002, 2.7173, 3.0096, 3.0556, 3.1754 +c *, 3.3887, 3.5239, 3.7800, 4.0200, 4.1348 +c *, 4.4617, 4.6469, 4.7663, 4.8636, 4.9591 +c *, 5.1263, 5.2349, 5.4110, 5.5816, 5.7308 +c *, 5.9080, 6.0646, 6.2173, 6.9306, 7.5770 +c *, 7.8207, 8.1725, 8.7275, 9.2493, 9.7431 +c *, 10.2131, 11.5086, 13.7378, 15.0415, 16.6402 +c *, 16.8085, 17.8898, 18.1501, 19.3991, 21.2453 +c *, 22.9435, 24.1389 +c */ +c data kppbmx/ +c * .5412, .6308, .6024, .6050, .5971 +c *, .6037, .6232, .6103, .6482, .6601 +c *, .6386, .6466, .6438, .6204, .6482 +c *, .6358, .6333, .6445, .6443, .6346 +c *, .6410, .6227, .6283, .6308, .6403 +c *, .6290, .6457, .5984, .6333, .5955 +c *, .5944, .6295, .6346, .6090, .6433 +c *, .6383, .6482, .6425, .6543, .6588 +c *, .6652, .6768, .6730, .6723, .6815 +c *, .7040, .6898, .7014, .7001, .7181 +c *, .7130, .7159, .7067, .7440, .7345 +c *, .7365, .7485, .7382, .7474, .7574 +c *, .7588, .7559, .7590, .7582, .7668 +c *, .7592, .7682, .7661, .7697, .7548 +c *, .7661, .7626, .7626, .7563, .7590 +c *, .7578, .7611, .7557, .7555, .7506 +c *, .7498, .7517, .7508, .7540, .7464 +c *, .7538, .7512, .7527, .7534, .7527 +c *, .7565, .7521, .7529, .7525, .7444 +c *, .7517, .7334, .7485, .7491, .7510 +c *, .7466, .7476, .7478, .7472, .7485 +c *, .7378, .7451, .7468, .7474, .7476 +c *, .7459, .7410, .7461, .7457, .7414 +c *, .7464, .7457, .7444, .7444, .7444 +c *, .7442, .7291, .7421, .7429, .7421 +c *, .7397, .7386, .7373, .7389, .7384 +c *, .7384, .7386, .7378, .7569, .7878 +c *, .7548, .7356, .7526, .7421, .7715 +c *, .7568, .7590, .7777, .7421, .7632 +c *, .7464, .7442, .7548, .7367, .7736 +c *, .7378, .7421, .7455, .7502, .7510 +c *, .7653, .7529, .7580, .7544, .7614 +c *, .7605, .7661, .7703, .7805, .7883 +c *, .7850, .7907, .7611, .7961, .8023 +c *, .8068, .8111 +c */ +c data kpnecm/ +c * 1.6875, 1.7430, 1.7670, 1.7816, 1.7905 +c *, 1.8144, 1.8383, 1.8615, 1.8749, 1.8846 +c *, 1.9080, 1.9308, 1.9345, 1.9535, 1.9760 +c *, 1.9974, 1.9983, 2.0205, 2.0460, 2.0647 +c *, 2.0678, 2.0864, 2.1066, 2.1079, 2.1109 +c *, 2.1292, 2.1322, 2.1504, 2.1533, 2.1743 +c *, 2.1922, 2.1951, 2.2157, 2.2239, 2.2334 +c *, 2.2362, 2.2565, 2.2739, 2.2767, 2.2967 +c *, 2.3138, 2.3166, 2.3402, 2.3559, 2.3753 +c *, 2.3919, 2.3946, 2.4138, 2.4328, 2.4517 +c *, 2.4704, 2.4891, 2.5076, 2.5259, 2.5442 +c *, 2.5551, 2.5623, 2.5803, 2.5982, 2.6160 +c *, 2.6337, 2.6513, 2.6687, 2.6861, 2.7033 +c *, 2.7204, 3.5279, 4.0245, 4.4666, 4.8690 +c *, 5.2406, 5.4169, 5.5877, 5.9144, 6.2241 +c *, 6.9381, 7.5852, 8.1813, 8.7369, 9.2592 +c *, 9.7536, 10.2241, 11.5209, 13.7525, 15.0575 +c *, 16.8264, 17.9089, 19.4198, 21.2680, 22.9680 +c *, 24.1646 +c */ +c data kpnbmx/ +c * .7024, .7324, .7485, .7527, .7680 +c *, .7758, .8100, .8224, .7611, .8151 +c *, .8031, .7915, .7674, .7842, .7822 +c *, .7590, .7791, .7767, .7758, .7734 +c *, .7754, .7709, .7674, .7713, .7742 +c *, .7752, .7748, .7721, .7680, .7707 +c *, .7674, .7713, .7715, .7695, .7684 +c *, .7734, .7682, .7709, .7672, .7659 +c *, .7653, .7653, .7506, .7626, .7624 +c *, .7701, .7588, .7622, .7592, .7491 +c *, .7588, .7574, .7592, .7582, .7571 +c *, .7464, .7559, .7538, .7529, .7529 +c *, .7534, .7538, .7487, .7487, .7498 +c *, .7474, .7464, .7485, .7464, .7485 +c *, .7464, .7565, .7442, .7485, .7545 +c *, .7555, .7542, .7634, .7653, .7686 +c *, .7671, .7723, .7695, .7785, .7824 +c *, .7905, .7927, .7923, .8052, .8100 +c *, .8137 +c */ +cc data lpecm/ +cc * 2.0577, 2.0583, 2.0593, 2.0595, 2.0609 +cc *, 2.0617, 2.0629, 2.0642, 2.0643, 2.0647 +cc *, 2.0666, 2.0671, 2.0683, 2.0692, 2.0709 +cc *, 2.0720, 2.0783, 2.0818, 2.0935, 2.1022 +cc *, 2.1058, 2.1117, 2.1326, 2.1559, 2.1731 +cc *, 2.1811, 2.2079, 2.2360, 2.2505, 2.3107 +cc *, 2.3733, 2.4534, 2.4695, 2.9278, 5.2476 +cc */ +cc data lpbmx/ +cc * 2.5793, 2.3937, 1.9381, 2.3736, 2.0342 +cc *, 2.2068, 1.9381, 1.8797, 1.7841, 1.7930 +cc *, 1.2676, 1.6641, 1.4604, 1.0403, 1.3470 +cc *, 1.0420, .8722, .8368, .5323, .5352 +cc *, .8867, .5382, .8106, .8043, .8058 +cc *, .8630, .7031, .7777, .9441, 1.0403 +cc *, .9772, .6628, 1.1968, 1.0555, 1.0495 +cc */ +c data pi1ecm/ +c * .45000, .55000, .62500, .68750, .73750 +c *, .78750, .83750, .88750, .95000, 1.02500 +c *, 1.10000, 1.17500 +c */ +c data pi1bmx/ +c * .48533, .47873, .55852, .58087, .55279 +c *, .49185, .47203, .46181, .46181, .47203 +c *, .41459, .40684 +c */ +c data pi2ecm/ +c * .45000, .55000, .62500, .68750, .73750 +c *, .78750, .83750, .88750, .95000, 1.02500 +c *, 1.10000, 1.17500 +c */ +c data pi2bmx/ +c * .45135, .80385, .87767, 1.28779, 1.81771 +c *, 2.07296, 1.55536, .95912, .94407, .77768 +c *, .70467, .54408 +c */ +c data pi3ecm/ +c * .45000, .55000, .61250, .65000, .67500 +c *, .70000, .72500, .75000, .77500, .80000 +c *, .82500, .85000, .87500, .90000, .93750 +c *, 1.02500, 1.10000, 1.17500 +c */ +c data pi3bmx/ +c * .50463, .79988, 1.13541, 1.30497, 1.34462 +c *, 1.52957, 1.63809, 1.94216, 1.98511, 1.66316 +c *, 1.69163, 1.62933, 1.06152, .96574, .83302 +c *, .71365, .66517, .59173 +c */ +c data pi4ecm/ +c * .28500, .29500, .30500, .31500, .37000 +c *, .46000, .54375, .61250, .65000, .67500 +c *, .70000, .72500, .75000, .77500, .80000 +c *, .82500, .85000, .87500, .90125, .92750 +c *, .96000 +c */ +c data pi4bmx/ +c * .29854, .46181, .54115, .54115, .51709 +c *, .72031, .80976, .96078, .90798, 1.07788 +c *, 1.37389, 1.70101, 2.02716, 1.83687, 1.52644 +c *, 1.57469, 1.35640, .93390, .98531, .84062 +c *, .79188 +c */ +c data pi5ecm/0.75,0.80,0.85,0.90,0.95,1.00,1.05,1.10,1.15/ +c data pi5bmx/0.4,0.5,0.7,0.9,1.1,1.1,0.7,0.6,0.5/ +c +c call utpri('jintcs',ish,ishini,7) +c +c ics=0 +c +c if(idptl(i).gt.10000)then +c call idquad(i,nqi,nai,jci) +c if(nqi.eq.0)then +c idi=999 +c else +c idi=9999 +c endif +c else +c idi=idptl(i) +c endif +c +c if(idptl(j).gt.10000)then +c call idquad(j,nqj,naj,jcj) +c if(nqj.eq.0)then +c idj=999 +c else +c idj=9999 +c endif +c else +c idj=idptl(j) +c endif +c +c do k=1,nflav +c kc(k)=jc(k,1)-jc(k,2) +c if(nq.lt.0)kc(k)=-kc(k) +c enddo +c if(nq.lt.0)nq=-nq +c +c if(ish.ge.7)then +c write(ifch,*)'i:',i,' id_i:',idptl(i),' j:',j,' id_j:',idptl(j) +c write(ifch,*)'E_cm:',ecm,' jc:',(jc(k,1),k=1,6),(jc(k,2),k=1,6) +c write(ifch,*)'nq:',nq,' kc:',(kc(k),k=1,6) +c endif +c +cc check minimal kinetic energy +c ekin=ecm-pptl(5,i)-pptl(5,j) +c if(ekin.lt.amimel)goto1000 +c +cc ------------------------------------------------------------------------- +c if(iabs(idi).gt.1000.or.iabs(idj).gt.1000)then !baryon involved +cc ------------------------------------------------------------------------- +c +c if(nq.eq.6)then !------------baryon-baryon -----> +c +c if(kc(1).eq.kc(2))then !isospin_z=0 +cc pn +c if(ish.ge.7)write(ifch,*)'sig_pn chosen' +c if(ecm.lt.2)then +c call utindx(npn,pnecm,ecm,iecm) +c bmx=pnbmx(iecm) +c else +c p=ecm*sqrt((ecm**2/4./.94**2)-1.) +c if(p.lt.1.)then +c sig=33.+196.*(abs(0.95-p))**2.5 +c elseif(p.lt.2)then +c sig=24.2+8.9*p +c else +c sig=47.3+.513*(alog(p)**2)-4.27*alog(p) +c endif +c bmx=sqrt(sig/10./pi) +c endif +c else !isospin_z=+-1 +cc pp +c if(ish.ge.7)write(ifch,*)'sig_pp chosen' +c if(ecm.le.1.882)then +c bmx=ppbmx(1) +c if(ish.ge.7)write(ifch,*)'b_mx:',bmx +c elseif(ecm.le.1.887)then +c bmx=ppbmx(2) +c if(ish.ge.7)write(ifch,*)'b_mx:',bmx +c elseif(ecm.le.1.893)then +c bmx=ppbmx(3) +c if(ish.ge.7)write(ifch,*)'b_mx:',bmx +c elseif(ecm.le.1.899)then +c bmx=ppbmx(4) +c elseif(ecm.le.1.909)then +c bmx=ppbmx(5) +c elseif(ecm.le.1.913)then +c bmx=ppbmx(6) +c elseif(ecm.le.1.918)then +c bmx=ppbmx(7) +c else +c p=ecm*sqrt((ecm**2/4./.94**2)-1.) +c if(p.lt.0.8)then +c sig=23.5+1000.*(0.7-p)**4 +c elseif(p.lt.1.5)then +c sig=23.5+24.6/(1+exp(-(p-1.2)/0.1)) +c elseif(p.lt.5)then +c sig=41.+60.*(p-0.9)*exp(-1.2*p) +c else +c sig=48+.522*(alog(p)**2)-4.51*alog(p) +c endif +c bmx=sqrt(sig/10./pi) +c endif +c endif +c +c elseif(nq.eq.0)then !-----------baryon-antibaryon ----> +c +c if(kc(1).eq.0.and.kc(2).eq.0.and.kc(3).eq.0)then !p-ap, n-an +cc app +c if(ish.ge.7)write(ifch,*)'sig_app chosen' +c if(ecm.lt.2)then +c call utindx(napp,appecm,ecm,iecm) +c bmx=appbmx(iecm) +c else +c p=ecm*sqrt((ecm**2/4./.94**2)-1.) +c sig=38.4+77.6*p**(-.64)+.26*(alog(p)**2)-1.2*alog(p) +c bmx=sqrt(sig/10./pi) +c endif +c else !p-an, n-ap +cc apn +c if(ish.ge.7)write(ifch,*)'sig_apn chosen' +c if(ecm.lt.2)then +c call utindx(napn,apnecm,ecm,iecm) +c bmx=apnbmx(iecm) +c else +c p=ecm*sqrt((ecm**2/4./.94**2)-1.) +c sig=133.6*p**(-.7)-1.22*(alog(p)**2)+13.7*alog(p) +c bmx=sqrt(sig/10./pi) +c endif +c endif +c +c elseif(nq.eq.3)then !----------baryon-meson ----> +c +c if(kc(3).eq.0)then +cc no kaons involved(except for K-L) +c if(kc(1).eq.0.or.kc(2).eq.0)then +cc pip +c if(ish.ge.7)write(ifch,*)'sig_pip chosen' +c if(ecm.lt.2.5)then +c call utindx(npip,pipecm,ecm,iecm) +c bmx=pipbmx(iecm) +c else +c p=sqrt(((ecm**2-0.94**2-0.14**2)/2./0.94)**2.-0.14**2) +c sig=16.4+19.3*p**(-.42)+.19*(alog(p)**2) +c bmx=sqrt(sig/10./pi) +c endif +c else +cc pim +c if(ish.ge.7)write(ifch,*)'sig_pim chosen' +c if(ecm.lt.2.5)then +c call utindx(npim,pimecm,ecm,iecm) +c bmx=pimbmx(iecm) +c else +c p=sqrt(((ecm**2-0.94**2-0.14**2)/2./0.94)**2.-0.14**2) +c sig=33.0+14.0*p**(-1.36)+.456*(alog(p)**2)-4.03*alog(p) +c bmx=sqrt(sig/10./pi) +c endif +c endif +c elseif(kc(3).eq.1)then +cc strange particles involved +c if(kc(1).eq.0.or.kc(2).eq.0)then +cc kmn +c if(ish.ge.7)write(ifch,*)'sig_kmn chosen' +c if(ecm.lt.2.5)then +c call utindx(nkmn,kmnecm,ecm,iecm) +c bmx=kmnbmx(iecm) +c else +c p=sqrt(((ecm**2-0.94**2-0.49**2)/2./0.94)**2.-0.49**2) +c sig=25.2+.38*(alog(p)**2)-2.9*alog(p) +c bmx=sqrt(sig/10./pi) +c endif +c else +cc kmp +c if(ish.ge.7)write(ifch,*)'sig_kmp chosen' +c if(ecm.lt.2.5)then +c call utindx(nkmp,kmpecm,ecm,iecm) +c bmx=kmpbmx(iecm) +c else +c p=sqrt(((ecm**2-0.94**2-0.49**2)/2./0.94)**2.-0.49**2) +c sig=32.1+.66*(alog(p)**2)-5.6*alog(p) +c bmx=sqrt(sig/10./pi) +c endif +c endif +c elseif(kc(3).eq.-1)then +cc strange particles involved +c if(kc(1).eq.3.or.kc(2).eq.3)then +cc kpp +c if(ish.ge.7)write(ifch,*)'sig_kpp chosen' +c if(ecm.lt.2.5)then +c call utindx(nkpp,kppecm,ecm,iecm) +c bmx=kppbmx(iecm) +c else +c p=sqrt(((ecm**2-0.94**2-0.49**2)/2./0.94)**2.-0.49**2) +c sig=18.1+.26*(alog(p)**2)-alog(p) +c bmx=sqrt(sig/10./pi) +c endif +c else +cc kpn +c if(ish.ge.7)write(ifch,*)'sig_kpn chosen' +c if(ecm.lt.2.5)then +c call utindx(nkpn,kpnecm,ecm,iecm) +c bmx=kpnbmx(iecm) +c else +c p=sqrt(((ecm**2-0.94**2-0.49**2)/2./0.94)**2.-0.49**2) +c sig=18.7+.21*(alog(p)**2)-.89*alog(p) +c bmx=sqrt(sig/10./pi) +c endif +c endif +c elseif(kc(3).ge.2)then +cc two strange particles involved +c bmx=1. +c elseif(kc(3).le.-2)then +cc two strange particles involved +c bmx=1. +c endif +c +c else !-----------baryon_cluster-anything----> +c +c write(ifch,*)'i:',i,' id_i:',idptl(i),' j:',j,' id_j:',idptl(j) +c write(ifch,*)'r_i:',radptl(i),' r_j:',radptl(j) +c write(ifch,*)'E_cm:',ecm,' jc:',(jc(k,1),k=1,6),(jc(k,2),k=1,6) +c write(ifch,*)'nq:',nq,' kc:',(kc(k),k=1,6) +c bmx=radptl(i)+radptl(j) +c +c endif ! <-------------- +c +cc ------------------------------------- +c else ! meson-meson +cc ------------------------------------- +c +c call idquad(i,nqi,nai,jci) +c call idquad(j,nqj,naj,jcj) +c do l=1,nflav +c kci(l)=jci(l,1)-jci(l,2) +c kcj(l)=jcj(l,1)-jcj(l,2) +c enddo +c +c if(kci(3).eq.0.and.pptl(5,i).le.1.0 +c * .and.kcj(3).eq.0.and.pptl(5,j).le.1.0)then +c +c if(kci(1).eq.0.and.kci(2).eq.0.and.pptl(5,i).le.0.5)then +c if(kcj(1).eq.0.and.kcj(2).eq.0.and.pptl(5,j).le.0.5)then +cc pi0 pi0 +c goto104 +c elseif(kcj(1).eq.1.and.kcj(2).eq.-1)then +cc pi0 pi+ +c goto102 +c elseif(kcj(1).eq.-1.and.kcj(2).eq.1)then +cc pi0 pi- +c goto103 +c else +cc pi0 eta +c goto105 +c endif +c elseif(kci(1).eq.1.and.kci(2).eq.-1)then +c if(kcj(1).eq.0.and.kcj(2).eq.0.and.pptl(5,j).le.0.5)then +cc pi+ pi0 +c goto102 +c elseif(kcj(1).eq.1.and.kcj(2).eq.-1)then +cc pi+ pi+ +c goto101 +c elseif(kcj(1).eq.-1.and.kcj(2).eq.1)then +cc pi+ pi- +c goto104 +c else +cc pi+ eta +c goto105 +c endif +c elseif(kci(1).eq.-1.and.kci(2).eq.1)then +c if(kcj(1).eq.0.and.kcj(2).eq.0.and.pptl(5,j).le.0.5)then +cc pi- pi0 +c goto103 +c elseif(kcj(1).eq.1.and.kcj(2).eq.-1)then +cc pi- pi+ +c goto104 +c elseif(kcj(1).eq.-1.and.kcj(2).eq.1)then +cc pi- pi- +c goto101 +c else +cc pi- eta +c goto105 +c endif +c else +c if(pptl(5,j).le.0.5)then +cc eta pi +c goto105 +c else +cc eta eta +c goto106 +c endif +c endif +c101 continue +c if(ish.ge.7)write(ifch,*)'sig_pi+pi+ chosen' +c call utindx(npi1,pi1ecm,ecm,iecm) +c bmx=pi1bmx(iecm) +c goto110 +c102 continue +c if(ish.ge.7)write(ifch,*)'sig_pi+pi0 chosen' +c call utindx(npi2,pi2ecm,ecm,iecm) +c bmx=pi2bmx(iecm) +c goto110 +c103 continue +c if(ish.ge.7)write(ifch,*)'sig_pi-pi0 chosen' +c call utindx(npi3,pi3ecm,ecm,iecm) +c bmx=pi3bmx(iecm) +c goto110 +c104 continue +c if(ish.ge.7)write(ifch,*)'sig_pi-pi+ chosen' +c call utindx(npi4,pi4ecm,ecm,iecm) +c bmx=pi4bmx(iecm) +c goto110 +c105 continue +c if(ish.ge.7)write(ifch,*)'sig_pi_eta chosen' +c call utindx(npi5,pi5ecm,ecm,iecm) +c bmx=pi5bmx(iecm) +c goto110 +c106 continue +c if(ish.ge.7)write(ifch,*)'sig_eta_eta chosen' +c bmx=0.4 ! approx. sig=5mb +c110 continue +c +c else !something else involved, strange etc. +c +c bmx=0.6 ! approx. sig=10mb +c +c endif +c +cc -------------------------------- +c endif +cc -------------------------------- +c +c if(bij.le.bmx)ics=1 +c if(ish.ge.7)then +c write(ifch,*)'b_mx:',bmx,' b_ij:',bij,' ics:',ics +c endif +c +c1000 continue +c call utprix('jintcs',ish,ishini,7) +c return +c end +c +cc---------------------------------------------------------------------- +c subroutine jintel(i,j,p,amim,xaver) +cc---------------------------------------------------------------------- +cc elastic scattering of ptls i,j +cc---------------------------------------------------------------------- +c include 'epos.inc' +c real xaver(4) +c real p(5),u(5),pei(5),pej(5) +c +cc determine momenta of outgoing particles (pei,pej) +cc ------------------------------------------------- +c if(p(5).le.(pptl(5,i)+pptl(5,j))*.99)then +c if(ish.ge.1)then +c call utmsg('jintel') +c write(ifch,132)p(5),pptl(5,i)+pptl(5,j) +c132 format(1x,'***** m_fus < m_i+m_j ---> qcm set zero ( ' +c *,2f10.3,' )') +c write(ifch,133)'p_i: ',(pptl(k,i),k=1,5) +c write(ifch,133)'p_j: ',(pptl(k,j),k=1,5) +c write(ifch,133)'p_fus:',(p(k),k=1,5) +c133 format(1x,a6,3x,5f10.3) +c call utmsgf +c endif +c qcm=0. +c elseif(p(5).le.pptl(5,i)+pptl(5,j))then +c qcm=0. +c else +c qcm=utpcm(p(5),pptl(5,i),pptl(5,j)) +c endif +c +cc isotropic +c u(3)=2.*rangen()-1. +c phi=2.*pi*rangen() +c u(1)=sqrt(1.-u(3)**2)*cos(phi) +c u(2)=sqrt(1.-u(3)**2)*sin(phi) +c do 47 k=1,3 +c pei(k)= qcm*u(k) +c47 pej(k)=-qcm*u(k) +c +cc nonisotropic +cc-c pt=sqrt(2./pi)*ptq*sqrt(-2*alog(rangen()) !2-dim Gauss +cc-c if(pt.ge.qcm)pt=rangen()*qcm +cc-c qpl=sqrt(qcm**2-pt**2) +cc-c u(3)=qpl +cc-c phi=2.*pi*rangen() +cc-c u(1)=pt*cos(phi) +cc-c u(2)=pt*sin(phi) +cc-c call utaxis(i,j,a1,a2,a3) +cc-c ivt=1 +cc-c if(a3.lt.0.)then +cc-c a1=-a1 +cc-c a2=-a2 +cc-c a3=-a3 +cc-c ivt=-1 +cc-c endif +cc-c call utrota(-1,a1,a2,a3,u(1),u(2),u(3)) +cc-c do 47 k=1,3 +cc-c pei(k)= u(k)*ivt +cc-c47 pej(k)=-u(k)*ivt +c +c pei(4)=sqrt(qcm**2+pptl(5,i)**2) +c pej(4)=sqrt(qcm**2+pptl(5,j)**2) +c pei(5)=pptl(5,i) +c pej(5)=pptl(5,j) +c call utlobo(-1,p(1),p(2),p(3),p(4),p(5) +c *,pei(1),pei(2),pei(3),pei(4)) +c call utlobo(-1,p(1),p(2),p(3),p(4),p(5) +c *,pej(1),pej(2),pej(3),pej(4)) +c +cc fill /cptl/ +cc ----------- +c do 49 lo=1,2 +c nptl=nptl+1 +c if(lo.eq.1)ij=i +c if(lo.eq.2)ij=j +c do 48 k=1,5 +c if(lo.eq.1)pptl(k,nptl)=pei(k) +c if(lo.eq.2)pptl(k,nptl)=pej(k) +c48 continue +c istptl(nptl)=0 +c idptl(nptl)=idptl(ij) +c ibptl(1,nptl)=ibptl(1,ij) +c ibptl(2,nptl)=ibptl(2,ij) +c ibptl(3,nptl)=ibptl(3,ij) +c ibptl(4,nptl)=ibptl(4,ij) +c xorptl(1,nptl)=xaver(1) +c xorptl(2,nptl)=xaver(2) +c xorptl(3,nptl)=xaver(3) +c xorptl(4,nptl)=xaver(4) +c iorptl(nptl)=i +c jorptl(nptl)=j +c tivptl(1,nptl)=xaver(4) +c call idtau(idptl(nptl),pptl(4,nptl),pptl(5,nptl),taugm) +c tivptl(2,nptl)=tivptl(1,nptl)+taugm*(-alog(rangen())) +c ifrptl(1,nptl)=0 +c ifrptl(2,nptl)=0 +c ityptl(nptl)=ityptl(ij) +c49 continue +c +c1000 return +c end +c +cc---------------------------------------------------------------------- +c subroutine jintfs(i,j,p,nq,jc,amim,iret) +cc---------------------------------------------------------------------- +cc input: +cc i,j: particle indices +cc output: +cc p: 5-momentum of fused ptl +cc nq: net quark number of fused ptl +cc jc: jc of fused ptl +cc amim : minimum mass of fused ptl +cc iret: return code +cc 0=ok +cc 1=mass p(5) less than amim +cc---------------------------------------------------------------------- +c include 'epos.inc' +c integer jci(nflav,2),jcj(nflav,2),jc(nflav,2) +c real p(5) +c double precision ppfus(4),pp52 +c +c iret=0 +c +c do 35 k=1,4 +c p(k)=pptl(k,i)+pptl(k,j) +c35 ppfus(k)=dble(p(k)) +c pp52=ppfus(4)**2-ppfus(3)**2-ppfus(2)**2-ppfus(1)**2 +c if(pp52.le.0.)then +c if(ish.ge.1)then +c call utmsg('jintfs') +c write(ifch,*)'***** mfus**2 < 0 (',pp52,' )' +c write(ifch,*)(ppfus(m),m=1,4) +c call utmsgf +c endif +c goto1001 +c endif +c p(5)=sngl(dsqrt(pp52)) +c +c call idquad(i,nqi,nai,jci) +c call idquad(j,nqj,naj,jcj) +c do 29 n=1,nflav +c do 29 k=1,2 +c29 jc(n,k)=jci(n,k)+jcj(n,k) +c nq=0 +c do 54 n=1,nflav +c54 nq=nq+jc(n,1)-jc(n,2) +c +c call idcomj(jc) +c amim=utamnz(jc,5)+amimfs +c if(p(5).lt.amim)goto1001 +c goto1000 +c1001 iret=1 +c1000 return +c end +c +cc---------------------------------------------------------------------- +c subroutine jintfu(i,j,p,jc) +cc---------------------------------------------------------------------- +cc input: +cc i,j: particle indices +cc p,jc: momentum and jc of fused object +cc outout: +cc id, ib, ist, ior, jor, ifr, ity of fused particle +cc written to /cptl/ after increasing nptl by 1 +cc---------------------------------------------------------------------- +c +c include 'epos.inc' +c parameter (mxlook=10000,mxdky=2000) +c common/dkytab/look(mxlook),cbr(mxdky),mode(5,mxdky) +c real p(5) +c integer jc(nflav,2),ic(2),ib(4) +c +c nptl=nptl+1 +c +cc momentum +c do k=1,5 +c pptl(k,nptl)=p(k) +c enddo +c amf=p(5) +c +cc determine idr, ib(1-4) +c idr=0 +c do 40 nf=1,nflav +c do 40 ij=1,2 +c if(jc(nf,ij).ge.10)idr=7*10**8 +c40 continue +c if(idr/10**8.ne.7)then +c call idenco(jc,ic,ireten) +c if(ireten.eq.1)call utstop('jintfu: idenco ret code = 1&') +c id=idtra(ic,0,0,3) +c43 amc=amf +c call idres(id,amc,idr,iadj) +c if(idr.ne.0)then +c lid=look(iabs(idr)) +c if((lid.le.0.or.lid.gt.0.and.mode(2,lid).eq.0) +c *.and.pptl(5,nptl).gt.amc+1e-3)then +c amf=amf+0.010 +c goto43 +c endif +c if((lid.le.0.or.lid.gt.0.and.mode(2,lid).eq.0) +c *.and.abs(amc-pptl(5,nptl)).gt.1e-3)then +c if(ish.ge.1)then +c call utmsg('jintfu') +c write(ifch,*)'***** not on mass shell after fusion: ' +c *,pptl(5,nptl),amc +c call utmsgf +c endif +c endif +c endif +c if(idr.eq.0)then +c if(mod(ic(1),100).ne.0.or.mod(ic(2),100).ne.0)then +c idr=9*10**8 +c else +c idr=8*10**8+ic(1)*100+ic(2)/100 +c endif +c endif +c else +c call idtrbi(jc,ib(1),ib(2),ib(3),ib(4)) +c idr=idr +c *+mod(jc(1,1)+jc(2,1)+jc(3,1)+jc(4,1),10**4)*10**4 +c *+mod(jc(1,2)+jc(2,2)+jc(3,2)+jc(4,2),10**4) +c if(ish.ge.7)write(ifch,*)'ib:',(ib(kk),kk=1,4) +c endif +c +c n=nptl +c +cc fill /cptl/ +cc ----------- +c idptl(n)=idr +c do k=1,4 +c ibptl(k,n)=ib(k) +c enddo +c istptl(n)=0 +c iorptl(n)=i +c jorptl(n)=j +c ifrptl(1,n)=0 +c ifrptl(2,n)=0 +c ityptl(n)=50 +c +c return +c end +c +c---------------------------------------------------------------------- + subroutine jintpo(lclean,iret) +c---------------------------------------------------------------------- +c parton-ladder-fusion -- 3D grid -- based on string segments +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incico' + common/cxyzt/xptl(mxptl),yptl(mxptl),zptl(mxptl),tptl(mxptl) + *,optl(mxptl),uptl(mxptl),sptl(mxptl),rptl(mxptl,3) + parameter(m1grid=10,kgrid=3,kegrid=3) + parameter(m3xgrid=21*kgrid*kegrid) + parameter(mxcl=4000,mxcli=1000) + integer idropgrid(m1grid,m1grid,m3xgrid) + & ,jdropgrid(m1grid,m1grid,m3xgrid) + & ,jclu(m3xgrid),nsegp4(mxcl) + & ,irep(mxcl),mmji(mxcl,mxcli) + & ,jccl(mxcl,nflav,2),nseg(mxcl),mseg(mxcl),kclu(mxcl) + & ,naseg(0:mxcl),nfseg(mxcl),nsegmx(mxcl) + & ,jc(nflav,2),ke(6),jcjj(nflav,2) + & ,nsegmt(mxptl),kmean(2,1001:1000+mxcl) + & ,ncluj(1001:1000+mxptl) !,ic(2),nclk(m3xgrid) + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat + & ,pptld(5,mxcl),p4tmp + double precision enp,pzp,ena,pza,ccc,sss,enew,pznew,taa2,pta2 + .,pold,pnew,pnew2,p5a2,eeta,enf,pzf + common /cttaus/tpro,zpro,ttar,ztar,ttaus,detap,detat + common/cdelzet/delzet,delsgr /cvocell/vocell + common/cranphi/ranphi + parameter(maxp=40*mxcl) + dimension yrad(maxp),phirad(maxp),pe(5),yrad2(maxp),nfrag(mxptl) + logical first,lnew(m1grid,m1grid),lold(m1grid,m1grid),lcont,lpass + &,lclean + double precision ptest(5),ttest,p52,p4mean(4,mxcl),zor,tor,xmxms + &,ppp(5),be(4),energ,bp,rmean(2,mxcl) !,qqq(5),www(5) + dimension mpair(mamx,mamx) + save ncntpo!,ntrr,ntrt + data ncntpo /0/!,ntrr/0/,ntrt/0/ + ncntpo=ncntpo+1 + call utpri('jintpo',ish,ishini,4) + tauico=ttaus + + if(kigrid.gt.kgrid)then + write(ifmt,*)'kigrid,kgrid:',kigrid,kgrid + stop'jintpo: kigrid too big. ' + endif + + fegrid=yhaha/5.36 !rapidity range/rap range at RHIC + if(fegrid.gt.kegrid)then + write(ifmt,*)'fegrid,kegrid:',fegrid,kegrid + stop'jintpo: kegrid too small. ' + endif + + m3grid=m3xgrid /kgrid *kigrid /kegrid *fegrid +c if(iLHC.eq.1)m3grid=min(m3xgrid,int(m3grid*0.75)) + if(mod(m3grid,2).eq.0)m3grid=m3grid+1 + + xgrid=8 + sgrid=fsgrid *ttaus *fegrid *6.0 + delxgr=2*xgrid/m1grid + delsgr=2*sgrid/m3grid + shiftx=(1.-2.*rangen())*rangen()*delxgr/2. + shifts=(1.-2.*rangen())*rangen()*delsgr/2. + vocell= delxgr * delxgr * delsgr + delzet=delsgr/ttaus + nptla=nptl + iflhc=1 + if(iLHC.eq.1)iflhc=min(3,max(1,nsegce-1)) + nsegsuj=max(nsegce,nint(float(nsegsu/iflhc)*fegrid)) + xmxms=150d0 !maximum mass for a subcluster + + if(ncntpo.eq.1)then + write(ifmt,*)'EPOS used with FUSION option' + if(ish.ge.1)then + print*,'+',('-',i=1,57) + print*,'| ttaus sgrid nsegce:',ttaus,fsgrid,' ',nsegce + print*,'| sgrid delxgr delsgr vocell:',sgrid,delxgr,delsgr,vocell + print*,'+',('-',i=1,57) + endif + endif +c print*,'+',('-',i=1,57) + +c...compute x,y,z + + if(ish.ge.6)write(ifch,*)'compute x,y,z' + do n=1,nptla + iaaptl(n)=1 + !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! + ! the following check is important for ioclude= 4 or 5 + !!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! + if(ioclude.ne.3.and.istptl(n).eq.10)then + stop'\n\n remnant cluster detected in jintpo\n\n' + endif + if(istptl(n).eq.0.or.istptl(n).eq.10)then + call jtain(n,xptl(n),yptl(n),zptl(n),tptl(n),nnn,0) + call idtau(idptl(n),pptl(4,n),pptl(5,n),taurem) + if(abs(taurem).gt.1e-6.and. + . ityptl(n).ge.40.and.ityptl(n).le.59.and.nnn.eq.1)then + iaaptl(n)=0 !!!!nnn=1: ptl lives later +c print*,n,ityptl(n),idptl(iorptl(n)),istptl(iorptl(n)),nnn + endif + call jtaus(zptl(n),tz,sptl(n)) + strap=1e10 + xpl=tptl(n)+zptl(n) + xmi=tptl(n)-zptl(n) + if(xmi.gt.0.0.and.xpl.gt.0.0)then + strap=0.5*log(xpl/xmi) + else !particle at eta=inf + iaaptl(n)=0 + endif + dezptl(n)=strap !space-time-rapidity +c write(ifch,*)'dez ???',n,nnn,taurem,ityptl(n) +c & ,pptl(4,n),pptl(3,n),idptl(n),xptl(n),yptl(n),zptl(n),sptl(n) + else + iaaptl(n)=0 + xptl(n)=0. + yptl(n)=0. + zptl(n)=0. + sptl(n)=0. + dezptl(n)=1e10 + endif + enddo + ntry=0 + +c...valid particles + +c print *,'start -----------------------------------------' + ptmax=ptclu**2 + nptlo=1 + if(iLHC.eq.1)nptlo=maproj+matarg+1 + do n=1,nptla + !random number calls before if's + !to keep random number sequence for testing + rdm=rangen() + if(istptl(n).eq.0)then + call idquac(n,idum1,idum2,idum3,jc) + else + jc(4,1)=0 + jc(4,2)=0 + endif + if(iaaptl(n).ne.0)then + if(istptl(n).ne.10)then + pt2=pptl(1,n)**2+pptl(2,n)**2 + am2tmp=(pptl(4,n)+pptl(3,n))*(pptl(4,n)-pptl(3,n))-pt2 + if(n.le.nptlo)then !spectators + iaaptl(n)=0 + elseif(ityptl(n).eq.47.or.ityptl(n).eq.57)then + iaaptl(n)=0 !no active spectators + elseif(istptl(n).ne.0.or.ityptl(n).ge.60)then + iaaptl(n)=0 + elseif(abs(idptl(n)).le.100)then + iaaptl(n)=0 !no fundamental particle (electron...) + !elseif(ityptl(n).eq.41.or.ityptl(n).eq.51)then + ! iaaptl(n)=0 !avoid particles coming from remnant droplet decay + ! !(already droplet decay products !) + elseif(abs(am2tmp-pptl(5,n)*pptl(5,n)).gt.30.)then + iaaptl(n)=0 !to discard off shell particles + elseif(jc(4,1).ne.0.or.jc(4,2).ne.0)then + iaaptl(n)=0 !to discard charmed particles + elseif(iLHC.eq.1)then + if(pt2.lt.1.e-3)then + iaaptl(n)=0 !to discard slow proton (spectators) + elseif(ptclu.gt.0.)then + if(pt2.gt.(1.5*ptclu)**2)then + ptmax=max(ptmax,pt2) + if(ioquen.eq.0.or.fploss.le.0.)then !high pt particle escape + iaaptl(n)=0 + elseif(fploss.gt.1.e10)then !high pt particle absorbed + iaaptl(n)=1 + else + iaaptl(n)=-1 !high pt particle lose energy + endif + elseif(pt2.gt.(0.5*ptclu)**2)then + if(rdm.lt.(sqrt(pt2)-0.5*ptclu)/ptclu)then + ptmax=max(ptmax,pt2) + if(ioquen.eq.0.or.fploss.le.0.)then !high pt particle escape + iaaptl(n)=0 + elseif(fploss.gt.1.e10)then !high pt particle absorbed + iaaptl(n)=1 + else + iaaptl(n)=-1 !high pt particle lose energy + endif + endif + endif + else + if(ioquen.eq.0.or.fploss.le.0.)then !high pt particle escape + iaaptl(n)=0 + elseif(fploss.gt.1.e10)then !high pt particle absorbed + iaaptl(n)=1 + else + iaaptl(n)=-1 !high pt particle lose energy + endif + endif + elseif(pt2.gt.(1.5*ptclu)**2)then + ptmax=max(ptmax,pt2) + if(maproj.lt.20.or.matarg.lt.20.or.ioquen.eq.0)then + iaaptl(n)=0 + endif + elseif(pt2.gt.(0.5*ptclu)**2)then + if(rdm.lt.(sqrt(pt2)-0.5*ptclu)/ptclu)then + if(maproj.lt.20.or.matarg.lt.20.or.ioquen.eq.0)iaaptl(n)=0 + endif + endif + endif + endif +c if(iaaptl(n).eq.0.and.abs(idptl(n)).le.10000.and.abs(idptl(n)) +c & .ge.100.and.mod(abs(idptl(n)),100).ne.0 +c & .and.ityptl(n).ne.0.and.ityptl(n).lt.50) +c & print*,'not selected',idptl(n),ityptl(n),pptl(4,n) + enddo + +c...Start cluster formation + + 8888 continue + + nsegsuj=max(nsegce,nint(nsegsuj/1.08**ntry)) + ntry=ntry+1 + if(ntry.gt.90) !do not put more than 100 or change limit for p4mean + &call utstop('jintpo: cluster formation impossible ! &') + nptl=nptla + + do 1 k=1,m3grid + do 1 j=1,m1grid + do 1 i=1,m1grid + idropgrid(i,j,k)=0 + 1 continue + +c...count string segments in cell + + if(ish.ge.6)write(ifch,*)'count string segments in cell' + do n=1,nptla + if(iaaptl(n).ne.0)then + i=1+(xptl(n)+xgrid+shiftx)/delxgr + j=1+(yptl(n)+xgrid+shiftx)/delxgr + k=1+(sptl(n)+sgrid+shifts)/delsgr + if( i.ge.1.and.i.le.m1grid + & .and.j.ge.1.and.j.le.m1grid + & .and.k.ge.1.and.k.le.m3grid)then + nfrag(n)=1 + if(iLHC.eq.1)then !count number of quarks to absorbe more baryon than mesons + call idquac(n,idum1,idum2,idum3,jc) + nfrag(n)=0 + do nj=1,2 + do ni=1,nflav + nfrag(n)=nfrag(n)+ni*jc(ni,nj) + enddo + enddo + + endif +c print *,idptl(n),nfrag(n) + idropgrid(i,j,k)=idropgrid(i,j,k)+nfrag(n) + endif + endif + enddo + + + if(iLHC.eq.1)then +cc...check high pt segments +c !to use this part one has to define: +c !... 1 = valid +c !... -1 = valid but high pt +c !... 0 = not valid +c + +c esu=0 +c do i=1,nptla +c if(istptl(i).eq.0.or.istptl(i).eq.3)esu=esu+pptl(4,i) +c enddo +c write(ifmt,'(a,41x,f15.1)')' +++++Eajint+++++',esu + + if(ish.ge.6)write(ifch,*)'check high pt segments' + if(fploss.gt.0.0)then + ein=0 + elo=0 + do n=1,nptla + delen=0. + if(iaaptl(n).eq.-1)then + i=1+(xptl(n)+xgrid+shiftx)/delxgr + j=1+(yptl(n)+xgrid+shiftx)/delxgr + k=1+(sptl(n)+sgrid+shifts)/delsgr + if( i.ge.1.and.i.le.m1grid + & .and.j.ge.1.and.j.le.m1grid + & .and.k.ge.1.and.k.le.m3grid)then + iescape=0 + xa=xptl(n) + ya=yptl(n) + eta=dezptl(n) + pz=pptl(3,n) + en=pptl(4,n) + taa2=pptl(1,n)**2+pptl(2,n)**2+pptl(5,n)**2 + pza=pz + ena=sqrt(taa2+pza**2) + enaxx=en + p5a2=pptl(5,n)**2 + pta2=pptl(1,n)**2+pptl(2,n)**2 + !transform to bjo + eeta=eta + ccc=cosh(eeta) + sss=sinh(eeta) + enp= ena*ccc-pza*sss + pzp=-ena*sss+pza*ccc + vz=pzp/enp + vx=pptl(1,n)/enp + vy=pptl(2,n)/enp + !print*,'+++++++',eta,vz,pz/en + if(vx.ne.0.0.or.vy.ne.0.0)then + if(abs(vx).ge.abs(vy))then + ica=1 + rat=vy/vx + is=sign(1.,vx) + l=i + va=xa + wa=ya + else + ica=2 + rat=vx/vy + is=sign(1.,vy) + l=j + va=ya + wa=xa + endif + if(is.eq.-1)then + imax=1 + else !if(is.eq. 1) + imax=m1grid + endif + vr=sqrt(vx**2+vy**2) + ratx=vz/vr + qu=fploss*delxgr*sqrt(1+rat**2)*sqrt(1+ratx**2) + do lu=l,imax,is + vu=-(xgrid+shiftx)+(lu-0.5)*delxgr + wu=wa+rat*(vu-va) + mu=1+(wu+xgrid+shiftx)/delxgr + if(mu.ge.1.and.mu.le.m1grid)then + if(ica.eq.1)then + ix=lu + jx=mu + else + ix=mu + jx=lu + endif + if(idropgrid(i,j,k).ge.nsegce)then + dens=float(idropgrid(ix,jx,k))/float(iflhc) + else + dens=0 + endif + !~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ + ! DeltaE ~ sqrt(T**3*E) * dL (BDMPS2008) + ! -> DeltaE ~ dens^3/8 * sqrt(E) *dL + !del=dens**(3./8.)*max(1.,sqrt(pptl(4,n))) + !~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ + escale=6 + xen=enp/escale + del=0.02*dens**(3./8.)*max(1.,sqrt(xen)) + delen=delen+del*escale*qu +c if(k.ge.m3grid/2-2.and.k.le.m3grid/2+4) +c & write(ifch,'(2i3,4x,2i3,4x,2i3,4x,i3,3f7.3)') +c & k,ica,i,j,ix,jx,idropgrid(ix,jx,k),qu,delen +c & ,pptl(4,n)-delen + endif + enddo + endif + pold=sqrt(pta2+pzp**2) + enew=enp-delen + pnew2=enew**2-p5a2 + if(enew.gt.0..and.pnew2.gt.0.)iescape=1 + if(iescape.eq.1)then + iaaptl(n)=0 + idropgrid(i,j,k)=idropgrid(i,j,k)-nfrag(n) + if(idropgrid(i,j,k).lt.0)stop'jintpo: not possible. ' + pnew=sqrt(pnew2) + p1=pnew*pptl(1,n)/pold + p2=pnew*pptl(2,n)/pold + pznew=pnew*pzp /pold + enf= enew*ccc+pznew*sss + pzf= enew*sss+pznew*ccc + if(ish.ge.1.and.enf.gt.ena.or.enf.ne.enf)then + if(ish.ge.1.and.(enf-ena.gt.0.1d0.or.enf.ne.enf))then + write(ifmt,*)'WWWW en gain for eta =',eta + write(ifmt,*)'e pz bf (lab)',ena,pza,enaxx + write(ifmt,*)'e pz bf (bjo)',enp,pzp ,enp**2-pzp**2 + write(ifmt,*)'e pz af (bjo)',enew,pznew,enew**2-pznew**2 + write(ifmt,*)'e pz af (lab)',enf,pzf ,enf**2-pzf**2 +c stop + endif + elseif(delen.gt.1e-3)then +c create fake particle with energy lost in cluster + nptl=nptl+1 + nptla=nptla+1 + istptl(nptl)=3 !daughter part of cluster + iaaptl(nptl)=1 + pptl(1,nptl)=pptl(1,n)-p1 + pptl(2,nptl)=pptl(2,n)-p2 + pptl(3,nptl)=pptl(3,n)-pzf + pptl(4,nptl)=pptl(4,n)-enf + do l=1,3 + xorptl(l,nptl)=xorptl(l,n) + enddo + ! mother + pptl(1,n)=p1 + pptl(2,n)=p2 + pptl(3,n)=pzf + tivptl(1,n)=xorptl(4,n) + pptl(4,n)=sqrt(pptl(1,n)**2+pptl(2,n)**2 + & +pptl(3,n)**2+pptl(5,n)**2) + if(abs(pptl(4,n)-enf).gt.0.01*pptl(4,n)) + & print *,'jintpo eloss',pptl(4,n),enf,(pptl(4,n)-enf)/pptl(4,n) + call idtau(idptl(n),pptl(4,n),pptl(5,n),taugm) + tivptl(2,n)=tivptl(1,n)+taugm*(-alog(rangen())) + ifrptl(1,n)=nptl + ! daughter + pptl(5,nptl)=0. + pptl(4,nptl)=sqrt(pptl(1,nptl)**2+pptl(2,nptl)**2 + & +pptl(3,nptl)**2+pptl(5,nptl)**2) + xorptl(4,nptl)=xorptl(4,n) + tivptl(1,nptl)=tivptl(1,n) + iorptl(nptl)=n + jorptl(nptl)=0 + idptl(nptl)=idptl(n)*100+sign(99,idptl(n)) + ityptl(nptl)=ityptl(n)+2 + xptl(nptl)=xptl(n) + yptl(nptl)=yptl(n) + zptl(nptl)=zptl(n) + sptl(nptl)=sptl(n) + dezptl(nptl)=dezptl(n) + if(ish.ge.6)write(ifch,*)'--> Virtual particle : ',nptl + & ,idptl(nptl),iorptl(nptl),ityptl(nptl),(pptl(kk,nptl),kk=1,5) + endif + elo= elo+ena-pptl(4,n) + !write(ifch,*)n,' escape' + else + iaaptl(n)=1 + ein=ein+pptl(4,n) + !write(ifch,*)n,'core' + endif + endif + endif + enddo + else + do n=1,nptla + if(iaaptl(n).eq.-1)then + iaaptl(n)=0 + endif + enddo + endif + +c eloss=esu +c esu=0 +c do i=1,nptla +c if(istptl(i).eq.0.or.istptl(i).eq.3)esu=esu+pptl(4,i) +c enddo +c write(ifmt,'(a,41x,f15.1)')' +++++Eajint+++++',esu +c eloss=eloss-esu +c write(ifch,*)'+++++ein,elo,eloss ',ein,elo,eloss + + +c do n=1,nptla +c if(iaaptl(n).eq.-1)then +c i=1+(xptl(n)+xgrid+shiftx)/delxgr +c j=1+(yptl(n)+xgrid+shiftx)/delxgr +c k=1+(sptl(n)+sgrid+shifts)/delsgr +c if( i.ge.1.and.i.le.m1grid +c & .and.j.ge.1.and.j.le.m1grid +c & .and.k.ge.1.and.k.le.m3grid)then +c if(idropgrid(i,j,k).lt.2*nsegce)then !surface segments +c iaaptl(n)=0 +c idropgrid(i,j,k)=idropgrid(i,j,k)-1 +c if(idropgrid(i,j,k).lt.0)stop'jintpo: not possible. ' +cc else +cc iaaptl(n)=1 +c endif +c endif +c endif +c enddo + + endif + +c...identify clusters + + ifirst=0 + if(ish.ge.6)write(ifch,*)'identify clusters' + do k=1,m3grid !~~~~~~k-loop + jjj=0 + do j=1,m1grid + first=.true. + do i=1,m1grid + if(idropgrid(i,j,k).ge.nsegce)then + if(first)then + ifirst=i + jjj=jjj+1 + if(jjj.gt.mxcl)stop'jintpo: mxcl too small. ' + irep(jjj)=0 + jj=jjj + first=.false. + endif + jdropgrid(i,j,k)=jj + if(j.gt.1)then + if(jdropgrid(i,j-1,k).ne.0)then + jjo=jdropgrid(i,j-1,k) + if(jjo.lt.jj)then + if(jj.eq.jjj)jjj=jjj-1 + jjx=jj + jj=jjo + do ii=ifirst,i + jdropgrid(ii,j,k)=jj + if(jdropgrid(ii,j-1,k).eq.jjx)then + if(jjx.gt.jjj)jjj=jjj+1 + jja=jjx + jjb=jj + 90 continue + if(irep(jja).eq.0.or.irep(jja).eq.jjb)then + irep(jja)=jjb + else + mn=min(irep(jja),jjb) + mx=max(irep(jja),jjb) + irep(jja)=mn + jja=mx + jjb=mn + goto 90 + endif + endif + enddo + elseif(jdropgrid(i,j-1,k).gt.jj)then + irep(jjo)=jj + endif + endif + endif + else + jdropgrid(i,j,k)=0 + first=.true. + endif + enddo + enddo + !~~~~cluster jj ---> cluster irep(jj) + do jj=jjj,1,-1 + if(irep(jj).ne.0)then + do j=1,m1grid + do i=1,m1grid + if(jdropgrid(i,j,k).eq.jj)jdropgrid(i,j,k)=irep(jj) + enddo + enddo + endif + enddo + !~~~~~remove empty cluster indices + jjjx=jjj + jjj=0 + jj=0 + do jjx=1,jjjx + if(irep(jjx).eq.0)then + jj=jj+1 + jjj=jjj+1 + else + do j=1,m1grid + do i=1,m1grid + if(jdropgrid(i,j,k).gt.jj) + & jdropgrid(i,j,k)=jdropgrid(i,j,k)-1 + enddo + enddo + endif + enddo + !~~~~~ + jclu(k)=jjj + enddo !~~~~~~~~~~~~~~~~~ END k-loop + +c...add segments to avoid holes + + if(ish.ge.6)write(ifch,*)'add segments from holes' + if(iohole.eq.1.and.iLHC.eq.1)then + do 83 n=1,nptla + if(iaaptl(n).eq.0)goto 83 + ihit=0 + i=1+(xptl(n)+xgrid+shiftx)/delxgr + j=1+(yptl(n)+xgrid+shiftx)/delxgr + k=1+(sptl(n)+sgrid+shifts)/delsgr + if( i.ge.1.and.i.le.m1grid + & .and.j.ge.1.and.j.le.m1grid + & .and.k.ge.1.and.k.le.m3grid)then + jgr=jdropgrid(i,j,k) + nplus=idropgrid(i,j,k) + if(jgr.eq.0)then + isgi=1 + if(rangen().gt.0.5)isgi=-1 + isgj=1 + if(rangen().gt.0.5)isgj=-1 + isgk=1 + if(rangen().gt.0.5)isgk=-1 + do ii=i-isgi,i+isgi,isgi + do jj=j-isgj,j+isgj,isgj + do kk=k-isgk,k+isgk,2*isgk + if( ii.ge.1.and.ii.le.m1grid + . .and.jj.ge.1.and.jj.le.m1grid + . .and.kk.ge.1.and.kk.le.m3grid)then + if(jdropgrid(ii,jj,kk).gt.0)nplus=nplus+1 +c nplus=idropgrid(ii,jj,kk)+iflhc + if(nplus.ge.nsegce)then + ihit=1 +c goto 84 + endif + endif + enddo + enddo + enddo + endif + endif +c 84 continue + if(ihit.eq.1)then + idropgrid(i,j,k)=nplus!idropgrid(i,j,k)+iflhc +c add cell randomly to adjacent cluster if any + isgi=1 + if(rangen().gt.0.5)isgi=-1 + isgj=1 + if(rangen().gt.0.5)isgj=-1 + do ii=i-isgi,i+isgi,2*isgi + do jj=j-isgj,j+isgj,2*isgj + if( ii.ge.1.and.ii.le.m1grid + . .and.jj.ge.1.and.jj.le.m1grid)then + jjj=jdropgrid(ii,jj,k) + if(jjj.gt.0)then + jdropgrid(i,j,k)=jjj + goto 83 + endif + endif + enddo + enddo +c if no adjacent cluster, create a new one + jclu(k)=jclu(k)+1 + jdropgrid(i,j,k)=jclu(k) + endif + 83 continue + endif + + if(ish.ge.8)then + write(ifch,*)'segment positions' + do k=1,m3grid + write(ifch,*)'k=',k,' jclu=',jclu(k) + & ,' s=',(k-1)*delsgr-sgrid-shifts + do j=m1grid,1,-1 + write(ifch,'(10i4,3x,10i4)')(idropgrid(i,j,k),i=1,m1grid) + & ,(jdropgrid(i,j,k),i=1,m1grid) + enddo + enddo + endif + +c...absolute clusters numbering (for all k) + + if(ish.ge.6)write(ifch,*)'absolute clusters numbering' + if(iLHC.eq.-1)then !fuse touching clusters along k (not used) +c midbin=m3grid/2 +c if(rangen().gt.0.5)midbin=midbin+1 + jjj=1000 + k=1 + jclu(k)=0 + do j=1,m1grid + do i=1,m1grid + if(jdropgrid(i,j,k).gt.0)then + jclu(k)=jclu(k)+1 + jjj=jjj+1 + ncluj(jjj)=0 + kmean(1,jjj)=k + kmean(2,jjj)=k + jjx=jdropgrid(i,j,k) + do jj=j,m1grid + do ii=i,m1grid + if(jdropgrid(ii,jj,k).eq.jjx)then + jdropgrid(ii,jj,k)=jjj + ncluj(jjj)=ncluj(jjj)+idropgrid(ii,jj,k) + endif + enddo + enddo + endif + enddo + enddo + do k=2,m3grid + do j=1,m1grid + do i=1,m1grid + lnew(i,j)=.true. + lold(i,j)=.true. + enddo + enddo + jclu(k)=0 + do j=1,m1grid + do i=1,m1grid + if(lnew(i,j).and.jdropgrid(i,j,k).gt.0)then + lcont=.false. + if(jdropgrid(i,j,k-1).gt.0)then + jj0=jdropgrid(i,j,k-1) + nlim=0 + if(jj0.gt.1000)nlim=ncluj(jj0) + if(nlim.lt.nsegsuj)then + jclu(k)=jclu(k)+1 + jjx=jdropgrid(i,j,k) + if(jjx.gt.jj0)then + do jj=jjx,jjj + ncluj(jj)=ncluj(jj+1) + kmean(1,jj)=kmean(1,jj+1) + kmean(2,jj)=kmean(2,jj+1) + enddo + jjj=jjj-1 + jclu(k)=jclu(k)-1 + endif + kmean(2,jj0)=k + do jj=1,m1grid + do ii=1,m1grid + if(lnew(ii,jj))then + if(jdropgrid(ii,jj,k).eq.jjx)then + jdropgrid(ii,jj,k)=jj0 + ncluj(jj0)=ncluj(jj0)+idropgrid(ii,jj,k) + lnew(ii,jj)=.false. + elseif(jdropgrid(ii,jj,k).gt.jjx.and.jjx.gt.jj0)then + jdropgrid(ii,jj,k)=jdropgrid(ii,jj,k)-1 + endif + endif + enddo + enddo + else + lcont=.true. + endif + else + lcont=.true. + endif + if(lcont.and.lold(i,j))then + jclu(k)=jclu(k)+1 + jjj=jjj+1 + ncluj(jjj)=0 + kmean(1,jjj)=k + kmean(2,jjj)=k + jjx=jdropgrid(i,j,k) + do jj=j,m1grid + do ii=i,m1grid + if(jdropgrid(ii,jj,k).eq.jjx)then + jdropgrid(ii,jj,k)=jjj + ncluj(jjj)=ncluj(jjj)+idropgrid(ii,jj,k) + lold(ii,jj)=.false. + endif + enddo + enddo + endif + endif + enddo + enddo + enddo + jjs=0 + do jj=1001,jjj + jjs=jjs+1 + kclu(jjs)=(kmean(1,jj)+kmean(2,jj))/2 + nseg(jjs)=0 + nsegp4(jjs)=0 + p4mean(1,jjs)=0d0 + p4mean(2,jjs)=0d0 + p4mean(3,jjs)=0d0 + p4mean(4,jjs)=0d0 + rmean(1,jjs)=0d0 !cluster distance to center + rmean(2,jjs)=0d0 !cluster maximal radius + enddo + do k=1,m3grid + do j=1,m1grid + do i=1,m1grid + if(jdropgrid(i,j,k).gt.0)then + jdropgrid(i,j,k)=jdropgrid(i,j,k)-1000 + endif + enddo + enddo + enddo + jjj=jjj-1000 + else + jjj=jclu(1) + do k=2,m3grid + do j=1,m1grid + do i=1,m1grid + if(jdropgrid(i,j,k).gt.0) + & jdropgrid(i,j,k)=jdropgrid(i,j,k)+jjj + enddo + enddo + jjj=jjj+jclu(k) + enddo + jjs=0 + do k=1,m3grid + do jj=1,jclu(k) + jjs=jjs+1 + kclu(jjs)=k + nseg(jjs)=0 + nsegp4(jjs)=0 + p4mean(1,jjs)=0d0 + p4mean(2,jjs)=0d0 + p4mean(3,jjs)=0d0 + p4mean(4,jjs)=0d0 + rmean(1,jjs)=0d0 !cluster distance to center + rmean(2,jjs)=0d0 !cluster maximal radius + enddo + enddo + endif + do 20 i=1,maproj + do 20 j=1,matarg + 20 mpair(j,i)=0 + + +c...calculate mean energy of segments going into in clusters + + if(ish.ge.6)write(ifch,*) + &'calculate mean energy of segments going into in clusters' + rmax=0. + do 95 n=1,nptla + if(iaaptl(n).eq.0)goto 95 + i=1+(xptl(n)+xgrid+shiftx)/delxgr + j=1+(yptl(n)+xgrid+shiftx)/delxgr + k=1+(sptl(n)+sgrid+shifts)/delsgr + if( i.ge.1.and.i.le.m1grid + & .and.j.ge.1.and.j.le.m1grid + & .and.k.ge.1.and.k.le.m3grid)then + jj=jdropgrid(i,j,k) + if(jj.gt.0)then + nsegp4(jj)=nsegp4(jj)+1 + io=iorptl(n) + if(iLHC.eq.1.and.ityptl(n).lt.40.and.io.gt.0)then !look for corresponding pair of nucleons + if(iorptl(io).gt.0)then + do while(iorptl(iorptl(io)).ge.0) + io=iorptl(io) + enddo + ip=iorptl(io) + it=jorptl(io)-maproj + if(ip.gt.0.and.it.gt.0)mpair(it,ip)=mpair(it,ip)+1 + endif + endif + do kk=1,4 + p4mean(kk,jj)=p4mean(kk,jj)+dble(pptl(kk,n)) + enddo + rr=sqrt(xptl(n)**2+yptl(n)**2) + rmean(1,jj)=rmean(1,jj)+rr + rmax=max(rr,rmax) +c if(jj.eq.9)write(ifch,*)'after',n +c & ,pptl(4,n),pptl(3,n),idptl(n),jj,nseg(jj),i,j,k + elseif(istptl(n).eq.3)then !virtual particle is lost (no cluster here) + iaaptl(n) = 0 !don't use this particle next time + istptl(n) = 5 + ior=iorptl(n) + ifrptl(1,ior) = 0 + ifrptl(2,ior) = 0 + do k=1,3 !restore energy to mother particle + pptl(k,ior)=pptl(k,ior)+pptl(k,n) + enddo + pptl(4,ior)=sqrt(pptl(1,ior)**2+pptl(2,ior)**2 + & +pptl(3,ior)**2+pptl(5,ior)**2) + call idtau(idptl(ior),pptl(4,ior),pptl(5,ior),taugm) + tivptl(2,ior)=tivptl(1,ior)+taugm*(-alog(rangen())) + endif + endif + 95 continue + + ectot=0. + amctot=0. + maptot=0 + mapmax=0 + npair=0 + do jj=1,jjj + ectot=ectot+p4mean(4,jj) + amctot=amctot+(p4mean(4,jj)+p4mean(3,jj)) + & *(p4mean(4,jj)-p4mean(3,jj))-p4mean(1,jj)**2-p4mean(2,jj)**2 + + if(nsegp4(jj).ge.nsegce/iflhc)then + p4mean(4,jj)=p4mean(4,jj)/dble(nsegp4(jj)) + rmean(1,jj)=rmean(1,jj)/dble(nsegp4(jj)) + else + p4mean(4,jj)=1d50 + rmean(1,jj)=-1d0 + endif + enddo + yco=0. + ycor=1. + if(iLHC.eq.1.and.amctot.gt.0.)then + do ip=1,maproj + do it=1,matarg + if(mpair(it,ip).gt.0)npair=npair+1 + mapmax=max(mapmax,mpair(it,ip)) + maptot=maptot+mpair(it,ip) + enddo + enddo + amctot=sqrt(amctot) + if(amctot.gt.amuseg**2)then + visco=1. + yrmaxi=yradmx +c if(fvisco.gt.0)yrmaxi=yrmaxi*(1.-visco) + yrmaxi=yrmaxi*log(exp(yradpi)+amctot**2) +c yrmaxi=yrmaxi*amctot**yradpi + if(yrmaxi.gt.1e-2)then + yyrmax=dble(yrmaxi) + fradflii=sngl(1d0/ + & ((sinh(yyrmax)*yyrmax-cosh(yyrmax)+1d0)/(yyrmax**2/2d0))) + else + yrmaxi=0. + fradflii=1. + endif + else + amctot=1. + visco=0. + fradflii=1. + yrmaxi=ainfin !to define ityptl as 19 if mass is too low (aumin=amuseg+yrmaxi in epos-hnb.f) + endif + if(ylongmx.lt.0.)then + delzet=abs(ylongmx)*log(exp(yradmi)+amctot**2) +c delzet=abs(ylongmx)*log(exp(yradmi)+amctot) +c delzet=abs(ylongmx)*amctot**yradmi + yco=delzet !* 1.75 + else + yco=ylongmx + endif + ycor=yco + if(fvisco.gt.0.)ycor=0. + if(ycor.gt.1.e-2)then + ycor=sqrt(sinh(ycor)/ycor)/fradflii + else + ycor=1. + endif + else + if(ylongmx.lt.0)delzet=1.75*delzet + endif + +c...mark segments going into in clusters, count them + + if(ish.ge.6)write(ifch,*)'mark segments going into in clusters' + do 96 n=1,nptla + if(iaaptl(n).eq.0)goto 96 + i=1+(xptl(n)+xgrid+shiftx)/delxgr + j=1+(yptl(n)+xgrid+shiftx)/delxgr + k=1+(sptl(n)+sgrid+shifts)/delsgr + if( i.ge.1.and.i.le.m1grid + & .and.j.ge.1.and.j.le.m1grid + & .and.k.ge.1.and.k.le.m3grid)then + jj=jdropgrid(i,j,k) + if(jj.gt.0)then + ! count only particles with reasonnable energy + pt2=pptl(1,n)**2+pptl(2,n)**2+pptl(5,n)**2 + am2tmp=(pptl(4,n)+pptl(3,n))*(pptl(4,n)-pptl(3,n))-pt2 + if(abs(am2tmp).lt.0.1.or. + & dble(pptl(4,n)).le.100.d0/dble(ntry)*p4mean(4,jj))then + istptl(n) = 3 + nseg(jj)=nseg(jj)+1 + if(rmean(1,jj).gt.0d0)then + rmean(2,jj)=max(rmean(2,jj) + & ,abs(rmean(1,jj)-sqrt(xptl(n)**2+yptl(n)**2))) +c print *,'r',jj,rmean(1,jj),sqrt(xptl(n)**2+yptl(n)**2),rmean(2,jj) + endif +c if(jj.eq.9)write(ifch,*)'after',n +c & ,pptl(4,n),pptl(3,n),idptl(n),jj,nseg(jj),i,j,k + else +c write(ifmt,*)'Rejected particle : ',n,idptl(n) + if(ish.ge.1)write(ifch,*)'Rejected particle : ',n,idptl(n) + & ,ityptl(n),(pptl(kk,n),kk=1,5),am2tmp + & ,dble(pptl(4,n))/dble(nsegp4(jj)),p4mean(4,jj),nsegp4(jj),jj + nsegp4(jj)=nsegp4(jj)-1 + iaaptl(n)=0 +c if(iaaptl(n).eq.0)print*,'rejected',idptl(n),ityptl(n) +c & ,pptl(4,n) + if(nsegp4(jj).ge.nsegce/iflhc)then + p4mean(4,jj)=(p4mean(4,jj)*dble(nsegp4(jj)+1)-pptl(4,n)) + & /dble(nsegp4(jj)) + else + p4mean(4,jj)=1d50 + endif + endif + endif + endif + 96 continue + + +c...add segments moving towards clusters + + if(ish.ge.6)write(ifch,*)'add segments moving towards clusters' + if(iocluin.eq.1)then + do 93 n=1,nptla + if(iaaptl(n).eq.0)goto 93 + ihit=0 + i=1+(xptl(n)+xgrid+shiftx)/delxgr + j=1+(yptl(n)+xgrid+shiftx)/delxgr + k=1+(sptl(n)+sgrid+shifts)/delsgr + if( i.ge.1.and.i.le.m1grid + & .and.j.ge.1.and.j.le.m1grid + & .and.k.ge.1.and.k.le.m3grid)then + jgr=jdropgrid(i,j,k) + if(jgr.eq.0)then + if(i.ge.m1grid/2)then + isi=-1 + else + isi=1 + endif + if(j.ge.m1grid/2)then + jsi=-1 + else + jsi=1 + endif + do ii=i,i+2*isi,isi + do jj=j,j+2*jsi,jsi + if(.not.(ii.eq.i.and.jj.eq.j))then + if(ii.ge.1.and.ii.le.m1grid + . .and.jj.ge.1.and.jj.le.m1grid)then + jg=jdropgrid(ii,jj,k) + if(jg.gt.0)then +c if(nseg(jg).gt.50)then + x=xptl(n) + y=yptl(n) + vrad=( x*pptl(1,n)/pptl(4,n)+y*pptl(2,n)/pptl(4,n)) + if(vrad.lt.0.)then + ihit=1 + goto 94 + endif +c endif + endif + endif + endif + enddo + enddo + endif + endif + 94 continue + if(ihit.eq.1)then + delx=delxgr*(ii-i) + dely=delxgr*(jj-j) + xn=xptl(n)+delx + yn=yptl(n)+dely + ix=1+(xn+xgrid+shiftx)/delxgr + jx=1+(yn+xgrid+shiftx)/delxgr + jgrx=jdropgrid(ix,jx,k) + if(jgrx.gt.0)then + xptl(n)=xn + yptl(n)=yn + istptl(n) = 3 + nseg(jgrx)=nseg(jgrx)+1 + if(rmean(1,jg).gt.0d0) + & rmean(2,jgrx)=max(rmean(2,jgrx) + & ,abs(rmean(1,jgrx)-sqrt(xptl(n)**2+yptl(n)**2))) + endif + endif + 93 continue + endif + + +c Decay Strings not included in clusters taking into account Z +c do it here to have this particles before the one from cluster +c (to define maxfra properly) + if(ish.ge.6)write(ifch,*)'decay Strings not included in clusters' + if(ifrade.ne.0.and.ntry.eq.1.and..not.lclean)then + nptlx=nptl+1 +c copy decayed strings into new strings if no fragments are used for cluster + do n=1,nptl + if(istptl(n).eq.29.and.ityptl(n).lt.40)then !fragmented central strings + iused=0 + do nn=ifrptl(1,n),ifrptl(2,n) + if(istptl(nn).eq.3.or.ifrptl(1,nn).ne.0)iused=iused+1 + enddo + if(iused.eq.0)then !if no fragment used, reset string + istptl(n)=28 + do nn=ifrptl(1,n),ifrptl(2,n) !suppress product + istptl(nn)=4 + iaaptl(nn)=0 + enddo + do nn=iorptl(n),jorptl(n) !reinitialize string ends + istptl(nn)=20 + enddo + endif + endif + enddo + call gakfra(0,iret) !fragmentation using Z + if(iret.gt.0)goto 1000 + do nn=nptlx,nptl !exclude new particle from cluster formation + iaaptl(nn)=0 + call jtain(nn,xptl(nn),yptl(nn),zptl(nn),tptl(nn),nnn,0) + call jtaus(zptl(nn),tz,sptl(nn)) + strap=1e10 + xpl=tptl(nn)+zptl(nn) + xmi=tptl(nn)-zptl(nn) + if(xmi.gt.0.0.and.xpl.gt.0.0)strap=0.5*log(xpl/xmi) + dezptl(nn)=strap !space-time-rapidity + enddo + maxfra=nptl + nptla=nptl + if(ish.ge.6.and.nptl.ne.nptlx-1) + & call alist('list after second fragmentation&',nptlx,nptl) + if(irescl.eq.1)then + call utghost(iret) + if(iret.gt.0)goto 1000 + endif + endif + + +c if(iLHC.eq.1)then +cc...split high pt segment into one part going out of the cluster and one part included in cluster (number of particle in cluster conserved) +c if(ish.ge.6) +c & write(ifch,*)'mark high pt segments going into in clusters' +c do 100 n=1,nptla +c if(iaaptl(n).ge.0)goto 100 +c i=1+(xptl(n)+xgrid+shiftx)/delxgr +c j=1+(yptl(n)+xgrid+shiftx)/delxgr +c k=1+(sptl(n)+sgrid+shifts)/delsgr +c if( i.ge.1.and.i.le.m1grid +c & .and.j.ge.1.and.j.le.m1grid +c & .and.k.ge.1.and.k.le.m3grid)then +c jj=jdropgrid(i,j,k) +c if(jj.gt.0)then +c if(rmean(1,jj).gt.0d0)then +c ! path through cluster +c rp=sngl(rmean(2,jj) +c & -abs(sqrt(xptl(n)**2+yptl(n)**2)-rmean(1,jj))) +c ! energy density (cluster mass approximate as sqrt(E)) +c rh=sngl(sqrt(p4mean(4,jj)*nsegp4(jj)) +c & /(4d0/3d0*pi*rmean(2,jj)**3)) +c ! Et used as Energy (transverse energy) +c pt2=pptl(1,n)**2+pptl(2,n)**2 +cc ept=sqrt(pt2+pptl(3,n)**2) +c ept=sqrt(pt2+pptl(5,n)**2) +c ! energy loss based on BDMPS (peigne et al.) +c eloss=fploss*rh**(3./8.)*max(1.,sqrt(ept))*rp +c ! scaling factor +c fscal=eloss/ept +cc print *,ept,eloss,nsegp4(jj),rmean(2,jj),rh,rp,fscal +c +c if(fscal.le.0.)then !exclude fragment from cluster +c nseg(jj)=nseg(jj)-1 +c istptl(n)=0 +c iaaptl(n)=0 +c ! update cluster mean energy +c nsegp4(jj)=nsegp4(jj)-1 +c if(nsegp4(jj).ge.nsegce/iflhc)then +c p4mean(4,jj)=(p4mean(4,jj)*dble(nsegp4(jj)+1) +c & -pptl(4,n))/dble(nsegp4(jj)) +c else +c p4mean(4,jj)=1d50 +c rmean(1,jj)=-1d0 +c endif +c elseif(fscal.lt.1..and.(1.-fscal)**2*pt2.gt. +c & (0.5-log(rangen()))**2*(ptclu**2))then +cc & (0.5-log(rangen()))**2*(pptl(5,n)**2+ptclu**2))then +cc print *,ept,eloss,nsegp4(jj),rmean(2,jj),rh,rp,fscal +c if(ish.ge.6)write(ifch,*)'Quenched particle : ',n +c & ,idptl(n),ityptl(n),(pptl(kk,n),kk=1,5),ept,eloss,nsegp4(jj),jj +c iaaptl(n)=0 !mother particle leave cluster +c istptl(n)=0 +c nptl=nptl+1 !create fake particle with energy lost in cluster +c nptla=nptla+1 +c istptl(nptl)=3 !daughter part of cluster +c iaaptl(nptl)=1 +c do l=1,3 +c pptl(l,nptl)=fscal*pptl(l,n) +c pptl(l,n)=(1.-fscal)*pptl(l,n) +c xorptl(l,nptl)=xorptl(l,n) +c enddo +c! mother +c tivptl(1,n)=xorptl(4,n) +c pptl(4,n)=sqrt(pptl(1,n)**2+pptl(2,n)**2 +c & +pptl(3,n)**2+pptl(5,n)**2) +c call idtau(idptl(n),pptl(4,n),pptl(5,n),taugm) +c tivptl(2,n)=tivptl(1,n)+taugm*(-alog(rangen())) +c ! daughter +c pptl(5,nptl)=0. +c pptl(4,nptl)=sqrt(pptl(1,nptl)**2+pptl(2,nptl)**2 +c & +pptl(3,nptl)**2+pptl(5,nptl)**2) +c xorptl(4,nptl)=xorptl(4,n) +c tivptl(1,nptl)=tivptl(1,n) +c iorptl(nptl)=n +c idptl(nptl)=idptl(n)*100+sign(99,idptl(n)) +c call idquac(nptl,idum1,idum2,idum3,jc) +c ityptl(nptl)=ityptl(n)+2 +c xptl(nptl)=xptl(n) +c yptl(nptl)=yptl(n) +c zptl(nptl)=zptl(n) +c sptl(nptl)=sptl(n) +c dezptl(nptl)=dezptl(n) +c if(ish.ge.6)write(ifch,*)'--> Virtual particle : ',nptl +c & ,idptl(nptl),ityptl(nptl),(pptl(kk,nptl),kk=1,5) +c ! update cluster mean energy +c p4mean(4,jj)=(p4mean(4,jj)*dble(nsegp4(jj)) +c & -pptl(4,n)+pptl(4,nptl))/dble(nsegp4(jj)) +c else +c istptl(n)=3 +c iaaptl(n)=1 +c if(ish.ge.6)write(ifch,*)'Absorbed particle : ',n +c & ,idptl(n),ityptl(n),(pptl(kk,n),kk=1,5),ept,eloss,nsegp4(jj),jj +c endif +c endif +c endif +c endif +c 100 continue +c +c +c +c endif +c + +c nptlb0=nptl + + nptlb=nptl+jjj +c...prepare /cptl/ for clusters + + if(ish.ge.6)write(ifch,*)'prepare /cptl/ for clusters' + do jj=1,jjj + nptl=nptl+1 + istptl(nptl)=12 + do l=1,4 + pptl(l,nptl)=0. + xorptl(l,nptl)=0 + enddo + sptl(nptl)=0 + uptl(nptl)=0 + optl(nptl)=0 + desptl(nptl)=0 + iorptl(nptl)=0 + jorptl(nptl)=0 +c limit the maximum number of subcluster to half the number of particle +c (not to have empty subclusters) + nsegmx(jj)=max(1,nint(float(nseg(jj))/float(nsegsuj))) + if(ish.ge.6)write(ifch,*)'nsegmx',jj,nseg(jj),nsegmx(jj) + & ,nsegsuj + enddo + +c...prepare /cptl/ for subclusters + + if(ish.ge.6)write(ifch,*)'prepare /cptl/ for subclusters' + mm=0 + do jj=1,jjj + do ii=1,nsegmx(jj) + mm=mm+1 + if(mm.gt.mxcl)stop'jintpo: mxcl too small. ' + mmji(jj,ii)=mm + mseg(mm)=0 + nptl=nptl+1 + istptl(nptl)=10 + do l=1,4 + pptld(l,mm)=0d0 + pptl(l,nptl)=0. + xorptl(l,nptl)=0 + enddo + sptl(nptl)=0 + uptl(nptl)=0 + optl(nptl)=0 + desptl(nptl)=0 + do l=1,nflav + jccl(mm,l,1)=0 + jccl(mm,l,2)=0 + enddo + iorptl(nptl)=nptla+jj + jorptl(nptl)=0 + if(ii.eq.1)ifrptl(1,nptla+jj)=nptlb+mm + ifrptl(2,nptla+jj)=nptlb+mm + enddo + enddo + +c...separate string segments, add dense area segments to clusters + + if(ish.ge.6)write(ifch,*)'separate string segments' + do 98 n=1,nptla + if(istptl(n).ne.3)goto 98 + i=1+(xptl(n)+xgrid+shiftx)/delxgr + j=1+(yptl(n)+xgrid+shiftx)/delxgr + k=1+(sptl(n)+sgrid+shifts)/delsgr + if( i.ge.1.and.i.le.m1grid + & .and.j.ge.1.and.j.le.m1grid + & .and.k.ge.1.and.k.le.m3grid)then + jj=jdropgrid(i,j,k) + if(jj.gt.0)then + iimx=nsegmx(jj) + do ii=1,iimx + mm=mmji(jj,ii) + if(mseg(mm).eq.0)goto 10 !not to have an empty cluster + enddo + ii=1+rangen()*iimx + ii=min(ii,iimx) + iini=ii + am2tmpmx=1e30 + 9 ntmp=mmji(jj,ii) + am2tmp=(pptld(4,ntmp)+pptld(3,ntmp)) + & *(pptld(4,ntmp)-pptld(3,ntmp)) + if(am2tmp.gt.xmxms**2/2.)then + if(am2tmp.lt.am2tmpmx)then + mm=mmji(jj,ii) + am2tmpmx=am2tmp + endif + ii=ii+1 + if(ii.gt.iimx)ii=1 + if(ii.ne.iini)then + goto 9 + else + goto 10 + endif + endif + mm=mmji(jj,ii) + 10 continue + mseg(mm)=mseg(mm)+1 + ifrptl(1,n)=mm !local use of ifrptl +c write(ifch,*)'end',n +c & ,pptl(4,n),pptl(3,n),idptl(n),i,j,k,sptl(n),mm + p4tmp=0d0 + do l=1,3 + pptld(l,mm)= pptld(l,mm) + dble(pptl(l,n)) + p4tmp=p4tmp+dble(pptl(l,n))*dble(pptl(l,n)) + enddo + p4tmp=sqrt(p4tmp+dble(pptl(5,n)*pptl(5,n))) + pptld(4,mm)= pptld(4,mm) + p4tmp +c if(mm.eq.86)write(ifch,*)'other',n +c & ,pptl(4,n),pptl(3,n),pptl(5,n),idptl(n),k,p4tmp +c & ,pptld(4,mm),pptld(3,mm),pptld(2,mm),pptld(1,mm) +c & ,(pptld(4,mm)+pptld(3,mm))*(pptld(4,mm)-pptld(3,mm)) + xorptl(1,nptlb+mm)=xorptl(1,nptlb+mm)+xptl(n) + xorptl(2,nptlb+mm)=xorptl(2,nptlb+mm)+yptl(n) + xorptl(3,nptlb+mm)=xorptl(3,nptlb+mm)+zptl(n) + xorptl(4,nptlb+mm)=xorptl(4,nptlb+mm)+tptl(n) + sptl(nptlb+mm)=sptl(nptlb+mm)+sptl(n) + aa=cos(phievt) + bb=sin(phievt) + cc=-sin(phievt) + dd=cos(phievt) + xrot=xptl(n)*aa+yptl(n)*bb + yrot=xptl(n)*cc+yptl(n)*dd + uptl(nptlb+mm)=uptl(nptlb+mm)+xrot**2 + optl(nptlb+mm)=optl(nptlb+mm)+yrot**2 + desptl(nptlb+mm)=desptl(nptlb+mm)+xrot*yrot + call idquac(n,idum1,idum2,idum3,jc) +c id=idptl(n) +c ida=iabs(id/10) +c ids=id/iabs(id) +c if(ida.ne.111.and.ida.ne.222.and.ida.ne.333)id=id/10*10 +c if(ida.eq.111.or. ida.eq.222.or. ida.eq.333)id=id/10*10+ids +c if(ida.eq.213)id=1230*ids +c ic(1)=idtrai(1,id,1) +c ic(2)=idtrai(2,id,1) +c call iddeco(ic,jc) + do l=1,nflav + jccl(mm,l,1)=jccl(mm,l,1)+jc(l,1) + jccl(mm,l,2)=jccl(mm,l,2)+jc(l,2) + enddo + else + idropgrid(i,j,k)=0 + endif + endif + 98 continue + +c...associate segments to clusters + + if(ish.ge.6)write(ifch,*)'associate segments to clusters' + naseg(0)=0 + do jj=1,jjj + do ii=1,nsegmx(jj) + mm=mmji(jj,ii) + naseg(mm)=naseg(mm-1)+mseg(mm) + nfseg(mm)=0 + enddo + enddo + do 97 n=1,nptla + if(istptl(n).ne.3)goto 97 + istptl(n) = 2 +c write(ifch,*)'final segments ',n +c & ,ityptl(n),istptl(n),idptl(n),dezptl(n),pptl(3,n) + mm=ifrptl(1,n) + nfseg(mm)=nfseg(mm)+1 + nsegmt(naseg(mm-1)+nfseg(mm))=n + 97 continue + do jj=1,jjj + nst=0 + do ii=1,nsegmx(jj) + mm=mmji(jj,ii) + if(mseg(mm).ne.nfseg(mm))stop'jintpo: mseg.ne.nfseg ' + nst=nst+mseg(mm) + enddo + if(nst.ne.nseg(jj))stop'sum(mseg(mm)).ne.nseg(jj)' + enddo + +c...finish cluster storage to /cptl/ + + if(ish.ge.6)write(ifch,*)'finish cluster storage to /cptl/' + xx=0. + yy=0. + xy=0. + mjjsegsum=0 + do jj=1,jjj + njj=nptla+jj + mjjseg=0 + do l=1,nflav + jcjj(l,1)=0 + jcjj(l,2)=0 + enddo + do ii=1,nsegmx(jj) + mm=mmji(jj,ii) + n=nptlb+mm + + do l=1,nflav + jc(l,1)=jccl(mm,l,1) + jc(l,2)=jccl(mm,l,2) + ke(l)=jc(l,1)-jc(l,2) + jcjj(l,1)=jcjj(l,1)+jc(l,1) + jcjj(l,2)=jcjj(l,2)+jc(l,2) + enddo + call idenct(jc,idptl(n) + * ,ibptl(1,n),ibptl(2,n),ibptl(3,n),ibptl(4,n)) + ttest=0d0 + do ji=1,4 + ptest(ji)=0d0 + do ns=naseg(mm-1)+1,naseg(mm) + ni=nsegmt(ns) + ptest(ji)=ptest(ji)+dble(pptl(ji,ni)) + enddo + ptest(ji)=abs(ptest(ji)-pptld(ji,mm)) + ttest=ttest+ptest(ji) + enddo + amcmin=1.01*utamnu(ke(1),ke(2),ke(3),ke(4),ke(5),ke(6),4) + p52=((pptld(4,mm)+pptld(3,mm))*(pptld(4,mm)-pptld(3,mm)) + & -pptld(1,mm)**2-pptld(2,mm)**2) + if(iLHC.eq.1)then + amcmin=sqrt(max(amcmin**2,sngl(p52))) + if(amcmin/ycor.gt.amuseg)amcmin=amcmin*ycor +c & **max(0.,min(1.,pptld(4,mm)-2.*amcmin*ycor)) + endif + + pptld(5,mm)=0d0 + if(p52.gt.0d0)then + pptld(5,mm)=sqrt(p52) + jerr(2)=jerr(2)+1 + if(iLHC.eq.1.and.pptld(5,mm).lt.amcmin + & .and.pptld(4,mm).gt.amcmin)then + pptld(5,mm)=dble(amcmin) + bp=sqrt((pptld(4,mm)+pptld(5,mm))*(pptld(4,mm)-pptld(5,mm)) + & /(pptld(3,mm)*pptld(3,mm)+pptld(2,mm)*pptld(2,mm) + & +pptld(1,mm)*pptld(1,mm))) + pptld(1,mm)=bp*pptld(1,mm) + pptld(2,mm)=bp*pptld(2,mm) + pptld(3,mm)=bp*pptld(3,mm) +c write(ifch,*)"ici ",n,sqrt(p52),pptld(5,mm),bp,pptld(4,mm), +c & sqrt(pptld(3,mm)*pptld(3,mm) +c & +pptld(2,mm)*pptld(2,mm) +c & +pptld(1,mm)*pptld(1,mm) +c & +pptld(5,mm)*pptld(5,mm)) +c write(ifch,*)'droplet uds=',ke(1),ke(2),ke(3),' E=',pptld(5,mm) + endif + elseif(p52.le.0d0)then + jerr(3)=jerr(3)+1 + pptld(5,mm)=dble(amcmin) + pptld(4,mm)=sqrt(pptld(3,mm)*pptld(3,mm) + & +pptld(2,mm)*pptld(2,mm) + & +pptld(1,mm)*pptld(1,mm) + & +pptld(5,mm)*pptld(5,mm)) + endif + if(ish.ge.1.and.(abs(ttest).gt.1.d0.or.pptld(5,mm).gt.xmxms)) + & then + call utmsg('jintpo&') + write(ifmt,*)'***** Warning in jintpo !',ntry + write(ifch,*)'***** jintpo: momenta messed up (ttest > 0)' + write(ifch,*)'*****',mm,n,mseg(mm),p52,ttest + write(ifch,*)'*****',jj,nsegp4(jj),p4mean(4,jj) + write(ifch,'(a,10x,4f15.4)')'*****',(pptld(ji,mm),ji=1,4) + do ns=naseg(mm-1)+1,naseg(mm) + ni=nsegmt(ns) + write(ifch,'(a,i5,i9,5f15.4,f12.4)')'*****',ni,idptl(ni) + * ,(pptl(ji,ni),ji=1,4),pptl(5,ni)**2 + * ,(pptl(4,ni)+pptl(3,ni))*(pptl(4,ni)-pptl(3,ni)) + * -pptl(1,ni)**2-pptl(2,ni)**2 + enddo + endif + if(pptld(5,mm).gt.xmxms)then + p4max=0. + nh=0 + do ns=naseg(mm-1)+1,naseg(mm) + ni=nsegmt(ns) + if(pptl(4,ni).ge.p4max)then + nh=ni + p4max=pptl(4,ni) + endif + enddo + if(nh.le.0)then + stop'Cannot be in jintpo ...' + else !put back nh as normal particle + iaaptl(nh) = 0 !don't use this fragment next time +c if(iaaptl(nh).eq.0)print*,'excluded',idptl(nh),ityptl(nh) +c & ,pptl(4,nh) + if(mod(abs(idptl(nh)),100).eq.99)then !restore lost energy + istptl(nh) = 5 + ior=iorptl(nh) + iaaptl(ior)=0 !don't use this fragment next time + ifrptl(1,ior) = 0 + ifrptl(2,ior) = 0 + if(istptl(ior).eq.0)then + do k=1,3 + pptl(k,ior)=pptl(k,ior)+pptl(k,n) + enddo + pptl(4,ior)=sqrt(pptl(1,ior)**2+pptl(2,ior)**2 + & +pptl(3,ior)**2+pptl(5,ior)**2) + call idtau(idptl(ior),pptl(4,ior),pptl(5,ior),taugm) + tivptl(2,ior)=tivptl(1,ior)+taugm*(-alog(rangen())) + else + istptl(ior) = 0 + endif + elseif(idptl(nh).lt.1e4)then + istptl(nh) = 0 !particle + ifrptl(1,nh) = 0 + ifrptl(2,nh) = 0 + else + istptl(nh) = 10 !droplet + endif + endif + if(ish.ge.1) + & write(ifch,*)'***** Redo cluster without heavy particle :' + & ,nh,ntry + goto 8888 + endif + do l=1,5 + pptl(l,n)=sngl(pptld(l,mm)) + enddo + mjjseg=mjjseg+mseg(mm) + do l=1,4 + pptl(l,njj)=pptl(l,njj)+pptl(l,n) + xorptl(l,njj)=xorptl(l,njj)+xorptl(l,n) + xorptl(l,n)=xorptl(l,n)/float(mseg(mm)) + enddo + sptl(njj)=sptl(njj)+sptl(n) + uptl(njj)=uptl(njj)+uptl(n) + optl(njj)=optl(njj)+optl(n) + desptl(njj)=desptl(njj)+desptl(n) + sptl(n)=sptl(n)/float(mseg(mm)) + uptl(n)=uptl(n)/float(mseg(mm)) + optl(n)=optl(n)/float(mseg(mm)) + desptl(n)=desptl(n)/float(mseg(mm)) + radptl(n)=0 + istptl(n)=10 + ifrptl(1,n)=0 + ifrptl(2,n)=0 + tivptl(1,n)=xorptl(4,n) + tivptl(2,n)=ainfin + ityptl(n)=60 + radptl(n)=0 + dezptl(n)=0. + enddo !ii + do l=1,4 + xorptl(l,njj)=xorptl(l,njj)/float(mjjseg) + enddo + mjjsegsum=mjjsegsum+mjjseg + xx=xx+uptl(njj) + yy=yy+optl(njj) + xy=xy+desptl(njj) + sptl(njj)=sptl(njj)/float(mjjseg) + uptl(njj)=uptl(njj)/float(mjjseg) + optl(njj)=optl(njj)/float(mjjseg) + desptl(njj)=desptl(njj)/float(mjjseg) + pjj52=(pptl(4,njj)+pptl(3,njj))*(pptl(4,njj)-pptl(3,njj)) + & -pptl(1,njj)**2-pptl(2,njj)**2 + pptl(5,njj)=0 + if(pjj52.gt.0)then + pptl(5,njj)=sqrt(pjj52) + endif + ityptl(njj)=60 + call idenct(jc,idptl(njj) + * ,ibptl(1,njj),ibptl(2,njj),ibptl(3,njj),ibptl(4,njj)) + enddo !jj + + +c...ranphi + + ranphi=0 + rini=0. + if(mjjsegsum.gt.0)then + xx=xx/float(mjjsegsum) + yy=yy/float(mjjsegsum) + xy=xy/float(mjjsegsum) + dta=0.5*(xx-yy) +c eba=0.5*(xx+yy) +c ww=-xy +c !------------------------------------------------------- +c ! inertia tensor: +c !----------------------+-------------------------------+ +c ! <y**2> -<x*y> ! with <x**2>=uptl ! +c ! -<x*y> <x**2> ! <y**2>=optl <xy>=desptl ! +c !----------------------+-------------------------------+ +c ! Eigenvalues ev1, ev2 +c !------------------------------------------------------- +c ev1=eba+sqrt(dta**2+ww**2) +c ev2=eba-sqrt(dta**2+ww**2) + if(xy.lt.0..and.dta.ne.0.)then + ranphi=0.5*atan(-xy/dta) + elseif(xy.gt.0..and.dta.ne.0.)then + ranphi=-0.5*atan(xy/dta) + else + ranphi=0 + endif +c if(dta.ne.0.)then +c ranphi=0.5*atan(abs(ww)/abs(dta)) +c if( ww.gt.0..and.dta.gt.0.)then +c ranphi=ranphi +c elseif(ww.lt.0..and.dta.gt.0.)then +c ranphi=-ranphi +c elseif(ww.gt.0..and.dta.lt.0.)then +c ranphi=pi-ranphi +c elseif(ww.lt.0..and.dta.lt.0.)then +c ranphi=ranphi-pi +c endif +c else +c ranphi=2.*pi*rangen() +c endif + rini=max(0.01,sqrt(5./3.*(xx+yy))) !<r**2>=3/5*R**2 for sphere of radius R + volu=(4./3.*pi*(xx+yy)**1.5) +c rho=amctot/volu + flowpp=0. + flowaa=0. + + if(iLHC.eq.1.and.visco.gt.0.)then + if(npair.gt.0)then + fcorr=min(1.,float(mapmax)*abs(fvisco)/float(maptot)) + visco=min(1.,2.*float(maptot)/float(npair)/float(mapmax))**2 +c & *abs(fvisco)) + elseif(lclean)then !large number of particles, npair can't be calculated + visco=1e-6 + fcorr=1. + else !cluster from remnants only + visco=1. + fcorr=1. + endif + if(visco.ge.1.)yrmaxi=0. !yrmaxi*(1.-visco) +c visco=exp(-min(50.,max(0., +c & float(koievt)/log(amctot)-abs(fvisco))**yradpi)) !mix flow +c & max(0.,rmax**2-abs(fvisco)))) !mix flow +c yrmaxi=log(amctot**2) +c yrmaxi=yradmx*yrmaxi*(1.-visco) +c if(visco.lt.1.and.yrmaxi.gt.1e-2)then +c yyrmax=dble(yrmaxi) +c fradflii=sngl(1d0/ +c & ((sinh(yyrmax)*yyrmax-cosh(yyrmax)+1d0)/(yyrmax**2/2d0))) +c else +c visco=1. +c yrmaxi=0. +c fradflii=1. +c endif +c if(visco.gt.1e-5)then +c yrmaxi=yradmx*(yrmaxi +c & +visco*(log(amctot)*yradpx/yradmx-yrmaxi)) +c else +c yrmaxi=yradmx*yrmaxi +c endif + fradflii=1. + if(yrmaxi.gt.0)then + flowpp=visco*log(fcorr*amctot)*yradpx + flowaa=yrmaxi + if(rangen().lt.flowaa/flowpp)then + visco=0. + yrmaxi=flowaa+max(0.,flowpp-flowaa) + yyrmax=dble(yrmaxi) + fradflii=sngl(1d0/ + & ((sinh(yyrmax)*yyrmax-cosh(yyrmax)+1d0)/(yyrmax**2/2d0))) + else + yrmaxi=0. + visco=log(fcorr*amctot)/log(amctot) + endif + elseif(fcorr.lt.1.)then + visco=log(fcorr*amctot)/log(amctot) + endif + endif + + if(ish.ge.3)write(ifch,*)'yrmaxi,delzet=',yrmaxi,delzet +c print *,'->',bimevt,yrmaxi,visco*yradpx*log(amctot),flowaa +c & ,flowpp,maptot,log(ectot),visco,log(amctot),rho +c & ,mapmax,npair +c & ,min(1.,2.*float(maptot)/float(npair)/float(mapmax))**2 + endif + +c...print + + if(ish.ge.5)then + write(ifch,*)'print' + do k=1,m3grid + write(ifch,*)'k=',k,' jclu=',jclu(k) + & ,' s=',(k-1)*delsgr-sgrid-shifts + do j=m1grid,1,-1 + write(ifch,'(10i4,3x,10i4)')(idropgrid(i,j,k),i=1,m1grid) + & ,(jdropgrid(i,j,k),i=1,m1grid) + enddo + enddo + write(ifch,'(a,a)') + & ' k jj nseg mm mseg n mass' + & ,' s y z t ' + do jj=1,jjj + do ii=1,max(1,nint(1.*nseg(jj)/nsegsuj)) + mm=mmji(jj,ii) + n=nptlb+mm + sg=pptl(3,n)/abs(pptl(3,n)) + tm=sqrt(pptl(5,n)**2+pptl(1,n)**2+pptl(2,n)**2) + y=sg*alog((pptl(4,n)+sg*pptl(3,n))/tm) +c if(kclu(jj).eq.44)print *,tm,pptl(4,n),pptl(3,n),iorptl(n) + write(ifch,'(2i5,i6,i8,2i6,5f10.3)') + & kclu(jj),jj,nseg(jj),mm,mseg(mm),n,pptl(5,n) + & ,sptl(n),y,xorptl(3,n),xorptl(4,n) + enddo + enddo + endif + +c...decay + iret=0 + if(jjj.gt.0)then !decay only if some cluster produced + if(4-abs(typevt).gt.0.0001)typevt=-typevt !typevt < 0 if fusion but only if not SD (sign used for something else for SD ... and no fusion produced for SD events) + if(ish.ge.5)write(ifch,*)'decay ...' + if(ifrade.eq.0.or.ispherio.gt.0)goto1000 + if(jdecay.eq.0)goto1000 + nptlbcf=nptl + nptl0=nptl + if(hydt.ne.'---')then + call HydroFO(ier) + else + nclu=0 + ptest(1)=0d0 + ptest(2)=0d0 + ptest(3)=0d0 + ptest(4)=0d0 + ptest(5)=0d0 + do jj=1,jjj + do ii=1,max(1,nint(1.*nseg(jj)/nsegsuj)) + mm=mmji(jj,ii) + np=nptlb+mm +c print *,'decay',jj + if(ioclude.eq.3)then + call hnbaaa(np,iret) + else + call DropletDecay(np,iret) + endif + if(iret.eq.1)then + istptl(np)=istptl(np)+2 + do ns=naseg(mm-1)+1,naseg(mm) + n=nsegmt(ns) + if(mod(abs(idptl(n)),100).eq.99)then !restore lost energy + istptl(n) = 5 + ior=iorptl(n) + ifrptl(1,ior) = 0 + ifrptl(2,ior) = 0 + if(istptl(ior).eq.0)then + do k=1,3 + pptl(k,ior)=pptl(k,ior)+pptl(k,n) + enddo + pptl(4,ior)=sqrt(pptl(1,ior)**2+pptl(2,ior)**2 + & +pptl(3,ior)**2+pptl(5,ior)**2) + call idtau(idptl(ior),pptl(4,ior),pptl(5,ior),taugm) + tivptl(2,ior)=tivptl(1,ior)+taugm*(-alog(rangen())) + else + istptl(ior) = 0 + endif + elseif(idptl(n).lt.1e4)then + istptl(n) = 0 !particle + ifrptl(1,n) = 0 + ifrptl(2,n) = 0 + else + istptl(n) = 10 !droplet + endif + enddo + elseif(ioclude.eq.3)then + do i=nptl0+1,nptl + if(ityptl(i).eq.60)then + nclu=nclu+1 + ptest(1)=ptest(1)+dble(pptl(1,i)) + ptest(2)=ptest(2)+dble(pptl(2,i)) + ptest(3)=ptest(3)+dble(pptl(3,i)) + ptest(4)=ptest(4)+dble(pptl(4,i)) + endif + enddo + nptl0=nptl + endif + enddo + enddo + endif + do jj=1,jjj + do ii=1,max(1,nint(1.*nseg(jj)/nsegsuj)) + mm=mmji(jj,ii) + np=nptlb+mm + istptl(np)=istptl(np)+1 + ifrptl(1,np)=nptlbcf+1 + ifrptl(2,np)=nptl + rinptl(np)=kclu(jj)-m3grid/2 + enddo + enddo +c add global flow on all particles of all decayed cluster + if(iLHC.eq.1)then + yrmax=0. + if(fvisco.gt.0.)yrmax=yradpx*visco + else + yrmax=yradpx + endif +c print *,bimevt,rini,yrmax,yrmaxi,delzet,np,ptmax,visco + if(ioclude.eq.3.and.yrmax.gt.1e-3.and.nclu.gt.0)then +c set angular informations + fecc=0 + aa=1 + bb=0 + cc=0 + dd=1 + dta=0.5*abs(xx-yy) + ev1=(xx+yy)/2+sqrt(dta**2+xy**2) + ev2=(xx+yy)/2-sqrt(dta**2+xy**2) + ecc=(ev1-ev2)/(ev1+ev2) +c fecc=facecc*ecc!/(1.+yrmax) +c print*,'pp',ecc,ranphi + fecc=min(facecc,ecc) !be careful : fecc change <pt> since it is the elliptical deformation of the sub cluster (give strength of v2) + + phiclu=mod(phievt+ranphi,2.*pi) !do not change otherwise v2 is gone + if(phiclu.lt.-pi)phiclu=phiclu+2*pi + if(phiclu.gt.pi)phiclu=phiclu-2*pi + aa=cos(phiclu) + bb=sin(phiclu) + cc=-sin(phiclu) + dd=cos(phiclu) + errlim=0.00005 +c loop on particles for each main cluster +c ncl=nptlb0 + npass=max(1,min(nclu/5,jjj)) !to have the same number of group of particles than original clusters but different repartition of particles + npart=nclu/npass + if(npart*npass-nclu.gt.max(5,npart/2))npass=npass+1 +c print *,'ici',nclu,npass,npart +c lcont=.true. +c if(nclu.lt.50)lcont=.false. + lcont=.false. + ncl=0 + nmin=nptlbcf+1 + nmax=nptl + idrc=-1+2.*int(0.5+rangen()) + ntot=nclu + +c prepare debug output for flow + nall=0 + if(ish.ge.5)then + nall=nmax-nmin+1 + do ii=1,nall + idptl(nptl+ii)=idptl(nptlbcf+ii) + enddo + iorptl(nptl+nall+1)=nptl+1 + jorptl(nptl+nall+1)=nptl+nall + do k=1,5 + pptl(k,nptl+nall+1)=0 + do ii=1,nall + pptl(k,nptl+ii)=pptl(k,nptlbcf+ii) + pptl(k,nptl+nall+1)=pptl(k,nptl+nall+1)+pptl(k,nptlbcf+ii) + enddo + enddo + endif + +c initialization for rescaling on ipart particles + ipart=0 + tecm0=0. + tecm=0. + ini0=0 + ifi0=0 + +c do 900 while (ncl.le.nptlb-1) + do while (ntot.gt.0) + ncl=ncl+1 + if(iLHC.eq.1)then + yrmax=yradpx*visco + else + yrmax=yradpx + endif +c cms frame of all particles from same cluster + do k=1,5 + ppp(k)=0d0 + enddo + ini=nptl + ifi=1 + if(idrc.gt.0)then + imax=nmax + imin=nmin-1 + if(ipart.eq.0)ini0=nmin + else + imax=nmin + imin=nmax+1 + if(ipart.eq.0)ifi0=nmax + endif +c npclu=0 +c 880 ncl=ncl+1 + n=0 + i=imin + lpass=.true. + do while ((n.lt.npart.or.ncl.eq.npass) + & .and.idrc*i.lt.idrc*imax.and.lpass) + i=i+idrc +c if(jorptl(i).eq.ncl)then +c if(jorptl(i).eq.ncl.and.ityptl(i).eq.60)then + + if(ityptl(i).eq.60)then + n=n+1 + ntot=ntot-1 + ini=min(ini,i) + ifi=max(ifi,i) +c if(ityptl(i).eq.60)npclu=npclu+1 + do k=1,4 + ppp(k)=ppp(k)+dble(pptl(k,i)) + enddo + elseif(.not.lcont.and.n.gt.0)then + lpass=.false. + endif +c print *,ityptl(i),i,imin,imax,idrc,n,npart,ncl,nclu,nptl + enddo + np=n + if(idrc.gt.0)then + nmin=nmin+i-imin + ifi0=i + else + nmax=nmax+i-imin + ini0=i + endif + +c if(ncl.lt.nptlb.and.npclu.lt.int(0.2*(nptl-nptlbcf+1)))goto880 + if(ifi.le.ini)goto 900 + +c record info for rescaling + ipart=ipart+np + +c test mass + ppp(5)=(ppp(4)-ppp(3))*(ppp(4)+ppp(3))-ppp(2)**2-ppp(1)**2 + if(ppp(5).gt.0d0)then + ppp(5)=sqrt(ppp(5)) + else + if(ish.ge.1)write(ifch,*)'Precision problem in jintpo, p:', + & (ppp(k),k=1,5) + ppp(5)=0d0 + endif + if(ish.ge.4) + & write(ifch,*)'Group of particle: ', + & idrc,ini,ifi,ncl,'/',npass,npart,nclu + if(ppp(5).gt.0d0)then ! here all particle should have flow + do i=ini,ifi + if(ityptl(i).eq.60)then + tecm=tecm+pptl(4,i) !use energy in collision frame as reference + call utlob4(1,ppp(1),ppp(2),ppp(3),ppp(4),ppp(5) + $ ,pptl(1,i),pptl(2,i),pptl(3,i),pptl(4,i)) + endif + enddo + if(tecm.gt.0.)then + yrmax=yrmax*log(amctot) !/rini**yradpi + else + yrmax=0. + endif +c print *,bimevt,rini,ppp(5),yrmax,yrmaxi,delzet,np,ptmax,visco + if(ish.ge.4) + & write(ifch,*)'Radial flow: ',yrmax,tecm,visco,yradpx,yradpp + if(yrmax.gt.0.)then + if(np.gt.maxp)stop'maxp too small in jintpo' + i=0 + if(ish.ge.8)call clist('list before flow&',ini,ifi,60,60) + do ii=ini,ifi + if(ityptl(ii).eq.60)then + i=i+1 + yrad(i)=sqrt(rangen()) + phirad(i)=2.*pi*rangen() + pt2=(pptl(1,ii)**2+pptl(2,ii)**2)!+pptl(5,ii)**2) + bex=sinh(yrad(i)*yrmax)*cos(phirad(i)) + & *(1+fecc/(1.+pt2)) + bey=sinh(yrad(i)*yrmax)*sin(phirad(i)) + & *(1-fecc/(1.+pt2)) + be(1)=aa*bex+cc*bey + be(2)=bb*bex+dd*bey + be(3)=0d0 + be(4)=sqrt(1+be(1)**2+be(2)**2) +c call utlob4(1,be(1),be(2),be(3),be(4),1d0 +c * , pptl(1,ii), pptl(2,ii), pptl(3,ii), pptl(4,ii)) +c mimic boost transformation but protect against to high values of p(3) (p(3)~p(4)) + pt2=pptl(1,ii)**2+pptl(2,ii)**2 + bet=-(pptl(1,ii)*be(1)+pptl(2,ii)*be(2))/(be(4)+1.) + + pt=yradpp**max(1.,pptl(5,ii)) + fac=1./(1.+sqrt(pt2/pptl(5,ii)**2))**pt + bet=bet+sqrt(pt2+(pptl(3,ii)**2+pptl(5,ii)**2)*fac) + +c bet=bet+sqrt(pt2+max(yradpp,pptl(5,ii))**2) !simplified version with yradpp~proton mass + + pptl(1,ii)=pptl(1,ii)-bet*be(1) + pptl(2,ii)=pptl(2,ii)-bet*be(2) + pptl(4,ii)=sqrt(pptl(1,ii)**2+pptl(2,ii)**2 + * +pptl(3,ii)**2+pptl(5,ii)**2) + else + yrad(i)=0. + phirad(i)=0. + endif + enddo + if(ish.ge.8)call clist('list after flow&',ini,ifi,60,60) + + +c boost back + pe(1)=0. + pe(2)=0. + pe(4)=0. + do i=ini,ifi + if(ityptl(i).eq.60)then + call utlob4(-1,ppp(1),ppp(2),ppp(3),ppp(4),ppp(5) + $ ,pptl(1,i),pptl(2,i),pptl(3,i),pptl(4,i)) + pe(1)=pe(1)+pptl(1,i) + pe(2)=pe(2)+pptl(2,i) + pe(4)=pe(4)+pptl(4,i) + endif + enddo + + + +cc random rescaling +c rescaling has to be done for different bins in eta to conserve +c energy flow (if everything is done at the end on all particles, +c the energy flow is concentred at mid-rapidity in contradiction +c with ATLAS data +c On the other hand, a sufficient number of particles is necessary +c to have proper eta distribution in particular at high pt. +c Since the clusters are ordered in rapidity we can do the rescaling on +c group of clusters having enough particles for the rescaling but +c not too much to keep the eta dependence of the energy flow. + +c set ipart.ge.1 to do rescaling for each subclusters + + if((ipart.ge.1.and.ntot.ge.ipart/2).or.ntot.eq.0)then + + ini=ini0 + ifi=ifi0 + + if(ish.ge.8) + & call clist('list before flow rescaling&',ini,ifi,60,60) + + if(fplmin.gt.0)then + +c ntrt=ntrt+1 + + niter=0 + 611 energ=0. + energ0=0. + niter=niter+1 + i=0 + ptmax=0. + plmax=0. + do j=ini,ifi + if(ityptl(j).eq.60)then + i=i+1 + pt2=pptl(1,j)**2+pptl(2,j)**2 + pz2=pptl(3,j)**2 + pp2=pt2+pz2 +c et2=(pp2+pptl(5,j)**2)*pt2/pp2 + pt=sqrt(pt2) +c pp=sqrt(pp2) +c base necessary to avoid peak at pt or pl=0 +c epsi change the shape of eta distributions and pt for +c identified particles (shift the maximum of the distribution) +c epsi=min(0.99,fplmin*rangen()**0.3) + base=0. !sqrt(1./(1.-epsi)**2-1.)*pptl(5,j)/pp + finc=2. + if(energ0.lt.tecm)then + finc=finc*sqrt(float(max(1,niter-300))) +c base=base+min(tecm/pe(4), +c & (max(0,niter-300))*0.3*pptl(5,j)/pp) + else +c base=base/log10(max(10.,float(niter-300))) + finc=finc/sqrt(max(1.,float(niter-300))) + endif +c if(1.-pptl(5,j)/pptl(4,j).ge.epsi +c & .and.1.+pptl(5,j)**2*(1./pp2-1./pt2).gt.0.)then + if(1.+pptl(5,j)**2*(1./pp2-1./pt2).gt.0.)then + ptmax=max(pt,ptmax) + plmax=max(abs(pptl(3,j)),plmax) + yrad2(i)=rangen() + yrad2(i)=yrad2(i)* + & max(0.,min(1.,finc*tecm/pe(4))-base) + + +c necessary even with epsi cut to smooth eta distribution +c and since sumEt has to be conserved, we can constrain scaling for pt +c and pz : +c ytmp=yrad2(i) + yrad2(i)= yrad2(i)**((1.-(pptl(5,j) + & /sqrt((min(1.,yrad2(i)*float(max(1,niter-100))))**2 + & *(pt**2+pptl(3,j)**2)+pptl(5,j)**2))**1.) + & *exp(-fplmin*max(0.,pt**2-(pe(4)/tecm)**2))) + + yrad2(i)=min(1.,base+yrad2(i)) !should be here to avoid peak at eta=0. + else + yrad2(i)=1. +c ytmp=yrad2(i) + endif + be(1)= pptl(1,j)*yrad2(i) + be(2)= pptl(2,j)*yrad2(i) + be(3)= pptl(3,j)*yrad2(i) + +c print *,niter,i,ntry,yrad2(i),energ/tecm,pt,pptl(3,j),finc,base +c * ,ytmp,(1.-(pptl(5,j) +c & /sqrt((min(1.,yrad2(i)*float(max(1,niter-100))))**2 +c & *(pt**2+pptl(3,j)**2)+pptl(5,j)**2))**0.1) + + energ=energ+sqrt(be(1)**2+be(2)**2 + * +be(3)**2+pptl(5,j)**2) + endif + enddo + energ0=energ +c print *,'fin',niter,energ/tecm + if(abs(energ-tecm)/tecm.gt.1..and.niter.lt.1000)then + goto 611 + elseif(niter.ge.1000)then +c print *,'Rescaling failed:',pe(4),tecm,ptmax,plmax,ipart,ini0,ifi + if(ish.ge.2)write(ifch,*)'Random rescaling failed:' + & ,energ,tecm,ptmax,plmax,ipart,ini0,ifi +c ntrr=ntrr+1 + goto 200 + endif +c print *,'done',niter,energ/tecm,ipart,ini0,ifi,finc + if(ish.ge.5)write(ifch,*)'Rescaling done:' + & ,tecm,energ/tecm,niter,ptmax,plmax,ipart,ini0,ifi + i=0 + do j=ini,ifi + if(ityptl(j).eq.60)then + i=i+1 + pptl(1,j)= pptl(1,j)*yrad2(i) + pptl(2,j)= pptl(2,j)*yrad2(i) + pptl(3,j)= pptl(3,j)*yrad2(i) + pptl(4,j)=sqrt(pptl(1,j)**2+pptl(2,j)**2 + * +pptl(3,j)**2+pptl(5,j)**2) + endif + enddo + endif + + 200 continue + + + if(ish.ge.8) + & call clist('list after flow rescaling&',ini,ifi,60,60) + + tecm0=tecm0+tecm + tecm=0. + ipart=0 + + endif + + endif ! yrmax + + endif !p(5)>0 + + + 900 continue + enddo + +c rescale momentum precisely and globaly to avoid artefacts for matrix +c but only at 10% level to keep dependence of sumEt with eta + if(tecm0.gt.0)then + ini=nptlbcf+1 + ifi=nptl + esoll=tecm0 + scal=1. + do ipass=1,2000 + sum=0. + n=0 + do j=ini,ifi + if(ityptl(j).eq.60)then + n=n+1 +c this part is EXTREMELY important for the pseudorapidity shape at various pt +c if nothing special a broad peak appear at eta=0 +c to avoid that, scal has to be reduced when p3 or pt reach 0 + if(scal.lt.1.)then + scal0=scal + pt=sqrt(pptl(1,j)**2+pptl(2,j)**2) + if(fplmin.le.0.)then + pt=abs(fplmin)/sqrt(pptl(5,j))*pt +c pt=abs(fplmin)*pt + else + pt=5.*pt + endif + pow=sqrt(pptl(5,j)**2+scal**2*(pt**2 + * +pptl(3,j)**2)) + pow=(1.-(1./sqrt(pptl(5,j))+pptl(5,j)) + * /(1./sqrt(pptl(5,j))+pow)) + pow=rangen()*pow + else + pow=1.-2.*pptl(4,j)/engy !to avoid particle with energy larger than beam energy + if(pow.lt.0.)then + scal0=1./((1.-pow) + * *exp(-0.25*max(-4.,log(rangen())))) + pow=1. +c print *,j,pptl(4,j),pow,scal0,scal +c * ,pptl(3,j)*scal0**pow + else + scal0=scal + pow=rangen()*pow + endif + endif + + do k=1,3 + pptl(k,j)=pptl(k,j)*scal0**pow !to smooth distributions + enddo + pptl(4,j)=sqrt(pptl(1,j)**2+pptl(2,j)**2 + * +pptl(3,j)**2+pptl(5,j)**2) + sum=sum+pptl(4,j) + endif + enddo + scal=esoll/sum +c write(ifmt,*)'ipass,scal,e,esoll:' +c $ ,ipass,scal,sum,esoll + if(abs(scal-1.).le.errlim) goto 300 + enddo + 300 continue +c write(ifmt,*)'ipass,scal,e,esoll:' +c $ ,ipass,scal,sum,esoll + +c adjust pt to have pt conservation in cms of particles having flow + if(nclu.gt.0)then + ptest(5)=(ptest(4)-ptest(3))*(ptest(4)+ptest(3))-ptest(2)**2 + & -ptest(1)**2 + if(ptest(5).gt.0d0)then + ptest(5)=sqrt(ptest(5)) + else + if(ish.ge.1)write(ifch,*)'Precision problem in jintpo, p:', + & (ptest(k),k=1,5) + ptest(5)=0d0 + endif + be(1)=0.d0 + be(2)=0.d0 + do i=ini,ifi + if(ityptl(i).eq.60)then + call utlob4(1,ptest(1),ptest(2),ptest(3),ptest(4),ptest(5) + $ ,pptl(1,i),pptl(2,i),pptl(3,i),pptl(4,i)) + be(1)=be(1)+dble(pptl(1,i)) + be(2)=be(2)+dble(pptl(2,i)) + endif + enddo +c shift nclu particles to have sum_pt=0. and boost back in global cms + pt1shift=-sngl(be(1)/dble(nclu)) + pt2shift=-sngl(be(2)/dble(nclu)) + do i=ini,ifi + if(ityptl(i).eq.60)then + pptl(1,i)=pptl(1,i)+pt1shift + pptl(2,i)=pptl(2,i)+pt2shift + pptl(4,i)=sqrt(pptl(1,i)**2+pptl(2,i)**2 + & +pptl(3,i)**2+pptl(5,i)**2) + call utlob4(-1,ptest(1),ptest(2),ptest(3),ptest(4),ptest(5) + & ,pptl(1,i),pptl(2,i),pptl(3,i),pptl(4,i)) + endif + enddo + endif + + endif + + +c if(ntrt.gt.0)print *,"jintpo rescaling :",float(ntrr)/float(ntrt) +c define life time + n=0 + do i=ini,ifi + if(ityptl(i).eq.60)then + n=n+1 + r=1.15*rini*yrad(n) !yrad=y/ymax + tau=2.25/sqrt(yrad(n)**2+0.04)-0.75 + z=xorptl(3,i) + t=xorptl(4,i) +! zeta=0.5*log((t+z)/(t-z))-0.5*delzet+2*0.5*delzet*rangen() + test=(pptl(4,i)-pptl(3,i))*(pptl(4,i)+pptl(3,i)) + if(test.gt.0.)then + zeta=0.5*log((pptl(4,i)+pptl(3,i)) + & /(pptl(4,i)-pptl(3,i))) + else !in case of precision problem (but not always good neither for p<0 + pt=sqrt(pptl(2,i)**2+pptl(1,i)**2) + zeta=0.5*log(1+2*pptl(3,i)*(pptl(4,i)+pptl(3,i)) + & /(pt*pt+pptl(5,i)**2)) + endif + z=tau*sinh(zeta) + t=tau*cosh(zeta) + xorptl(1,i)=xorptl(1,i)+r*cos(phirad(n)) + xorptl(2,i)=xorptl(2,i)+r*sin(phirad(n)) + xorptl(3,i)=z + xorptl(4,i)=t + endif + enddo + + + if(ish.ge.5)then + do k=1,5 + pptl(k,nptl+nall+2)=0 + do ii=nptlbcf+1,nptl + pptl(k,nptl+nall+2)=pptl(k,nptl+nall+2)+pptl(k,ii) + enddo + enddo + iorptl(nptl+nall+2)=nptlbcf+1 + jorptl(nptl+nall+2)=nptl + call alist2('longitudinal and radial flow&',nptl+1 + & ,nptl+nall,nptlbcf+1,nptl) + call alist2('momentum sum&',nptl+nall+1,nptl+nall+1 + & ,nptl+nall+2,nptl+nall+2) + write(ifch,'(1x,50a1/)')('-',k=1,50) + endif + + + endif !ioclude=3 and flow + + + do n=nptlbcf+1,nptl + if(ioclude.ne.3)then + iorptl(n)=nptlb+1 + jorptl(n)=nptlbcf + rinptl(n)=rinptl((iorptl(n)+jorptl(n))/2) + else + rinptl(n)=rinptl(iorptl(n)) + endif + istptl(n)=0 + ifrptl(1,n)=0 + ifrptl(2,n)=0 + tivptl(1,n)=xorptl(4,n) + call idtau(idptl(n),pptl(4,n),pptl(5,n),taugm) + r=rangen() + tivptl(2,n)=tivptl(1,n)+taugm*(-alog(r)) + radptl(n)=0. + dezptl(n)=0. + itsptl(n)=0 + enddo + + endif + +c Decay droplets not included in clusters + iret=0 + do mm=1,nptla + nptlb=nptl + if(istptl(mm).eq.10)then + if(ish.ge.5)write(ifch,*)'Decay remaining droplet :',mm + if(nptlb.gt.mxptl-10) + & call utstop('jintpo: mxptl too small (2)&') + if(ioclude.eq.3)then + call hnbaaa(mm,iret) + else + call DropletDecay(mm,iret) !Decay remn + iret=0 + endif + if(iret.eq.0.and.nptl.ne.nptlb)then ! ---successful decay--- + istptl(mm)=istptl(mm)+1 + ifrptl(1,mm)=nptlb+1 + ifrptl(2,mm)=nptl + t=tivptl(2,mm) + x=xorptl(1,mm)+(t-xorptl(4,mm))*pptl(1,mm)/pptl(4,mm) + y=xorptl(2,mm)+(t-xorptl(4,mm))*pptl(2,mm)/pptl(4,mm) + z=xorptl(3,mm)+(t-xorptl(4,mm))*pptl(3,mm)/pptl(4,mm) + do 21 n=nptlb+1,nptl + iorptl(n)=mm + jorptl(n)=0 + istptl(n)=0 + ifrptl(1,n)=0 + ifrptl(2,n)=0 + radius=0.8*sqrt(rangen()) + phi=2*pi*rangen() + ti=t + zi=z + xorptl(1,n)=x + radius*cos(phi) + xorptl(2,n)=y + radius*sin(phi) + xorptl(3,n)=zi + xorptl(4,n)=ti + iioo=mm + zor=dble(xorptl(3,iioo)) + tor=dble(xorptl(4,iioo)) + r=rangen() + tauran=-taurea*alog(r) + call jtaix(n,tauran,zor,tor,zis,tis) + tivptl(1,n)=amax1(ti,tis) + call idtau(idptl(n),pptl(4,n),pptl(5,n),taugm) + r=rangen() + tivptl(2,n)=t+taugm*(-alog(r)) + radptl(n)=0. + dezptl(n)=0. + itsptl(n)=0 + rinptl(nptl)=-9999 + 21 continue + else ! Unsuccessful decay + if(ish.ge.1)write(ifch,*) + * '***** Unsuccessful remnant cluster decay' + * ,' --> redo event.' + endif + endif + enddo + + + + 1000 continue + call utprix('jintpo',ish,ishini,4) + end + +cc----------------------------------------------------------------------- +c subroutine jrad(i,nq,na,jc,rad) +cc----------------------------------------------------------------------- +cc return hadron radius (data taken from huefner and povh) +cc----------------------------------------------------------------------- +c include 'epos.inc' +c integer jc(nflav,2),kc(nflav) +c +c id=iabs(idptl(i)) +c am=pptl(5,i) +c if(id.lt.10000)then +c k=mod(id,10) +c else +c k=1 +c endif +c do l=1,nflav +c kc(l)=iabs(jc(l,1)-jc(l,2)) +c enddo +c +c if(nq.eq.0)then ! mesons +c if(kc(1).eq.0.and.kc(2).eq.0.and.kc(3).eq.0.and.kc(4).eq.0)then +c if(k.eq.0)then ! flavor singlet pseudoscalar mesons +c if(am.ge.0.000)then +c rad=0.64 ! pi0 +c if(am.ge.0.500)then +c rad=0.60 ! eta +c if(am.ge.0.900)then +c rad=0.40 ! eta prime +c if(am.ge.2.900)then +c rad=0.17 ! eta charm +c endif +c endif +c endif +c else +c write(ifch,*) +c * 'i:',i,' id:',idptl(i),' k:',k,' m:',am +c write(ifch,*)'jc:',(jc(l,1),l=1,6),(jc(l,2),l=1,6) +c call utstop('jrad: meson radius not defined&') +c endif +c else ! flavor singlet vector mesons +c if(am.ge.0.000)then +c rad=0.72 ! rho,omega +c if(am.ge.1.000)then +c rad=0.46 ! phi +c if(am.ge.3.000)then +c rad=0.20 ! J/psi +c endif +c endif +c else +c write(ifch,*) +c * 'i:',i,' id:',idptl(i),' k:',k,' m:',am +c write(ifch,*)'jc:',(jc(l,1),l=1,6),(jc(l,2),l=1,6) +c call utstop('jrad: meson radius not defined&') +c endif +c endif +c elseif(kc(3).eq.0.and.kc(4).eq.0)then ! nonstrange, noncharmed +c if(k.eq.0)then +c rad=0.64 ! pi +c else +c rad=0.72 ! resonances +c endif +c elseif(kc(3).ne.0.and.kc(4).eq.0)then ! strange +c if(k.eq.0)then +c rad=0.59 ! kaons +c else +c rad=0.68 ! kaon resonances +c endif +c else ! charmed +c write(ifch,*)'i:',i,' id:',idptl(i) +c call utstop('jrad: radius of meson not defined&') +c endif +c else !baryons +c if(kc(4).gt.0)then ! charmed +c write(ifch,*) +c * 'i:',i,' id:',idptl(i),' k:',k,' m:',am +c write(ifch,*)'i:',i,' id:',idptl(i) +c call utstop('jrad: radius of charmed baryon not defined&') +c elseif(kc(3).eq.0)then ! nonstrange +c if(k.eq.0)then +c rad=0.82 !nucleons +c else +c rad=1.00 !resonances +c endif +c elseif(kc(3).eq.1)then ! strange +c if(k.eq.0)then +c rad=0.76 !lambda, sigma +c else +c rad=0.93 !resonances +c endif +c elseif(kc(3).eq.2)then ! double strange +c if(k.eq.0)then +c rad=0.71 !cascades +c else +c rad=0.87 !resonances +c endif +c elseif(kc(3).ge.3)then ! triple strange +c rad=0.79 !omega +c else +c write(ifch,*) +c * 'i:',i,' id:',idptl(i),' k:',k,' m:',am +c write(ifch,*) +c * 'q:',(jc(l,1),l=1,6),' qbar:',(jc(l,2),l=1,6), +c * ' |q-qbar|:',(kc(l),l=1,6) +c call utstop('jrad: should not happen&') +c endif +cc string fragments with |#q|>3 +c if(na.gt.3)then +c a=(na/3.)**(1./3.) +c if(ish.ge.7)then +c call utmsg('jrad ') +c write(ifch,*) +c * 'i:',i,' id:',idptl(i),' k:',k,' m:',am +c write(ifch,*) +c * 'q:',(jc(l,1),l=1,6),' qbar:',(jc(l,2),l=1,6), +c * ' |q-qbar|:',(kc(l),l=1,6) +c write(ifch,*)'nq:',nq,' na:',na,' r:',rad,' ar:',a*rad +c call utmsgf +c endif +c rad=rad*a +c endif +c endif +c +c if(ish.ge.7)then +c write(ifch,*) +c * 'i:',i,' id:',idptl(i),' k:',k,' m:',am,' rad:',rad +c write(ifch,*)'jc:',(jc(l,1),l=1,6),(jc(l,2),l=1,6) +c endif +c +c return +c end +c +c----------------------------------------------------------------------- + subroutine jresc +c----------------------------------------------------------------------- + include 'epos.inc' + double precision pa(5),pj(5) + integer ipptl(mxptl) + + call utpri('jresc ',ish,ishini,4) + + iret=0 + nptlpt=maproj+matarg + np=0 + do i=nptlpt+1,nptl + if(istptl(i).eq.0 + * .and.idptl(i).lt.10000.and.pptl(5,i).gt.0.01)then + np=np+1 + ipptl(np)=i + endif + enddo + if(np.lt.2)goto1001 + do ii=1,np + i=ipptl(ii) + if(mod(iabs(idptl(i)),10).lt.2)then + call idmass(idptl(i),ami) + dm=abs(ami-pptl(5,i)) + if(dm.gt.0.001)then + ntry=0 +1 continue + ntry=ntry+1 +2 jj=1+int(rangen()*np) + j=ipptl(jj) + if(ish.ge.4)write(ifch,*)i,j,istptl(j) + if(j.eq.i)goto2 + if(mod(iabs(idptl(j)),10).lt.2)then + call idmass(idptl(j),amj) + else + amj=pptl(5,j) + endif + do l=1,5 + pa(l)=dble(pptl(l,i)) + pj(l)=dble(pptl(l,j)) + enddo + if(ish.ge.4)write(ifch,'(70a1)')('-',l=1,70) + if(ish.ge.4)write(ifch,11)i,idptl(i),'before:',pa,'want:',ami + if(ish.ge.4)write(ifch,11)j,idptl(j),'before:',pj,'want:',amj + call jrescl(pa,dble(ami),pj,dble(amj),iret) + if(iret.eq.1)then + if(ntry.le.50)then + goto1 + else + goto1001 + endif + endif + if(ish.ge.4)write(ifch,11)i,idptl(i),' after:',pa + if(ish.ge.4)write(ifch,11)j,idptl(j),' after:',pj + if(ish.ge.4)write(ifch,'(70a1)')('-',l=1,70) + do l=1,5 + pptl(l,i)=sngl(pa(l)) + pptl(l,j)=sngl(pj(l)) + enddo + endif + endif + enddo +11 format(i5,1x,i5,1x,a,1x,5(d8.2,1x),a,1x,e8.2) + +1000 continue + call utprix('jresc ',ish,ishini,4) + return + +1001 continue + if(ish.ge.1)then + write(ifmt,'(a)')'jresc: could not put on shell' + endif + goto1000 + + end + +c----------------------------------------------------------------------- + subroutine jrescl(p1,am1,p2,am2,iret) +c----------------------------------------------------------------------- +c rescale momenta of two particles such that the masses assume given +c values. +c input: +c p1, p2: momenta of the two particles +c am1, am2: desired masses of the two particles +c output: +c p1, p2: new momenta of the two particles +c----------------------------------------------------------------------- + include 'epos.inc' + double precision p1(5),p2(5) + * ,p1n(5),p2n(5) + * ,a1,a2,a12,am1,am2 + * ,b1,b2,c,d,e,f,g,p,q,r + + call utpri('jrescl',ish,ishini,7) + + iret=0 + a1=p1(5)**2 + a2=p2(5)**2 + a12=p1(4)*p2(4)-p1(3)*p2(3)-p1(2)*p2(2)-p1(1)*p2(1) + if(a12.le.(a1+a2))then + if(ish.ge.7)write(ifch,*)'a_12 < a_1 + a_2' + if(ish.ge.7)write(ifch,*)a12,' < ',a1+a2 +c goto1001 + endif + +11 format(5(d9.3,1x)) + if(ish.ge.7)write(ifch,11)p1,a1 + if(ish.ge.7)write(ifch,11)p2,a2 + if(ish.ge.7)write(ifch,*)a12 + + c=(a1+a12)/(a2+a12) + d=(a1-am1**2-a2+am2**2)/(a2+a12)*0.5d0 + + e=a1-2d0*a12*c+a2*c**2 + f=2d0*(a1-a12*(c+d)+a2*c*d) + g=a1-2d0*a12*d+a2*d**2-am1**2 + + p=f/e + q=g/e + r=p**2-4d0*q + + if(ish.ge.7)write(ifch,*)'c:',c,' d:',d + if(ish.ge.7)write(ifch,*)'e:',e,' f:',f,' g:',g + if(ish.ge.7)write(ifch,*)'p:',p,' q:',q,' r:',r + if(r.lt.0d0)goto1001 + + b1=-0.5d0*(p-dsqrt(r)) + + b2=b1*c+d + + if(ish.ge.7)write(ifch,*)'b_1:',b1,' b_2:',b2 + + do i=1,4 + p1n(i)=(1d0+b1)*p1(i)-b2*p2(i) + p2n(i)=(1d0+b2)*p2(i)-b1*p1(i) + enddo + + a1=p1n(4)**2-p1n(3)**2-p1n(2)**2-p1n(1)**2 + a2=p2n(4)**2-p2n(3)**2-p2n(2)**2-p2n(1)**2 + if(a1.gt.0d0.and.a2.gt.0d0)then + do i=1,4 + p1(i)=p1n(i) + p2(i)=p2n(i) + enddo + p1(5)=dsqrt(a1) + p2(5)=dsqrt(a2) + if(ish.ge.7)write(ifch,11)p1,a1 + if(ish.ge.7)write(ifch,11)p2,a2 + else + goto1001 + endif + + if(p1(4).lt.0..or.p2(4).lt.0.)goto1001 + +1000 continue + call utprix('jrescl',ish,ishini,7) + return + +1001 continue + iret=1 + goto1000 + end + +c----------------------------------------------------------------------- + subroutine jtain(i,x,y,z,t,n,iopt) +c----------------------------------------------------------------------- +c returns intersection (x,y,z,t) of ptl-i-trajectory with taus-line. +c input: +c i: particle number +c iopt: formation time considered (0) or not (1) +c output: +c x,y,z,t: 4-vector of intersection point +c n: exit code +c n=0: ok +c n=1: ptl lives later +c n=2: ptl lives earlier +c n=9: tiv1>tiv2 +c----------------------------------------------------------------------- + include 'epos.inc' + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat + common/cttaus/tpro,zpro,ttar,ztar,ttaus,detap,detat + double precision vv,zza,zz,tt,xo3,xo4,ti1,ti2,derr,dd + double precision ttp,zzp,ttt,zzt,vvt,vvp,spt2m2E,p4 + common/ctfi/tin,tfi + double precision ttau0 + common/cttau0/ttau0 + + n=0 + + tin=0 + tfi=0 + + derr=1d-2 + ttp=tpro*ttaus + zzp=zpro*ttaus + ttt=ttar*ttaus + zzt=ztar*ttaus + vv=sign(min(1.d0,abs(dble(pptl(3,i)))/dble(pptl(4,i))) + & ,dble(pptl(3,i))) + + + if(abs(vv).ge.1.d0)then + spt2m2E=dble(pptl(1,i)*pptl(1,i)+pptl(2,i)*pptl(2,i) + & +pptl(5,i)*pptl(5,i)) +c if(pptl(4,i).le.0.)then + p4=sqrt(dble(pptl(3,i)*pptl(3,i))+spt2m2E) +c else +c p4=dble(pptl(4,i)) +c endif +ctp to avoid precision problem, replace abs(p3)/p4 by sqrt(1-(pt2+m2)/E2) + spt2m2E=min(1.d0,sqrt(spt2m2E)/p4) + vv=sign(sqrt((1d0+spt2m2E)*(1d0-spt2m2E)),dble(pptl(3,i))) + endif + xo3=dble(xorptl(3,i)) + xo4=dble(xorptl(4,i)) + zza=xo3-xo4*vv + if(iopt.eq.0)then + ti1=dble(tivptl(1,i)) + elseif(iopt.eq.1)then + ti1=dble(xo4) + else + ti1=0 + call utstop("Wrong iopt in jtain !&") + endif + ti2=dble(tivptl(2,i)) + + if(ti1.gt.ti2)then + n=9 + goto1 + endif + + zfi=sngl(xo3+(ti2-xo4)*vv) + call jtaus(zfi,tzfi,szfi) + tfi=tzfi + if(tfi.ge.sngl(ti2))then + n=2 + goto1 + endif + + zin=sngl(xo3+(ti1-xo4)*vv) + call jtaus(zin,tzin,szin) + tin=tzin + if(tin.le.sngl(ti1))then + n=1 + goto1 + endif + + + 1 continue + + if(ttaus.le.ttau0)then + tt=ttaus + zz=xo3+(tt-xo4)*vv + if(tt.lt.ti1.and.n.eq.0)n=1 + if(tt.ge.ti2.and.n.eq.0)n=2 + goto1000 + else + vvt=zzt/ttt + vvp=zzp/ttp + tt=(ttt+(zza-zzt)*vvt)/(1-vv*vvt) + zz=xo3+(tt-xo4)*vv + if(zz.le.zzt)then + if(tt.lt.ti1.and.n.eq.0)n=1 + if(tt.ge.ti2.and.n.eq.0)n=2 + goto1000 + endif + tt=(ttp+(zza-zzp)*vvp)/(1-vv*vvp) + zz=xo3+(tt-xo4)*vv + if(zz.ge.zzp)then + if(tt.lt.ti1.and.n.eq.0)n=1 + if(tt.ge.ti2.and.n.eq.0)n=2 + goto1000 + endif + dd=1-vv**2 + if(sngl(dd).eq.0..and.vv.gt.0.)then + tt=-(ttaus**2+zza**2)/2d0/zza + elseif(sngl(dd).eq.0..and.vv.lt.0.)then + tt=(ttaus**2+zza**2)/2d0/zza + else + tt=(zza*vv+dsqrt(zza**2+ttaus**2*dd))/dd + endif + zz=xo3+(tt-xo4)*vv + if(tt.lt.ti1.and.n.eq.0)n=1 + if(tt.ge.ti2.and.n.eq.0)n=2 + if(dabs(ttaus**2-(tt+zz)*(tt-zz)).gt.derr*ttaus**2.and. + *dabs(ttaus**2-(tt+zz)*(tt-zz)).gt.derr)then + if(ish.ge.1)then + call utmsg('jtain') + write(ifch,*)'***** ttaus**2 .ne. (tt+zz)*(tt-zz)' + write(ifch,*)sngl(ttaus**2),sngl((tt+zz)*(tt-zz)) + call utmsgf + endif + goto1000 + endif + endif + +1000 t=sngl(tt) + z=sngl(zz) + x=xorptl(1,i)+(t-xorptl(4,i))*pptl(1,i)/pptl(4,i) + y=xorptl(2,i)+(t-xorptl(4,i))*pptl(2,i)/pptl(4,i) + return + end + +c----------------------------------------------------------------------- + subroutine jtaix(i,tau,zor,tor,z,t) +c----------------------------------------------------------------------- +c returns intersection z,t of ptl-i-trajectory with hyperbola h. +c h: (t-tor)**2-(z-zor)**2=tau**2 . +c zor, tor double precision. +c----------------------------------------------------------------------- + include 'epos.inc' + double precision tor,zor,tors,zors,vv,cc,dd,ttau,derr,tt,zz + derr=1d-3 + ttau=dble(tau) + zors=dble(xorptl(3,i))-zor + tors=dble(xorptl(4,i))-tor + vv=dble(pptl(3,i)/pptl(4,i)) + vv=dmin1(vv,1d0) + vv=dmax1(vv,-1d0) + cc=zors-tors*vv + dd=1d0-vv**2 + dd=dmax1(dd,0d0) + if(dd.eq.0d0.and.cc.eq.0d0)then + if(tau.eq.0.)tt=0d0 + if(tau.ne.0.)tt=dble(ainfin) + zz=tt + goto1000 + elseif(dd.eq.0d0)then + tt=-(ttau**2+cc**2)/2d0/cc/vv + elseif(dd.lt.1e-8)then + tt=-(ttau**2+cc**2)/2d0/cc/vv + call utmsg('jtaix') + write(ifch,*)'***** dd = ',dd,' treated as zero' + call utmsgf + else + tt=(cc*vv+dsqrt(cc**2+ttau**2*dd)) + tt=tt/dd + endif + zz=cc+tt*vv + if(dabs(ttau**2-(tt+zz)*(tt-zz)).gt.derr*ttau**2 + *.and.dabs(ttau**2-(tt+zz)*(tt-zz)).gt.derr + *.and.tors**2-zors**2.lt.1e6)then + if(ish.ge.2)then + call utmsg('jtaix') + write(ifch,*)'***** ttau**2 .ne. (tt+zz)*(tt-zz)' + write(ifch,*)sngl(ttau**2),sngl((tt+zz)*(tt-zz)) + write(ifch,*)'tau,t,z:' + write(ifch,*)tau,tt,zz + write(ifch,*)'#,id(ptl):',i,idptl(i) + write(ifch,*)'zor,tor(str):',zor,tor + write(ifch,*)'zors,tors,p,e(ptl):' + write(ifch,*)sngl(zors),sngl(tors),pptl(3,i),pptl(4,i) + call utmsgf + endif + endif +1000 z=sngl(zz+zor) + t=sngl(tt+tor) + return + end + +c----------------------------------------------------------------------- + subroutine jtaug(su,so,g,y) +c----------------------------------------------------------------------- +c returns g factor and rapidity y for given su, so +c----------------------------------------------------------------------- + include 'epos.inc' + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat + common/cttaus/tpro,zpro,ttar,ztar,ttaus,detap,detat + double precision ttp,zzp,ttt,zzt,ssp,sst,ssu,sso,ss1,ss2,gg + *,ssav,yyav,hh + double precision ttau0 + common/cttau0/ttau0 + + ssu=dble(su) + sso=dble(so) + + if(ssu.ge.sso)then + sso=(ssu+sso)*0.5d0 + dble(abs(dezzer))*ttaus*0.5d0 + ssu=(ssu+sso)*0.5d0 - dble(abs(dezzer))*ttaus*0.5d0 + so=real(sso) + su=real(ssu) + endif + if(ssu.ge.sso)then + print*,ssu,sso,dble(abs(dezzer))*ttaus*0.5d0 + stop'STOP: sr jtaug: ssu.ge.sso' + endif + + g=1 + + if(ttaus.le.ttau0)return + + ttp=tpro*ttaus + zzp=zpro*ttaus + ttt=ttar*ttaus + zzt=ztar*ttaus + ssp=ttaus*0.5d0*dlog((ttp+zzp)/(ttp-zzp)) + sst=ttaus*0.5d0*dlog((ttt+zzt)/(ttt-zzt)) + + ssav=(ssu+sso)/2d0 + yyav=ssav/ttaus + if(ssav.ge.ssp)yyav=detap + if(ssav.le.sst)yyav=detat + + gg=0 + if(ssu.lt.sst)gg=gg + dcosh(detat-yyav) * (dmin1(sst,sso)-ssu) + if(sso.gt.ssp)gg=gg + dcosh(detap-yyav) * (sso-dmax1(ssp,ssu)) + if(ssu.lt.ssp.and.sso.gt.sst)then + ss1=dmax1(ssu,sst) + ss2=dmin1(sso,ssp) + gg=gg+ttaus*( dsinh(ss2/ttaus-yyav)-dsinh(ss1/ttaus-yyav) ) + endif + gg=gg/(sso-ssu) + + hh=0 + if(ssu.lt.sst)hh=hh + dsinh(detat-yyav) * (dmin1(sst,sso)-ssu) + if(sso.gt.ssp)hh=hh + dsinh(detap-yyav) * (sso-dmax1(ssp,ssu)) + if(ssu.lt.ssp.and.sso.gt.sst)then + ss1=dmax1(ssu,sst) + ss2=dmin1(sso,ssp) + hh=hh+ttaus*( dcosh(ss2/ttaus-yyav)-dcosh(ss1/ttaus-yyav) ) + endif + hh=hh/(sso-ssu) + + yyav=yyav+0.5d0*dlog((gg+hh)/(gg-hh)) + + gg=0 + if(ssu.lt.sst)gg=gg + dcosh(detat-yyav) * (dmin1(sst,sso)-ssu) + if(sso.gt.ssp)gg=gg + dcosh(detap-yyav) * (sso-dmax1(ssp,ssu)) + if(ssu.lt.ssp.and.sso.gt.sst)then + ss1=dmax1(ssu,sst) + ss2=dmin1(sso,ssp) + gg=gg+ttaus*( dsinh(ss2/ttaus-yyav)-dsinh(ss1/ttaus-yyav) ) + endif + gg=gg/(sso-ssu) + + g=sngl(gg) + y=sngl(yyav) + return + end + +c----------------------------------------------------------------------- + subroutine jtaui(s,ts,zs) +c----------------------------------------------------------------------- +c returns time ts and coord zs corresponding to ttaus and inv. length s +c----------------------------------------------------------------------- + + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat + common/cttaus/tpro,zpro,ttar,ztar,ttaus,detap,detat + double precision ttau0 + common/cttau0/ttau0 + + double precision ttp,zzp,ttt,zzt,ssp,sst,ss,zeta + + zs=s + ts=sngl(ttaus) + + if(ttaus.le.ttau0)return + + ttp=tpro*ttaus + zzp=zpro*ttaus + ttt=ttar*ttaus + zzt=ztar*ttaus + ssp=ttaus*0.5d0*dlog((ttp+zzp)/(ttp-zzp)) + sst=ttaus*0.5d0*dlog((ttt+zzt)/(ttt-zzt)) + ss=dble(s) + + if(ss.le.sst)then + zs=sngl(zzt+ttar*(ss-sst)) + ts=sngl(ttt+(dble(zs)-zzt)*zzt/ttt) + elseif(ss.ge.ssp)then + zs=sngl(zzp+tpro*(ss-ssp)) + ts=sngl(ttp+(dble(zs)-zzp)*zzp/ttp) + else + zeta=ss/ttaus + ts=sngl(ttaus*dcosh(zeta)) + zs=sngl(ttaus*dsinh(zeta)) + endif + + return + end + +c----------------------------------------------------------------------- + subroutine jtauin +c----------------------------------------------------------------------- +c initializes equal time hyperbola at ttaus +c----------------------------------------------------------------------- + include 'epos.inc' + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat + common/cttaus/tpro,zpro,ttar,ztar,ttaus,detap,detat + double precision ttau0,rcproj,rctarg + common/geom1/rcproj,rctarg + common/cttau0/ttau0 + + call utpri('jtauin',ish,ishini,6) + + if(ttaus.gt.ttau0)then + if(rcproj.gt.1d-10)then + detap=dmin1(dble((ypjtl-yhaha)*etafac),dlog(ttaus/rcproj)) + else + detap=dble((ypjtl-yhaha)*etafac) + endif + if(rctarg.gt.1d-10)then + detat=dmax1(dble(-yhaha*etafac),dlog(rctarg/ttaus)) + else + detat=dble(-yhaha*etafac) + endif + tpro=dcosh(detap) + zpro=dsinh(detap) + ttar=dcosh(detat) + ztar=dsinh(detat) + else + detap=0d0 + detat=0d0 + tpro=0d0 + zpro=0d0 + ttar=0d0 + ztar=0d0 + endif + + if(ish.ge.6)then + write(ifch,*)'hyperbola at tau=',ttaus + write(ifch,*)'r_p:',rcproj,' r_t:',rctarg + write(ifch,*)'y_p:',detap,' y_t:',detat + write(ifch,*)'t_p:',tpro,' z_p:',zpro + write(ifch,*)'t_t:',ttar,' z_t:',ztar + endif + + call utprix('jtauin',ish,ishini,6) + return + end + +c----------------------------------------------------------------------- + subroutine jtaus(z,tz,sz) +c----------------------------------------------------------------------- +c returns time tz and inv length sz corresponding to ttaus and z +c----------------------------------------------------------------------- + include 'epos.inc' + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat + common/cttaus/tpro,zpro,ttar,ztar,ttaus,detap,detat + double precision ttau0 + common/cttau0/ttau0 + + double precision ttp,zzp,ttt,zzt,zz,tzz + + tz=sngl(ttaus) + sz=z + + if(ttaus.le.ttau0)return + + ttp=tpro*ttaus + zzp=zpro*ttaus + ttt=ttar*ttaus + zzt=ztar*ttaus + zz=dble(z) + + if(zz.le.zzt)then + tz=sngl(ttt+(zz-zzt)*zzt/ttt) + sz=sngl(ttaus*detat+(zz-zzt)/ttar) + elseif(zz.ge.zzp)then + tz=sngl(ttp+(zz-zzp)*zzp/ttp) + sz=sngl(ttaus*detap+(zz-zzp)/tpro) + else + if(sngl(ttaus).ge.ainfin)then + tz=sngl(ttaus) + sz=0. + if(ish.ge.1)then + call utmsg('jtaus') + write(ifch,*)'***** large ttaus; set tz=ttaus, sz=0' + write(ifch,*)'ttaus=',ttaus,'zz=',zz + call utmsgf + endif + else + tzz=dsqrt(ttaus**2+zz**2) + tz=sngl(tzz) + sz=sngl(ttaus*0.5d0*dlog((tzz+zz)/(tzz-zz))) + endif + endif + + return + end + +c----------------------------------------------------------------------- + subroutine jtaux(t,z,ttaux) +c----------------------------------------------------------------------- +c returns ttaux (-> tau-line) for given t and z. +c ttaux: double precision. +c----------------------------------------------------------------------- + double precision ttaux,tt,zz,rcproj,rctarg,zt1,zp1,zt2,zp2,ttau0 + common/geom1/rcproj,rctarg + common/cttau0/ttau0 + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat + common/cttaus/ tpro,zpro,ttar,ztar,ttaus,detap,detat + + tt=dble(t) + zz=dble(z) + + if(tt.gt.ttau0)then + zt1=rctarg-tt + zp1=tt-rcproj + zt2=ztar/ttar*tt + zp2=zpro/tpro*tt + if(zz.le.dmax1(zt1,zt2))then + if(zt1.gt.zt2)then + ttaux=rctarg*dsqrt((tt-zz)/(2d0*rctarg-tt-zz)) + else + ttaux=(ttar*tt-ztar*zz)/(ttar**2-ztar**2) + endif + elseif(zz.ge.dmin1(zp1,zp2))then + if(zp1.lt.zp2)then + ttaux=rcproj*dsqrt((tt+zz)/(2d0*rcproj-tt+zz)) + else + ttaux=(tpro*tt-zpro*zz)/(tpro**2-zpro**2) + endif + else + ttaux=dsqrt(tt**2-zz**2) + endif + else + ttaux=tt + endif + + return + end + +c----------------------------------------------------------------------- + subroutine xjden1(ii,itau,x,y,rad,o,u) +c----------------------------------------------------------------------- +c ii=0: initialization +c ii=1: determining dense regions in space of individual events +c x,y,rad: tranverse coordinates and radius of particle i +c o,u: specifies long range: u < s < o (s: long coordinate) +c ii=2: plot of individual event +c xpar1: itau ; valid: 1,..,10 +c xpar2: z-range: -xpar2 < z < xpar2 +c xpar3, x-range: -xpar3 < x < xpar3 +c xpar4, y-range: -xpar4 < y < xpar4 +c----------------------------------------------------------------------- + include "epos.inc" + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat + common/cttaus/ tpro,zpro,ttar,ztar,ttaus,detap,detat + + if(idensi.ne.1)stop'STOP in xjden1: idensi must be set 1' + + dlcoox=0.5 + dlcooy=0.5 + + if(ii.eq.0)then + + do i=1,nzeta + do j=1,mxcoox + do k=1,mxcooy + kdensi(itau,i,j,k)=0 + enddo + enddo + enddo + + elseif(ii.eq.1)then + + if(itau.lt.1.or.itau.gt.mxtau)return + + tau=sngl(ttaus) + zu=u/tau + zo=o/tau + + do 1 i=1,nzeta + zi=-nzeta*dlzeta/2-dlzeta/2+i*dlzeta + if(zu.gt.zi.or.zo.lt.zi)goto1 + do 2 j=1,mxcoox + xj=-mxcoox*dlcoox/2-dlcoox/2+j*dlcoox + do 3 k=1,mxcooy + yk=-mxcooy*dlcooy/2-dlcooy/2+k*dlcooy + if((x-xj)**2+(y-yk)**2.gt.rad**2)goto3 + kdensi(itau,i,j,k)=1 + 3 continue + 2 continue + 1 continue + + elseif(ii.eq.2)then + + itaux=nint(xpar1) + if(itaux.gt.mxtau)stop'STOP in xjden1: itaux too large' + + iz=nint(xpar2/dlzeta) + ix=nint(xpar3/dlcoox) + iy=nint(xpar4/dlcooy) + if(iz.gt.nzeta/2)stop'STOP in xjden1: zeta-range too large' + if(ix.gt.mxcoox/2)stop'STOP in xjden1: x-range too large' + if(iy.gt.mxcooy/2)stop'STOP in xjden1: y-range too large' + + do k=mxcooy/2+1-iy,mxcooy/2+iy + write(ifhi,'(a,f7.2)') '! tau: ',tauv(itaux) + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a,2f7.2)')'xrange',-iz*dlzeta,iz*dlzeta + write(ifhi,'(a,2f7.2)')'yrange',-ix*dlcoox,ix*dlcoox + write(ifhi,'(a)') 'set ityp2d 3' + write(ifhi,'(a)') 'txt "xaxis space-time rapidity [z]"' + write(ifhi,'(a)') 'txt "yaxis transverse coordinate x (fm)"' + write(ifhi,'(a,i4)') 'array2d',2*iz + do j=mxcoox/2+1-ix,mxcoox/2+ix + write(ifhi,'(40i2)') (kdensi(itaux,i,j,k), + * i=nzeta/2+1-iz,nzeta/2+iz) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot2d' + enddo + + else + + stop'STOP in xjden1: wrong option' + + endif + + return + end + +c----------------------------------------------------------------------- + subroutine xjden2(ii,itau,x,y,rad,s) +c----------------------------------------------------------------------- +c ii=0: initialization +c ii=1: determining dense regions in space of individual events +c x,y,rad: tranverse coordinates and radius of particle i +c s: long coordinate +c ii=2: plot of individual event +c xpar1: itau ; valid: 1,..,10 +c xpar2: s-range: -xpar2 < s < xpar2 +c xpar3, x-range: -xpar3 < x < xpar3 +c xpar4, y-range: -xpar4 < y < xpar4 +c----------------------------------------------------------------------- + include "epos.inc" + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat + common/cttaus/ tpro,zpro,ttar,ztar,ttaus,detap,detat + parameter (mxcoos=60) + common/cdensh/kdensh(matau,mxcoos,mxcoox,mxcooy),ktot(matau) + character cy*3 + + dlcoox=0.5 + dlcooy=0.5 + dlcoos=0.5 + + if(ii.eq.0)then + + do i=1,mxcoos + do j=1,mxcoox + do k=1,mxcooy + kdensh(itau,i,j,k)=0 + enddo + enddo + enddo + ktot(itau)=0 + + elseif(ii.eq.1)then + + if(itau.lt.1.or.itau.gt.mxtau)return + + tau=sngl(ttaus) + z=s/tau + + do 1 i=1,mxcoos + si=-mxcoos*dlcoos/2-dlcoos/2+i*dlcoos + do 2 j=1,mxcoox + xj=-mxcoox*dlcoox/2-dlcoox/2+j*dlcoox + do 3 k=1,mxcooy + yk=-mxcooy*dlcooy/2-dlcooy/2+k*dlcooy + if(((x-xj)**2+(y-yk)**2+(z-si)**2).gt.rad**2)goto3 + kdensh(itau,i,j,k)=kdensh(itau,i,j,k)+1 + ktot(itau)=ktot(itau)+1 + 3 continue + 2 continue + 1 continue + + elseif(ii.eq.2)then + + itaux=nint(xpar1) + if(itaux.gt.mxtau)stop'STOP in xjden2: itaux too large' + + is=nint(xpar2/dlcoos) + ix=nint(xpar3/dlcoox) + iy=nint(xpar4/dlcooy) + if(is.gt.mxcoos/2)stop'STOP in xjden2: s-range too large' + if(ix.gt.mxcoox/2)stop'STOP in xjden2: x-range too large' + if(iy.gt.mxcooy/2)stop'STOP in xjden2: y-range too large' + + do k=mxcooy/2+1-iy,mxcooy/2+iy + write(cy,'(f3.1)')-mxcooy*dlcooy/2-dlcooy/2+k*dlcooy + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a,2f7.2)')'xrange',-is*dlcoos,is*dlcoos + write(ifhi,'(a,2f7.2)')'yrange',-ix*dlcoox,ix*dlcoox + write(ifhi,'(a)') 'set ityp2d 5' + write(ifhi,'(a)') 'txt "xaxis [z] "' + write(ifhi,'(a)') + *'txt "yaxis x (fm), y='//cy//' fm"' + write(ifhi,'(a,i4)') 'array2d',2*is + do j=mxcoox/2+1-ix,mxcoox/2+ix + do i=mxcoos/2+1-is,mxcoos/2+is + write(ifhi,'(e11.3)') + *kdensh(itaux,i,j,k)/dlcooy/dlcoos/dlcoox/ktot(itaux) + enddo + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot2d' + enddo + + else + + stop'STOP in xjden2: wrong option' + + endif + + return + end + +cc----------------------------------------------------------------------- +c subroutine postscript(iii,ii,ic) +cc----------------------------------------------------------------------- +c include 'epos.inc' +c character*10 color(10) +c if(iii.eq.0)then +c ifps=21 +c open(unit=ifps,file='zzz.ps',status='unknown') +c WRITE(ifps,'(a)') '%!PS-Adobe-2.0' +c WRITE(ifps,'(a)') '%%Title: tt2.fig' +c WRITE(ifps,'(a)') '%%Orientation: Portrait' +c WRITE(ifps,'(a)') '%%BeginSetup' +c WRITE(ifps,'(a)') '%%IncludeFeature: *PageSize A4' +c WRITE(ifps,'(a)') '%%EndSetup' +c WRITE(ifps,'(a)') '%%EndComments' +c WRITE(ifps,*) '/l {lineto} bind def' +c WRITE(ifps,*) '/rl {rlineto} bind def' +c WRITE(ifps,*) '/m {moveto} bind def' +c WRITE(ifps,*) '/rm {rmoveto} bind def' +c WRITE(ifps,*) '/s {stroke} bind def' +c WRITE(ifps,*) '/gr {grestore} bind def' +c WRITE(ifps,*) '/gs {gsave} bind def' +c WRITE(ifps,*) '/cp {closepath} bind def' +c WRITE(ifps,*) '/tr {translate} bind def' +c WRITE(ifps,*) '/sc {scale} bind def' +c WRITE(ifps,*) '/sd {setdash} bind def' +c WRITE(ifps,*) '/sdo {[.01 .05] 0 sd} bind def' +c WRITE(ifps,*) '/sdf {[1 .0] 0 sd} bind def' +c WRITE(ifps,*) '/n {newpath} bind def' +c WRITE(ifps,*) '/slw {setlinewidth } bind def' +c write(ifps,*) '/srgb {setrgbcolor} bind def' +c write(ifps,*) '/lgrey { 0 0.95 0.95 srgb} bind def' +c write(ifps,*) '/black { 0 0 0 srgb} bind def' +c write(ifps,*) '/red { 1 0 0 srgb} bind def ' +c write(ifps,*) '/green { 0 1 0 srgb} bind def ' +c write(ifps,*) '/blue { 0 0 1 srgb} bind def ' +c write(ifps,*) '/yellow { 1 0.5 0 srgb} bind def ' +c write(ifps,*) '/turquoise { 0 1 1 srgb} bind def ' +c write(ifps,*) '/purple { 1 0 1 srgb} bind def ' +cc write(ifps,*) '/ { srgb} bind def ' +cc write(ifps,*) '/ { srgb} bind def ' +c write(ifps,*) '/ef {eofill} bind def' +c WRITE(ifps,'(a)') '%%EndProlog' +c WRITE(ifps,*) 'gsave' +c WRITE(ifps,*) '/Helvetica findfont 10 scalefont setfont' +c color(9)='lgrey ' +c color(1)='black ' +c color(2)='red ' +c color(3)='green ' +c color(4)='blue ' +c color(7)='yellow ' +c color(5)='turquoise ' +c color(6)='purple ' +c np=0 +c elseif(iii.eq.1)then +c np=np+1 +c write(ifps,'(a,i4)') '%%Page: number ',np +c write(ifps,'(a)') 'gsave' +c WRITE(ifps,*) '100 700 tr' +c scale=0.125 +c WRITE(ifps,*) 1./scale,1./scale,' sc' +c WRITE(ifps,*) scale/2.,' slw' +c WRITE(ifps,*) '/Helvetica findfont ',15.*scale +c & ,' scalefont setfont' +c write(ifps,*) color(1),' n ',smin,xmin,' m ( tau:',tau,') show ' +c +c WRITE(ifps,*) '/Helvetica findfont ',5.*scale +c & ,' scalefont setfont' +c +c +c yb=-2. +c dy=4./12. +c yb=yb-dy/2 +c do iyb=0,11 +c yb=yb+dy +c WRITE(ifps,*) 'gsave' +c WRITE(ifps,*) (xmax-xmin)*1.1*float(int(iyb/4)) +c & ,-(xmax-xmin)*1.1*mod(iyb,4),' tr' +c write(ifps,*) ' n ',smin,xmin,' m ',smax,xmin,' l ' +c & ,smax,xmax,' l ',smin,xmax,' l cp s ' +cc.......particles in layer iyb............. +c do i=1,nptl +c if(ii.gt.0)then +c write(ifps,*) color(mod(i,5)+2) +c & ,' n ',u,x-r,' m ',o,x-r,' l ' +c & ,o,x+r,' l ',u,x+r,' l cp s ' +c write(ifps,*) ' n ',u,x-r,' m (',i,ior,') show ' +c else +c write(ifps,*) ' n ',s,x,r,0,360,' arc ',color(ic),' s ' +c write(ifps,*) ' n ',s-r,x,' m (',i,io,') show ' +c endif +c 10 enddo +c write(ifps,*) color(1),' n ',smin,xmin,' m (',yb,') show ' +c WRITE(ifps,*) 'grestore' +c enddo !yb bin +c write(ifps,'(a)') 'grestore' +c write(ifps,*) 'showpage' +c elseif(iii.eq.2)then +c write(ifps,*) 'gr' +c +c write(ifps,'(a)') '%%Trailer' +c write(ifps,'(a,i4)') '%%Pages: ',np +c write(ifps,'(a)') '%%EOF' +c close(unit=ifps) +c endif +c +c return +c end +c + +c------------------------------------------------------------------------------ + subroutine xtauev(iii) +c------------------------------------------------------------------------------ + jdum=iii + end +c------------------------------------------------------------------------------ + subroutine wimi +c------------------------------------------------------------------------------ + end +c------------------------------------------------------------------------------ + subroutine wimino +c------------------------------------------------------------------------------ + end +c------------------------------------------------------------------------------ + subroutine xspace(iii) +c------------------------------------------------------------------------------ + jdum=iii + end +c------------------------------------------------------------------------------ + subroutine wclu +c------------------------------------------------------------------------------ + end +c------------------------------------------------------------------------------ + subroutine wclufi +c------------------------------------------------------------------------------ + end +c------------------------------------------------------------------------------ + subroutine wtime(iii) +c------------------------------------------------------------------------------ + jdum=iii + end diff --git a/modules/epos/epos-jps-lhc.f b/modules/epos/epos-jps-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..549ad897976fd89fdaf225e99dac446edf34796d --- /dev/null +++ b/modules/epos/epos-jps-lhc.f @@ -0,0 +1,1347 @@ +c----------------------------------------------------------------------- + subroutine jpsifo(npjpsi) +c----------------------------------------------------------------------- +c forms a jpsi +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + common/geom/rmproj,rmtarg,bmax,bkmx + common/nucl3/phi,bimp + parameter (ndep=129,ndet=129) + common/cdep/xdep(ndep),qdep(ndep),wdep(ndep) + common/cdet/xdet(ndet),qdet(ndet),wdet(ndet) + parameter (nptj=129) + common /cptj/xptj(nptj),qptj(nptj),wptj(nptj) + parameter (mxbim=12) + common/jpsi1/bimmax,kolran,delt,taumi,jpsinu,jpsidr,taudmx + parameter (mxmass=20) + + parameter (nxmdk=20) + parameter (ntjpsi=150) + common/jpsi7/xydens(ntjpsi,mxbim,nxmdk,nxmdk),a4min,a4max + common/jpsi8/xys(mxbim,nxmdk,nxmdk),a5min,a5max + common/jpsi9/ami(ntjpsi,mxmass),a6min,a6max + + call utpri('jpsifo',ish,ishini,4) + if(ish.ge.6)write(ifch,'(a)')' jpsi formation' + +c trigger +c ------- + + ymax=0.5 + ymin=-0.5 + +c jpsi momenta +c ------------ + id=441 + call idmass(id,amass) + s=amass**2 + 2 rqptj=rangen()*qptj(nptj) + pt=utinvt(nptj,xptj,qptj,rqptj) + phi=2.*pi*rangen() + px=pt*cos(phi) + py=pt*sin(phi) + lo=0 + 1 lo=lo+1 + if(lo.gt.10)call utstop('jpsifo: lo > 10 &') + z=0.19*sqrt(-2*alog(rangen()))*cos(2*pi*rangen()) !1-dim gauss + + + if(z.gt.1.)goto 1 + pz=z*engy/2*ransig() + e=sqrt(s+px**2+py**2+pz**2) + amt=sqrt(amass**2+pt**2) + y=sign(1.,pz)*alog( (e+abs(pz))/amt ) + if(y.lt.ymin.or.y.gt.ymax)goto 2 + +c fill /cptl/ +c ----------- + if(npjpsi.eq.0)then + nptl=nptl+1 + npjpsi=nptl + endif + if(npjpsi.gt.mxptl)then + print *,npjpsi,mxptl + call utstop('jpsifo: npjpsi>mxptl&') + endif + istptl(npjpsi)=1 + idptl(npjpsi)=id + pptl(1,npjpsi)=px + pptl(2,npjpsi)=py + pptl(3,npjpsi)=pz + pptl(4,npjpsi)=e + pptl(5,npjpsi)=amass + kolran=1+rangen()*kolevt + xorptl(1,npjpsi)=coord(1,kolran) + xorptl(2,npjpsi)=coord(2,kolran) + xorptl(3,npjpsi)=coord(3,kolran) + xorptl(4,npjpsi)=coord(4,kolran) + iorptl(npjpsi)=0 + jorptl(npjpsi)=0 + tivptl(1,npjpsi)=xorptl(4,npjpsi) + tivptl(2,npjpsi)=ainfin + ifrptl(1,npjpsi)=0 + ifrptl(2,npjpsi)=0 + if(ish.ge.6) then + call alist("&",npjpsi,npjpsi) + write (ifch,*) xorptl(1,npjpsi) + $ ,xorptl(2,npjpsi),xorptl(3,npjpsi),xorptl(4,npjpsi) + $ ,tivptl(1,npjpsi),tivptl(2,npjpsi) + ii=iproj(kolran) + jj=maproj+itarg(kolran) + call alist("collision&",ii,ii) + call alist("&",jj,jj) + endif + a4min=-15. + a4max= 15. + a5min=-15. + a5max= 15. + a6min= 2. + a6max= 10. + call utprix('jpsifo',ish,ishini,4) + return + end + +c----------------------------------------------------------------------- + function sptj(x) +c----------------------------------------------------------------------- +c jpsi pt-distribution in 200 gev pp +c----------------------------------------------------------------------- + a=0.95 + c=1/0.363 + z=x/a + sptj=1/a*c**c/utgam1(c)*z**(c-1)*exp(-c*z) + return + end + +c----------------------------------------------------------------------- + subroutine jpsian(ifirst) +c----------------------------------------------------------------------- +c jpsi analysis. +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + parameter (mxbim=12,ntjpsi=150,mxtauc=16) + common/jpsi1/bimmax,kolran,delt,taumi,jpsinu,jpsidr,taudmx + common/jpsi2/jjtot(mxbim),jjnuc(mxbim),jjjtau(mxbim,mxtauc) + common/jpsi3/jjjtot(mxbim,ntjpsi),jjjdro(mxbim,ntjpsi) + common/jpsi4/nnucl(mxbim,ntjpsi),nclose(mxbim,ntjpsi,3) + common/jpsi5/ndrop(mxbim,ntjpsi),jjjnt(mxbim,mxtauc) + parameter (mxmass=20,mxassy=20) + common/jpsi6/ndrp2(mxbim,ntjpsi,mxmass,mxassy) + & ,ndrop3(mxbim,ntjpsi,mxmass,mxassy) + parameter (nxmdk=20) + common/jpsi7/xydens(ntjpsi,mxbim,nxmdk,nxmdk),a4min,a4max + common/jpsi8/xys(mxbim,nxmdk,nxmdk),a5min,a5max + common/jpsi9/ami(ntjpsi,mxmass),a6min,a6max + common/jpsi10/ndrop0(mxbim,ntjpsi) + + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat + common/cttaus/tpro,zpro,ttar,ztar,ttaus,detap,detat /ctain/mtain + common/geom/rmproj,rmtarg,bmax,bkmx + common/nucl3/phi,bimp + parameter (ndep=129,ndet=129) + common/cdep/xdep(ndep),qdep(ndep),wdep(ndep) + common/cdet/xdet(ndet),qdet(ndet),wdet(ndet) + + common/c9ptl/tauptl(mxptl),ss0ptl(mxptl) + + call utpri('jpsian',ish,ishini,5) + + detap=(ypjtl-yhaha)*etafac + detat=-yhaha*etafac + tpro=dcosh(detap) + zpro=dsinh(detap) + ttar=dcosh(detat) + ztar=dsinh(detat) + + jpsinu=1 + jpsidr=1 + +c fac=1 ! <-------- should be one finally + taudmx=4 + rad=sqrt(0.62 / pi) + taud=0 + nucia=0 + taumi=-2 + delt=0.1 + bimmax=amin1(rmproj+rmtarg,bmaxim) + delbim=bimmax/mxbim + ii=iproj(kolran) + jj=maproj+itarg(kolran) + + +c.....first event: delete commom blocks............................... + if(ifirst.eq.1)then + ifirst=0 + do nbim=1,mxbim + jjtot(nbim)=0 + jjnuc(nbim)=0 + do ix=1,nxmdk + do iy=1,nxmdk + xys(nbim,ix,iy)=0. + enddo + enddo + do nt=1,ntjpsi + jjjtot(nbim,nt)=0 + nnucl(nbim,nt)=0 + jjjdro(nbim,nt)=0 + ndrop(nbim,nt)=0 + ndrop0(nbim,nt)=0 + do kk=1,3 + nclose(nbim,nt,kk)=0 + enddo + do ix=1,nxmdk + do iy=1,nxmdk + xydens(nt,nbim,ix,iy)=0. + enddo + enddo + enddo + do mm=1,mxtauc + jjjtau(nbim,mm)=0 + enddo + enddo + endif + + nbim=1+int(bimevt/delbim) + if(nbim.lt.0.or.nbim.gt.mxbim) goto 5 + jjtot(nbim)=jjtot(nbim)+1 !events pro bin + + do 1 i=1,nptl + if(idptl(i).eq.441)j=i + 1 continue + +c if(jpsidr.eq.1)then +c write(6,'(a,i5,a,f6.2,a,f6.2,a,f6.2)')'ip=',ip +c *,' rin= ' +c *,' mass= ',pptl(5,ip) +c enddo +c endif +c endif + + taumax=0. + ttaus=taumi-delt + do 2 nt=1,ntjpsi + idrin=0 + ttaus=ttaus+delt !increment of time + if(ish.ge.6)write(ifch,*) 'ttaus:-->',ttaus,ii,jj + jpsiex=1 + call jtain(j,xj,yj,zj,tj,n,1) + if(n.eq.1.or.n.eq.2.or.n.eq.9)jpsiex=0 !goto 2 + if(jpsiex.eq.1)jjjtot(nbim,nt)=jjjtot(nbim,nt)+1 + +c nucleons +c -------- + + if(jpsinu.eq.1.and.jpsiex.eq.1)then !test jpsi-nucleon collision + do 6 i=1,maproj+matarg + if(i.eq.ii.or.i.eq.jj)goto 6 + nnucl(nbim,nt)=nnucl(nbim,nt)+1 + t=sngl(ttaus) + x=xorptl(1,i)+(t-xorptl(4,i))*pptl(1,i)/pptl(4,i) + y=xorptl(2,i)+(t-xorptl(4,i))*pptl(2,i)/pptl(4,i) + z=xorptl(3,i)+(t-xorptl(4,i))*pptl(3,i)/pptl(4,i) + pde=(pptl(3,i)+pptl(3,j))/(pptl(4,i)+pptl(4,j)) + gam2i=1-pde**2 + if(gam2i.eq.0.)goto 6 + dist=sqrt((x-xj)**2+(y-yj)**2 + & +1/gam2i*(z-zj-(t-tj)*pde)**2) + if(dist.le.rad)then + nclose(nbim,nt,1)=nclose(nbim,nt,1)+1 + nucia=1 + if(ish.ge.6)then + write (ifch,*) "nucl dist:",dist,' dist(sig)=' + $ ,rad + call alist("&",i,i) + call alist("&",j,j) + endif + elseif(dist.le.rad+1)then + nclose(nbim,nt,2)=nclose(nbim,nt,2)+1 + elseif(dist.le.rad+3)then + nclose(nbim,nt,3)=nclose(nbim,nt,3)+1 + endif + 6 continue + endif + +c particles +c --------- + do 8 i=1,nptl +c if ( i.eq.ii.or.i.eq.jj ) goto 8 + call jtain(i,x,y,z,t,n,1) + call jtaus(z,tz,sz) + if(n.eq.1.or.n.eq.2.or.n.eq.9)goto 8 +c calculate s +c ----------- + iad=iabs(idptl(i)) +c s=(pptl(4,i)+pptl(4,j))**2-(pptl(3,i)+pptl(3,j))**2 +c $ -(pptl(2,i)+pptl(2,j))**2-(pptl(1,i)+pptl(1,j))**2 + if ( iad.eq.120 .or. iad.eq.110 ) then !pion + sig=1. ! + elseif ( iad.eq.121 .or. iad.eq.111 ) then ! rho + sig=1. ! + elseif ( iad.eq.1120 .or. iad.eq.1220 ) then + sig=3.0 ! ???? or 6 ???? + else + goto 8 + endif + call jtaus(zj,tzj,szj) !????????????????? OK ? + dist=sqrt((x-xj)**2+(y-yj)**2+(sz-szj)**2) + if ( dist .lt. sqrt(0.1*sig/pi) ) then + istptl(j)=2 + if(ish.ge.6)then + write (ifch,*) "dist:",dist,' dist(sig)=' + $ ,sqrt(0.1*sig/pi),' sig=',sig + call alist("&",i,i) + call alist("&",j,j) + endif + endif + 8 continue + +c droplets +c -------- + + if(jpsidr.eq.1)then + call jtaus(zj,tzj,szj) + do 3 i=maproj+matarg+1,nptl +c...........x-y distribution of strings.............................. + if(istptl(i).eq.29.and.nt.eq.1)then + call jtain(i,x,y,z,t,n,1) + if(x.gt.a5min.and.x.lt.a5max.and. + & y.gt.a5min.and.y.lt.a5max)then + ix=(x-a5min)/(a5max-a5min)*nxmdk + 1 + iy=(y-a5min)/(a5max-a5min)*nxmdk + 1 + xys(nbim,ix,iy)=xys(nbim,ix,iy)+pptl(5,i) + endif + endif + if(istptl(i).gt.10)goto 3 + if(i.eq.j)goto 3 + +c................................................................... + + call jtain(i,x,y,z,t,n,1) + if(n.eq.1.or.n.eq.2.or.n.eq.9)goto 3 + stop'jpsian: change!!!! ' !call jintep(i,x,y,z,t,sz,eps,rho) + if(eps.lt.aouni)goto 3 !min-dichte + ndrop(nbim,nt)=ndrop(nbim,nt)+1 !droplets at time nt + ndrop0(nbim,nt)=ndrop0(nbim,nt)+pptl(5,i) !mass + des=0 !????????????????????????????????? + o=sz+des + u=sz-des + r=0 !( xxxx(i) +sngl(ttaus) ) *fac +c..............assym-mass-distribution............................... + assym=log(des/r) + amass=pptl(5,i) + a1min=-5. + a1max=5. + a2min=0. + a2max=40. + if(assym.ge.a1min.and.assym.lt.a1max + & .and.amass.ge.a2min.and.amass.lt.a2max + & ) then + nassym=(assym-a1min)/(a1max-a1min)*mxassy+1 + namass=(amass-a2min)/(a2max-a2min)*mxmass+1 + ndrp2(nbim,nt,namass,nassym)= + & ndrp2(nbim,nt,namass,nassym)+1 + endif + +c..............vol-mass-distribution............................... + a3min=-2. + a3max=3. + v=log(pi*r**2.*2.*des)/log(10.) + if(v.ge.a3min.and.v.lt.a3max + & .and.amass.ge.a2min.and.amass.lt.a2max + & ) then + nv=(v-a3min)/(a3max-a3min)*mxassy+1 + namass=(amass-a2min)/(a2max-a2min)*mxmass+1 + ndrop3(nbim,nt,namass,nv)= + & ndrop3(nbim,nt,namass,nv)+1 + endif +c..............x-y distribution of droplet.............................. + ix=(x-a4min)/(a4max-a4min)*nxmdk + 1 + iy=(y-a4min)/(a4max-a4min)*nxmdk + 1 + xydens(nt,nbim,ix,iy)=xydens(nt,nbim,ix,iy)+eps + + if(jpsiex.eq.0)goto 3 + +c if(mod(nt,10).eq.1) +c write(6,'(f5.2,i6,5x,3f7.2,5x,4f6.2)')sngl(ttaus),i, +c * u,szj,o,sqrt((x-xj)**2+(y-yj)**2),r,v,eps + + if(szj.lt.u.or.szj.gt.o)goto 3 + if((x-xj)**2+(y-yj)**2.gt.r**2)goto 3 + +c write(6,'(a,f5.2,a,i5,a)')'***** t=',sngl(ttaus) +c *,' -- jpsi in droplet ',i,' *****' + + taud=taud+delt + taumax=max(taud,taumax) + +c write (*,*) taud,taumax + + idrin=1 + jjjdro(nbim,nt)=jjjdro(nbim,nt)+1 + 3 continue + +c if (idrin.ne.1)taud=max(taud-delt,0.) + + if (idrin.ne.1)taud=0. + endif + + 2 continue !end nt-loop + + ijmod=2 + if(ijmod.eq.2)taud=taumax + if(nucia.eq.1)jjnuc(nbim)=jjnuc(nbim)+1 + if(taud.gt.0.)then + do ntaud=1,mxtauc + tauc=ntaud*taudmx/mxtauc + if(taud.gt.tauc)jjjtau(nbim,ntaud)=jjjtau(nbim,ntaud)+1 + if(nucia.eq.1.or.taud.gt.tauc) + & jjjnt(nbim,ntaud)=jjjnt(nbim,ntaud)+1 + enddo + else + do ntaud=1,mxtauc + if(nucia.eq.1) + & jjjnt(nbim,ntaud)=jjjnt(nbim,ntaud)+1 + enddo + endif + + 5 continue + call utprix('jpsian',ish,ishini,5) + return + end + +c----------------------------------------------------------------------- + subroutine jtauan(is,im) +c----------------------------------------------------------------------- +c display collision +c im = ijk +c k > 0 --> post-script +c j > 0 --> povray +c j = 1 --> time and z in n-n cms +c j = 2 --> time and z on hyberbola +c i > 0 --> text ( changes in alist per time step ) +c cut in zeta-x (or y) plane for tau +c----------------------------------------------------------------------- + include 'epos.inc' + double precision tpro,zpro,ttar,ztar,ttaus,detap,detat + common/cttaus/tpro,zpro,ttar,ztar,ttaus,detap,detat /ctain/mtain + parameter (mxbim=12,ntjpsi=150,mxtauc=16) + common/jpsi1/bimmax,kolran,delt,taumi,jpsinu,jpsidr,taudmx + common/jpsi2/jjtot(mxbim),jjnuc(mxbim),jjjtau(mxbim,mxtauc) + common/jpsi3/jjjtot(mxbim,ntjpsi),jjjdro(mxbim,ntjpsi) + common/jpsi4/nnucl(mxbim,ntjpsi),nclose(mxbim,ntjpsi,3) + common/jpsi5/ndrop(mxbim,ntjpsi),jjjnt(mxbim,mxtauc) + parameter (mxmass=20,mxassy=20) + common/jpsi6/ndrp2(mxbim,ntjpsi,mxmass,mxassy) + & ,ndrop3(mxbim,ntjpsi,mxmass,mxassy) + parameter (nxmdk=20) + common/jpsi7/xydens(ntjpsi,mxbim,nxmdk,nxmdk),a4min,a4max + common/jpsi8/xys(mxbim,nxmdk,nxmdk),a5min,a5max + common/jpsi9/ami(ntjpsi,mxmass),a6min,a6max + common/jpsi10/ndrop0(mxbim,ntjpsi) + character*20 name,nnrr + character*28 filename + character*12 color(20) + character*12 colpo(20) + logical lcalc!,zet + dimension isch(mxptl) +c zet=.true. +c zet=.false. + xmin=-10. + xmax=10. + zmin=-10. + zmax=10. + +c zevent=float(nevent*jpsi) + if(mod(im,10).ne.0)then + name='tau-' + n=1 + 5 l=4 + ll=int(log(real(n))/log(10.))+1 + do ii=ll,1,-1 + l=l+1 + name(l:l)=char(48+mod(int(n/10**(ii-1)),10)) + enddo + name(l+1:l+3)='.ps' + l=l+3 + inquire(file=name(1:l),exist=lcalc) + if (lcalc)then + n=n+1 + goto 5 + endif + write(*,*) 'jtauan name ',name + ifps=92 + open(unit=ifps,file=name(1:l),status='unknown') + WRITE(ifps,'(a)') '%!PS-Adobe-2.0' + WRITE(ifps,'(a)') '%%Title: tt2.fig' + WRITE(ifps,'(a)') '%%Orientation: Portrait' + WRITE(ifps,'(a)') '%%BeginSetup' + WRITE(ifps,'(a)') '%%IncludeFeature: *PageSize A4' + WRITE(ifps,'(a)') '%%EndSetup' + WRITE(ifps,'(a)') '%%EndComments' + WRITE(ifps,*) '/l {lineto} bind def' + WRITE(ifps,*) '/rl {rlineto} bind def' + WRITE(ifps,*) '/m {moveto} bind def' + WRITE(ifps,*) '/rm {rmoveto} bind def' + WRITE(ifps,*) '/s {stroke} bind def' + WRITE(ifps,*) '/gr {grestore} bind def' + WRITE(ifps,*) '/gs {gsave} bind def' + WRITE(ifps,*) '/cp {closepath} bind def' + WRITE(ifps,*) '/tr {translate} bind def' + WRITE(ifps,*) '/sc {scale} bind def' + WRITE(ifps,*) '/sd {setdash} bind def' + WRITE(ifps,*) '/sdo {[.01 .05] 0 sd} bind def' + WRITE(ifps,*) '/sdf {[1 .0] 0 sd} bind def' + WRITE(ifps,*) '/n {newpath} bind def' + WRITE(ifps,*) '/slw {setlinewidth } bind def' + write(ifps,*) '/srgb {setrgbcolor} bind def' + write(ifps,*) '/lgrey { 0 0.95 0.95 srgb} bind def' + write(ifps,*) '/black { 0 0 0 srgb} bind def' + write(ifps,*) '/red { 1 0 0 srgb} bind def ' + write(ifps,*) '/green { 0 1 0 srgb} bind def ' + write(ifps,*) '/blue { 0 0 1 srgb} bind def ' + write(ifps,*) '/yellow { 1 0.5 0 srgb} bind def ' + write(ifps,*) '/turquoise { 0 1 1 srgb} bind def ' + write(ifps,*) '/purple { 1 0 1 srgb} bind def ' +c.......write(ifps,*) '/ { srgb} bind def ' +c.......write(ifps,*) '/ { srgb} bind def ' + write(ifps,*) '/ef {eofill} bind def' + WRITE(ifps,'(a)') '%%EndProlog' + WRITE(ifps,*) 'gsave' + WRITE(ifps,*) '/Helvetica findfont 10 scalefont setfont' + endif + color(9)='lgrey ' + color(1)='black ' + color(2)='red ' + color(3)='green ' + color(4)='blue ' + color(7)='yellow ' + color(5)='turquoise ' + color(6)='purple ' + colpo(1)='Red ' + colpo(2)='Green ' + colpo(3)='Blue ' + colpo(4)='Yellow ' + colpo(5)='Cyan ' + colpo(6)='Magenta ' + colpo(7)='Black ' + colpo(8)='Aquamarine ' + + + do i=1,mxptl + isch(i)=0 + enddo + +c gray0=.95 +c gray1=0. + iyb=0 !???????????????????? + np=0 + nt=-10 + deltau=0.1 + taumin=-1 + ttaus=0 + do while (ttaus.lt.20.) + nt=nt+1 + ! ttaus=dble(taumin+deltau*(factau**(1.*nt-1.)-1)/(factau-1.)) + ttaus=taumin+deltau*nt + tau=ttaus + np=np+1 + if(mod(im,10).ne.0)then + write(ifps,'(a,i4)') '%%Page: number ',np + write(ifps,'(a)') 'gsave' + WRITE(ifps,*) '100 700 tr' + scale=0.125 + WRITE(ifps,*) 1./scale,1./scale,' sc' + WRITE(ifps,*) scale/2.,' slw' + WRITE(ifps,*) '/Helvetica findfont ',15.*scale + & ,' scalefont setfont' + write(ifps,*) color(1),' n ',zmin,xmin,' m ( tau:' + $ ,tau,') show ' + WRITE(ifps,*) '/Helvetica findfont ',2.*scale + & ,' scalefont setfont' + endif + +*--------------------------------------------------------------------* +*------ povray ------------------------------------------------------* +*--------------------------------------------------------------------* + + if (mod(im/100,10).gt.0) then + write (ifch,*) "-----",np,", tau:",ttaus,"------" + endif + if (mod(im/10,10).gt.0) then + write (nnrr,'(i5)') np + li=6-log(1.*np+0.1)/log(10.) + write (*,*) "--->"//nnrr(li:5)//"<-----",li,ttaus + ifpo=55 + filename="tau."//nnrr(li:5)//".pov" + open(unit=ifpo,file=filename,status='unknown') + write (ifpo,'(a)') '#include "colors.inc";' +c write (ifpo,'(a)') '#include "shapes.inc" ' +c write (ifpo,'(a)') '#include "textures.inc" ' + write (ifpo,'(a)') 'background {color White} ' + write (ifpo,'(a)') 'camera {location <0,0,-120> ' + write (ifpo,'(a)') ' direction <0,0,2> look_at <0,0,0>} ' + write (ifpo,'(a)') 'light_source{<0,300,0> color White} ' + write (ifpo,'(a)') 'light_source{<0,5,-90> color White} ' + write (ifpo,'(a)') ' ' + write (ifpo,'(a)') ' ' + endif + do i=1,nptl + if (istptl(i).gt.1) goto 123 + if((tivptl(2,i)-tivptl(1,i)).lt.1e-3 + $ .and.idptl(i).gt.1000000.and.iyb.eq.0) + $ then + write (*,*) 'tiv1=tiv2 !!!!!!!!',i + tivptl(2,i)=tivptl(1,i)+100. + endif +c...........calculate coordinates.................................... + if(mod(im/10,10).eq.1) then !n-n cms frame + if (istptl(i).gt.1 + $ .or.ttaus.lt.tivptl(1,i) + $ .or.ttaus.gt.tivptl(2,i)) goto 123 + x=xorptl(1,i)+(ttaus-xorptl(4,i))*pptl(1,i)/pptl(4,i) + y=xorptl(2,i)+(ttaus-xorptl(4,i))*pptl(2,i)/pptl(4,i) + z=xorptl(3,i)+(ttaus-xorptl(4,i))*pptl(3,i)/pptl(4,i) + else ! hyperbola frame + call jtain(i,x,y,z,t,n,0) + call jtaus(z,tz,sz) + z=sz + if(n.ne.0) goto 123 + endif +c...........plot sphere or cylinder ................................ + if(idptl(i).gt.700000000) + $ then + if(mod(im/10,10).eq.1)then + + else + des=0 !????????????????????????????? + r=0 !(xxxx(i)+vrad*sngl(ttaus)) + o=sz+des + u=sz-des + print *,ttaus,o,u,r,x,y + ic=4 + if (mod(im/10,10).gt.0) then + write (ifpo,111) o,x,y,u,x,y,r,colpo(ic) + endif + endif +c.............text output of changes in time step ................... + if (mod(im/100,10).gt.0) then + if(isch(i).eq.0)then + write (ifch,'("> ",$)') + call alist("&",i,i) + isch(i)=1 + endif + endif +c$$$ o=sz+des +c$$$ u=sz-des +c$$$ r=(xxxx(i)+vrad*sngl(ttaus)) +c$$$ rr2=r**2-(y-yb)**2 +c$$$ if(rr2.gt.0.)then +c$$$ write(ifps,*) +c$$$ & ,' n ',u,x-r,' m ',o,x-r,' l ' +c$$$ & ,o,x+r,' l ',u,x+r,' l cp s ' +c$$$ write(ifps,*) ' n ',u,x-r,' m (',i,iorptl(i),') show ' +c$$$ endif + else +c.............cylinder................................................ + r=0.8 + ic=1 + if(abs(idptl(i)).lt.999) r=0.5 + if(iabs(idptl(i)).eq.1120) ic=2 + if(iabs(idptl(i)).eq.1220) ic=3 + if(iabs(idptl(i)).eq.441) ic=5 + if(mod(im/10,10).gt.0)then + write (ifpo,110) z,x,y,r,colpo(ic) ! sphere + endif +c.............text................................................... + if(mod(im/100,10).gt.0)then + if(isch(i).eq.0)then + write (ifch,'("> ",$)') + call alist("&",i,i) + isch(i)=1 + endif + endif + endif + goto 124 + 123 continue +c.........text................................ + if(mod(im/100,10).gt.0)then + if(isch(i).eq.1)then + write (ifch,'("< ",$)') + call alist("&",i,i) + isch(i)=0 + endif + endif + 124 continue + enddo +c....... + 110 format('sphere {<',G12.6,',',g12.6,',',g12.6,'>,',g12.6 + $ ,'pigment {color ',a,'}}') + 111 format('cylinder {<', + $ G12.6,',',g12.6,',',g12.6, + $ '>,<', + $ G12.6,',',g12.6,',',g12.6, + $ '>,', + $ g12.6, + $ 'pigment {color ',a,'}}') + if(mod(im/10,10).gt.0)then + close(unit=ifpo) + endif +*-------------------------------------------------------------------* +*------- end povray ------------------------------------------* +*------- begin post-script ---------------------------------------* +*-------------------------------------------------------------------* + + if(mod(im,10).eq.0) goto 159 + yb=-6. + dy=12./12. + yb=yb-dy/2 + do iyb=0,11 + yb=yb+dy + WRITE(ifps,*) 'gsave' + WRITE(ifps,*) (xmax-xmin)*1.1*float(int(iyb/4)) + & ,-(xmax-xmin)*1.1*mod(iyb,4),' tr' + write(ifps,*) ' n ',zmin,xmin,' m ',zmax,xmin,' l ' + & ,zmax,xmax,' l ',zmin,xmax,' l cp s ' +c ttaus=dble(tau) +c.........particles in layer iyb............. + do 10 i=1,nptl + if (istptl(i).gt.1) goto 10 + if((tivptl(2,i)-tivptl(1,i)).lt.1e-3 + $ .and.idptl(i).gt.1000000.and.iyb.eq.0) + $ then + write (*,*) 'tiv1=tiv2 !!!!!!!!',i + tivptl(2,i)=tivptl(1,i)+100. + endif + call jtain(i,x,y,z,t,n,0) + call jtaus(z,tz,sz) + if(n.ne.0) goto 10 + if( + $ (is.eq.0.or.is.eq.i.or.is.eq.iorptl(i)))then +*............. +*............. is is the particle number to observe +*............. if is=0 then all particles +*............. +c .and.abs(y-yb).lt.dy/2)then + des=0 !?????????????????????????????????? + if(iyb.eq.11.and + $ .abs(tivptl(2,i)-tivptl(1,i)-100.).le.1e-4 ) then + tivptl(2,i)=tivptl(1,i)+0.01 + endif + o=sz+des + u=sz-des + r=0 !(xxxx(i)+vrad*sngl(ttaus)) + rr2=r**2-(y-yb)**2 + if(rr2.gt.0.)then + r=sqrt(rr2) +c write (*,*) i,des,o,u,r,y + write(ifps,*) color(mod(i,5)+2) + & ,' n ',u,x-r,' m ',o,x-r,' l ' + & ,o,x+r,' l ',u,x+r,' l cp s ' + write(ifps,*) ' n ',u,x-r,' m (',i,iorptl(i),') show ' + endif + elseif(abs(y-yb).lt.dy/2.and.zmin.lt.sz.and.sz.lt.zmax + & .and.xmin.lt.x.and.x.lt.xmax)then + r=0.8 + ic=1 + if(abs(idptl(i)).lt.999)r=0.5 + if(abs(idptl(i)).lt.999)ic=2 + if(abs(idptl(i)).eq.1120)ic=3 + if(abs(idptl(i)).eq.1220)ic=4 + if(idptl(i).eq.441) ic=7 + + io=iorptl(i) + if(is.eq.0.or.io.eq.is)then + write(ifps,*) ' n ',sz,x,r,0,360,' arc ',color(ic),' s ' + write(ifps,*) ' n ',sz-r,x,' m (',i,io,') show ' + endif + endif + 10 continue + write(ifps,*) color(1),' n ',zmin,xmin,' m (',yb,') show ' + WRITE(ifps,*) 'grestore' + enddo !yb bin + write(ifps,'(a)') 'grestore' + write(ifps,*) 'showpage' + 159 continue + enddo + + +c write(ifps,*) ' n ',y0,x0,' m ',y1,x0,' l ',y1,x1,' l ' +c & ,y0,x1,' l cp s ' +c write(ifps,*) ' n ',(y0+y1)/2-10.*scale,(x0+x1)/2-5.*scale +c & ,' m (',ii,jj,') show ' +c ii=nob-1 + + + if(mod(im,10).ne.0)then + write(ifps,*) 'gr' + write(ifps,'(a)') '%%Trailer' + write(ifps,'(a,i4)') '%%Pages: ',np + write(ifps,'(a)') '%%EOF' + close(unit=ifps) + endif + return + end + + +c----------------------------------------------------------------------- + subroutine jpsihi +c----------------------------------------------------------------------- +c histogram +c----------------------------------------------------------------------- + include 'epos.inc' + parameter (mxbim=12,ntjpsi=150,mxtauc=16) + common/jpsi1/bimmax,kolran,delt,taumi,jpsinu,jpsidr,taudmx + common/jpsi2/jjtot(mxbim),jjnuc(mxbim),jjjtau(mxbim,mxtauc) + common/jpsi3/jjjtot(mxbim,ntjpsi),jjjdro(mxbim,ntjpsi) + common/jpsi4/nnucl(mxbim,ntjpsi),nclose(mxbim,ntjpsi,3) + common/jpsi5/ndrop(mxbim,ntjpsi),jjjnt(mxbim,mxtauc) + parameter (mxmass=20,mxassy=20) + common/jpsi6/ndrp2(mxbim,ntjpsi,mxmass,mxassy) + & ,ndrop3(mxbim,ntjpsi,mxmass,mxassy) + parameter (nxmdk=20) + common/jpsi7/xydens(ntjpsi,mxbim,nxmdk,nxmdk),a4min,a4max + common/jpsi8/xys(mxbim,nxmdk,nxmdk),a5min,a5max + common/jpsi9/ami(ntjpsi,mxmass),a6min,a6max + common/jpsi10/ndrop0(mxbim,ntjpsi) + + zevent=float(nevent*jpsi) + + write(ifhi,'(a)') 'cd /users/theoric/werner/histo/newdata' + write(ifhi,'(a)') 'newpage' + +c suppression as a function of b +c ------------------------------ + + write(ifhi,'(a)') 'zone 1 2 1 openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis bmax-b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis J(b) et Jnuc(b) / J"' + write(ifhi,'(a,2e11.3)')'xrange',0.,bimmax + write(ifhi,'(3a)')'yrange',' 0 ',' auto' + write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' + write(ifhi,'(a)') 'array 4' + do j=mxbim,1,-1 + bim=(j-0.5)*bimmax/mxbim + write(ifhi,'(4e12.4)')bimmax-bim,jjtot(j)/zevent,0.,zevent + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis bmax-b (fm)"' + write(ifhi,'(a)') 'text 0 0 " "' + write(ifhi,'(a,2e11.3)')'xrange',0.,bimmax + write(ifhi,'(3a)')'yrange',' 0 ',' auto' + write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' + write(ifhi,'(a)') 'array 4' + do j=mxbim,1,-1 + bim=(j-0.5)*bimmax/mxbim + write(ifhi,'(4e12.4)')bimmax-bim,jjnuc(j)/zevent,0.,zevent + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis bmax-b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis survival ratio"' + write(ifhi,'(a,3e11.3)')'xrange',0.,bimmax + write(ifhi,'(3a)')'yrange',' 0.2 ',' auto ' + write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' + write(ifhi,'(a)') 'array 4' + do j=mxbim,1,-1 + bim=(j-0.5)*bimmax/mxbim + rat=0 + if(jjtot(j).gt.0.)rat=float(jjtot(j)-jjnuc(j))/jjtot(j) + write(ifhi,'(4e12.4)')bimmax-bim,rat,0.,float(jjtot(j)) + enddo + write(ifhi,'(a)') ' endarray' + if(maproj.eq.208.and.matarg.eq.208)then + write(ifhi,'(a)') 'closehisto plot 0-' + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'set fmsc 1.0' + write(ifhi,'(a,f4.1,a)')'column c1 = ( ',bimmax,' - c1 )' + write(ifhi,'(a)') 'column c2 = ( c2 * 0.02 )' + write(ifhi,'(a)') 'input na50 ratio-b plot 0' + else + write(ifhi,'(a)') 'closehisto plot 0' + endif + +c nr of jpsi vs t +c --------------- + + write(ifhi,'(a)') 'zone 3 4 1' + do nb=mxbim,1,-1 + bim=(nb-0.5)*bimmax/mxbim + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a,f5.2,a)')'text .1 .90 "b= ',bim,' fm"' + write(ifhi,'(a)') 'text 0 0 "xaxis time t (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis J(b,t) / J"' + write(ifhi,'(a,2e11.3)')'xrange',taumi,taumi+ntjpsi*delt + write(ifhi,'(3a)') 'yrange',' 0 ',' auto' + write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' + write(ifhi,'(a)') 'array 4' + do j=1,ntjpsi + tau=taumi+(j-0.5)*delt + write(ifhi,'(4e12.4)')tau,float(jjjtot(nb,j))/nevent,0.,nevent + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + enddo + +c nr of nucleons vs t +c ------------------- + + if(jpsinu.eq.1)then + write(ifhi,'(a)') 'zone 3 4 1' + do nb=mxbim,1,-1 + bim=(nb-0.5)*bimmax/mxbim + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a,f5.2,a)')'text .1 .90 "b= ',bim,' fm"' + write(ifhi,'(a)') 'text 0 0 "xaxis time t (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis N(b,t) / J"' + write(ifhi,'(a,2e11.3)')'xrange',taumi,taumi+ntjpsi*delt + write(ifhi,'(3a)')'yrange',' 0 ',' auto' + write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' + write(ifhi,'(a)') 'array 4' + do j=1,ntjpsi + tau=taumi+(j-0.5)*delt + rat=0 + if(jjjtot(nb,j).gt.0)rat=nnucl(nb,j)/float(jjjtot(nb,j)) + write(ifhi,'(4e12.4)')tau,rat,0.,float(jjjtot(nb,j)) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + enddo + endif + +c nr of close nucleons vs t +c ------------------------- + + if(jpsinu.eq.1)then + write(ifhi,'(a)') 'zone 3 4 1' + do nb=mxbim,1,-1 + bim=(nb-0.5)*bimmax/mxbim + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a,f5.2,a)')'text .1 .90 "b= ',bim,' fm"' + write(ifhi,'(a)') 'text 0 0 "xaxis time t (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis Nclose(b,t) / J"' + write(ifhi,'(a,2e11.3)')'xrange',taumi,taumi+ntjpsi*delt + write(ifhi,'(3a)')'yrange',' 0 ',' auto ' + write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' + write(ifhi,'(a)') 'array 4' + do j=1,ntjpsi + tau=taumi+(j-0.5)*delt + rat=0 + if(jjjtot(nb,j).ne.0)rat=nclose(nb,j,1)/float(jjjtot(nb,j)) + write(ifhi,'(4e12.4)')tau,rat,0.,float(jjjtot(nb,j)) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + enddo + endif + +c number of droplets +c ------------------ + + if(jpsidr.eq.1)then + write(ifhi,'(a)') 'zone 3 4 1' + do nb=mxbim,1,-1 + bim=(nb-0.5)*bimmax/mxbim + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lfu xmod lin ymod lin' + write(ifhi,'(a,f5.2,a)')'text .1 .90 "b= ',bim,' fm"' + write(ifhi,'(a)') 'text 0 0 "xaxis time t (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis D(b,t) / J"' + write(ifhi,'(a,2e11.3)')'xrange',taumi,taumi+ntjpsi*delt + write(ifhi,'(3a)')'yrange',' 0 ',' auto ' + write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' + write(ifhi,'(a)') 'array 4' + do j=1,ntjpsi + tau=taumi+(j-0.5)*delt + rat=0 + if(jjjtot(nb,j).ne.0)rat=ndrop(nb,j)/float(jjjtot(nb,j)) + write(ifhi,'(4e12.4)')tau,rat,0.,float(jjjtot(nb,j)) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + enddo + endif + +c number of droplets +c ------------------ + + if(jpsidr.eq.1)then + write(ifhi,'(a)') 'zone 3 4 1' + do nb=mxbim,1,-1 + bim=(nb-0.5)*bimmax/mxbim + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lfu xmod lin ymod lin' + write(ifhi,'(a,f5.2,a)')'text .1 .90 "b= ',bim,' fm"' + write(ifhi,'(a)') 'text 0 0 "xaxis time t (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis mass*D(b,t) / J"' + write(ifhi,'(a,2e11.3)')'xrange',taumi,taumi+ntjpsi*delt + write(ifhi,'(3a)')'yrange',' 0 ',' auto ' + write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' + write(ifhi,'(a)') 'array 4' + do j=1,ntjpsi + tau=taumi+(j-0.5)*delt + rat=0 + if(jjjtot(nb,j).ne.0)rat=ndrop0(nb,j)/float(jjjtot(nb,j)) + write(ifhi,'(4e12.4)')tau,rat,0.,float(jjjtot(nb,j)) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + enddo + endif + +c$$$c assymetry and mass of droplets +c$$$c ------------------ +c$$$ +c$$$ if(jpsidr.eq.1)then +c$$$ do nb=11,1,-5 +c$$$ bim=(nb-0.5)*bimmax/mxbim +c$$$ write(ifhi,'(a)') 'zone 3 4 1' +c$$$ do nt=40,150,10 +c$$$ tau=taumi+(nt-0.5)*delt +c$$$ +c$$$ write(ifhi,'(a)') 'openhisto' +c$$$ write(ifhi,'(a)') 'htyp lfu xmod lin ymod lin' +c$$$ write(ifhi,*) 'text .1 .90 "b= ',bim,' fm ','t=',tau,'"' +c$$$ write(ifhi,'(a)') 'text 0 0 "xaxis mass "' +c$$$ write(ifhi,'(a)') 'text 0 0 "yaxis assym"' +c$$$ write(ifhi,'(a,2e11.3)')'xrange ',0.,40. +c$$$ write(ifhi,'(a,2e11.3)')'yrange ',-5.,5. +c$$$ write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' +c$$$ write(ifhi,'(a,i)') 'set ityp2d 5' +c$$$ write(ifhi,'(a,i)') 'array2d ',mxmass +c$$$ +c$$$ do i=1,mxassy +c$$$ do j=1,mxmass +c$$$ rat=0. +c$$$ rat=float(ndrp2(nb,nt,j,i)) +c$$$ & /zevent ! nevent +c$$$ & /(40./20) ! mass-bin +c$$$ & /(10./20) ! log(assy)-bin +c$$$ & /1. ! b-bin +c$$$ write (ifhi,*) rat +c$$$ enddo +c$$$ enddo +c$$$ +c$$$ write(ifhi,'(a)') ' endarray' +c$$$ write(ifhi,'(a)') 'closehisto plot2d' +c$$$ enddo +c$$$ enddo +c$$$ endif +c$$$ +c$$$c volume and mass of droplets +c$$$c ------------------ +c$$$ +c$$$ if(jpsidr.eq.1)then +c$$$ do nb=11,1,-5 +c$$$ bim=(nb-0.5)*bimmax/mxbim +c$$$ write(ifhi,'(a)') 'zone 3 4 1' +c$$$ do nt=40,150,10 +c$$$ tau=taumi+(nt-0.5)*delt +c$$$ +c$$$ write(ifhi,'(a)') 'openhisto' +c$$$ write(ifhi,'(a)') 'htyp lfu xmod lin ymod lin' +c$$$ write(ifhi,*) 'text .1 .90 "b= ',bim,' fm ','t=',tau,'"' +c$$$ write(ifhi,'(a)') 'text 0 0 "xaxis mass "' +c$$$ write(ifhi,'(a)') 'text 0 0 "yaxis volume"' +c$$$ write(ifhi,'(a,2e11.3)')'xrange ',0.,40. +c$$$ write(ifhi,'(a,2e11.3)')'yrange ',-2.,3. +c$$$ write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' +c$$$ write(ifhi,'(a,i)') 'array2d ',mxmass +c$$$ +c$$$ do i=1,mxassy +c$$$ do j=1,mxmass +c$$$ rat=0. +c$$$ rat=float(ndrop3(nb,nt,j,i)) +c$$$ & /zevent ! nevent +c$$$ & /(40./20) ! mass-bin +c$$$ & /(5./20) ! log(v)-bin +c$$$ & /1. ! b-bin +c$$$ write (ifhi,*) rat +c$$$ enddo +c$$$ enddo +c$$$ +c$$$ write(ifhi,'(a)') ' endarray' +c$$$ write(ifhi,'(a)') 'closehisto plot2d' +c$$$ enddo +c$$$ enddo +c$$$ endif +c$$$ +c$$$c xy of droplets +c$$$c ------------------ +c$$$ +c$$$ if(jpsidr.eq.1)then +c$$$ write(ifhi,'(a)') 'zone 3 4 1' +c$$$ do nb=11,1,-5 +c$$$ bim=(nb-0.5)*bimmax/mxbim +c$$$ do nt=40,150,10 +c$$$ tau=taumi+(nt-0.5)*delt +c$$$ write(ifhi,'(a)') 'openhisto' +c$$$ write(ifhi,'(a)') 'htyp lfu xmod lin ymod lin' +c$$$ write(ifhi,*) 'text .1 .90 "xy b= ',bim,' fm ','t=',tau,'"' +c$$$ write(ifhi,'(a)') 'text 0 0 "xaxis x "' +c$$$ write(ifhi,'(a)') 'text 0 0 "yaxis y "' +c$$$ write(ifhi,'(a,2e11.3)')'xrange ',a4min,a4max +c$$$ write(ifhi,'(a,2e11.3)')'yrange ',a4min,a4max +c$$$ write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' +c$$$ write(ifhi,'(a,i)') 'array2d ',nxmdk +c$$$ do i=1,nxmdk +c$$$ do j=1,nxmdk +c$$$ rat=0. +c$$$ rat=xydens(nt,nb,i,j) +c$$$ & /zevent ! nevent +c$$$ & /((a4max-a4min)/float(nxmdk)) ! x-bin +c$$$ & /((a4max-a4min)/float(nxmdk)) ! y-bin +c$$$c...............& /1. ! b-bin +c$$$ write (ifhi,*) rat +c$$$ enddo +c$$$ enddo +c$$$ write(ifhi,'(a)') ' endarray' +c$$$ write(ifhi,'(a)') 'closehisto plot2d' +c$$$ enddo +c$$$ enddo +c$$$ endif +c$$$ +c$$$ +c$$$c$$$c.....michael-verteilung......................................... +c$$$c$$$ write(ifhi,'(a)') 'zone 3 4 1' +c$$$c$$$ do j=1,ntjpsi +c$$$c$$$ tau=taumi+(j-0.5)*delt +c$$$c$$$ +c$$$c$$$ write(ifhi,'(a)') 'openhisto' +c$$$c$$$ write(ifhi,'(a)') 'htyp lin xmod lin ymod log' +c$$$c$$$ write(ifhi,'(a,f5.2,a)')'text .1 .90 "tau= ',tau,' fm"' +c$$$c$$$ write(ifhi,'(a)') 'text 0 0 "xaxis mass t (fm)"' +c$$$c$$$ write(ifhi,'(a)') 'text 0 0 "yaxis Nclose(b,t) / J"' +c$$$c$$$ write(ifhi,'(a,2e11.3)')'xrange',a6min,a6max +c$$$c$$$ write(ifhi,'(3a)')'yrange',' 0 ',' auto ' +c$$$c$$$ write(ifhi,'(a)') 'array 2' +c$$$c$$$ do k=1,mxmass +c$$$c$$$ rat=0. +c$$$c$$$ amass=(k-0.5)/(mxmass)*(a6max-a6min)+a6min +c$$$c$$$ rat=ami(j,k)/zevent/(a6max-a6min)*mxmass +c$$$c$$$ write(ifhi,'(2e12.4)')amass,rat +c$$$c$$$ enddo +c$$$c$$$ write(ifhi,'(a)') ' endarray' +c$$$c$$$ write(ifhi,'(a)') 'closehisto plot 0' +c$$$c$$$ enddo +c$$$ +c$$$c xy of strings +c$$$c ------------- +c$$$ +c$$$ if(jpsidr.eq.1)then +c$$$ write(ifhi,'(a)') 'zone 3 4 1' +c$$$ do nb=11,1,-1 +c$$$ bim=(nb-0.5)*bimmax/mxbim +c$$$ write(ifhi,'(a)') 'openhisto' +c$$$ write(ifhi,'(a)') 'htyp lfu xmod lin ymod lin' +c$$$ write(ifhi,*) 'text .1 .90 "xy b= ',bim,' fm ','t=',tau,'"' +c$$$ write(ifhi,'(a)') 'text 0 0 "xaxis x "' +c$$$ write(ifhi,'(a)') 'text 0 0 "yaxis y "' +c$$$ write(ifhi,'(a,2e11.3)')'xrange ',a4min,a4max +c$$$ write(ifhi,'(a,2e11.3)')'yrange ',a4min,a4max +c$$$ write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' +c$$$ write(ifhi,'(a,i)') 'array2d ',nxmdk +c$$$ do i=1,nxmdk +c$$$ do j=1,nxmdk +c$$$ rat=0. +c$$$ rat=xys(nb,i,j) +c$$$ & /zevent ! nevent +c$$$ & /((a5max-a5min)/float(nxmdk)) ! x-bin +c$$$ & /((a5max-a5min)/float(nxmdk)) ! y-bin +c$$$c...............& /1. ! b-bin +c$$$ write (ifhi,*) rat +c$$$ enddo +c$$$ enddo +c$$$ write(ifhi,'(a)') ' endarray' +c$$$ write(ifhi,'(a)') 'closehisto plot2d' +c$$$ enddo +c$$$ endif + + +c fraction of jpsis in a droplet +c ------------------------------ + + if(jpsidr.eq.1)then + write(ifhi,'(a)') 'zone 3 4 1' + do nb=mxbim,1,-1 + bim=(nb-0.5)*bimmax/mxbim + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lfu xmod lin ymod lin' + write(ifhi,'(a,f5.2,a)')'text .1 .90 "b= ',bim,' fm"' + write(ifhi,'(a)') 'text 0 0 "xaxis time t (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis Jdrop(b,t) / J"' + write(ifhi,'(a,2e11.3)')'xrange',taumi,taumi+ntjpsi*delt + write(ifhi,'(3a)')'yrange',' 0 ',' auto ' + write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' + write(ifhi,'(a)') 'array 4' + do j=1,ntjpsi + tau=taumi+(j-0.5)*delt + rat=0 + if(jjjtot(nb,j).ne.0)rat=jjjdro(nb,j)/float(jjjtot(nb,j)) + write(ifhi,'(4e12.4)')tau,rat,0.,float(jjjtot(nb,j)) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + enddo + endif + +c fraction of jpsis with taud gt tauc +c ----------------------------------- + + if(jpsidr.eq.1)then + write(ifhi,'(a)') 'zone 2 4 1' + do ntauc=1,mxtauc + tauc=ntauc*(taudmx/mxtauc) + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lfu xmod lin ymod lin' + write(ifhi,'(a,f5.2,a)')'text .1 .90 "tauc= ',tauc,' fm/c"' + write(ifhi,'(a)') 'text 0 0 "xaxis bmax-b (fm)"' + write(ifhi,'(a)') + *'text 0 0 "yaxis J(b, taud) / J(b)"' + write(ifhi,'(a,2e11.3)')'xrange',0.,bimmax + write(ifhi,'(3a)')'yrange',' 0 ',' auto ' + write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' + write(ifhi,'(a)') 'array 4' + do j=mxbim,1,-1 + bim=(j-0.5)*bimmax/mxbim + rat=0 + if(jjtot(j).gt.0.)rat=float(jjjtau(j,ntauc))/jjtot(j) + write(ifhi,'(4e12.4)')bimmax-bim,rat,0.,float(jjtot(j)) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + enddo + endif + +c droplet survival ratio +c -------------- + + if(jpsidr.eq.1)then + write(ifhi,'(a)') 'zone 2 4 1' + do ntauc=1,mxtauc + tauc=ntauc*(taudmx/mxtauc) + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lfu xmod lin ymod lin' + write(ifhi,'(a,f5.2,a)')'text .1 .90 "tauc= ',tauc,' fm/c"' + write(ifhi,'(a)') 'text 0 0 "xaxis bmax-b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis droplet survival ratio"' + write(ifhi,'(a,2e11.3)')'xrange',0.,bimmax + write(ifhi,'(3a)')'yrange',' 0 ',' auto ' + write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' + write(ifhi,'(a)') 'array 4' + do j=mxbim,1,-1 + bim=(j-0.5)*bimmax/mxbim + rat=0 + if(jjtot(j).gt.0.)rat=float(jjtot(j)-jjjtau(j,ntauc))/jjtot(j) + write(ifhi,'(4e12.4)')bimmax-bim,rat,0.,float(jjtot(j)) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + enddo + endif + +c total approx. survival ratio +c -------------- + + if(jpsidr.eq.1)then + write(ifhi,'(a)') 'zone 2 4 1' + do ntauc=1,mxtauc + tauc=ntauc*(taudmx/mxtauc) + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lfu xmod lin ymod lin' + write(ifhi,'(a,f5.2,a)')'text .1 .90 "tauc= ',tauc,' fm/c"' + write(ifhi,'(a)') 'text 0 0 "xaxis bmax-b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis tot. ap. survival ratio"' + write(ifhi,'(a,2e11.3)')'xrange',0.,bimmax + write(ifhi,'(3a)')'yrange',' 0 ',' auto ' + write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' + write(ifhi,'(a)') 'array 4' + do j=mxbim,1,-1 + bim=(j-0.5)*bimmax/mxbim + rat=0 + if(jjtot(j).gt.0.)rat=float(jjtot(j)-jjjtau(j,ntauc))/jjtot(j) + write(ifhi,'(4e12.4)')bimmax-bim,rat,0.,float(jjtot(j)) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto ' + if(maproj.eq.208.and.matarg.eq.208)then + write(ifhi,'(a,a)') 'openhisto htyp lfu input jpbpb', + & ' j-nucl mult plot 0- ' + write(ifhi,'(a)')'openhisto htyp ldo input jpbpb j-nucl plot 0- ' + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'set fmsc 1.0' + write(ifhi,'(a)') 'column c1 = ( 11.9 - c1 )' + write(ifhi,'(a)') 'column c2 = ( c2 * 0.019 )' + write(ifhi,'(a)') 'input na50 ratio-b plot 0' + elseif(maproj.eq.32.and.matarg.eq.32)then + write(ifhi,'(a,a)') 'openhisto htyp lfu input jss', + & ' j-nucl mult plot 0- ' + write(ifhi,'(a)')'openhisto htyp ldo input jss j-nucl plot 0 ' + endif + enddo + endif + +c total survival ratio +c -------------- + + if(jpsidr.eq.1)then + write(ifhi,'(a)') 'zone 2 4 1' + do ntauc=1,mxtauc + tauc=ntauc*(taudmx/mxtauc) + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lfu xmod lin ymod lin' + write(ifhi,'(a,f5.2,a)')'text .1 .90 "tauc= ',tauc,' fm/c"' + write(ifhi,'(a)') 'text 0 0 "xaxis bmax-b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis total survival ratio"' + write(ifhi,'(a,2e11.3)')'xrange',0.,bimmax + write(ifhi,'(3a)')'yrange',' 0 ',' auto ' + write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' + write(ifhi,'(a)') 'array 4' + do j=mxbim,1,-1 + bim=(j-0.5)*bimmax/mxbim + rat=0 + if(jjtot(j).gt.0.)rat=float(jjtot(j)-jjjnt(j,ntauc))/jjtot(j) + write(ifhi,'(4e12.4)')bimmax-bim,rat,0.,float(jjtot(j)) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp ldo xmod lin ymod lin' + write(ifhi,'(a)') 'columnweight 4 column c4 = ( 0 ) ' + write(ifhi,'(a)') 'array 4' + do j=mxbim,1,-1 + bim=(j-0.5)*bimmax/mxbim + rat=0 + if(jjtot(j).gt.0.)rat=float(jjtot(j)-jjnuc(j))/jjtot(j) + write(ifhi,'(4e12.4)')bimmax-bim,rat,0.,float(jjtot(j)) + enddo + write(ifhi,'(a)') ' endarray' + if(maproj.eq.208.and.matarg.eq.208)then + write(ifhi,'(a)') 'closehisto plot 0-' + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'set fmsc 1.0' + write(ifhi,'(a)') 'column c1 = ( 11.9 - c1 )' + write(ifhi,'(a)') 'column c2 = ( c2 * 0.019 )' + write(ifhi,'(a)') 'input na50 ratio-b plot 0' + else + write(ifhi,'(a)') ' closehisto plot 0' + endif + enddo + endif + + end + diff --git a/modules/epos/epos-omg-lhc.f b/modules/epos/epos-omg-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..db6a48a5ac05595d8fdea4f8b169a831d3400f37 --- /dev/null +++ b/modules/epos/epos-omg-lhc.f @@ -0,0 +1,5349 @@ +c---------------------------------------------------------------------- +c The two elementary fuctions of our approach, the profile fuction G +c and the Phi exponent G~, are here referred to as Gpro and Gtilde. +c Both functions can be written as +c +c G = \sum_type alp * xp**bet * xm**betp +c +c The parameters alp, bet, betp are calculated in GfunParK (k-mode, +c b is takento the one of pair k) or GfunPar (b-mode: arbitrary b) as +c +c Gpro: bet = betD' + epsGp + gamD*b**2 + epsG -alppar +c bet' = betD'' + epsGt + gamD*b**2 + epsG -alppar +c +c alp = alpD*f * s**(betD+gamD*b**2+epsG) * exp(-b**2/delD) +c +c Gtilde: bet~ = bet + 1 +c bet~' = bet' + 1 +c +c alp~ = alp * gam(bet~) * gam(bet~') +c * gam(1+alppro) * gam(1+alptar) +c * gam(1+alppro+bet~) * gam(1+alptar+bet~') +c * (1+epsGt') * (1+epsGt') +c +c The parameters depend implicitely on s. +c +c In the program we use om1 = Gpro +c (they differ by a constant which is actually one) +c and om5 = om1 * 0.5 +c All functions related to om1 are called om1... . +c +c The inclusive Pomeron distributions are +c +c PomInc(xp,xm) = Gpro(xp,xm) * (1-xp)**alppro * (1-xm)**alptar +c +c---------------------------------------------------------------------- + + +c---------------------------------------------------------------------- + subroutine GfunParK(irea) !---MC--- +c---------------------------------------------------------------------- +c calculates parameters alp,bet,betp of the G functions (k-mode) +c and the screening exponents epsilongp(k,i), epsilongt(k,i), epsilongs(k,i) +c---------------------------------------------------------------------- +c Gpro parameters written to /comtilde/atilde(,)btildep(,),btildepp(,) +c Gtilde parameters written to /cgtilde/atildg(,)btildgp(,),btildgpp(,) +c two subscripts: first=type, second=collision k +c Certain pieces of this routine are only done if irea is <= or = zero. +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + include 'epos.incpar' + double precision atildg,btildgp,btildgpp + common/cgtilde/atildg(idxD0:idxD1,kollmx) + *,btildgp(idxD0:idxD1,kollmx),btildgpp(idxD0:idxD1,kollmx) + double precision utgam2,coefgdp,coefgdt + parameter(nbkbin=40) + common /kfitd/ xkappafit(nclegy,nclha,nclha,nbkbin),xkappa,bkbin + common /cgtilnu/ cfbetpnp,cfbetppnp,cfbetpnm,cfbetppnm,cfalpro + &,cfaltar,cfbpap,cfbpam,cfbppap,cfbppam + double precision cfbetpnp,cfbetppnp,cfbetpnm,cfbetppnm,cfalpro + &,cfaltar,cfbpap,cfbpam,cfbppap,cfbppam,gamv,eps + parameter (eps=1.d-25) + parameter(nxeps=20,nyeps=32) + common/cxeps1/w(0:nxeps,nyeps),y1(nyeps),y2(nyeps) + common/cxeps2/db,b1,b2 + common/geom/rmproj,rmtarg,bmax,bkmx + common/nucl3/phi,bimp + common /cncl/xproj(mamx),yproj(mamx),zproj(mamx) + * ,xtarg(mamx),ytarg(mamx),ztarg(mamx) + + b1=0.03 + b2=bkmx*1.2 + db=(b2-b1)/nyeps + call utprj('GfunParK ',ish,ishini,10) + + cfbetpnp=0.d0 + cfbetppnp=0.d0 + cfbetpnm=0.d0 + cfbetppnm=0.d0 + cfalpro=dble(ucfpro) + cfaltar=dble(ucftar) + cfbpap=1.d0 + cfbppap=1.d0 + cfbpam=1.d0 + cfbppam=1.d0 + alpfom=0. + sy=engy*engy + + do k=1,koll + do i=ntymi,ntymx + atilde(i,k)=0.d0 + btildep(i,k)=0.d0 + btildepp(i,k)=0.d0 + enddo + do i=idxD0,idxD1 + atildg(i,k)=0.d0 + btildgp(i,k)=0.d0 + btildgpp(i,k)=0.d0 + enddo + enddo + + +! calculate collision number according to Glauber ----------------------- + + bglaub=sqrt(sigine/10./pi) + nglevt=0 + do ko=1,koll + r=bk(ko) + if(r.le.bglaub)nglevt=nglevt+1 + enddo + +! Z_parton_projectile (zparpro) and Z_parton_target (zpartar)----------- + + ztav=0. + zpav=0. + if(iscreen.eq.1.or.isplit.eq.1)then + + b2x=b2xscr + alpfom=alpfomi*fegypp + rho0p=conrho(1,0.) + rho0t=conrho(2,0.) + bcut=0. + + do k=1,koll + ip=iproj(k) + it=itarg(k) + !....... targ partons seen by proj + if(lproj(ip).gt.0)then + absb=max(1.e-9,bk(k)) + b2=absb*absb + zkp=fegypp*exp(-b2/b2x) + zpartar(k)=min(zkp,epscrx) + if(lproj3(ip).gt.1)then + do lt=1,lproj3(ip) + kp=kproj3(ip,lt) + if(kp.ne.k)then + ikt=itarg(kp) + rtarg=sqrt(xtarg(ikt)**2+ytarg(ikt)**2+ztarg(ikt)**2) + rho=conrho(2,rtarg)/rho0t + fegyAA=epscrw*fscro(engy/egyscr,rho) + absb=max(1.e-9,abs(bk(kp))-bcut) + b2=absb*absb + zkp=fegyAA*exp(-b2/b2x) + zpartar(k)=zpartar(k)+min(zkp,epscrx) + endif +c alpfom=max(alpfom,dble(zpartar(k))) + enddo + endif + else + zpartar(k)=0. + endif + ztav=ztav+zpartar(k) + !...........proj partons seen by targ + if(ltarg(it).gt.0)then + absb=max(1.e-9,bk(k)) + b2=absb*absb + zkt=fegypp*exp(-b2/b2x) + zparpro(k)=min(zkt,epscrx) + if(ltarg3(it).gt.1)then + do lp=1,ltarg3(it) + kt=ktarg3(it,lp) + if(kt.ne.k)then + ikp=iproj(kt) + rproj=sqrt(xproj(ikp)**2+yproj(ikp)**2+zproj(ikp)**2) + rho=conrho(1,rproj)/rho0p + fegyAA=epscrw*fscro(engy/egyscr,rho) + absb=max(1.e-9,abs(bk(kt))-bcut) + b2=absb*absb + zkt=fegyAA*exp(-b2/b2x) + zparpro(k)=zparpro(k)+min(zkt,epscrx) + endif +c alpfom=max(alpfom,dble(zparpro(k))) + enddo + endif + else + zparpro(k)=0. + endif + zpav=zpav+zparpro(k) + xzcutpar(k)=dble(exp(-min(50.,xzcut*(zparpro(k)+zpartar(k))))) + enddo + + else ! no screening + + do k=1,koll + zparpro(k)=0. + zpartar(k)=0. + xzcutpar(k)=1d0 + enddo + + endif + +c calculation of epsilongp epsilongt + + if(iscreen.eq.1)then + + !ip=0 + do k=1,koll + !ipp=ip + epsG=0. + epsilongs(k,0)=0. + epsilongs(k,1)=0. + ip=iproj(k) !...........projectile + if(lproj(ip).gt.0)then + x=zparpro(k) + epsilongs(k,0)=sign(abs(epscrd)*x + & ,epscrd) + epsilongp(k,0)=max(-betDp(0,iclpro,icltar)-0.95+alppar, + & epscrs*x) +c & min(epscrx,epscrs*x)) + if(sy.ge.sfshlim)then + epsilongp(k,1)=max(-betDp(1,iclpro,icltar)-0.95+alppar, + & epscrh*x) +c & min(epscrx,epscrh*x)) + else + epsilongp(k,1)=epsilongp(k,0) +c epsilongs(k,1)=epsilongs(k,0) + endif + gammaV(k)=1.d0 + else + epsilongp(k,0)=0. + epsilongp(k,1)=0. + gammaV(k)=1.d0 + endif + + it=itarg(k) !...........target + if(ltarg(it).gt.0)then + x=zpartar(k) + epsilongs(k,1)=sign(abs(epscrd)*x + & ,epscrd) + epsilongt(k,0)=max(-betDpp(0,iclpro,icltar)-0.95+alppar, + & epscrs*x) +c & min(epscrx,epscrs*x)) + if(sy.ge.sfshlim)then + epsilongt(k,1)=max(-betDpp(1,iclpro,icltar)-0.95+alppar, + & epscrh*x) +c & min(epscrx,epscrh*x)) + else + epsilongt(k,1)=epsilongt(k,0) +c epsilongs(k,1)=epsilongs(k,0) + endif +cc gammaV(k)=gammaV(k) + else + epsilongt(k,0)=0. + epsilongt(k,1)=0. + gammaV(k)=gammaV(k) + endif + + enddo + + else ! no screening + + do k=1,koll + epsilongs(k,0)=0. + epsilongs(k,1)=0. + epsilongp(k,0)=0. + epsilongp(k,1)=0. + epsilongt(k,0)=0. + epsilongt(k,1)=0. + gammaV(k)=1.d0 + enddo + + endif + + +!..............alpha beta betap for Gtilde (->PhiExpo)....................... + + imax=idxD1 + if(iomega.eq.2)imax=1 + + do k=1,koll + + b=bk(k) + b2=bk(k)*bk(k) + ip=iproj(k) + it=itarg(k) + + if(b.lt.(nbkbin-1)*bkbin)then + ibk=int(bk(k)/bkbin)+1 + if(isetcs.gt.1.and.iclegy.lt.iclegy2)then + egy0=egylow*egyfac**float(iclegy-1) + xkappa1=xkappafit(iclegy,iclpro,icltar,ibk) + * +(bk(k)-bkbin*float(ibk-1))/bkbin + * *(xkappafit(iclegy,iclpro,icltar,ibk+1) + * -xkappafit(iclegy,iclpro,icltar,ibk)) + xkappa2=xkappafit(iclegy+1,iclpro,icltar,ibk) + * +(bk(k)-bkbin*float(ibk-1))/bkbin + * *(xkappafit(iclegy+1,iclpro,icltar,ibk+1) + * -xkappafit(iclegy+1,iclpro,icltar,ibk)) + xkappa=xkappa1+(xkappa2-xkappa1)/log(egyfac) + * *(log(engy)-log(egy0)) + xkappa=facmc*xkappa + else + xkappa=xkappafit(iclegy,iclpro,icltar,ibk) + * +(bk(k)-bkbin*float(ibk-1))/bkbin + * *(xkappafit(iclegy,iclpro,icltar,ibk+1) + * -xkappafit(iclegy,iclpro,icltar,ibk)) + xkappa=facmc*xkappa + endif + else + xkappa=1. + endif + gfactorp=1.!+(gfactor-1)*exp(-5*b/gwidth/bglaub) + gfactort=1.!+(gfactor-1)*exp(-5*b/gwidth/bglaub) + + do i=idxDmin,imax + gamV=gammaV(k) +c if(i.lt.2)then +c if(i.eq.0)then +c epsG=epsilongs(k,i) + if(i.eq.2)then + if(epscrd.lt.0.)then + epsG=epsilongs(k,0)+epsilongs(k,1) + epsGp=0. + epsGt=0. + else + epsG=0. + epsGp=epsilongs(k,0) + epsGt=epsilongs(k,1) + endif + else + epsG=0. + epsGp=0. + epsGt=0. + endif + gamb=gamD(i,iclpro,icltar)*b2 + atildg(i,k)=dble(alpD(i,iclpro,icltar)) + * *cfalpro*cfaltar + * *gamv +c if(i.eq.0) atildg(i,k)=atildg(i,k) + atildg(i,k)=atildg(i,k) + * *dble(xkappa*xkappa) + if(i.lt.2)then + atildg(i,k)=atildg(i,k)*dble( + * chad(iclpro)*chad(icltar) + * *exp(-b2/delD(i,iclpro,icltar)) + * *sy**(betD(i,iclpro,icltar)+gamb+epsG) + * *gfactorp *gfactort) + epsGp=epsilongp(k,i) + epsGt=epsilongt(k,i) + btildgp(i,k)=dble(betDp(i,iclpro,icltar) + * +epsGp + * +gamb-alppar)+1.d0 + btildgpp(i,k)=dble(betDpp(i,iclpro,icltar) + * +epsGt + * +gamb-alppar)+1.d0 + else + absb=abs(bk(k))-bmxdif(iclpro,icltar) + b2a=absb*absb + atildg(i,k)=atildg(i,k)*dble( + * sy**(betD(i,iclpro,icltar)+epsG) + * *exp(-b2a/delD(i,iclpro,icltar))) + btildgp(i,k)=dble(betDp(i,iclpro,icltar)-alppar+epsGp)+1.d0 + btildgpp(i,k)=dble(betDpp(i,iclpro,icltar)-alppar+epsGt)+1.d0 + endif + coefgdp=utgam2(1.d0+dble(alplea(iclpro))+btildgp(i,k)) + coefgdt=utgam2(1.d0+dble(alplea(icltar))+btildgpp(i,k)) + atildg(i,k)=atildg(i,k) + * *utgam2(btildgp(i,k))*utgam2(btildgpp(i,k)) + * /coefgdp/coefgdt + !...........prepare plot in xepsilon + if(irea.eq.0)then + kk=max(1,int((bk(k)-b1)/db)+1) + if(i.lt.2)then + if(i.eq.0)w(0,kk)=w(0,kk)+1 + if(i.eq.0)w(1,kk)=w(1,kk)+epsGp + if(i.eq.0)w(2,kk)=w(2,kk)+epsGt +c w(3+i,kk)=w(3+i,kk)+abs(epsG) + !...5-8 soft ... 9-12 semi + w(5+4*i,kk)=w(5+4*i,kk) + * +betDp(i,iclpro,icltar) !prj eff + * +epsGp+gamb + w(6+4*i,kk)=w(6+4*i,kk) + * +betDpp(i,iclpro,icltar) !tgt eff + * +epsGt+gamb + w(7+4*i,kk)=w(7+4*i,kk) + * +betDp(i,iclpro,icltar) !prj unscr + * +gamb + w(8+4*i,kk)=w(8+4*i,kk) + * +betDpp(i,iclpro,icltar) !tgt unscr + * +gamb + if(i.eq.0)w(13,kk)=w(13,kk)+zparpro(k) + if(i.eq.0)w(14,kk)=w(14,kk)+zpartar(k) + else + if(epscrd.lt.0.)then + w(3,kk)=w(3,kk)+abs(epsG) + else + w(3,kk)=w(3,kk)+epsGp + w(4,kk)=w(4,kk)+epsGt + endif + endif + endif + !................ + enddo + enddo + +!........................................................................... + + zppevt=zpav/koll + zptevt=ztav/koll + if(irea.eq.0)then + ktot=int(bimp)+1 + if(ktot.le.nyeps)then + w(15,ktot)=w(15,ktot)+zppevt + w(16,ktot)=w(16,ktot)+zptevt + w(17,ktot)=w(17,ktot)+1 + endif + n=1+int(float(nglevt)/(0.1*maproj*matarg))*(nyeps-1) + if(nglevt.ge.1.and.n.ge.1.and.n.le.nyeps)then + w(18,n)=w(18,n)+zppevt + w(19,n)=w(19,n)+zptevt + w(20,n)=w(20,n)+1 + endif + endif + + +!........alpha beta betap for Gpro........................................... + + if(irea.le.0)then + do k=1,koll + ip=iproj(k) + it=itarg(k) + + b2=bk(k)*bk(k) + imax=ntymx + if(iomega.eq.2)imax=1 + do i=ntymin,imax + +c if(i.lt.2)then +c if(i.eq.0)then +c epsG=epsilongs(k,i) + if(i.eq.2)then + if(epscrd.lt.0.)then + epsG=epsilongs(k,0)+epsilongs(k,1) + epsGp=0. + epsGt=0. + else + epsG=0. + epsGp=epsilongs(k,0) + epsGt=epsilongs(k,1) + endif + else + epsG=0. + epsGp=0. + epsGt=0. + endif + gamb=gamD(i,iclpro,icltar)*b2 + + atilde(i,k)=dble(alpD(i,iclpro,icltar)) + if(i.lt.2)then + atilde(i,k)=atilde(i,k)*dble( + * exp(-b2/delD(i,iclpro,icltar)) + * *sy**(betD(i,iclpro,icltar) + * +gamb+epsG) + * *chad(iclpro)*chad(icltar)) + epsGp=epsilongp(k,i) + epsGt=epsilongt(k,i) + btildep(i,k)=dble(betDp(i,iclpro,icltar) + * +epsGp + * +gamb-alppar) + btildepp(i,k)=dble(betDpp(i,iclpro,icltar) + * +epsGt + * +gamb-alppar) + else + absb=abs(bk(k))-bmxdif(iclpro,icltar) + b2a=absb*absb + atilde(i,k)=atilde(i,k)*dble( + * sy**(betD(i,iclpro,icltar)+epsG) + * *exp(-b2a/delD(i,iclpro,icltar))) + + btildep(i,k)=dble(betDp(i,iclpro,icltar)-alppar+epsGp) + btildepp(i,k)=dble(betDpp(i,iclpro,icltar)-alppar+epsGt) + endif + + if(btildep(i,k)+1d0.lt.-eps.or.btildepp(i,k)+1d0.lt.-eps)then + write(ifmt,*)' k,b,ip,it,gamb,alppar',k,bk(k),ip,it,gamb + * ,alppar + write(ifmt,*)' gammaV,epsGP1/2,epsGT1/2,epsGS1/2' + * ,gammaV(k),epsilongp(k,0),epsilongp(k,1) + * ,epsilongt(k,0),epsilongt(k,1),epsilongs(k,0),epsilongs(k,1) + write(ifmt,*)'*******************************************' + write(ifmt,*)" atilde,btildep,btildepp " + do ii=ntymin,ntymx + write(ifmt,*)ii,atilde(ii,k),btildep(ii,k),btildepp(ii,k) + enddo + call utstop('Error in epos-omg in GfunPark&') + endif + enddo + + enddo + endif + +!........................................................................... + + if(ish.ge.10)then + do k=1,koll + ip=iproj(k) + it=itarg(k) + write(ifch,*)' k,b,ip,it,',k,bk(k),ip,it + write(ifch,*)' zparpro,zpartar,xzcutpar' + * ,zparpro(k),zpartar(k),xzcutpar(k) + write(ifch,*)' gammaV,epsilonGP1/2,epsilonGT1/2,epsilonGs1/2' + * ,gammaV(k),epsilongp(k,0),epsilongp(k,1) + * ,epsilongt(k,0),epsilongt(k,1),epsilongs(k,0),epsilongs(k,1) + write(ifch,*)'*******************************************' + write(ifch,*)" atilde,btildep,btildepp " + do i=ntymin,ntymx + write(ifch,*)i,atilde(i,k),btildep(i,k),btildepp(i,k) + enddo + write(ifch,*)" atildg,btildgp,btildgpp " + do i=ntymin,ntymx + write(ifch,*)i,atildg(i,k),btildgp(i,k),btildgpp(i,k) + enddo + call GfunPar(xpar7,xpar7,1,0,bk(k),sy,alp,bet,betp + & ,epsp,epst,epss,gamvv) + call GfunPar(xpar7,xpar7,1,1,bk(k),sy,alp,bet,betp + & ,epsp,epst,epss,gamvv) + enddo + endif + + call utprjx('GfunParK ',ish,ishini,10) + + return + end + +c---------------------------------------------------------------------- + subroutine GfunPar(zzip,zzit,m,i,b,spp,alp,bet,betp,epsp,epst + & ,epss,gamvv) +c---------------------------------------------------------------------- +c calculates parameters alp,bet,betp of the G functions for pp (b-mode) +c and the screening exponents epsp,epst,epss,gamvv +c---------------------------------------------------------------------- +c zzip:additional z component (nuclear effect projectile side) +c zzit:additional z component (nuclear effect target side) +c m=1: profile function Gpro, i=0: soft i=2: diff +c m=2: Gtilde, i=1: semi (no screening for diff) +c b: impact param, spp: pp energy squared +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + include 'epos.incems' + parameter(nbkbin=40) + common /kfitd/ xkappafit(nclegy,nclha,nclha,nbkbin),xkappa,bkbin + common /kwrite/ xkapZ + double precision utgam2,coefgdp,coefgdt,dalp,dbet,dbetp,eps + parameter(eps=1.d-20) + + call utprj('GfunPar ',ish,ishini,10) + + ee=sqrt(spp) +c bglaub2=FbGlaub2(ee) + rs=r2had(iclpro)+r2had(icltar)+slopom*log(spp) + bglaub2=4.*.0389*rs + if(ish.ge.10)write(ifch,*)'Gf in:',m,i,b,bglaub2,spp,zzip,zzit + & ,iclpro,icltar + b2=b*b + cfalpro=ucfpro + cfaltar=ucftar + gamb=gamD(i,iclpro,icltar)*b2 + + if(iscreen.ne.0)then + absb=max(1.e-9,abs(b)) + b2a=absb*absb + b2x=2.*epscrp*bglaub2 + zzp=epscrw*exp(-b2a/b2x)*fscra(ee/egyscr) + zzp=min(zzp,epscrx)+zzip !saturation + zzt=epscrw*exp(-b2a/b2x)*fscra(ee/egyscr) + zzt=min(zzt,epscrx)+zzit !saturation + + x=zzp + epsG=0. + if(i.eq.1.and.spp.ge.sfshlim)then + epsGp=max(-betDp(i,iclpro,icltar)-0.95+alppar, + & epscrh*x) +c & min(epscrx,epscrh*x)) + elseif(i.le.1)then + epsGp=max(-betDp(i,iclpro,icltar)-0.95+alppar, + & epscrs*x) +c & min(epscrx,epscrs*x)) + else + if(epscrd.lt.0.)then + epsG=epsG+sign(abs(epscrd)*x,epscrd) + epsGp=0. + else + epsGp=sign(abs(epscrd)*x,epscrd) + epsG=0. + endif + endif + gamV=1. + x=zzt + if(i.eq.1.and.spp.ge.sfshlim)then + epsGt=max(-betDpp(i,iclpro,icltar)-0.95+alppar, + & epscrh*x) +c & min(epscrx,epscrh*x)) + elseif(i.le.1)then + epsGt=max(-betDpp(i,iclpro,icltar)-0.95+alppar, + & epscrs*x) +c & min(epscrx,epscrs*x)) + else + if(epscrd.lt.0.)then + epsG=epsG+sign(abs(epscrd)*x,epscrd) + epsGt=0. + else + epsGt=sign(abs(epscrd)*x,epscrd) + epsG=0. + endif + endif +c gamV=gamV + else + zzp=0. + zzt=0. + epsGp=0. + epsGt=0. + epsG=0. + gamV=1. + endif + + gfactorp=1.!+(gfactor-1)*exp(-5*b/gwidth/bglaub) + gfactort=1.!+(gfactor-1)*exp(-5*b/gwidth/bglaub) + + rho=betD(i,iclpro,icltar)+gamb+epsG + + + if(m.eq.1)then + + dalp=dble(alpD(i,iclpro,icltar)) + if(i.lt.2)then + dalp=dalp + * *exp(min(50d0,dble(rho*log(spp)-b2/delD(i,iclpro,icltar)))) + dbet=dble(betDp(i,iclpro,icltar) + * +epsGp + * +gamb-alppar) + dbetp=dble(betDpp(i,iclpro,icltar) + * +epsGt + * +gamb-alppar) + else + absb=abs(b)-bmxdif(iclpro,icltar) + b2a=absb*absb + dalp=dalp + * *exp(min(50d0,dble((betD(i,iclpro,icltar)+epsG)*log(spp) + * -b2a/delD(i,iclpro,icltar)))) + dbet=dble(betDp(i,iclpro,icltar)-alppar+epsGp) + dbetp=dble(betDpp(i,iclpro,icltar)-alppar+epsGt) + endif + + if((dbet+1.d0).lt.-eps.or.(dbetp+1.d0).lt.-eps)then + write(*,*)'m,i,b,spp,alp,bet,betp',m,i,b,spp,dalp,dbet,dbetp + call utstop('Error : beta < -1 in Gfunpar in epos-omg&') + endif + + elseif(m.eq.2)then + xkappa=1. +c if(i.eq.0.and.b.lt.(nbkbin-1)*bkbin)then + if(b.lt.(nbkbin-1)*bkbin)then + ibk=int(b/bkbin)+1 + if(isetcs.gt.1.and.iclegy.lt.iclegy2)then + egy0=egylow*egyfac**float(iclegy-1) + xkappa1=xkappafit(iclegy,iclpro,icltar,ibk) + * +(b-bkbin*float(ibk-1))/bkbin + * *(xkappafit(iclegy,iclpro,icltar,ibk+1) + * -xkappafit(iclegy,iclpro,icltar,ibk)) + xkappa2=xkappafit(iclegy+1,iclpro,icltar,ibk) + * +(b-bkbin*float(ibk-1))/bkbin + * *(xkappafit(iclegy+1,iclpro,icltar,ibk+1) + * -xkappafit(iclegy+1,iclpro,icltar,ibk)) + xkappa=xkappa1+(xkappa2-xkappa1)/log(egyfac) + * *(log(ee)-log(egy0)) + xkappa=facmc*xkappa + else + xkappa=xkappafit(iclegy,iclpro,icltar,ibk) + * +(b-bkbin*float(ibk-1))/bkbin + * *(xkappafit(iclegy,iclpro,icltar,ibk+1) + * -xkappafit(iclegy,iclpro,icltar,ibk)) + xkappa=facmc*xkappa + endif + xkapZ=xkappa + endif + + dalp=dble(alpD(i,iclpro,icltar) + * *cfalpro*cfaltar + * *gamV) +c if(i.eq.0)alp=alp + dalp=dalp + * *dble(xkappa)*dble(xkappa) + + if(i.lt.2)then + dalp=dalp + * *exp(min(50d0,dble(rho*log(spp)-b2/delD(i,iclpro,icltar)))) + * *dble(chad(iclpro)*chad(icltar) + * *gfactorp *gfactort) + dbet=dble(betDp(i,iclpro,icltar) + * +epsGp + * +gamb-alppar+1.) + dbetp=dble(betDpp(i,iclpro,icltar) + * +epsGt + * +gamb-alppar+1.) + else + absb=abs(b)-bmxdif(iclpro,icltar) + b2a=absb*absb + dalp=dalp + * *exp(min(50d0,dble((betD(i,iclpro,icltar)+epsG)*log(spp) + * -b2a/delD(i,iclpro,icltar)))) + dbet=dble(betDp(i,iclpro,icltar)-alppar+1.+epsGp) + dbetp=dble(betDpp(i,iclpro,icltar)-alppar+1.+epsGt) + endif + coefgdp=utgam2(1.d0+dble(alplea(iclpro))+dbet) + coefgdt=utgam2(1.d0+dble(alplea(icltar))+dbetp) + dalp=dalp*utgam2(dbet)*utgam2(dbetp)/coefgdp/coefgdt + else + + stop'GproPar: wrong m value. ' + + endif + + + alp=sngl(dalp) + bet=sngl(dbet) + betp=sngl(dbetp) + epsp=epsGp + epst=epsGt + epss=epsG + gamvv=gamV + + alpUni(i,m)=dalp + betUni(i,m)=dbet + betpUni(i,m)=dbetp + + + if(ish.ge.10)write(ifch,*)' GfunPar :',alp,bet,betp,epsp,epst + & ,epss,gamvv + + call utprjx('GfunPar ',ish,ishini,10) + end + +c---------------------------------------------------------------------- + subroutine GfomPar(b,spp) +c---------------------------------------------------------------------- +c calculates parameters of the fom functions for pp (b-mode) +c---------------------------------------------------------------------- +c b: impact param, spp: pp energy squared +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + include 'epos.incems' + + call utprj('GfomPar ',ish,ishini,6) + + ee=sqrt(spp) + rs=r2had(iclpro)+r2had(icltar)+slopom*log(spp) + bglaub2=4.*.0389*rs + + if(iscreen.ne.0)then + absb=max(1.e-9,abs(b)) + b2a=absb*absb + b2x=2.*epscrp*bglaub2 + zzp=(epscrw*exp(-b2a/b2x))*fscra(ee/egyscr) + zzp=min(zzp,epscrx) !saturation + zzt=(epscrw*exp(-b2a/b2x))*fscra(ee/egyscr) + zzt=min(zzt,epscrx) !saturation + else + zzp=0. + zzt=0. + endif + + + z0=alpfomi!*epscrw*fscra(ee/egyscr) + if(z0.gt.0.)then + z1=zzp + zzpUni=dble(z1**gamfom/z0)*exp(-dble(b*b/delD(1,iclpro,icltar))) +c zzpUni=dble(4.*z0*(z1/z0)**1.5) + z1=zzt + zztUni=dble(z1**gamfom/z0)*exp(-dble(b*b/delD(1,iclpro,icltar))) +c zztUni=dble(4.*z0*(z1/z0)**1.5) + else + zzpUni=0d0 + zztUni=0d0 + endif + + if(ish.ge.6)write(ifch,*)' GfomPar :',zzpUni,zztUni + + call utprjx('GfomPar ',ish,ishini,6) + end + +c---------------------------------------------------------------------- + function fscra(x) +c---------------------------------------------------------------------- + fscra=0 + x2=x*x + if(x2.gt.1.)fscra=log(x2)!**2 + end + +c---------------------------------------------------------------------- + function fscro(x,rho) +c---------------------------------------------------------------------- + include 'epos.incpar' + fscro=znurho*rho + x2=x*x +c if(x2.gt.1.)fscro=sqrt(log(x2)**2+fscro**2) + if(x2.gt.1.)fscro=log(x2)*(1.+fscro) + end + +c---------------------------------------------------------------------- + function FbGlaub2(x) +c---------------------------------------------------------------------- +c calculates (glauber radius)^2 from pp cross section (data fit) +c(estimated if not already calculated --> not any more to have smoother xs) +c---------------------------------------------------------------------- +c x: pp energy +c---------------------------------------------------------------------- + + include 'epos.inc' + +c if(sigine.eq.0.)then + if(iclpro+icltar.eq.3)then !pi+p + siginex=20.+0.08*log(x)**3.-0.004*log(x)**4. + elseif(iclpro+icltar.eq.5)then !K+p + siginex=16.+0.08*log(x)**3.-0.004*log(x)**4. + else + siginex=30.+0.095*log(x)**3.-0.004*log(x)**4. + endif +c else +c siginex=sigine +c endif + FbGlaub2=siginex/10./pi + + return + end + +c---------------------------------------------------------------------- + subroutine recalcZPtn !???????????? not updated !!! +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + stop'recalcZPtn not valid any more!!!!!!!' +c if(koll.eq.1.and.maproj.eq.1.and.matarg.eq.1)then +c npom=nprt(1) +c k=1 +c ip=iproj(1) +c it=itarg(1) +c zparpro(k)=max(0,npom-1)*0.2 +c zpartar(k)=0 +c zpartar(k)=max(0,npom-1)*0.2 +c ztav=zpartar(k) +c zpav=zparpro(k) +c zppevt=zpav +c zptevt=ztav +c endif + end + +c---------------------------------------------------------------------- + double precision function om1(xh,yp,b) !---test--- +c---------------------------------------------------------------------- +c om1 = G * C * gamd (C and gamd usually 1) +c xh - fraction of the energy squared s for the pomeron; +c b - impact parameter between the pomeron ends; +c yp - rapidity for the pomeron; +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + + double precision Gf,xp,xm,xh,yp + + Gf=0.d0 + xp=sqrt(xh)*exp(yp) + xm=xh/xp + spp=engy**2 + imax=idxD1 + if(iomega.eq.2)imax=1 + do i=idxDmin,imax + call Gfunpar(0.,0.,1,i,b,spp,alp,bet,betp,epsp,epst,epss,gamv) + Gf=Gf+dble(alp)*xp**dble(bet)*xm**dble(betp) + enddo + om1=Gf + * * dble(chad(iclpro)*chad(icltar)) + end + +c---------------------------------------------------------------------- + double precision function om1intb(b) !---test--- +c---------------------------------------------------------------------- +c om1 integrated over xp and xm for given b +c Calculation by analytical integration +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + double precision cint,cint2,eps + parameter(eps=1.d-20) + + spp=engy*engy + imax=idxD1 + if(iomega.eq.2)imax=1 + cint=0.d0 + do i=idxDmin,imax + call Gfunpar(0.,0.,1,i,b,spp,alp,bet,betp,epsp,epst,epss,gamv) + cint2=dble(gamv*alp) + if((bet+1.0).gt.eps)then + cint2=cint2/dble(bet+1.0) + else + cint2=-cint2*log(xminDf) + endif + if((betp+1.0).gt.eps)then + cint2=cint2/dble(betp+1.0) + else + cint2=-cint2*log(xminDf) + endif + cint=cint+cint2 + enddo + + if(cint.lt.-eps)then + write(*,*) 'WARNING ! om1intb in epos-omg is <0 !!!!!' + write(*,*) 'WARNING ! => om1intb set to 1e-3 !!!!!' + write(*,*) 'WARNING ! => bmax=3.5 fm !!!!!' + cint=1.d-3 + endif + + om1intb=cint + * *dble(chad(iclpro)*chad(icltar)) + + return + end + +c---------------------------------------------------------------------- + double precision function om1intbk(k) !---MC--- +c---------------------------------------------------------------------- +c Diffractive part of om1 integrated over xp and xm for given pair k +c Calculation by analytical integration +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + include 'epos.incpar' + double precision cint,cint2,eps,bet,betp + parameter(eps=1.d-20) + + imax=idxD1 + if(iomega.eq.2)imax=1 + om1intbk=0d0 + cint=0 + do i=idxDmin,imax + bet=btildep(i,k) + betp=btildepp(i,k) + cint2=atilde(i,k) + if((bet+1.d0).gt.eps)then + cint2=cint2/(bet+1.d0) + else + cint2=-cint2*log(xminDf) + endif + if((betp+1.d0).gt.eps)then + cint2=cint2/(betp+1.d0) + else + cint2=-cint2*log(xminDf) + endif + cint=cint+cint2 + enddo + + if(cint.lt.-eps)then + write(*,*) 'WARNING ! om1intbk in epos-omg is <0 !!!!!' + write(*,*) 'WARNING ! => om1intbk set to 1e-3 !!!!!' + write(*,*) 'WARNING ! => bmax=3.5 fm !!!!!' + cint=1.d-3 + endif + + om1intbk=cint + * *dble(chad(iclpro)*chad(icltar)) + + return + end + +c---------------------------------------------------------------------- + double precision function om1intbi(b,iqq) !---MC--- +c---------------------------------------------------------------------- +c om1 integrated over xp and xm for given b +c Calculation by analytical integration of contribution iqq +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + double precision eps,cint + parameter(eps=1.d-20) + + spp=engy*engy + call Gfunpar(0.,0.,1,iqq,b,spp,alp,bet,betp,epsp,epst,epss,gamv) + cint=dble(gamv*alp) + if(dble(bet+1.0).gt.eps)then + cint=cint/dble(bet+1.0) + else + cint=-cint*log(xminDf) + endif + if(dble(betp+1.0).gt.eps)then + cint=cint/dble(betp+1.0) + else + cint=-cint*log(xminDf) + endif + if(cint.lt.-eps)then + write(*,*) 'WARNING ! om1intbi in epos-omg is <0 !!!!!' + write(*,*) 'WARNING ! => om1intbi set to 1e-3 !!!!!' + write(*,*) 'WARNING ! => bmax=3.5 fm !!!!!' + cint=1.d-3 + endif + + om1intbi=cint + * *dble(chad(iclpro)*chad(icltar)) + + return + end + +c---------------------------------------------------------------------- + double precision function om1intbc(b) !---MC--- +c---------------------------------------------------------------------- +c om1*F*F integrated over xp and xm for given b +c Calculation by analytical integration +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + double precision cint,gamom,deltap,deltam + double precision utgam2,Fp,Fm + + spp=engy**2 + om1intbc=0.d0 + Fp=dble(ucfpro) !gamma(1+alplea) + Fm=dble(ucftar) + + imax=idxD1 + if(iomega.eq.2)imax=1 + + cint=0.d0 + + do i=idxDmin,imax + call Gfunpar(0.,0.,1,i,b,spp,alp,bet,betp,epsp,epst,epss,gamv) + gamom=dble(alp*gamv*chad(iclpro)*chad(icltar)) + deltap=dble(bet) + deltam=dble(betp) + cint=cint+gamom*utgam2(deltap+1.d0)*utgam2(deltam+1.d0) + & /utgam2(2.d0+deltap+dble(alplea(iclpro))) + & /utgam2(2.d0+deltam+dble(alplea(icltar))) + enddo + + om1intbc=cint*Fp*Fm + + if(om1intbc.lt.-1.d-10)then + write(*,*) 'WARNING ! om1intbc in epos-omg is <0 !!!!!' + write(*,*) 'WARNING ! => om1intbc set to 0. !!!!!' + om1intbc=0.d0 + endif + + return + end + +cc---------------------------------------------------------------------- +c double precision function om1intbci(b,iqq) !---MC--- +cc---------------------------------------------------------------------- +cc om1*F*F integrated over xp and xm for given b and given Pomeron type iqq +cc Calculation by analytical integration +cc---------------------------------------------------------------------- +c include 'epos.inc' +c include 'epos.incems' +c include 'epos.incsem' +c double precision cint,gamom,deltap,deltam +c double precision utgam2,Fp,Fm,eps +c +c spp=engy**2 +c om1intbci=0.d0 +c Fp=dble(ucfpro) !gamma(1+alplea) +c Fm=dble(ucftar) +c +c i=iqq +c call Gfunpar(0.,0.,1,i,b,spp,alp,bet,betp,epsp,epst,epss,gamv) +c gamom=dble(alp*gamv)*chad(iclpro)*chad(icltar) +c deltap=dble(bet) +c deltam=dble(betp) +c cint=gamom*utgam2(deltap+1.d0)*utgam2(deltam+1.d0) +c & /utgam2(2.d0+deltap+dble(alplea(iclpro))) +c & /utgam2(2.d0+deltam+dble(alplea(icltar))) +c +c om1intbci=cint*Fp*Fm +c +c if(om1intbci.lt.-1.d-10)then +c write(*,*) 'WARNING ! om1intbci in epos-omg is <0 !!!!!' +c write(*,*) 'WARNING ! => om1intbci set to 0. !!!!!' +c om1intbci=0.d0 +c endif +c +c return +c end +c +c---------------------------------------------------------------------- + double precision function om1intgck(k,xprem,xmrem) !---MC--- +c---------------------------------------------------------------------- +c om1*(xprem-xp)*(xmrem-xm) integrated over xp and xm for given k +c Calculation by analytical integration +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + double precision cint,gamom,deltap,deltam,xprem,xmrem + + om1intgck=0.d0 + + imax=idxD1 + if(iomega.eq.2)imax=1 + + cint=0.d0 + do i=idxDmin,imax + gamom=dble(atilde(i,k)) + deltap=dble(btildep(i,k)) + deltam=dble(btildepp(i,k)) + cint=cint+gamom/(deltap+1.d0)/(deltam+1.d0) + & /(2.d0+deltap) /(2.d0+deltam) + & *xprem**(deltap+2.d0) + & *xmrem**(deltam+2.d0) + enddo + om1intgck=cint + + return + end + +c---------------------------------------------------------------------- + double precision function om1intgc(b) !---test--- +c---------------------------------------------------------------------- +c om1*(1-xp)*(1-xm) integrated over xp and xm for given b +c Calculation by analytical integration +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incpar' + include 'epos.incsem' + double precision cint,gamom,deltap,deltam,eps + parameter(eps=1.d-20) + + spp=engy**2 + om1intgc=0.d0 + + imax=idxD1 + if(iomega.eq.2)imax=1 + + + + cint=0.d0 + + do i=idxDmin,imax + call Gfunpar(0.,0.,1,i,b,spp,alp,bet,betp,epsp,epst,epss,gamv) + gamom=dble(alp*gamv*chad(iclpro)*chad(icltar)) + deltap=dble(bet) + deltam=dble(betp) + if((deltap+1.d0).gt.eps)then + gamom=gamom/(deltap+1.d0) + else + gamom=-gamom*log(xminDf) + endif + if((deltam+1.d0).gt.eps)then + gamom=gamom/(deltam+1.d0) + else + gamom=-gamom*log(xminDf) + endif + cint=cint+gamom /(2.d0+deltap) /(2.d0+deltam) + enddo + om1intgc=cint + + if(om1intgc.lt.eps)then + write(*,*) b,deltap,deltam,gamom + write(*,*) 'WARNING ! om1intgc in epos-omg is <0 !!!!!' + write(*,*) 'WARNING ! => om1intgc set to 0. !!!!!' + om1intgc=0.d0 + endif + + return + end + + +c---------------------------------------------------------------------- + subroutine integom1(irea) +c---------------------------------------------------------------------- +c om1 integrated over xp and xm for all b=bk(k) if irea=0 +c result written to : +c om1int(k) = om1intb(bk(k)) = \int om1 +c om1intc(k) = om1intgc(bk(k)... = \int om1*(1-xp)*(1-xm) +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + double precision om1intbk,om1intgck,PomIncExactk + + if(irea.le.0)then + + + do k=1,koll + + om1int(k)=om1intbk(k) !only diffractive contribution + om1intc(k)=om1intgck(k,1d0,1d0) + + enddo + + if(irea.eq.0.and.zrminc.gt.0..and.xzcut.gt.0.)then + do k=1,koll + PomInck(k)=PomIncExactk(k) + enddo + endif + + endif + + + return + end + + +c---------------------------------------------------------------------- + double precision function om1xpk(xp,xpr1i,k) !---test--- +c---------------------------------------------------------------------- +c \int dxm om1*(1-xp)*(1-xm) (normalized) +c k - pair indice; +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incpar' + include 'epos.incems' + double precision xp,gamomx(ntymi:ntymx),cint,gamom + double precision deltap(ntymi:ntymx),deltam(ntymi:ntymx),eps + & ,xpr1,xmr1,xpr1i + parameter(eps=1.d-20) + + om1xpk=0.d0 + if(xp.ge.xpr1i)return + + xpr1=1.d0 + xmr1=1.d0 + imin=ntymin + imax=ntymx + if(iomega.eq.2)imax=1 + + do i=imin,imax + deltap(i)=btildep(i,k) + deltam(i)=btildepp(i,k) + gamomx(i)=atilde(i,k)*xmr1**(deltam(i)+2.d0)/(2.d0+deltam(i)) + if((deltam(i)+1.d0).gt.eps)then + gamomx(i)=gamomx(i)/(deltam(i)+1.d0) + else + gamomx(i)=-gamomx(i)*log(xminDf) + endif + enddo + + + cint=0.d0 + do i=imin,imax + gamom=gamomx(i)*xpr1**(deltap(i)+2.d0)/(2.d0+deltap(i)) + if((deltap(i)+1.d0).gt.eps)then + gamom=gamom/(deltap(i)+1.d0) + else + gamom=-gamom*log(xminDf) + endif + cint=cint+gamom + enddo + + + do i=imin,imax + om1xpk=om1xpk+gamomx(i)*xp**deltap(i) + & *(xpr1-xp) + + enddo + + om1xpk=om1xpk/cint + + return + end + + +c---------------------------------------------------------------------- + double precision function om1xmk(xp,xm,xpr1i,xmr1i,k) !---test--- +c---------------------------------------------------------------------- +c om1(xp,xm)*(1-xp)*(1-xm) (normalized for fixed xp) +c k - pair indice; +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incpar' + include 'epos.incems' + double precision xp,xm,gamomx(ntymi:ntymx),cint,gamom + double precision deltam(ntymi:ntymx),eps,xpr1,xmr1,xpr1i,xmr1i + parameter(eps=1.d-20) + + om1xmk=0.d0 + if(xp.ge.xpr1i)return + if(xm.ge.xmr1i)return + xpr1=1.d0 + xmr1=1.d0 + + imin=ntymin + imax=ntymx + if(iomega.eq.2)imax=1 + + do i=imin,imax + gamomx(i)=atilde(i,k)*xp**btildep(i,k)*(xpr1-xp) + deltam(i)=btildepp(i,k) + enddo + + cint=0.d0 + do i=imin,imax + gamom=gamomx(i)*xmr1**(deltam(i)+2.d0)/(2.d0+deltam(i)) + if((deltam(i)+1.d0).gt.eps)then + gamom=gamom/(deltam(i)+1.d0) + else + gamom=-gamom*log(xminDf) + endif + cint=cint+gamom + enddo + + + do i=imin,imax + om1xmk=om1xmk+gamomx(i)*xm**deltam(i)*(xmr1-xm) + enddo + + om1xmk=om1xmk/cint + + return + end + +c---------------------------------------------------------------------- + double precision function om1xpr(atil,btilp,btilpp + & ,xpremi,xmremi,ir) !---MC--- +c---------------------------------------------------------------------- +c Random number generated from the function om1xpk. We solve the equation +c which give om1xprk by Newton-Raphson + secant method. +c k - pair indice; +c ir - 1 to get xp, -1 to get xm (be carrefull to inverse xpremi et xmremi +c when calling with ir=-1) +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incpar' + include 'epos.incems' + double precision x,x0,x1,gamomx(ntymi:ntymx),eps,f0t,f1t,f00 + double precision xt,fx,fpx,r,f1,f0,cint,deltx,prec,drangen,xmrem + double precision deltap(ntymi:ntymx),deltam(ntymi:ntymx),xprem + parameter (eps=1.d-20) + double precision xpremi,xmremi,xlmin,atil(ntymi:ntymx) + & ,btilp(ntymi:ntymx),btilpp(ntymi:ntymx) + + + om1xpr=0.d0 + if(xpremi.gt.1d0.or.xmremi.gt.1d0)return + x0=log(xminDf) + x1=log(xpremi) + xprem=xpremi + xmrem=xmremi + imin=ntymin + imax=ntymx + xlmin=1.d0 + xt=0d0 + if(iomega.eq.2)imax=1 + + do i=imin,imax + if(ir.gt.0)then + deltap(i)=btilp(i) + deltam(i)=btilpp(i) + else + deltap(i)=btilpp(i) + deltam(i)=btilp(i) + endif + gamomx(i)=atil(i)*xmrem**(deltam(i)+2.d0)/(2.d0+deltam(i)) + if((deltam(i)+1.d0).gt.eps)then + gamomx(i)=gamomx(i)/(deltam(i)+1.d0) + else + xlmin=log(xminDf) + gamomx(i)=-gamomx(i)*xlmin + endif + enddo + + f0=0.d0 + f1=0.d0 + do i=imin,imax + if((deltap(i)+1.d0).gt.eps)then + f0=f0+gamomx(i) + & *(xprem*exp(x0)**(1.d0+deltap(i))/(1.d0+deltap(i)) + & -exp(x0)**(2.d0+deltap(i))/(2.d0+deltap(i))) + f1=f1+gamomx(i) + & *(xprem*exp(x1)**(1.d0+deltap(i))/(1.d0+deltap(i)) + & -exp(x1)**(2.d0+deltap(i))/(2.d0+deltap(i))) + else + xlmin=log(xminDf) + f0=f0+gamomx(i)*(xprem*(x0-xlmin)-exp(x0)+xminDf) + f1=f1+gamomx(i)*(xprem*(x1-xlmin)-exp(x1)+xminDf) + endif + enddo + f00=f0 + cint=f1-f00 + f0=-(f0-f00)/cint + f1=-(f1-f00)/cint + ntry=0 + 11 ntry=ntry+1 + r=drangen(dble(ntry)) + f0t=f0+r + f1t=f1+r + if(f1t*f0t.ge.eps.and.ntry.lt.100)goto 11 + if(f1t*f0t.ge.eps)then + do i=imin,imax + write(ifmt,*)i,gamomx(i),deltap(i),deltam(i) + enddo + write(ifmt,*)x0,f0,f0t,x1,f1,f1t,r,cint,ntry + call utstop('om1xpr (2)&') + endif + f0=f0t + f1=f1t + if(abs(f0).le.eps) then + om1xpr=exp(x0) + return + endif + if(abs(f1).le.eps) then + om1xpr=exp(x1) + return + endif + x=0.5d0*(x1+x0) + deltx=abs(x1-x0) + + + ntry=0 + + 111 continue + if(ntry.le.1000)then + fx=0.d0 + fpx=0.d0 + do i=imin,imax + if((deltap(i)+1.d0).gt.eps)then + fx=fx+gamomx(i) + & *(xprem*exp(x)**(1.d0+deltap(i))/(1.d0+deltap(i)) + & -exp(x)**(2.d0+deltap(i))/(2.d0+deltap(i))) + fpx=fpx+gamomx(i)*exp(x)**deltap(i)*(xprem-exp(x)) + else + fx=fx+gamomx(i)*(xprem*(x-xlmin)-exp(x)+xminDf) + fpx=fpx+gamomx(i)*(xprem/exp(x)-1.d0) + endif + enddo + fx=-(fx-f00)/cint+r + fpx=fpx/cint + xt=x-fx/fpx + + if (f0*fx.lt.0.D0) then + f1=fx + x1=x + else + f0=fx + x0=x + endif + if ((xt.lt.x0.or.xt.gt.x1).and.abs(f1-f0).gt.eps) then + xt=x1-f1*(x1-x0)/(f1-f0) + endif + + else + + write(ifmt,*)'Warning in om1xpr, to much try !' + + endif + + + if(abs(x-xt).gt.deltx*0.5d0) then + xt=(x1+x0)*0.5D0 + endif + deltx=abs(x-xt) + if(abs(x).gt.eps)then + prec=abs(deltx/x) + else + prec=0d0 + call utstop('Problem in om1xpr&') + endif + + if (prec.gt.1.d-3.and.abs(f1-f0).gt.eps.and.ntry.le.1000) then + x=xt + ntry=ntry+1 + goto 111 + endif + + om1xpr=exp(x) + + return + end + +c---------------------------------------------------------------------- + double precision function om1xprk(k,xpremi,xmremi,ir) !---MC--- +c---------------------------------------------------------------------- +c Random number generated from the function om1xpk. We solve the equation +c which give om1xprk by Newton-Raphson + secant method. +c k - pair indice; +c ir - 1 to get xp, -1 to get xm (be carrefull to inverse xpremi et xmremi +c when calling with ir=-1) +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incpar' + include 'epos.incems' + double precision x,x0,x1,gamomx(ntymi:ntymx),eps,f0t,f1t,f00 + double precision xt,fx,fpx,r,f1,f0,cint,deltx,prec,drangen,xmrem + double precision deltap(ntymi:ntymx),deltam(ntymi:ntymx),xprem + parameter (eps=1.d-20) + double precision xpremi,xmremi,xlmin + + + om1xprk=0.d0 + x0=log(xmremi) + x1=log(xpremi) + xprem=1.d0 + xmrem=1.d0 + imin=ntymin + imax=ntymx + xlmin=1.d0 + xt=0d0 + if(iomega.eq.2)imax=1 + + do i=imin,imax + if(ir.gt.0)then + deltap(i)=btildep(i,k) + deltam(i)=btildepp(i,k) + else + deltap(i)=btildepp(i,k) + deltam(i)=btildep(i,k) + endif + gamomx(i)=atilde(i,k)*xmrem**(deltam(i)+2.d0)/(2.d0+deltam(i)) + if((deltam(i)+1.d0).gt.eps)then + gamomx(i)=gamomx(i)/(deltam(i)+1.d0) + else + xlmin=log(xminDf) + gamomx(i)=-gamomx(i)*xlmin + endif + enddo + + f0=0.d0 + f1=0.d0 + do i=imin,imax + if((deltap(i)+1.d0).gt.eps)then + f0=f0+gamomx(i) + & *(xprem*exp(x0)**(1.d0+deltap(i))/(1.d0+deltap(i)) + & -exp(x0)**(2.d0+deltap(i))/(2.d0+deltap(i))) + f1=f1+gamomx(i) + & *(xprem*exp(x1)**(1.d0+deltap(i))/(1.d0+deltap(i)) + & -exp(x1)**(2.d0+deltap(i))/(2.d0+deltap(i))) + else + xlmin=log(xminDf) + f0=f0+gamomx(i)*(xprem*(x0-xlmin)-exp(x0)+xminDf) + f1=f1+gamomx(i)*(xprem*(x1-xlmin)-exp(x1)+xminDf) + endif + enddo + f00=f0 + cint=f1-f00 + f0=-(f0-f00)/cint + f1=-(f1-f00)/cint + ntry=0 + 11 ntry=ntry+1 + r=drangen(dble(ntry)) + f0t=f0+r + f1t=f1+r + if(f1t*f0t.ge.eps.and.ntry.lt.100)goto 11 + if(f1t*f0t.ge.eps)then + do i=imin,imax + write(ifmt,*)i,gamomx(i),deltap(i),deltam(i) + enddo + write(ifmt,*)x0,f0,f0t,x1,f1,f1t,r,cint,ntry,bk(k),k + call utstop('om1xprk (2)&') + endif + f0=f0t + f1=f1t + if(abs(f0).le.eps) then + om1xprk=exp(x0) + return + endif + if(abs(f1).le.eps) then + om1xprk=exp(x1) + return + endif + x=0.5d0*(x1+x0) + deltx=abs(x1-x0) + + + ntry=0 + + 111 continue + if(ntry.le.1000)then + fx=0.d0 + fpx=0.d0 + do i=imin,imax + if((deltap(i)+1.d0).gt.eps)then + fx=fx+gamomx(i) + & *(xprem*exp(x)**(1.d0+deltap(i))/(1.d0+deltap(i)) + & -exp(x)**(2.d0+deltap(i))/(2.d0+deltap(i))) + fpx=fpx+gamomx(i)*exp(x)**deltap(i)*(xprem-exp(x)) + else + fx=fx+gamomx(i)*(xprem*(x-xlmin)-exp(x)+xminDf) + fpx=fpx+gamomx(i)*(xprem/exp(x)-1.d0) + endif + enddo + fx=-(fx-f00)/cint+r + fpx=fpx/cint + xt=x-fx/fpx + + if (f0*fx.lt.0.D0) then + f1=fx + x1=x + else + f0=fx + x0=x + endif + if ((xt.lt.x0.or.xt.gt.x1).and.abs(f1-f0).gt.eps) then + xt=x1-f1*(x1-x0)/(f1-f0) + endif + + else + + write(ifmt,*)'Warning in om1xprk, to much try !' + + endif + + + if(abs(x-xt).gt.deltx*0.5d0) then + xt=(x1+x0)*0.5D0 + endif + deltx=abs(x-xt) + if(abs(x).gt.eps)then + prec=abs(deltx/x) + else + prec=0d0 + call utstop('Problem in om1xprk&') + endif + + if (prec.gt.1.d-3.and.abs(f1-f0).gt.eps.and.ntry.le.1000) then + x=xt + ntry=ntry+1 + goto 111 + endif + + om1xprk=exp(x) + + return + end + +c---------------------------------------------------------------------- + double precision function om1xmrk(k,xp,xpremi,xmremi,ir) !---MC--- +c---------------------------------------------------------------------- +c Random number generated from the function om1xmk. We solve the equation +c which give om1xmrk by Newton-Raphson + secant method. +c k - pair indice; +c ir - 1 to get xm, -1 to get xp (be carrefull to inverse xpremi et xmremi +c when calling with ir=-1) +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incpar' + include 'epos.incems' + double precision x,x0,x1,gamomx(ntymi:ntymx),eps,xp,f0t,f1t + double precision xt,fx,fpx,r,f1,f0,cint,deltx,prec,f00 + double precision deltam(ntymi:ntymx),drangen,xprem,xmrem + double precision xpremi,xmremi,xlmin + parameter (eps=1.d-20) + + om1xmrk=0.d0 +c if(xp.ge.xpremi)return + + xprem=1.d0 + xmrem=1.d0 + x0=log(xpremi) + x1=log(xmremi) + imin=ntymin + imax=ntymx + if(iomega.eq.2)imax=1 + + do i=imin,imax + if(ir.gt.0)then + gamomx(i)=atilde(i,k)*xp**btildep(i,k)*(xprem-xp) + deltam(i)=btildepp(i,k) + else + gamomx(i)=atilde(i,k)*xp**btildepp(i,k)*(xprem-xp) + deltam(i)=btildep(i,k) + endif + enddo + + + + f0=0.d0 + f1=0.d0 + xlmin=0.d0 + do i=imin,imax + if(abs(deltam(i)+1.d0).gt.eps)then + f0=f0+gamomx(i) + & *(xmrem*exp(x0)**(1.d0+deltam(i))/(1.d0+deltam(i)) + & -exp(x0)**(2.d0+deltam(i))/(2.d0+deltam(i))) + f1=f1+gamomx(i) + & *(xmrem*exp(x1)**(1.d0+deltam(i))/(1.d0+deltam(i)) + & -exp(x1)**(2.d0+deltam(i))/(2.d0+deltam(i))) + else + xlmin=log(xminDf) + f0=f0+gamomx(i)*(xmrem*(x0-xlmin)-exp(x0)+xminDf) + f1=f1+gamomx(i)*(xmrem*(x1-xlmin)-exp(x1)+xminDf) + endif + enddo + f00=f0 + cint=f1-f00 + f0=-(f0-f00)/cint + f1=-(f1-f00)/cint + ntry=0 + 11 ntry=ntry+1 + r=drangen(dble(ntry)) + f0t=f0+r + f1t=f1+r + if(f1t*f0t.ge.eps.and.ntry.lt.100)goto 11 + if(f1t*f0t.ge.eps)then + write(ifmt,*)x0,f0,f0t,x1,f1,f1t,r,cint,ntry + call utstop('Error(2) in epos-omg in om1xmrk&') + endif + f0=f0t + f1=f1t + if(abs(f0).lt.eps) then + om1xmrk=exp(x0) + return + endif + if(abs(f1).lt.eps) then + om1xmrk=exp(x1) + return + endif + x=0.5d0*(x1+x0) + deltx=abs(x1-x0) + + + ntry=0 + xt=0d0 + + 111 continue + if(ntry.le.1000)then + fx=0.d0 + fpx=0.d0 + do i=imin,imax + if(abs(deltam(i)+1.d0).gt.eps)then + fx=fx+gamomx(i) + & *(xmrem*exp(x)**(1.d0+deltam(i))/(1.d0+deltam(i)) + & -exp(x)**(2.d0+deltam(i))/(2.d0+deltam(i))) + fpx=fpx+gamomx(i)*exp(x)**deltam(i)*(xmrem-exp(x)) + else + fx=fx+gamomx(i)*(xmrem*(x-xlmin)-exp(x)+xminDf) + fpx=fpx+gamomx(i)*(xmrem/exp(x)-1.d0) + endif + enddo + fx=-(fx-f00)/cint+r + fpx=fpx/cint + xt=x-fx/fpx + + if (f0*fx.lt.-eps) then + f1=fx + x1=x + else + f0=fx + x0=x + endif + if ((xt.lt.x0-eps.or.xt.gt.x1+eps).and.abs(f1-f0).gt.eps) then + xt=x1-f1*(x1-x0)/(f1-f0) + endif + + else + + write(ifmt,*)'Warning in om1xmrk, to much try !' + + endif + + if(abs(x-xt).gt.deltx*0.5d0) then + xt=(x1+x0)*0.5D0 + endif + deltx=abs(x-xt) + if(abs(x).gt.eps)then + prec=abs(deltx/x) + else + prec=0d0 + call utstop('Problem in om1xmrk&') + endif + + if (prec.gt.1.d-3.and.abs(f1-f0).gt.eps.and.ntry.le.1000) then + x=xt + ntry=ntry+1 + goto 111 + endif + + om1xmrk=exp(x) + + return + end + +c---------------------------------------------------------------------- + double precision function om1xk(xh,k) !---test--- +c---------------------------------------------------------------------- +c \int dxp om1 (normalised) +c k - pair indice; +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incpar' + include 'epos.incems' + + double precision xh,gamomx(ntymi:ntymx),cint,alpp(ntymi:ntymx) + &,delta(ntymi:ntymx),deltap(ntymi:ntymx),deltam(ntymi:ntymx),eps + &,gamom + parameter(eps=1.d-20) + + + om1xk=0.d0 + + imin=ntymin + imax=ntymx + if(iomega.eq.2)imax=1 + + do i=imin,imax + gamomx(i)=atilde(i,k) + deltap(i)=btildep(i,k) + deltam(i)=btildepp(i,k) + + delta(i)=(deltap(i)+deltam(i))*0.5d0 + alpp(i)=deltap(i)-deltam(i) + + enddo + + cint=0.d0 + do i=imin,imax + gamom=gamomx(i) + if((deltap(i)+1.d0).gt.eps)then + gamom=gamom/(deltap(i)+1.d0) + else + gamom=-gamom*log(xminDf) + endif + if((deltam(i)+1.d0).gt.eps)then + gamom=gamom/(deltam(i)+1.d0) + else + gamom=-gamom*log(xminDf) + endif + cint=cint+gamom + enddo + + + do i=imin,imax + if(abs(alpp(i)).gt.eps)then + om1xk=om1xk+gamomx(i)/alpp(i)*xh**deltam(i)*(1.d0-xh**alpp(i)) + else + om1xk=om1xk-gamomx(i)*xh**delta(i)*log(xh) + endif + enddo + + om1xk=om1xk/cint + + return + end + +c---------------------------------------------------------------------- + double precision function om1yk(xh,yp,k) !---test--- +c---------------------------------------------------------------------- +c om1 normalized for fixed xp +c xh - fraction of the energy squared s for the pomeron; +c k - pair indice; +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + double precision xh,yp,gamomy(ntymi:ntymx),alpp(ntymi:ntymx),cint + double precision deltap,deltam,eps + parameter(eps=1.d-20) + + om1yk=0.d0 + + imin=ntymin + imax=ntymx + if(iomega.eq.2)imax=1 + + do i=imin,imax + gamomy(i)=atilde(i,k) + deltap=btildep(i,k) + deltam=btildepp(i,k) + + alpp(i)=deltap-deltam + gamomy(i)=gamomy(i)*xh**((deltap+deltam)*0.5d0) + + enddo + + cint=0.d0 + do i=imin,imax + if(abs(alpp(i)).gt.eps)then + cint=cint-gamomy(i)/alpp(i)*xh**(alpp(i)*0.5d0) + & *(1.d0-xh**(-alpp(i))) + else + cint=cint-gamomy(i)*log(xh) + endif + enddo + + do i=imin,imax + if(abs(alpp(i)).gt.eps)then + om1yk=om1yk+gamomy(i)*exp(alpp(i)*yp) + else + om1yk=om1yk+gamomy(i) + endif + enddo + + om1yk=om1yk/cint + + + return + end + +c---------------------------------------------------------------------- + double precision function om1xrk(k) !---test--- +c---------------------------------------------------------------------- +c Random number generated from the function om1xk. We solve the equation +c which give om1xrk by Newton-Raphson + secant method. +c k - pair indice; +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incpar' + + double precision x,x0,x1,gamomx(ntymi:ntymx),eps,prec,drangen + double precision xt,fx,fpx,r,f1,f0,cint,deltx,alpp(ntymi:ntymx) + &,delta(ntymi:ntymx),deltap(ntymi:ntymx),deltam(ntymi:ntymx) + &,gamom,f0t,f1t + parameter (eps=1.d-20) + + + om1xrk=0.d0 + + imin=ntymin + imax=ntymx + if(iomega.eq.2)imax=1 + + do i=imin,imax + gamomx(i)=atilde(i,k) + deltap(i)=btildep(i,k) + deltam(i)=btildepp(i,k) + + delta(i)=(deltap(i)+deltam(i))*0.5d0 + alpp(i)=deltap(i)-deltam(i) + + enddo + + cint=0.d0 + do i=imin,imax + gamom=gamomx(i) + if((deltap(i)+1.d0).gt.eps)then + gamom=gamom/(deltap(i)+1.d0) + else + gamom=-gamom*log(xminDf) + endif + if((deltam(i)+1.d0).gt.eps)then + gamom=gamom/(deltam(i)+1.d0) + else + gamom=-gamom*log(xminDf) + endif + cint=cint+gamom + enddo + + x0=eps + x1=1.d0 + f0=0.d0 + f1=0.d0 + do i=imin,imax + + if(abs(alpp(i)).lt.eps)then + if(delta(i)+1.d0.gt.eps)then + f0=f0-gamomx(i)/(delta(i)+1.d0)*x0**(delta(i)+1.d0) + & *(log(x0)-1.d0/(delta(i)+1.d0)) + f1=f1-gamomx(i)/(delta(i)+1.d0)*x1**(delta(i)+1.d0) + & *(log(x1)-1.d0/(delta(i)+1.d0)) + else + f0=f0-0.5d0*gamomx(i)*(log(x0)**2-log(xminDf)**2) + f1=f1-0.5d0*gamomx(i)*(log(x1)**2-log(xminDf)**2) + endif + else + if(abs(deltap(i)+1.d0).gt.eps + & .and.abs(deltam(i)+1.d0).gt.eps)then + f0=f0+gamomx(i)/alpp(i)*(x0**(deltam(i)+1.d0)/(deltam(i)+1.d0) + & -x0**(deltap(i)+1.d0)/(deltap(i)+1.d0)) + f1=f1+gamomx(i)/alpp(i)*(x1**(deltam(i)+1.d0)/(deltam(i)+1.d0) + & -x1**(deltap(i)+1.d0)/(deltap(i)+1.d0)) + elseif(abs(deltap(i)+1.d0).gt.eps)then + f0=f0+gamomx(i)/alpp(i)*(log(x0/xminDf) + & -x0**(deltap(i)+1.d0)/(deltap(i)+1.d0)) + f1=f1+gamomx(i)/alpp(i)*(log(x1/xminDf) + & -x1**(deltap(i)+1.d0)/(deltap(i)+1.d0)) + elseif(abs(deltam(i)+1.d0).gt.eps)then + f0=f0-gamomx(i)/alpp(i)*(log(x0/xminDf) + & -x0**(deltam(i)+1.d0)/(deltam(i)+1.d0)) + f1=f1-gamomx(i)/alpp(i)*(log(x1/xminDf) + & -x1**(deltam(i)+1.d0)/(deltam(i)+1.d0)) + endif + endif + enddo + f0=-f0/cint + f1=-f1/cint + ntry=0 + 11 ntry=ntry+1 + r=drangen(dble(ntry)) + f0t=f0+r + f1t=f1+r + if(f1t*f0t.ge.eps.and.ntry.lt.100)goto 11 + if(f1t*f0t.ge.eps)then + do i=imin,imax + write(ifmt,*)i,gamomx(i),deltap(i),deltam(i),alpp(i),delta(i) + enddo + write(ifmt,*)x0,f0,f0t,x1,f1,f1t,r,cint,ntry,bk(k),k + call utstop('om1xrk (1)&') + endif + f0=f0t + f1=f1t +c if(f1*f0.gt.eps)then +c call utmsg('om1xrk') +c write(ifch,*)'Poblem with x0, no root ! --> om1xrk=xminDf' +c write(ifmt,*)'Poblem with x0, no root ! --> om1xrk=xminDf' +c write(ifmt,*)f0,f1,cint,r +c call utmsgf +c om1xrk=x0 +c return +c endif + if(abs(f0).lt.eps) then + om1xrk=x0 + return + endif + if(abs(f1).lt.eps) then + om1xrk=x1 + return + endif +c x=(x1+x0)*0.5D0 + x=sqrt(x1*x0) + deltx=abs(x1-x0) + + ntry=0 + fx=0.d0 + fpx=0.d0 + xt=x + 111 continue + + if(ntry.le.1000)then + fx=0.d0 + fpx=0.d0 + do i=imin,imax + if(abs(alpp(i)).lt.eps)then + if(delta(i)+1.d0.gt.eps)then + fx=fx-gamomx(i)/(delta(i)+1.d0)*x**(delta(i)+1.d0) + & *(log(x)-1.d0/(delta(i)+1.d0)) + fpx=fpx-gamomx(i)*x**delta(i)*log(x) + else + fx=fx-0.5d0*gamomx(i)*(log(x)**2-log(xminDf)**2) + fpx=fpx-gamomx(i)*log(x)/x + endif + else + if(abs(deltap(i)+1.d0).gt.eps + & .and.abs(deltam(i)+1.d0).gt.eps)then + fx=fx+gamomx(i)/alpp(i)*(x**(deltam(i)+1.d0)/(deltam(i)+1.d0) + & -x**(deltap(i)+1.d0)/(deltap(i)+1.d0)) + fpx=fpx+gamomx(i)/alpp(i)*x**deltam(i)*(1.d0-x**alpp(i)) + elseif(abs(deltap(i)+1.d0).gt.eps)then + fx=fx+gamomx(i)/alpp(i)*(log(x/xminDf) + & -x**(deltap(i)+1.d0)/(deltap(i)+1.d0)) + fpx=fpx+gamomx(i)/alpp(i)*x**deltam(i)*(1.d0-x**alpp(i)) + elseif(abs(deltam(i)+1.d0).gt.eps)then + fx=fx-gamomx(i)/alpp(i)*(log(x/xminDf) + & -x**(deltam(i)+1.d0)/(deltam(i)+1.d0)) + fpx=fpx+gamomx(i)/alpp(i)*x**deltam(i)*(1.d0-x**alpp(i)) + endif + endif + enddo + fx=-fx/cint+r + fpx=fpx/cint + xt=x-fx/fpx + + if (f0*fx.lt.-eps) then + f1=fx + x1=x + else + f0=fx + x0=x + endif + if ((xt.lt.x0-eps.or.xt.gt.x1+eps).and.abs(f1-f0).gt.eps) then + xt=x1-f1*(x1-x0)/(f1-f0) + endif + + else + + write(ifmt,*)'Warning in om1xrk, to much try !' + + endif + + if(abs(x-xt).gt.deltx*0.5d0) then + xt=sqrt(x1*x0) + endif + deltx=abs(x-xt) + if(abs(x).gt.eps)then + prec=deltx/x + else + prec=0d0 + call utstop('Problem in om1xrk&') + endif + + if (prec.gt.1.d-3.and.abs(f1-f0).gt.eps.and.ntry.le.1000)then + x=xt + ntry=ntry+1 + goto 111 + endif + + om1xrk=x + + return + end + +c---------------------------------------------------------------------- + double precision function om1yrk(xh) !---test--- +c---------------------------------------------------------------------- +c Random number generated from the function om1yk(xh). We solve the +c equation which give om1yrk by Newton-Raphson + secant method. +c xh - fraction of the energy squared s for the pomeron; +c k - pair indice; +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + + double precision xh,r!,y0,y1,y,gamomy(ntymi:ntymx),eps,ymin,prec,yt + + r=dble(rangen()) + + om1yrk=(0.5d0-r)*log(xh) + return + + end + +c---------------------------------------------------------------------- + function ffom12aii(iq,je1,je2) !---test--- +c---------------------------------------------------------------------- + include 'epos.inc' + ig=5 + xmin=0.01/engy + xmax=1 + r2=0 + do i2=1,ig + do m2=1,2 + xm=xmin+(xmax-xmin)*(.5+tgss(ig,i2)*(m2-1.5)) + r1=0 + do i1=1,ig + do m1=1,2 + xp=xmin+(xmax-xmin)*(.5+tgss(ig,i1)*(m1-1.5)) + f=ffom12a(xp,xm,iq,iq,je1,je2) + r1=r1+wgss(ig,i1)*f + enddo + enddo + f=r1*0.5*(xmax-xmin) + r2=r2+wgss(ig,i2)*f + enddo + enddo + ffom12aii=r2*0.5*(xmax-xmin) + end + +c---------------------------------------------------------------------- + function ffom12ai(xp,iq1,iq2,je1,je2) !---test--- +c---------------------------------------------------------------------- + include 'epos.inc' + ig=5 + xmin=0.01/engy + xmax=1 + r2=0 + do i2=1,ig + do m2=1,2 + xm=xmin+(xmax-xmin)*(.5+tgss(ig,i2)*(m2-1.5)) + f=ffom12a(xp,xm,iq1,iq2,je1,je2) + r2=r2+wgss(ig,i2)*f + enddo + enddo + ffom12ai=r2*0.5*(xmax-xmin) + end + +c---------------------------------------------------------------------- + function ffom12a(xp,xm,iq1,iq2,je1,je2) !---test--- +c---------------------------------------------------------------------- +c +c 2*om52*F*F == PomInc +c +c xp - xplus +c xm - xminus +c iq=1 .... sea-sea +c iq1 - min iq iq=2 .... val-sea +c iq2 - max iq iq=3 .... sea-val +c iq=4 .... val-val +c je = emission type (projectile and target side) +c 0 ... no emissions +c 1 ... emissions +c else ... all +c +c already b-averaged (\int d2b /sigine*10) +c---------------------------------------------------------------------- + include 'epos.inc' + + sy=engy*engy + xh=xm*xp +ctp060829 yp=0.5*log(xp/xm) + ffom12a=0 + do i=iq1,iq2 + if(i.eq.1)then + ffom12a=ffom12a+2*om52pi(sy*xh,1.,1.,0,je1,je2) + elseif(i.eq.2)then + ffom12a=ffom12a+2*om52pi(sy*xh,xp,1.,1,je1,je2) + elseif(i.eq.3)then + ffom12a=ffom12a+2*om52pi(sy*xh,xm,1.,2,je1,je2) + elseif(i.eq.4)then + ffom12a=ffom12a+2*om52pi(sy*xh,xp,xm,3,je1,je2) + endif + enddo + ffom12a=ffom12a + * *alpff(iclpro)*xp**betff(1)*(1-xp)**alplea(iclpro) + * *alpff(icltar)*xm**betff(2)*(1-xm)**alplea(icltar) + + end + +c---------------------------------------------------------------------- + function ffom11a(xp,xm,iq1,iq2) !---test--- +c---------------------------------------------------------------------- +c +c int(db) om1ff /sigine*10 +c +c xp - xplus iq=-1 ... fit +c xm - xminus iq=0 .... soft +c iq=1 .... gg +c iq1 - min iq iq=2 .... qg +c iq2 - max iq iq=3 .... gq +c iq=4 .... qq +c iq=5 .... diff +c---------------------------------------------------------------------- + include 'epos.inc' + common/geom/rmproj,rmtarg,bmax,bkmx + ig=5 + bmid=bkmx/2. + r=0.d0 + do i=1,ig + do m=1,2 + bb=bmid*(1.+(2.*m-3)*tgss(ig,i)) + f=ffom11(xp,xm,bb,iq1,iq2) + r=r+bb*wgss(ig,i)*f + enddo + enddo + ffom11a=r*2.*pi*bmid /sigine*10 + return + end + +c---------------------------------------------------------------------- + function ffom11(xp,xm,b,iq1,iq2) !---test--- +c---------------------------------------------------------------------- +c +c 2*om5*F*F == PomInc +c +c xp - xplus iq=-1 ... fit +c xm - xminus iq=0 .... soft +c b - impact parameter iq=1 .... gg +c iq1 - min iq iq=2 .... qg +c iq2 - max iq iq=3 .... gq +c iq=4 .... qq +c iq=5 .... diff +c---------------------------------------------------------------------- + include 'epos.inc' + double precision om51 + + if(xm.ge.0.)then + + xh=xm*xp + yp=0.5*log(xp/xm) + ffom11=2.*sngl(om51(dble(xh),dble(yp),b,iq1,iq2)) + * *(1-xm)**alplea(icltar)*(1-xp)**alplea(iclpro) + + else !xm integration + + ig=5 + xmin=0.01/engy + xmax=1 + r=0 + do i=1,ig + do m=1,2 + xmm=xmin*(xmax/xmin)**(.5+tgss(ig,i)*(m-1.5)) + xh=xmm*xp + yp=0.5*log(xp/xmm) + f=2.*sngl(om51(dble(xh),dble(yp),b,iq1,iq2)) + * *(1-xmm)**alplea(icltar)*(1-xp)**alplea(iclpro) + r=r+wgss(ig,i)*f*xmm + enddo + enddo + ffom11=r*0.5*log(xmax/xmin) + + endif + + end + +c---------------------------------------------------------------------- + double precision function om51(xh,yp,b,iq1,iq2) !---test--- +c---------------------------------------------------------------------- +c xh - xplus*xminus iq=-1 ... fit (om1 * 0.5) +c yp - rapidity iq=0 .... soft +c b - impact param iq=1 .... gg +c iq1 - min iq iq=2 .... qg +c iq2 - max iq iq=3 .... gq +c iq=4 .... qq +c iq=5 .... diff +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + double precision xp,xm,xh,yp,om51p,om1 + om51=0.d0 + if(xh.le.0.d0.or.xh.gt.1.d0)return + + sy=engy*engy + xp=sqrt(xh)*exp(yp) + xm=xh/xp + + if(iq1.eq.-1.and.iq2.eq.-1)then + om51=0.5d0*om1(xh,yp,b) + elseif(iq1.ge.0)then + om51=0.d0 + do i=iq1,iq2 + if(i.ne.5)then + i1=min(i,1) + call Gfunpar(0.,0.,1,i1,b,sy,alp,bet,betp,epsp,epst,epss,gamv) + om51=om51+om51p(sy*sngl(xh),xh,yp,b,i) + * *xp**dble(epsp)*xm**dble(epst) + * *dble(sy)**dble(epss) + else + call Gfunpar(0.,0.,1,2,b,sy,alp,bet,betp,epsp,epst,epss,gamv) + om51=om51+0.5d0*dble(alp)*xp**dble(bet)*xm**dble(betp) + endif + enddo + else + stop'om5: choice of iq1 and iq2 is nonsense. ' + endif + + end + +c---------------------------------------------------------------------- + double precision function om5s(sx,xh,yp,b,iq1,iq2) !---test--- +c---------------------------------------------------------------------- + include 'epos.inc' + double precision om51 + double precision xh,yp + ss=sx/xh + engyx=engy + engy=sqrt(ss) + om5s=om51(xh,yp,b,iq1,iq2) + engy=engyx + end + +c---------------------------------------------------------------------- + double precision function om5Jk(k,xh,yp,iqq) !---MC--- +c---------------------------------------------------------------------- +c partial om5 +c xh - fraction of the energy squared s for the pomeron; +c b - impact parameter between the pomeron ends; +c yp - rapidity for the pomeron; +c iqq=0 - soft +c iqq=1 - gg +c iqq=2 - qg +c iqq=3 - gq +c iqq=4 - qq +c iqq=5 - diffractif +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + + double precision xh,yp,om51p + double precision plc,s + common/cems5/plc,s + + sy=sngl(s*xh) + b=bk(k) + epsGp=0. + epsGt=0. + + if(iqq.ne.5)then + om5Jk=om51p(sy,xh,yp,b,iqq) +c Screening effect on Pomeron type set in WomTy + if(iscreen.ne.0)then + xp=sqrt(xh)*exp(yp) + xm=xh/xp + i1=min(iqq,1) +c use pp screening even for nuclei (avoid to many diffractive collisions) +c call Gfunpar(0.,0.,1,i1,b,sngl(s),alp,bet,betp,epsp,epst,epss +c & ,gamv) +c epsGp=epsp +c epsGt=epst +cc epsG=epsilongs(k,i1) + if(iqq.eq.0)then + epsGp=epsilongp(k,i1) + epsGt=epsilongt(k,i1) + elseif(gfactor.gt.0.)then + epsGp=epsilongp(k,i1)*exp(-min(50.,gfactor*zparpro(k))) + epsGt=epsilongt(k,i1)*exp(-min(50.,gfactor*zpartar(k))) + endif + om5Jk=om5Jk*xp**dble(epsGp)*xm**dble(epsGt)!*s**dble(epsG)) + endif + else + xp=sqrt(xh)*exp(yp) + xm=xh/xp + om5Jk=0.5d0*atilde(2,k)*xp**btildep(2,k)*xm**btildepp(2,k) + endif + return + end + +c---------------------------------------------------------------------- + double precision function om5J(zzp,zzt,xh,yp,b,iq) !---test--- +c---------------------------------------------------------------------- +c xh - xplus*xminus iq=-1 ... fit (om1 * 0.5) +c yp - rapidity iq=0 .... soft +c b - impact param iq=1 .... gg +c iq=2 .... qg +c iq=3 .... gq +c zzp - projectile Z iq=4 .... qq +c zzt - target Z iq=5 .... diff +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + double precision xp,xm,xh,yp,om51p,om1 + om5J=0.d0 + if(xh.le.0.d0.or.xh.gt.1.d0)return + + sy=engy*engy + xp=sqrt(xh)*exp(yp) + xm=xh/xp + epsGp=0. + epsGt=0. + + if(iq.eq.-1)then + om5J=0.5d0*om1(xh,yp,b) + elseif(iq.ne.5)then + i1=min(iq,1) + call Gfunpar(zzp,zzt,1,i1,b,sy,alp,bet,betp,epsp,epst,epss,gamv) +c call Gfunpar(0.,0.,1,i1,b,sy,alp,bet,betp,epsp,epst,epss,gamv) +c epsG=epss + if(iq.eq.0)then + epsGp=epsp + epsGt=epst + elseif(gfactor.gt.0.)then + epsGp=epsp*exp(-min(50.,gfactor*zzp)) + epsGt=epst*exp(-min(50.,gfactor*zzt)) + endif + om5J=om51p(sy*sngl(xh),xh,yp,b,iq) + & *xp**dble(epsGp)*xm**dble(epsGt)!*sy**dble(epsG) + else + call Gfunpar(zzp,zzt,1,2,b,sy,alp,bet,betp,epsp,epst,epss,gamv) +c call Gfunpar(0.,0.,1,2,b,sy,alp,bet,betp,epsp,epst,epss,gamv) + om5J=0.5d0*alp*xp**dble(bet)*xm**dble(betp) + endif + + end + +c---------------------------------------------------------------------- + double precision function omIgamint(b,iqq) !---test--- +c---------------------------------------------------------------------- +c - integrated chi~(b)FF/2 for cut I diagram (simple Pomeron) +c b - impact parameter between the pomeron ends; +c yp - rapidity for the pomeron; +c iqq=0 effective one +c iqq=1 soft +c iqq=2 gg +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + include 'epos.incpar' + + double precision Df + + Df=0.d0 + sy=engy*engy + omIgamint=0.d0 + imax=idxD1 + if(iomega.eq.2)imax=1 + + if(iqq.eq.0)then + coefp=1.+alplea(iclpro) + coeft=1.+alplea(icltar) + + do i=idxDmin,imax + call Gfunpar(0.,0.,1,i,b,sy,alpx,betx,betpx,epsp,epst,epss,gamv) + betp=1.+betx + betpp=1.+betpx + Df=alpx*dble(utgam1(betp)*utgam1(betpp)*ucfpro + * *ucftar/utgam1(betp+coefp)/utgam1(betpp+coeft)) + omIgamint=omIgamint+Df + enddo + else + call utstop('Wrong iqq in omIgamint&') + endif + + omIgamint=omIgamint + * *dble(chad(iclpro)*chad(icltar)) + + omIgamint=omIgamint*0.5d0 + + return + end + +c----------------------------------------------------------------------- + subroutine WomTy(w,xh,yp,k) +c----------------------------------------------------------------------- +c - w(ity) for group iqq of cut enhanced diagram giving +c the probability of the type of the same final state. +c k - pair indice; +c xh - fraction of the energy squared s for the pomeron; +c yp - rapidity for the pomeron; +c xpr,xmr impulsion fraction of remnant +c ity = 0 - soft +c ity = 1 - gg +c ity = 2 - qg +c ity = 3 - gq +c ity = 4 - qq +c Modified by gfactor to increase semihard int. probability +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incpar' + include 'epos.incems' + include 'epos.incsem' + doubleprecision xh,yp,om5Jk,w(0:7),ww + + do i=0,7 + w(i)=0.d0 + enddo + + do i=0,5 + w(i)=om5Jk(k,xh,yp,i) + enddo + if(gfactor.lt.0..and.w(1).gt.xggfit*w(0))then !?????????????? + corfac=exp(-dble(abs(gfactor)*(zparpro(k)+zpartar(k))) + & *max(0d0,1d0-sqrt(xggfit*w(0)/w(1)))) + ww=w(0)+w(1) !gg interaction probability + w(0)=w(0)*corfac !soft suppressed + w(1)=ww-w(0) !semi-hard increased + + +c corfac=float(iotst1) !?????????????????????? +c ww=w(0)+w(1)+w(2)+w(3)+w(4)+w(5) +c whard=0. +c do i=1,4 +c w(i)=w(i)*corfac +c whard=whard+w(i) +c enddo +c if(whard.gt.ww)then +c do i=1,4 +c w(i)=w(i)/whard*ww +c enddo +c whard=ww +c endif +c w05=w(0)+w(5) +c if(whard.lt.ww)then +c w(0)=w(0)/w05*(ww-whard) +c w(5)=w(5)/w05*(ww-whard) +c else +c w(0)=0 +c w(5)=0 +c endif + !write(*,'(2f11.4)')(ww-w05)/ww,(ww-w(0)-w(5))/ww + endif + + return + end + + +c----------------------------------------------------------------------- + double precision function Womegak(xp,xm,xprem,xmrem,k) !---MC--- +c----------------------------------------------------------------------- +c - sum(omGam(xp,xm))*(1-xp)*(1-xm) for group of cut enhanced +c diagram giving the same final state (without nuclear effect). +c xp,xm - fraction of the loght cone momenta of the pomeron; +c k - pair index +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + double precision xp,xm,xprem,xmrem + + Womegak=0.d0 + + imax=ntymx + if(iomega.eq.2)imax=1 + + do i=ntymin,imax + Womegak=Womegak+atilde(i,k)*xp**btildep(i,k)*xm**btildepp(i,k) + enddo + + + Womegak=Womegak*(xprem-xp)*(xmrem-xm) + + return + end + + +cc---------------------------------------------------------------------- +c double precision function omNpcut(xp,xm,xprem,xmrem,bh,iqq) !---test--- +cc---------------------------------------------------------------------- +cc Sum of all cut diagrams +cc iqq=0 ideal G +cc iqq=1 exact G + diff +cc---------------------------------------------------------------------- +c include "epos.inc" +c double precision om51,xh,yp,xprem,xmrem,xp,xm!,omYcutI +c +c omNpcut=0.d0 +c xh=xp*xm +c if(abs(xh).gt.1.d-10)then +c yp=0.5d0*log(xp/xm) +c else +c yp=0.d0 +c endif +c +c if(iqq.eq.0)omNpcut=om51(xh,yp,bh,-1,-1) +c if(iqq.eq.1)omNpcut=om51(xh,yp,bh,0,5) +c +c omNpcut=omNpcut*2.d0 +c +c return +c end +c +c---------------------------------------------------------------------- + double precision function omGam(xp,xm,bh) !---test--- +c----------------------------------------------------------------------- +c Cut diagram part for calculation of probability distribution +c xp,xm impulsion fraction of remnant +c bh - impact parameter between the pomeron ends; +c----------------------------------------------------------------------- + include "epos.inc" + include "epos.incems" + double precision om51,xp,xm,xh,yp,eps!,omYgam + parameter (eps=1.d-20) + + omGam=0.d0 + if(xp.lt.eps.or.xm.lt.eps)return + xh=xp*xm + if(abs(xh).gt.1.d-10)then + yp=0.5d0*log(xp/xm) + else + yp=0.d0 + endif + + omGam=om51(xh,yp,bh,-1,-1) + + omGam=2.d0*omGam + + return + end + +c---------------------------------------------------------------------- + double precision function omGamk(k,xp,xm) !---MC--- +c----------------------------------------------------------------------- +c Cut diagram part for calculation of probability distribution (for omega) +c xp,xm impulsion fraction of remnant +c bh - impact parameter between the pomeron ends; +c----------------------------------------------------------------------- + include "epos.inc" + include "epos.incems" + double precision xp,xm + omGamk=0.d0 + imax=ntymx + if(iomega.eq.2)imax=1 + do i=ntymin,imax + omGamk=omGamk+atilde(i,k)*xp**btildep(i,k)*xm**btildepp(i,k) + enddo + + return + end + +c---------------------------------------------------------------------- + double precision function omGamint(bh) !---test--- +c----------------------------------------------------------------------- +c Integrated cut diagram part for calculation of probability distribution +c bh - impact parameter between the pomeron ends; +c----------------------------------------------------------------------- + include "epos.inc" + double precision omIgamint!,omYgamint + + omGamint=2.d0*omIgamint(bh,0) + + return + end + + + + + +c---------------------------------------------------------------------- + block data dgdata +c---------------------------------------------------------------------- +c constants for numerical integration (gaussian weights) +c---------------------------------------------------------------------- + double precision dgx1,dga1 + common /dga20/ dgx1(10),dga1(10) + + + data dgx1/ + & .765265211334973D-01, + & .227785851141645D+00, + & .373706088715420D+00, + & .510867001950827D+00, + & .636053680726515D+00, + & .746331906460151D+00, + & .839116971822219D+00, + & .912234428251326D+00, + & .963971927277914D+00, + & .993128599185095D+00/ + data dga1/ + & .152753387130726D+00, + & .149172986472604D+00, + & .142096109318382D+00, + & .131688638449177D+00, + & .118194531961518D+00, + & .101930119817233D+00, + & .832767415767047D-01, + & .626720483341090D-01, + & .406014298003871D-01, + & .176140071391506D-01/ + + end + + + +c---------------------------------------------------------------------- + double precision function Phiexact(zzip,zzit,fj,xp,xm,s,b) !---test--- +c---------------------------------------------------------------------- +c Exact expression of the Phi function for pp collision +c zzip : additionnal component for Z (nuclear effect projectile side) +c zzit : additionnal component for Z (nuclear effect target side) +c fj : overall factor for cross section (elastic or inelastic) +c xp,xm: momentum fraction +c s : energy square +c b : impact parameter +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + double precision al(idxD0:idxD1),betp(idxD0:idxD1) + *,z,xIrst!,ffacto + double precision zp(idxD0:idxD1),Phitmp,betpp(idxD0:idxD1) + *,yp,ym,xm,xp + double precision eps + parameter(eps=1.d-20) + dimension ipr(idxD0:idxD1),imax(idxD0:idxD1) + + if(idxD0.ne.0.or.idxD1.ne.2) stop "Problem in PhiExact" + Phitmp=0.d0 + + if(xp.gt.eps.and.xm.gt.eps.and.xp.le.1.d0+eps + & .and.xm.le.1.d0+eps)then + + + do i=idxD0,idxD1 + imax(i)=0 + ipr(i)=0 + zp(i)=1.d0 + al(i)=0.d0 + betp(i)=0.d0 + betpp(i)=0.d0 + enddo + + imax0=idxD1 + if(iomega.eq.2)imax0=1 + + do i=idxDmin,imax0 + imax(i)=10+max(5,int(log10(s))) + if(b.ge.1.)imax(i)=4+max(3,int(log10(sqrt(s)))) + imax(i)=min(30,imax(i)) + enddo + Phitmp=0.d0 + do i=idxDmin,imax0 + call Gfunpar(zzip,zzit,1,i,b,s,alpx,betx,betpx,epsp,epst,epss + * ,gamv) + betp(i)=dble(betx)+1.d0 + betpp(i)=dble(betpx)+1.d0 + al(i)=dble(alpx*gamv) + * *dble(chad(iclpro)*chad(icltar)) + enddo + + do ipr0=0,imax(0) + ipr(0)=ipr0 + zp(0)=1.d0 + if (ipr(0).ne.0) zp(0)=(-dble(fj)*al(0))**ipr(0)*facto(ipr(0)) + do ipr1=0,imax(1) + ipr(1)=ipr1 + zp(1)=1.d0 + if (ipr(1).ne.0) zp(1)=(-dble(fj)*al(1))**ipr(1)*facto(ipr(1)) + do ipr2=0,imax(2) + ipr(2)=ipr2 + zp(2)=1.d0 + if (ipr(2).ne.0) zp(2)=(-dble(fj)*al(2))**ipr(2)*facto(ipr(2)) + yp=0.d0 + ym=0.d0 + z=1.d0 + isum=0 + do i=idxDmin,imax0 + yp=yp+dble(ipr(i))*betp(i) + ym=ym+dble(ipr(i))*betpp(i) + isum=isum+ipr(i) + z=z*zp(i) + enddo + + z=z*xIrst(1,xp,yp,betp,ipr) + z=z*xIrst(2,xm,ym,betpp,ipr) + + Phitmp=Phitmp+z + + enddo + enddo + enddo + + + + endif + + PhiExact=Phitmp + + + return + end + + +c---------------------------------------------------------------------- + double precision function PhiExpoK(k,xp,xm) !---MC--- +c---------------------------------------------------------------------- +c Exponential expression of the Phi function for pp collision +c for given k +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + + double precision xp,xm,Phitmp,Gt1 + double precision atildg,btildgp,btildgpp + common/cgtilde/atildg(idxD0:idxD1,kollmx) + *,btildgp(idxD0:idxD1,kollmx),btildgpp(idxD0:idxD1,kollmx) + + + Phitmp=0.d0 + + imax=idxD1 + if(iomega.eq.2)imax=1 + + Phitmp=0.d0 + Gt1=0.d0 + do i=idxDmin,imax + Gt1=Gt1+atildg(i,k)*xp**btildgp(i,k)*xm**btildgpp(i,k) + enddo + + Phitmp=exp(-Gt1) + + PhiExpoK=Phitmp + + return + end + +c---------------------------------------------------------------------- + double precision function PhiExpoK2(k,xp,xm) !---xs--- +c---------------------------------------------------------------------- +c Exponential expression of the Phi function for pp collision +c for given k without diffractive part +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + + double precision xp,xm,Phitmp,Gt1 + double precision atildg,btildgp,btildgpp + common/cgtilde/atildg(idxD0:idxD1,kollmx) + *,btildgp(idxD0:idxD1,kollmx),btildgpp(idxD0:idxD1,kollmx) + + + Phitmp=0.d0 + + imax=1 + + Phitmp=0.d0 + Gt1=0.d0 + do i=idxDmin,imax + Gt1=Gt1+atildg(i,k)*xp**btildgp(i,k)*xm**btildgpp(i,k) + enddo + + Phitmp=exp(-Gt1) + + PhiExpoK2=Phitmp + + return + end + +c---------------------------------------------------------------------- + double precision function Phiexpo(zzip,zzit,fj,xp,xm,s,b) !---MC--- +c---------------------------------------------------------------------- +c Exponential expression of the Phi function for pp collision +c for given b +c input : +c zzip : additionnal component for Z (nuclear effect projectile side) +c zzit : additionnal component for Z (nuclear effect target side) +c fj : overall factor for cross section (elastic or inelastic) +c xp,xm: momentum fraction +c s : energy square +c b : impact parameter +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + include 'epos.incpar' + + parameter(nbkbin=40) + common /kfitd/ xkappafit(nclegy,nclha,nclha,nbkbin),xkappa,bkbin + double precision AlTi + double precision BeTip,BeTipp + double precision xp,xm,Phitmp,Gt1 + + imax=idxD1 + if(iomega.eq.2)imax=1 + + Gt1=0.d0 + do i=idxDmin,imax + call Gfunpar(zzip,zzit,2,i,b,s,alpx,betx,betpx,epsp,epst,epss + & ,gamv) + BeTip =dble(betx) + BeTipp=dble(betpx) + AlTi =dble(alpx) + Gt1=Gt1+AlTi*xp**BeTip*xm**BeTipp*dble(fj*xkappa**(fj-1.)) + + enddo + + Phitmp=exp(-Gt1) + + PhiExpo=Phitmp + & *xp**dble(alplea(iclpro)) + & *xm**dble(alplea(icltar)) + + return + end + +c---------------------------------------------------------------------- + double precision function PhiUnit(xp,xm) !---test--- +c---------------------------------------------------------------------- +c Exponential expression of the Phi function for pp collision +c for given b +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + include 'epos.incpar' + + double precision AlTi + double precision BeTip,BeTipp + double precision xp,xm,Phitmp,Gt1 + + imax=idxD1 + if(iomega.eq.2)imax=1 + + Gt1=0.d0 + do i=idxDmin,imax + BeTip =betUni(i,2) + BeTipp=betpUni(i,2) + AlTi =alpUni(i,2) + Gt1=Gt1+AlTi*xp**BeTip*xm**BeTipp +c write(ifch,*)'Phiunit',i,xp,xm,Gt1,AlTi,BeTip,BeTipp + enddo + + Phitmp=exp(-Gt1) + + PhiUnit=Phitmp + & *xp**dble(alplea(iclpro)) + & *xm**dble(alplea(icltar)) + + + return + end + + +cc---------------------------------------------------------------------- +c double precision function PhiUnit(xp,xm,s,b) !---inu--- +cc---------------------------------------------------------------------- +c include 'epos.inc' +c double precision xp,xm,PhiExpo,Znorm +c +c PhiUnit=Phiexpo(0.,0.,1.,xp,xm,s,b) +c & /Znorm(s,b) +c +c return +c end +c + +c---------------------------------------------------------------------- + double precision function Hrst(s,b,xp,xm) !test +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + include 'epos.incpar' + parameter(idxD2=8) + double precision GbetUni,GbetpUni,HbetUni,HbetpUni,HalpUni + common/DGamUni/GbetUni( idxD0:idxD2),HbetUni( idxD0:idxD2), + & GbetpUni(idxD0:idxD2),HbetpUni(idxD0:idxD2), + & HalpUni(idxD0:idxD2) + double precision al(idxD0:idxD2),betp(idxD0:idxD2) + *,z,xJrst!,ffacto + double precision zp(idxD0:idxD2),Htmp,betpp(idxD0:idxD2) + *,yp,ym,xp,xm + dimension ipr(idxD0:idxD2),imax(idxD0:idxD2) + + if(idxD0.ne.0.or.idxD1.ne.2) stop "Problem in Hrst" + Htmp=0.d0 + do i=idxD0,idxD2 + imax(i)=0 + ipr(i)=0 + zp(i)=1.d0 + al(i)=0.d0 + enddo + + if(xp.ge.0.d0.and.xm.ge.0.d0.and.xp.lt.1.d0.and.xm.le.1.d0)then + + imax0=idxD1 + if(iomega.eq.2)imax0=1 + imax1=idxD2 + if(iomega.eq.2)imax1=imax1-1 + + do i=idxDmin,imax1 + imax(i)=max(2,int(log10(100.*s)/3.)) +c if(i.ge.2)imax(i)=imax(i)*2 + if(b.ge.1.5)imax(i)=2 !max(2,imax(i)/2) + imax(i)=min(30,imax(i)) + if(i.gt.imax0)then + if((zzpUni*zztUni.lt.1.d-6) + & .or.(xp.lt.0.1d0.and.xm.lt.0.1d0))then + imax(i)=0 + else + imax(i)=1 !imax(i)/3 + endif + endif + enddo + + Htmp=0.d0 + do i=idxDmin,imax1 + betp(i)=HbetUni(i) + betpp(i)=HbetpUni(i) + al(i)=HalpUni(i) + enddo + + do ipr0=0,imax(0) +c write(ifmt,*)'Hrst ipr0,xp,xm :',ipr0,xp,xm + ipr(0)=ipr0 + zp(0)=1.d0 + if (ipr(0).ne.0) zp(0)=al(0)**ipr(0)*facto(ipr(0)) + do ipr1=0,imax(1) + ipr(1)=ipr1 + zp(1)=1.d0 + if (ipr(1).ne.0) zp(1)=al(1)**ipr(1)*facto(ipr(1)) + do ipr2=0,imax(2) + ipr(2)=ipr2 + zp(2)=1.d0 + if (ipr(2).ne.0) zp(2)=al(2)**ipr(2)*facto(ipr(2)) + do ipr3=0,imax(3) + ipr(3)=ipr3 + zp(3)=1.d0 + if (ipr(3).ne.0) zp(3)=al(3)**ipr(3)*facto(ipr(3)) + do ipr4=0,imax(4) + ipr(4)=ipr4 + zp(4)=1.d0 + if (ipr(4).ne.0) zp(4)=al(4)**ipr(4)*facto(ipr(4)) + do ipr5=0,imax(5) + ipr(5)=ipr5 + zp(5)=1.d0 + if (ipr(5).ne.0) zp(5)=al(5)**ipr(5)*facto(ipr(5)) + do ipr6=0,imax(6) + ipr(6)=ipr6 + zp(6)=1.d0 + if (ipr(6).ne.0) zp(6)=al(6)**ipr(6)*facto(ipr(6)) + do ipr7=0,imax(7) + ipr(7)=ipr7 + zp(7)=1.d0 + if (ipr(7).ne.0) zp(7)=al(7)**ipr(7)*facto(ipr(7)) + do ipr8=0,imax(8) + ipr(8)=ipr8 + zp(8)=1.d0 + if (ipr(8).ne.0) zp(8)=al(8)**ipr(8)*facto(ipr(8)) + if (ipr(0)+ipr(1)+ipr(2)+ipr(3)+ipr(4)+ipr(5) + & +ipr(6)+ipr(7)+ipr(8).ne.0) then + yp=0.d0 + ym=0.d0 + z=1.d0 + do i=idxDmin,imax1 + yp=yp+dble(ipr(i))*betp(i) + ym=ym+dble(ipr(i))*betpp(i) + z=z*zp(i) + enddo + z=z*xJrst(xp,yp,GbetUni,ipr) + z=z*xJrst(xm,ym,GbetpUni,ipr) + Htmp=Htmp+z + endif + enddo + enddo + enddo + enddo + enddo + enddo + enddo + enddo + enddo + + endif + + Hrst=Htmp + + return + end + +c---------------------------------------------------------------------- + double precision function HrstI(s,b,xp,xm) !test +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + include 'epos.incpar' + parameter(idxD2=8) + double precision GbetUni,GbetpUni,HbetUni,HbetpUni,HalpUni + common/DGamUni/GbetUni( idxD0:idxD2),HbetUni( idxD0:idxD2), + & GbetpUni(idxD0:idxD2),HbetpUni(idxD0:idxD2), + & HalpUni(idxD0:idxD2) + double precision al(idxD0:idxD2),betp(idxD0:idxD2) + *,z,xJrstI!,ffacto + double precision zp(idxD0:idxD2),Htmp,betpp(idxD0:idxD2) + *,yp,ym,xp,xm + dimension ipr(idxD0:idxD2),imax(idxD0:idxD2) + + if(idxD0.ne.0.or.idxD1.ne.2) stop "Problem in HrstI" + Htmp=0d0 + do i=idxD0,idxD2 + imax(i)=0 + ipr(i)=0 + zp(i)=1.d0 + al(i)=0.d0 + enddo + + + if(xp.ge.0.d0.and.xm.ge.0.d0.and.xp.lt.1.d0.and.xm.le.1.d0)then + + + imax0=idxD1 + if(iomega.eq.2)imax0=1 + imax1=idxD2 + if(iomega.eq.2)imax1=imax1-1 + + do i=idxDmin,imax1 + imax(i)=max(3,int(log10(s)/2.)) +c if(i.ge.2)imax(i)=imax(i)*2 + if(b.ge.1.5)imax(i)=max(2,imax(i)/2) + imax(i)=min(30,imax(i)) + if(i.gt.imax0)then + if((zzpUni*zztUni.lt.1.d-6) + & .or.(xp.lt.0.1d0.and.xm.lt.0.1d0))then + imax(i)=0 + else + imax(i)=1 !imax(i)/3 + endif + endif + enddo + + Htmp=0.d0 + do i=idxDmin,imax1 + betp(i)=HbetUni(i) + betpp(i)=HbetpUni(i) + al(i)=HalpUni(i) + enddo + do ipr0=0,imax(0) + ipr(0)=ipr0 + zp(0)=1.d0 + if (ipr(0).ne.0) zp(0)=al(0)**ipr(0)*facto(ipr(0)) + do ipr1=0,imax(1) + ipr(1)=ipr1 + zp(1)=1.d0 + if (ipr(1).ne.0) zp(1)=al(1)**ipr(1)*facto(ipr(1)) + do ipr2=0,imax(2) + ipr(2)=ipr2 + zp(2)=1.d0 + if (ipr(2).ne.0) zp(2)=al(2)**ipr(2)*facto(ipr(2)) + do ipr3=0,imax(3) + ipr(3)=ipr3 + zp(3)=1.d0 + if (ipr(3).ne.0) zp(3)=al(3)**ipr(3)*facto(ipr(3)) + do ipr4=0,imax(4) + ipr(4)=ipr4 + zp(4)=1.d0 + if (ipr(4).ne.0) zp(4)=al(4)**ipr(4)*facto(ipr(4)) + do ipr5=0,imax(5) + ipr(5)=ipr5 + zp(5)=1.d0 + if (ipr(5).ne.0) zp(5)=al(5)**ipr(5)*facto(ipr(5)) + do ipr6=0,imax(6) + ipr(6)=ipr6 + zp(6)=1.d0 + if (ipr(6).ne.0) zp(6)=al(6)**ipr(6)*facto(ipr(6)) + do ipr7=0,imax(7) + ipr(7)=ipr7 + zp(7)=1.d0 + if (ipr(7).ne.0) zp(7)=al(7)**ipr(7)*facto(ipr(7)) + do ipr8=0,imax(8) + ipr(8)=ipr8 + zp(8)=1.d0 + if (ipr(8).ne.0) zp(8)=al(8)**ipr(8)*facto(ipr(8)) + if (ipr(0)+ipr(1)+ipr(2)+ipr(3)+ipr(4)+ipr(5) + & +ipr(6)+ipr(7)+ipr(8).ne.0) then + yp=0.d0 + ym=0.d0 + z=1.d0 + do i=idxDmin,imax1 + yp=yp+dble(ipr(i))*betp(i) + ym=ym+dble(ipr(i))*betpp(i) + z=z*zp(i) + enddo + z=z*xJrstI(xp,yp,GbetUni,ipr) + z=z*xJrstI(xm,ym,GbetpUni,ipr) + Htmp=Htmp+z + endif + enddo + enddo + enddo + enddo + enddo + enddo + enddo + enddo + enddo + + endif + + HrstI=Htmp + + return + end + + + +cc---------------------------------------------------------------------- +c double precision function HrstI(s,xp,xm) !---inu--- +cc---------------------------------------------------------------------- +c include 'epos.inc' +c include 'epos.incems' +c include 'epos.incsem' +c include 'epos.incpar' +c double precision al(idxD0:idxD1),betp(idxD0:idxD1) +c *,z,xJrstI!,ffacto +c double precision zp(idxD0:idxD1),Htmp,betpp(idxD0:idxD1) +c *,yp,ym,xp,xm +c dimension ipr(idxD0:idxD1),imax(idxD0:idxD1) +c +c if(idxD0.ne.0.or.idxD1.ne.2) stop "Problem in HrstI" +c HrstI=0.d0 +c do i=idxD0,idxD1 +c imax(i)=0 +c ipr(i)=0 +c zp(i)=1.d0 +c al(i)=0.d0 +c enddo +c +c if(xp.ge.0.d0.and.xm.ge.0.d0.and.xp.lt.1.d0.and.xm.lt.1.d0)then +c +c HrstI=0.d0 +c +c imax0=idxD1 +c if(iomega.eq.2)imax0=1 +c +c do i=idxDmin,imax0 +c imax(i)=max(5,int(log10(s))) +cc if(i.ge.2)imax(i)=imax(i)*2 +c imax(i)=min(30,imax(i)) +c enddo +c Htmp=0.d0 +c do i=idxDmin,imax0 +c betp(i)=betUni(i,1)+1.d0 +c betpp(i)=betpUni(i,1)+1.d0 +c al(i)=alpUni(i,1)*dble(chad(iclpro)*chad(icltar)) +c enddo +c +c do ipr0=0,imax(0) +c ipr(0)=ipr0 +c zp(0)=1.d0 +c if (ipr(0).ne.0) zp(0)=al(0)**ipr(0)*facto(ipr(0)) +c do ipr1=0,imax(1) +c ipr(1)=ipr1 +c zp(1)=1.d0 +c if (ipr(1).ne.0) zp(1)=al(1)**ipr(1)*facto(ipr(1)) +c do ipr2=0,imax(2) +c ipr(2)=ipr2 +c zp(2)=1.d0 +c if (ipr(2).ne.0) zp(2)=al(2)**ipr(2)*facto(ipr(2)) +c if (ipr(0)+ipr(1)+ipr(2).ne.0) then +c yp=0.d0 +c ym=0.d0 +c z=1.d0 +c do i=idxDmin,imax0 +c yp=yp+dble(ipr(i))*betp(i) +c ym=ym+dble(ipr(i))*betpp(i) +c z=z*zp(i) +c enddo +c z=z*xJrstI(xp,yp,betp,ipr) +c z=z*xJrstI(xm,ym,betpp,ipr) +c Htmp=Htmp+z +c endif +c enddo +c enddo +c enddo +c +c HrstI=Htmp +c +c endif +c +c return +c end +c + +cc---------------------------------------------------------------------- +c double precision function ffacto(n) !---test--- +cc---------------------------------------------------------------------- +c +c ffacto=1.D0 +c do i=1,n +c ffacto=ffacto*dble(i) +c enddo +c return +c end +c + +c---------------------------------------------------------------------- + double precision function xIrst(id,x,y,bet,ipr) !---test--- +c---------------------------------------------------------------------- + include 'epos.inc' + double precision y,gammag,utgam2,x,bet(idxD0:idxD1) + dimension ipr(idxD0:idxD1) + + if(id.eq.1)iclrem=iclpro + if(id.eq.2)iclrem=icltar + imax=idxD1 + if(iomega.eq.2)imax=1 + if(y.le.160.)then + xIrst=gammag(iclrem,y)*x**dble(alplea(iclrem)) + else + xIrst=0 + endif + if(xIrst.gt.0.d0)then + do i=idxDmin,imax + if(ipr(i).ne.0.and.bet(i).gt.1.d-10) + & xIrst=xIrst*utgam2(bet(i))**dble(ipr(i)) + enddo + if (abs(y).gt.1.d-10) xIrst=xIrst*x**y + endif + return + end + + +c---------------------------------------------------------------------- + double precision function xJrst(x,y,Gbeta,ipr) !---inu--- +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(idxD2=8) + double precision y,utgam2,x,Gbeta(idxD0:idxD2),eps,gam + dimension ipr(idxD0:idxD2) + + eps=1.d-10 + + imax=idxD2 + if(iomega.eq.2)imax=imax-1 + + gam=utgam2(y) + + if(gam.lt.1.d99)then + + if ((x-1.d0).gt.eps.or.(y-1.d0).gt.eps) then + xJrst=(1.d0-x)**(y-1.d0)/gam + do i=idxDmin,imax + if (ipr(i).ne.0) xJrst=xJrst*Gbeta(i)**dble(ipr(i)) + enddo + else +c write (*,*) 'Warning in xJrst, infinite value !' + xJrst=(1.d0-x+eps)**(y-1.d0)/gam + do i=idxDmin,imax + if (ipr(i).ne.0) xJrst=xJrst*Gbeta(i)**dble(ipr(i)) + enddo + endif + else + xJrst=0.d0 + endif + + return + end + + +c---------------------------------------------------------------------- + double precision function xJrstI(x,y,Gbeta,ipr) !---inu--- +c---------------------------------------------------------------------- +c Function used for the integration of H*Phi. We do the changement of +c variable (1-x)=z**alpha. The power alpha can be change if necessary. +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(idxD2=8) + double precision y,utgam2,x,Gbeta(idxD0:idxD2),alpha,w,gam + dimension ipr(idxD0:idxD2) + + alpha=4.d0 + w=alpha*(y-1.d0)+alpha-1.d0 + imax=idxD2 + if(iomega.eq.2)imax=imax-1 + + gam=utgam2(y) + + if(gam.lt.1.d99)then + + if (w.ge.0)then + + xJrstI=alpha*x**w/gam + do i=idxDmin,imax + if (ipr(i).ne.0) xJrstI=xJrstI*Gbeta(i)**dble(ipr(i)) + enddo + + else + write(*,*) 'x,y,bet,ipr,w',x,y,Gbeta,ipr,w + stop 'Error in xJrstI in epos-omg, integration not possible' + endif + + else + xJrstI=0.d0 + endif + + + return + end + +c---------------------------------------------------------------------- + double precision function HPhiInt(s,b) !---inu--- +c---------------------------------------------------------------------- +c Set integrated over xp and xm (x and y) H(x,y)*Phi(x,y) for a +c given b by gauss method +c---------------------------------------------------------------------- + include 'epos.inc' + parameter(idxD2=8) + double precision GbetUni,GbetpUni,HbetUni,HbetpUni,HalpUni + common/DGamUni/GbetUni( idxD0:idxD2),HbetUni( idxD0:idxD2), + & GbetpUni(idxD0:idxD2),HbetpUni(idxD0:idxD2), + & HalpUni(idxD0:idxD2) + double precision xhm,x,y,yhm,w,Hrst,utgam2,PhiUnit!,PhiExact +c double precision zp2,zm2,HrstI,eps +c common /ar3/ x1(7),a1(7) + common /ar9/ x9(3),a9(3) + + eps=0d0 !1.d-5 + + imax0=idxD1 + imax1=idxD2 + if(iomega.eq.2)then + imax0=1 + imax1=imax1-1 + endif + do i=idxDmin,imax0 + HbetUni(i)=betUni(i,1)+1.d0 + HbetpUni(i)=betpUni(i,1)+1.d0 + GbetUni(i)=utgam2(HbetUni(i)) + GbetpUni(i)=utgam2(HbetpUni(i)) + HalpUni(i)=alpUni(i,1)*dble(chad(iclpro)*chad(icltar)) + enddo + do i=0,1 + HbetUni(imax0+1+i)=betUni(i,1)+1.d0+betfom + HbetUni(imax0+3+i)=betUni(i,1)+1.d0 + HbetUni(imax0+5+i)=betUni(i,1)+1.d0+betfom + HbetpUni(imax0+1+i)=betpUni(i,1)+1.d0 + HbetpUni(imax0+3+i)=betpUni(i,1)+1.d0+betfom + HbetpUni(imax0+5+i)=betpUni(i,1)+1.d0+betfom + GbetUni(imax0+1+i)=utgam2(HbetUni(imax0+1+i)) + GbetUni(imax0+3+i)=utgam2(HbetUni(imax0+3+i)) + GbetUni(imax0+5+i)=utgam2(HbetUni(imax0+5+i)) + GbetpUni(imax0+1+i)=utgam2(HbetpUni(imax0+1+i)) + GbetpUni(imax0+3+i)=utgam2(HbetpUni(imax0+3+i)) + GbetpUni(imax0+5+i)=utgam2(HbetpUni(imax0+5+i)) + HalpUni(imax0+1+i)=zztUni*alpUni(i,1) + HalpUni(imax0+3+i)=zzpUni*alpUni(i,1) + HalpUni(imax0+5+i)=zzpUni*zztUni*alpUni(i,1) + enddo + + w=0.d0 + xhm=.5d0*(1d0-eps) + yhm=.5d0*(1d0-eps) + do m=1,2 + do i=1,3 +c do i=1,7 + x=xhm+dble((2*m-3)*x9(i))*xhm +c write(ifmt,*)'HPhiInt, xp int :',x + do n=1,2 + do j=1,3 +c do j=1,7 + y=yhm+dble((2*n-3)*x9(j))*yhm + w=w+dble(a9(i)*a9(j))*Hrst(s,b,x,y) + & *PhiUnit(x,y) +c & *Phiexact(0.,0.,1.,x,y,s,b) + enddo + enddo + enddo + enddo + + HPhiInt=w*xhm*yhm + + +c w=0.d0 +c xhm=.5d0*eps +c yhm=.5d0*eps +c do m=1,2 +c do i=1,7 +c x=1d0-eps+xhm+dble((2*m-3)*x1(i))*xhm +c do n=1,2 +c do j=1,7 +c y=1d0-epsyhm+dble((2*n-3)*x1(j))*yhm +c zp2=1.d0-x**4 +c zm2=1.d0-y**4 +c w=w+dble(a1(i)*a1(j))*HrstI(s,x,y) +cc & *PhiUnit(zp2,zm2) +c & *Phiexact(0.,0.,1.,zp2,zm2,s,b) +c enddo +c enddo +c enddo +c enddo +c +c HPhiInt=HPhiInt+w*xhm*yhm + + return + end + + + +c---------------------------------------------------------------------- + subroutine Kfit(iiclegy) +c---------------------------------------------------------------------- + include "epos.inc" + include "epos.incsem" + double precision Znorm + parameter(nbkbin=40) + common /kfitd/ xkappafit(nclegy,nclha,nclha,nbkbin),xkappa,bkbin + parameter (nmax=30) + logical lnoch + + if(iiclegy.eq.-1.or.iiclegy.gt.iclegy2)then + do iiiegy=1,nclegy + do iiipro=1,nclha + do iiitar=1,nclha + do iiibk=1,nbkbin + xkappafit(iiiegy,iiipro,iiitar,iiibk)=1. + enddo + enddo + enddo + enddo + + else + + if(isetcs.le.1)then + s=engy*engy + eps=0.05 + else + s=(egylow*egyfac**(iiclegy-1))**2. + eps=0.001 + endif + + write(ifmt,*)"Fit xkappa ..." + if(ish.ge.2)then + write(ifmt,*)"Kfit s,bkbin,iclegy,ipro,itar" + * ,s,bkbin,iiclegy,iclpro,icltar + endif + + + b=0. + if(isetcs.le.1.or.iiclegy.eq.iclegy2)then + xkf=1. + else + xkf=xkappafit(iiclegy+1,iclpro,icltar,1) + endif + xkfs=1. + delta=0. + deltas=0. + + + do 5 ib=1,nbkbin-1 + b=float(ib-1)*bkbin + xkappafit(iiclegy,iclpro,icltar,ib)=1. + if(b.gt.3.+0.05*log(s).or.s.le.20.*q2min)then + xkf=1. + goto 5 + endif + if(ib.gt.1.and.ish.ge.3)write(ifch,*)" End",delta,xkf + delta=1.-sngl(Znorm(s,b)) + if(delta.le.0d0)then + if(xkf.ne.1.)then + xkappafit(iiclegy,iclpro,icltar,ib)=xkf + delta=1.-sngl(Znorm(s,b)) + endif + else!if(xkf.ne.1.)then + goto 5 + endif + if(abs(delta).lt.eps)then + if(delta.lt.0d0)then + xkfs=xkf-delta + deltas=delta + endif + xkf=1. + goto 5 + elseif(ib.le.nbkbin-1)then + + if(delta.gt.0.d0)then + xkf0=1. + xkf1=xkf + delta0=delta + xkf2=xkf-delta0 + xkappafit(iiclegy,iclpro,icltar,ib)=xkf2 + delta1=1.-sngl(Znorm(s,b)) + if(delta1.lt.0.d0)then + xkf0=xkf2 + xkf1=xkf + delta=delta1 + xkf=xkf0 + else + xkf1=max(delta0,xkf2) + xkf0=0. + xkf=xkf1 + endif + else + xkf0=xkf + xkf1=1.-delta + xkf2=xkf + delta1=delta + endif + + if(ib.eq.1)then + deltas=delta + xkfs=max(0.00001,1.-delta) + endif + + if(delta.le.deltas)xkf=xkfs + if(ish.ge.3)write(ifch,*)" Start",ib,b,delta,xkf,xkf0,xkf1 + if(xkf.eq.xkf2)delta=delta1 + + n=0 + delta0=delta + lnoch=.true. + 10 continue + n=n+1 + if(n.le.nmax.and.xkf1.ne.xkf0)then + if(abs(xkf-xkf2).gt.1e-6.or.abs(delta).gt.abs(deltas))then + xkappafit(iiclegy,iclpro,icltar,ib)=xkf + delta=1.-sngl(Znorm(s,b)) + endif + if(ish.ge.5)write(ifch,*)" step",ib,n,delta,xkf,delta0 + if(delta*delta0.ge.0.)then + if(lnoch.and.abs(delta).gt.abs(delta0))goto 5 + else + lnoch=.false. + endif + if(abs(delta).gt.eps)then + if(delta.gt.0.)then + xkf1=xkf + xkf=(xkf1+xkf0)*0.5 + delta0=delta + else + xkf0=xkf + xkf=(xkf1+xkf0)*0.5 + delta0=delta + endif + goto 10 + endif + else + if(ish.ge.2) + * write(ifmt,*)"Warning in Kfit, nmax reached : xkappafit=1." + xkappafit(iiclegy,iclpro,icltar,ib)=xkf + endif + endif + + 5 continue + + if(ish.ge.3)write(ifch,*)" End",delta,xkf + if(xkf.gt.1.+eps)write(ifmt,*) + * "Warning in Kfit, xkappafit not yet 1" + xkappafit(iiclegy,iclpro,icltar,nbkbin)=1. + + endif + + return + end + +c---------------------------------------------------------------------- + double precision function Znorm(s,b) !---inu--- +c---------------------------------------------------------------------- + include 'epos.inc' + common /kwrite/ xkapZ + double precision HPhiInt,PhiUnit!,PhiExact + +c write(ifmt,*)'Z calculation for (s,b) :',s,b + imax=idxD1 + if(iomega.eq.2)imax=1 + do i=idxDmin,imax + call Gfunpar(0.,0.,1,i,b,s,alpx,betx,betpx,epsp,epst,epss,gamv) + call Gfunpar(0.,0.,2,i,b,s,alpx,betx,betpx,epsp,epst,epss,gamv) + enddo + call GfomPar(b,s) + Znorm=HPhiInt(s,b) +c write(ifch,*)'int',Znorm,' phi',Phiexact(0.,0.,1.,1.d0,1.d0,s,b) + Znorm=Znorm + & +PhiUnit(1.d0,1.d0) +c & +Phiexact(0.,0.,1.,1.d0,1.d0,s,b) + + !write(ifmt,*)'Z=',Znorm,xkapZ,b + return + end + + +c------------------------------------------------------------ + double precision function gammag(iclrem,x) !---test--- +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + double precision x,utgam2 + + gammag=utgam2(dble(alplea(iclrem))+1.D0) + & /utgam2(dble(alplea(iclrem))+1.D0+x) + + return + end + + + +cc---------------------------------------------------------------------- +c double precision function PomNbri(iqq) !---xsigma--- +cc---------------------------------------------------------------------- +cc integral d2b om1intbci +cc iqq, Pomeron type +cc---------------------------------------------------------------------- +c include 'epos.inc' +c double precision om1intbci +c common/geom/rmproj,rmtarg,bmax,bkmx +c common /ar3/ x1(7),a1(7) +c +c bmid=bkmx/2. +c PomNbri=0.d0 +c do i=1,7 +c do m=1,2 +c bb=bmid*(1.+(2.*m-3)*x1(i)) +c PomNbri=PomNbri+dble(bb*a1(i))*om1intbci(bb,iqq) +c enddo +c enddo +c +c PomNbri=PomNbri*dble(2.*pi*bmid) +c +c return +c end +c +c +c + + +c#################################################################################### +c############# former chk ######################################################### +c#################################################################################### + + + + + + + + +cc---------------------------------------------------------------------- +c double precision function PomIncII(b) !---check--- +cc---------------------------------------------------------------------- +cc integral_dx_dy om1*F_remn*F_remn for a given b !---check--- +cc---------------------------------------------------------------------- +c include 'epos.inc' +c include 'epos.incems' +c include 'epos.incsem' +c include 'epos.incpar' +c double precision cint,gamom(idxD0:idxD1),deltap(idxD0:idxD1) +c &,deltapp(idxD0:idxD1),utgam2 +c +cc Calculation by analytical integration (perfect but it changes +cc if om1 change): +c +c s=engy**2 +c imax=1 +c if(iomega.eq.2)imax=1 +c do i=idxDmin,imax +c call Gfunpar(0.,0.,1,i,b,s,alp,bet,betp,epsp,epst,epss,gamv) +c gamom(i)=dble(alp*gamv)*chad(iclpro)*chad(icltar) +c deltap(i)=dble(bet) +c deltapp(i)=dble(betp) +c +cc Integration possible only if delta(i)>-1 +c +c if(deltap(i).le.-1.d0.or.deltapp(i).le.-1.d0) +c & stop 'Error in epos-par-300 in PomIncII' +c enddo +c +c cint=0.d0 +c do i=idxDmin,imax +c cint=cint+gamom(i)*utgam2(deltap(i)+1.d0)*utgam2(deltapp(i)+1.d0) +c & *dble(ucfpro*ucftar) +c & /utgam2(dble(alplea(iclpro))+deltap(i)+2.d0) +c & /utgam2(dble(alplea(icltar))+deltapp(i)+2.d0) +c enddo +c +c PomIncII=cint +c +c return +c end +c + +c---------------------------------------------------------------------- + double precision function PomIncXIExact(x) !---check--- +c---------------------------------------------------------------------- +c integral d2b PomIncXExact +c---------------------------------------------------------------------- + include 'epos.inc' + double precision x,PomIncXExact + common /ar3/ x1(7),a1(7) + common/geom/rmproj,rmtarg,bmax,bkmx + + bmid=bkmx/2. + PomIncXIExact=0.d0 + do i=1,7 + do m=1,2 + bb=bmid*(1.+(2.*m-3)*x1(i)) + PomIncXIExact=PomIncXIExact+dble(bb*a1(i))*PomIncXExact(x,bb) + enddo + enddo + + PomIncXIExact=PomIncXIExact*dble(2.*pi*bmid) + + return + end + +c---------------------------------------------------------------------- + double precision function PomIncXIUnit(x) !---check--- +c---------------------------------------------------------------------- +c integral d2b PomIncXUnit +c---------------------------------------------------------------------- + include 'epos.inc' + double precision x,PomIncXUnit + common /ar3/ x1(7),a1(7) + common/geom/rmproj,rmtarg,bmax,bkmx + + bmid=bkmx/2. + PomIncXIUnit=0.d0 + do i=1,7 + do m=1,2 + bb=bmid*(1.+(2.*m-3)*x1(i)) + PomIncXIUnit=PomIncXIUnit+dble(bb*a1(i))*PomIncXUnit(x,bb) + enddo + enddo + + PomIncXIUnit=PomIncXIUnit*dble(2.*pi*bmid) + + return + end + +c---------------------------------------------------------------------- + double precision function PomIncPIExact(x) !---check--- +c---------------------------------------------------------------------- +c integral d2b PomIncPExact +c---------------------------------------------------------------------- + include 'epos.inc' + double precision x,PomIncPExact + common/geom/rmproj,rmtarg,bmax,bkmx + common /ar3/ x1(7),a1(7) + + bmid=bkmx/2. + PomIncPIExact=0.d0 + do i=1,7 + do m=1,2 + bb=bmid*(1.+(2.*m-3)*x1(i)) + PomIncPIExact=PomIncPIExact+dble(bb*a1(i))*PomIncPExact(x,bb) + enddo + enddo + + PomIncPIExact=PomIncPIExact*dble(2.*pi*bmid) + + return + end + +c---------------------------------------------------------------------- + double precision function PomIncPIUnit(x) !---check--- +c---------------------------------------------------------------------- +c integral d2b PomIncPUnit +c---------------------------------------------------------------------- + include 'epos.inc' + double precision x,PomIncPUnit + common/geom/rmproj,rmtarg,bmax,bkmx + common /ar3/ x1(7),a1(7) + + bmid=bkmx/2. + PomIncPIUnit=0.d0 + do i=1,7 + do m=1,2 + bb=bmid*(1.+(2.*m-3)*x1(i)) + PomIncPIUnit=PomIncPIUnit+dble(bb*a1(i))*PomIncPUnit(x,bb) + enddo + enddo + + PomIncPIUnit=PomIncPIUnit*dble(2.*pi*bmid) + + return + end + +c---------------------------------------------------------------------- + double precision function PomIncMIExact(x) !---check--- +c---------------------------------------------------------------------- +c integral d2b PomIncMExact +c---------------------------------------------------------------------- + include 'epos.inc' + double precision x,PomIncMExact + common/geom/rmproj,rmtarg,bmax,bkmx + common /ar3/ x1(7),a1(7) + + bmid=bkmx/2. + PomIncMIExact=0.d0 + do i=1,7 + do m=1,2 + bb=bmid*(1.+(2.*m-3)*x1(i)) + PomIncMIExact=PomIncMIExact+dble(bb*a1(i))*PomIncMExact(x,bb) + enddo + enddo + + PomIncMIExact=PomIncMIExact*dble(2.*pi*bmid) + + return + end + +c---------------------------------------------------------------------- + double precision function PomIncMIUnit(x) !---check--- +c---------------------------------------------------------------------- +c integral d2b PomIncMUnit +c---------------------------------------------------------------------- + include 'epos.inc' + double precision x,PomIncMUnit + common/geom/rmproj,rmtarg,bmax,bkmx + common /ar3/ x1(7),a1(7) + + bmid=bkmx/2. + PomIncMIUnit=0.d0 + do i=1,7 + do m=1,2 + bb=bmid*(1.+(2.*m-3)*x1(i)) + PomIncMIUnit=PomIncMIUnit+dble(bb*a1(i))*PomIncMUnit(x,bb) + enddo + enddo + + PomIncMIUnit=PomIncMIUnit*dble(2.*pi*bmid) + + return + end + +c---------------------------------------------------------------------- + double precision function PomIncMExact(xm,b) !---check--- +c---------------------------------------------------------------------- +c incluse Pomeron distribution \int dx+ { 2G F_remn F_remn } +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + double precision AlTiP,BeTip,al,bep,bepp,xpInt,utgam2,xm + + s=engy**2 + PomIncMExact=0.d0 + imax=1 + if(iomega.eq.2)imax=1 + do i=idxDmin,imax + call Gfunpar(0.,0.,1,i,b,s,alp,bet,betp,epsp,epst,epss,gamv) + bep =dble(bet) + bepp=dble(betp) + al =dble(alp*gamv) + + BeTip=bep+1.d0 + xpInt=utgam2(BeTip)*dble(ucfpro) + * /utgam2(1.d0+dble(alplea(iclpro))+BeTip) + AlTiP=al*xpInt + PomIncMExact=PomIncMExact+AlTiP*xm**bepp + * *(1.d0-xm)**dble(alplea(icltar)) + enddo + + return + end + +c---------------------------------------------------------------------- + double precision function PomIncMUnit(xm,b) !---check--- +c---------------------------------------------------------------------- +c incluse Unitarized Pomeron distribution \int dx+ +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + double precision Df,xp,xm,G2,w,xpm + double precision PoInU!,Znorm + common /ar3/ x1(7),a1(7) + + s=engy**2 + +c Calculation by numeric integration : + w=0.d0 + xpm=.5d0 + do m=1,2 + do j=1,7 + xp=xpm*(1.d0+dble((2.*m-3.)*x1(j))) + Df=0.d0 + do i=idxDmin,idxD1 + call Gfunpar(0.,0.,1,i,b,s,alp,bet,betp,epsp,epst,epss,gamv) + Df=Df+dble(alp)*xp**dble(bet)*xm**dble(betp) + enddo + call GfomPar(b,s) + G2=Df*(1.d0+zztUni*xp**betfom)*(1.d0+zzpUni*xm**betfom) + w=w+dble(a1(j))*PoInU(xp,xm,s,b)*G2 + enddo + enddo + w=w*xpm + + + PomIncMUnit=w!/Znorm(s,b) + + return + end + + +c---------------------------------------------------------------------- + double precision function PomIncPExact(xp,b) !---check--- +c---------------------------------------------------------------------- +c incluse Pomeron distribution \int dx- { 2G F_remn F_remn } +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + double precision AlTiP,BeTipp,al,bep,bepp,xmInt,utgam2,xp + + s=engy**2 + PomIncPExact=0.d0 + imax=1 + if(iomega.eq.2)imax=1 + do i=idxDmin,imax + call Gfunpar(0.,0.,1,i,b,s,alp,bet,betp,epsp,epst,epss,gamv) + bep=dble(bet) + bepp=dble(betp) + al=dble(alp*gamv) + BeTipp=bepp+1.d0 + xmInt=utgam2(BeTipp)*dble(ucftar) + * /utgam2(1.d0+dble(alplea(icltar))+BeTipp) + AlTiP=al*xmInt + PomIncPExact=PomIncPExact+AlTiP*xp**bep + * *(1.d0-xp)**dble(alplea(iclpro)) + enddo + + return + end + +c---------------------------------------------------------------------- + double precision function PomIncPUnit(xp,b) !---check--- +c---------------------------------------------------------------------- +c incluse Unitarized Pomeron distribution \int dx- +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + double precision Df,xp,xm,G2,w,xmm + double precision PoInU!,Znorm + common /ar3/ x1(7),a1(7) + + s=engy**2 + imax=1 + if(iomega.eq.2)imax=1 + +c Calculation by numeric integration : + w=0.d0 + xmm=.5d0 + do m=1,2 + do j=1,7 + xm=xmm*(1.d0+dble((2.*m-3.)*x1(j))) + Df=0.d0 + do i=idxDmin,imax + call Gfunpar(0.,0.,1,i,b,s,alp,bet,betp,epsp,epst,epss,gamv) + Df=Df+alp*xp**dble(bet)*xm**dble(betp) + enddo + call GfomPar(b,s) + G2=Df*(1.d0+zztUni*xp**betfom)*(1.d0+zzpUni*xm**betfom) + w=w+dble(a1(j))*PoInU(xp,xm,s,b)*G2 + enddo + enddo + w=w*xmm + + + PomIncPUnit=w!/Znorm(s,b) + + return + end + + +c---------------------------------------------------------------------- + double precision function PomIncJExact(b) !---check--- +c---------------------------------------------------------------------- +c integral of Pomeron distribution \int dy dx { 2G F_remn F_remn } +c---------------------------------------------------------------------- + include 'epos.inc' + double precision allea,PomIncXExact,xh + common /ar3/ x1(7),a1(7) + + allea=2.d0+dble(alplea(iclpro)+alplea(icltar)) + PomIncJExact=0.d0 + do i=1,7 + do m=1,2 + xh=1.d0-(.5d0+dble(x1(i)*(float(m)-1.5)))**(1.d0/allea) + PomIncJExact=PomIncJExact+dble(a1(i)) + & *PomIncXExact(xh,b)/(1.d0-xh)**(allea-1.d0) + enddo + enddo + PomIncJExact=PomIncJExact/allea/2.d0 + + return + end + + +c---------------------------------------------------------------------- + double precision function PomIncExactk(k) !---MC--- +c---------------------------------------------------------------------- +c integral of Pomeron distribution \int dy dx { 2G F_remn F_remn } +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + double precision allea,PomIncXExactk,xh + common /ar3/ x1(7),a1(7) + + allea=2.d0+dble(alplea(iclpro)+alplea(icltar)) + PomIncExactk=0.d0 + do i=1,7 + do m=1,2 + xh=1.d0-(.5d0+dble(x1(i)*(float(m)-1.5)))**(1.d0/allea) + PomIncExactk=PomIncExactk+dble(a1(i)) + & *PomIncXExactk(k,xh)/(1.d0-xh)**(allea-1.d0) + enddo + enddo + PomIncExactk=PomIncExactk/allea/2.d0 + + return + end + + +c---------------------------------------------------------------------- + double precision function PomIncJUnit(b) !---check--- +c---------------------------------------------------------------------- +c integral of Pomeron distribution \int dy dx { 2G F_remn F_remn } +c---------------------------------------------------------------------- + include 'epos.inc' + double precision PomIncXUnit,xh,xhm + common /ar3/ x1(7),a1(7) + + PomIncJUnit=0.d0 + xhm=.5d0 + do i=1,7 + do m=1,2 + xh=xhm*(1.d0+dble(x1(i)*(2.*float(m)-3.))) + PomIncJUnit=PomIncJUnit+dble(a1(i)) + & *PomIncXUnit(xh,b) + enddo + enddo + PomIncJUnit=PomIncJUnit*xhm + + return + end + + +c---------------------------------------------------------------------- + double precision function PomIncXExactk(k,xh) !---MC--- +c---------------------------------------------------------------------- +c incluse Pomeron distribution \int dy { 2G F_remn F_remn } +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + double precision xh,Df,xp,xm,w,ymax,bet,betp,alp + common /ar3/ x1(7),a1(7) + + imax=1 + if(iomega.eq.2)imax=1 +c Calculation by numeric integration : + w=0.d0 + ymax=-.5d0*log(xh) + do m=1,2 + do j=1,7 + xp=sqrt(xh)*exp(dble((2.*m-3.)*x1(j))*ymax) + xm=xh/xp + Df=0.d0 + do i=idxDmin,imax + bet=btildep(i,k)+dble(alppar) + betp=btildepp(i,k)+dble(alppar) + alp=atilde(i,k) + Df=Df+alp*xp**bet*xm**betp + * *(1.d0-xp)**dble(alplea(iclpro)) + * *(1.d0-xm)**dble(alplea(icltar)) + enddo + w=w+dble(a1(j))*Df + enddo + enddo + w=w*ymax*xh**dble(-alppar) + + + PomIncXExactk=w + + return + end + +c---------------------------------------------------------------------- + double precision function PomIncXExact(xh,b) !---check--- +c---------------------------------------------------------------------- +c incluse Pomeron distribution \int dy { 2G F_remn F_remn } +c (optimized integration but with no y dependance) +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + double precision AlTiP,bep,bepp,factor,factor1 + double precision xpmin,xh,xp,xm,ymax,y + common /ar3/ x1(7),a1(7) + + imax=1 + if(iomega.eq.2)imax=1 + s=engy**2 + PomIncXExact=0.d0 + do i=idxDmin,imax + call Gfunpar(0.,0.,1,i,b,s,alpx,betx,betpx,epsp,epst,epss,gamv) + bep =betx + bepp =betpx + AlTiP=alpx*gamv + PomIncXExact=PomIncXExact+AlTiP*xh**((bep+bepp)/2.d0) + enddo + + factor=0.d0 + allea=min(alplea(iclpro),alplea(icltar))+1. + xpmin=max(sqrt(xh),exp(-1.d0)) + do i=1,7 + do m=1,2 + xp=1.d0-(1.d0-xpmin)*(.5d0+dble(x1(i)*(float(m)-1.5))) + * **(1.d0/dble(allea)) + xm=xh/xp + factor=factor+dble(a1(i)) + * *((1.d0-xp)**dble(alplea(iclpro)-allea+1.) + * *(1.d0-xm)**dble(alplea(icltar)) + * +(1.d0-xp)**dble(alplea(icltar)-allea+1.) + * *(1.d0-xm)**dble(alplea(iclpro)))/xp + enddo + enddo + factor=factor*(1.d0-xpmin)**dble(allea)/dble(allea) + + + if(xpmin.gt.1.00001d0*sqrt(xh))then + ymax=-log(xh)-2.d0 + factor1=0.d0 + do i=1,7 + do m=1,2 + y=ymax*dble(x1(i)*(2*m-3)) + xp=sqrt(xh*exp(y)) + xm=xh/xp + factor1=factor1+dble(a1(i))*(1.d0-xp)**dble(alplea(iclpro)) + * *(1.d0-xm)**dble(alplea(icltar)) + enddo + enddo + factor=factor+factor1*ymax + endif + + factor=factor/2.d0 + + PomIncXExact=PomIncXExact*factor + + return + end + + +c---------------------------------------------------------------------- + double precision function PomIncXUnit(xh,b) !---check--- +c---------------------------------------------------------------------- +c incluse Unitarized Pomeron distribution \int dy +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + double precision xh,Df,xp,xm,w + double precision PoInU,ymax!,Znorm + common /ar3/ x1(7),a1(7) + + imax=1 + if(iomega.eq.2)imax=1 + s=engy**2 +ctp060829 sy=s*sngl(xh) +c Calculation by numeric integration : + w=0.d0 + ymax=-.5d0*log(xh) + do m=1,2 + do j=1,7 + xp=sqrt(xh)*exp(dble((2.*m-3.)*x1(j))*ymax) + xm=xh/xp + Df=0.d0 + do i=idxDmin,imax + call Gfunpar(0.,0.,1,i,b,s,alp,bet,betp,epsp,epst,epss,gamv) + Df=Df+alp*xp**dble(bet)*xm**dble(betp) + enddo + call GfomPar(b,s) + Df=Df*(1.d0+zztUni*xp**betfom)*(1.d0+zzpUni*xm**betfom) + w=w+dble(a1(j))*Df*PoInU(xp,xm,s,b) + enddo + enddo + w=w*ymax + + + PomIncXUnit=w!/Znorm(s,b) + + return + end + + + +c---------------------------------------------------------------------- + double precision function PoInU(xp,xm,s,b) !---check--- +c---------------------------------------------------------------------- +c Function : PhiU(1-xp,1-xm) + /int(H(z+ + x+,z- + x-)PhiU(z+,z-)dz+dz-) +c---------------------------------------------------------------------- + include 'epos.inc' + double precision xp,xm,zp,zm,zp2,zm2,zpmin,zmmin,deltzp,deltzm + double precision zpm,zmm,w,HrstI,PhiUnit,Hrst,eps!,PhiExact + common /ar3/ x1(7),a1(7) + + eps=1.d-5 + + imax=idxD1 + if(iomega.eq.2)imax=1 + do i=idxDmin,imax + call Gfunpar(0.,0.,1,i,b,s,alpx,betx,betpx,epsp,epst,epss,gamv) + call Gfunpar(0.,0.,2,i,b,s,alpx,betx,betpx,epsp,epst,epss,gamv) + enddo + call GfomPar(b,s) + + if (1.d0-xp-eps.gt.0.d0.and.1.d0-xm-eps.gt.0.d0) then + w=0.d0 + zpmin=1.d0-xp-eps + zmmin=1.d0-xm-eps + zpm=.5d0*zpmin + zmm=.5d0*zmmin + do m=1,2 + do i=1,7 + zp=zpm+dble((2*m-3)*x1(i))*zpm + do n=1,2 + do j=1,7 + zm=zmm+dble((2*n-3)*x1(j))*zmm + w=w+dble(a1(i)*a1(j))*Hrst(s,b,zp+xp,zm+xm) + & *PhiUnit(zp,zm) +c & *Phiexact(0.,0.,1.,zp,zm,s,b) + enddo + enddo + enddo + enddo + PoInU=w*zpm*zmm + deltzp=eps + deltzm=eps + else + PoInU=0.d0 + zpmin=0.d0 + zmmin=0.d0 + deltzp=1.d0-xp + deltzm=1.d0-xm + endif + + w=0.d0 + zpm=0d0 + zmm=0d0 + if(abs(deltzp).gt.1.d-10.and.abs(deltzm).gt.1.d-10)then + zpm=.5d0*deltzp + zmm=.5d0*deltzm + do m=1,2 + do i=1,7 + zp=zpmin+zpm+dble((2*m-3)*x1(i))*zpm + do n=1,2 + do j=1,7 + zm=zmmin+zmm+dble((2*n-3)*x1(j))*zmm + zp2=1.d0-xp-zp**2 + zm2=1.d0-xm-zm**2 + w=w+dble(a1(i)*a1(j))*HrstI(s,b,zp,zm) + & *PhiUnit(zp2,zm2) +c & *Phiexact(0.,0.,1.,zp2,zm2,s,b) + enddo + enddo + enddo + enddo + endif + + PoInU=PoInU+w*zpm*zmm + & +PhiUnit(1.d0-xp,1.d0-xm) +c & +Phiexact(0.,0.,1.,1.d0-xp,1.d0-xm,s,b) + + return + end + +c---------------------------------------------------------------------- + double precision function PomIncExact(xp,xm,b) !---check--- +c---------------------------------------------------------------------- +c inclusive Pomeron distribution { 2G F_remn F_remn } +c---------------------------------------------------------------------- + include "epos.inc" + include "epos.incsem" + double precision Df,xp,xm + + Df=0.d0 + s=engy**2 + imax=1 + if(iomega.eq.2)imax=1 + do i=idxDmin,imax + call Gfunpar(0.,0.,1,i,b,s,alp,bet,betp,epsp,epst,epss,gamv) + Df=Df+alp*gamv*xp**dble(bet)*xm**dble(betp) + enddo + Df=dble(chad(iclpro)*chad(icltar)) + * *Df + + PomIncExact=Df + * *(1.d0-xp)**dble(alplea(iclpro)) + * *(1.d0-xm)**dble(alplea(icltar)) + + return + end + +c---------------------------------------------------------------------- + double precision function PomIncUnit(xp,xm,b) !---check--- +c---------------------------------------------------------------------- +c inclusive Pomeron distribution { Sum{int{G*Phi} } +c---------------------------------------------------------------------- + include "epos.inc" + include "epos.incpar" + include "epos.incsem" + double precision PoInU,xp,xm,om1,xh,yp + + + xh=xp*xm + yp=0.d0 + if(xm.ne.0.d0)yp=0.5d0*log(xp/xm) + PomIncUnit=om1(xh,yp,b)*PoInU(xp,xm,engy*engy,b) + & *(1.d0+zztUni*xp**betfom)*(1.d0+zzpUni*xm**betfom) + + return + end + + +cc---------------------------------------------------------------------- +c double precision function PomIncUnitMC(xp,xm,b) !---check--- +cc---------------------------------------------------------------------- +cc inclusive Pomeron distribution { Sum{int{G*Phi} } +cc---------------------------------------------------------------------- +c include "epos.inc" +c include "epos.incpar" +c include "epos.incsem" +c include "epos.incems" +c parameter(mmax=20) +c double precision Gtab,Phitab,xxpu(mmax),xxmu(mmax) +c double precision Zm,xp,xm,pGtab,Z,omNpcut,xprem,xmrem, +c * sxp,sxm,PhiExpo +c +c PomIncUnitMC=0.d0 +c if(xp.lt.1.d0.and.xm.lt.1.d0)then +c m=10 +c +c sy=engy*engy +c nmcint=2000 +c nmax=nmcint +c do i=1,mmax +c xxpu(i)=0.d0 +c xxmu(i)=0.d0 +c enddo +c xprem=1.d0 +c xmrem=1.d0 +c sxp=xprem-xp +c sxm=xmrem-xm +c +c Gtab=omNpcut(xp,xm,sxp,sxm,b,0) +c Phitab=Phiexpo(0.,0.,1.,sxp,sxm,sy,b) +c Z=Gtab*Phitab +c Zm=0.d0 +c +c do mtmp=2,m +c +c write(*,*)"GPhi",mtmp-1,Zm,Z +c Zm=0.d0 +c n=0 +c +c 10 continue +c n=n+1 +c if(mod(n,1000000).eq.0)write(*,*) +c & "Calculation of PomIncUnit(",mtmp,")->",n +c xxpu(1)=xp +c xxmu(1)=xm +c sxp=xxpu(1) +c sxm=xxmu(1) +c pGtab=1.d0 +c do i=2,mtmp +c rnau=rangen()*sngl(xprem-sxp) +c xxpu(i)=dble(rnau) +c sxp=sxp+xxpu(i) +c rnau=rangen()*sngl(xmrem-sxm) +c xxmu(i)=dble(rnau) +c sxm=sxm+xxmu(i) +c enddo +c if(sxp.lt.xprem.and.sxm.lt.xmrem)then +c do i=1,mtmp +c Gtab=omNpcut(xxpu(i),xxmu(i),xprem-sxp,xmrem-sxm,b,0) +c pGtab=pGtab*Gtab +c enddo +c Zm=Zm+pGtab*Phiexpo(0.,0.,1.,xprem-sxp,xmrem-sxm,sy,b) +c endif +c if(n.lt.nmax)goto 10 +c Zm=Zm/dble(nmax)*fctrl(m-mtmp)*facto(mtmp) +c Z=Z+Zm +c enddo +c +c PomIncUnitMC=Z/dble(chad(iclpro)*chad(icltar)) +c endif +c +c return +c end +c +c +cc---------------------------------------------------------------------- +c double precision function PhiMCExact(xp,xm,b) !---check--- +cc---------------------------------------------------------------------- +cc virtual emissions { Sum{int{-GFF} } +cc---------------------------------------------------------------------- +c include "epos.inc" +c include "epos.incpar" +c include "epos.incsem" +c include "epos.incems" +c parameter(mmax=20) +c double precision Gtab,xxpu(mmax),xxmu(mmax) +c double precision Zm,xp,xm,pGtab,Z,om51,sxp,sxm,xh,yp +cc * ,omNpuncut +c +c PhiMCExact=0.d0 +c if(xp.le.1.d0.and.xm.le.1.d0)then +c m=6 +c +c sy=engy*engy +c nmcint=50000 +c nmax=nmcint +c do i=1,mmax +c xxpu(i)=0.d0 +c xxmu(i)=0.d0 +c enddo +c +c Z=xp**dble(alplea(iclpro)) +c * *xm**dble(alplea(icltar)) +c Zm=0.d0 +c +c do mtmp=1,m +c +c write(*,*)"GPhi",mtmp-1,Zm,Z/xp**dble(alplea(iclpro)) +c * /xm**dble(alplea(icltar)) +c Zm=0.d0 +c n=0 +c +c 10 continue +c n=n+1 +c if(mod(n,1000000).eq.0)write(*,*) +c & "Calculation of Phiexact(0.,0.,",mtmp,")->",n +c sxp=0.d0 +c sxm=0.d0 +c pGtab=1.d0 +c do i=1,mtmp +c rnau=rangen()!*sngl(xp-sxp) +c xxpu(i)=dble(rnau) +c sxp=sxp+xxpu(i) +c rnau=rangen()!*sngl(xm-sxm) +c xxmu(i)=dble(rnau) +c sxm=sxm+xxmu(i) +c enddo +c if(sxp.lt.xp.and.sxm.lt.xm)then +c do i=1,mtmp +c xh=xxpu(i)*xxmu(i) +c if(abs(xh).gt.1.d-30)then +c yp=0.5d0*log(xxpu(i)/xxmu(i)) +c else +c yp=0.d0 +c endif +c Gtab=2*om51(xh,yp,b,0,4) +cc * +omNpuncut(sy*sngl(xh),xh,yp,b,1) !om1(xh,yp,b) +c pGtab=pGtab*(-Gtab) +c enddo +c Zm=Zm+pGtab*(xp-sxp)**dble(alplea(iclpro)) +c * *(xm-sxm)**dble(alplea(icltar)) +c endif +c if(n.lt.nmax)goto 10 +c Zm=Zm/dble(nmax)*fctrl(m-mtmp)*facto(m) +c Z=Z+Zm +c enddo +c +c PhiMCExact=Z +c endif +c +c return +c end + +c---------------------------------------------------------------------- + double precision function Gammapp(sy,b,mtmp) !---check--- +c---------------------------------------------------------------------- + include "epos.inc" + include "epos.incpar" + include "epos.incsem" + include "epos.incems" + parameter(mmax=20) + double precision Gtab,xxpu(mmax),xxmu(mmax),PhiExpo + double precision Zm,xp,xm,pGtab,om1,sxp,sxm,xh,yp + + Gammapp=0.d0 + + xp=1.d0 + xm=1.d0 + nmcint=20000 + nmax=nmcint + do i=1,mmax + xxpu(i)=0.d0 + xxmu(i)=0.d0 + enddo + Zm=0.d0 + + n=0 + + 10 continue + n=n+1 + if(mod(n,10000).eq.0)write(*,*) + & "Calculation of Gammapp(",mtmp,")->",n + sxp=0.d0 + sxm=0.d0 + pGtab=1.d0 + do i=1,mtmp + rnau=rangen()!*sngl(xp-sxp) + xxpu(i)=dble(rnau) + sxp=sxp+xxpu(i) + rnau=rangen()!*sngl(xm-sxm) + xxmu(i)=dble(rnau) + sxm=sxm+xxmu(i) + enddo + if(sxp.lt.xp.and.sxm.lt.xm)then + do i=1,mtmp + xh=xxpu(i)*xxmu(i) + if(abs(xh).gt.1.d-30)then + yp=0.5d0*log(xxpu(i)/xxmu(i)) + else + yp=0.d0 + endif + Gtab=om1(xh,yp,b) + pGtab=pGtab*Gtab + enddo + Zm=Zm+pGtab*Phiexpo(0.,0.,1.,xp-sxp,xm-sxm,sy,b) + endif + if(n.lt.nmax)goto 10 + Zm=Zm/dble(nmax)!**2.d0*(xp*xm)**dble(mtmp) + + Gammapp=Zm + + return + end + +cc---------------------------------------------------------------------- +c double precision function GammaMCnew(sy,b,mtmp) !---check--- +cc---------------------------------------------------------------------- +c include "epos.inc" +c include "epos.incpar" +c include "epos.incsem" +c include "epos.incems" +c parameter(mmax=20) +c common /psar7/ delx,alam3p,gam3p +c double precision Gtab,xxpu(mmax),xxmu(mmax) +c double precision Zm,xp,xm,pGtab,omGam,Zmtot, +c * sxp,sxm,PhiExpo!,om1,yp,xh +c +c GammaMCnew=0.d0 +c Zmtot=0.d0 +c xp=1.d0 +c xm=1.d0 +c nmcint=1000 +c nmax=nmcint +c +c +c do i=1,mmax +c xxpu(i)=0.d0 +c xxmu(i)=0.d0 +c enddo +c +c Zm=0.d0 +c +c n=0 +c +c 10 continue +c n=n+1 +c if(mod(n,1000000).eq.0)write(*,*) +c & "Calculation of GammaMCnew(",mtmp,")->",n +c sxp=0.d0 +c sxm=0.d0 +c pGtab=1.d0 +c do i=1,mtmp +c rnau=rangen() +c xxpu(i)=dble(rnau) +c sxp=sxp+xxpu(i) +c rnau=rangen() +c xxmu(i)=dble(rnau) +c sxm=sxm+xxmu(i) +c enddo +c if(sxp.lt.xp.and.sxm.lt.xm)then +c i=0 +c do k=1,mtmp +c i=i+1 +c Gtab=omGam(xxpu(i),xxmu(i),b) !om1(xh,yp,b) +c pGtab=pGtab*Gtab +c enddo +c Zm=Zm+pGtab*Phiexpo(0.,0.,1.,xp-sxp,xm-sxm,sy,b) +c endif +c if(n.lt.nmax)goto 10 +c +c Zmtot=Zmtot+Zm/dble(nmax) +c +c GammaMCnew=Zmtot +c +c return +c end +cc---------------------------------------------------------------------- +c double precision function GammaMC(sy,b,mtmp) !---check--- +cc---------------------------------------------------------------------- +c include "epos.inc" +c include "epos.incpar" +c include "epos.incsem" +c include "epos.incems" +c parameter(mmax=20) +c double precision Gtab,xxpu(mmax),xxmu(mmax) +c double precision Zm,xp,xm,pGtab,om1, +c * sxp,sxm,xh,yp,PhiExpo!,omNpcut +c +c GammaMC=0.d0 +c +c xp=1.d0 +c xm=1.d0 +c nmcint=50000 +c nmax=nmcint +c do i=1,mmax +c xxpu(i)=0.d0 +c xxmu(i)=0.d0 +c enddo +c +c Zm=0.d0 +c +c n=0 +c +c 10 continue +c n=n+1 +c if(mod(n,1000000).eq.0)write(*,*) +c & "Calculation of GammaMC(",mtmp,")->",n +c sxp=0.d0 +c sxm=0.d0 +c pGtab=1.d0 +c do i=1,mtmp +c rnau=rangen()!*sngl(xp-sxp) +c xxpu(i)=dble(rnau) +c sxp=sxp+xxpu(i) +c rnau=rangen()!*sngl(xm-sxm) +c xxmu(i)=dble(rnau) +c sxm=sxm+xxmu(i) +c enddo +c if(sxp.lt.xp.and.sxm.lt.xm)then +c do i=1,mtmp +c xh=xxpu(i)*xxmu(i) +c if(abs(xh).gt.1.d-30)then +c yp=0.5d0*log(xxpu(i)/xxmu(i)) +c else +c yp=0.d0 +c endif +c Gtab=om1(xh,yp,b)!omNpcut(xxpu(i),xxmu(i),xp-sxp,xm-sxm,b,0) !om1(xh,yp,b) +c pGtab=pGtab*Gtab +c enddo +c Zm=Zm+pGtab*Phiexpo(0.,0.,1.,xp-sxp,xm-sxm,sy,b) +c endif +c if(n.lt.nmax)goto 10 +c Zm=Zm/dble(nmax)*fctrl(n-mtmp)*facto(mtmp) +c +c GammaMC=Zm +c +c return +c end +c +c +c + +c---------------------------------------------------------------------- + double precision function GammaGauss(sy,b,mtmp) !---check--- +c---------------------------------------------------------------------- + include "epos.inc" + include "epos.incpar" + include "epos.incsem" + include "epos.incems" + parameter(mmax=3) + common /psar7/ delx,alam3p,gam3p + double precision xpmin,xmmin,Gst,zm(mmax),zp(mmax) + *,xpmax,xmmax,zpmin(mmax),zmmin(mmax),zpmax(mmax) + double precision xp,xm,pGtab,omGam,dzp(mmax),Gp1,Gm1,xmin,eps + *,sxp,sxm,PhiExpo,zmmax(mmax),dzm(mmax),Gp2,Gm2,Gp3,Gm3,G0 +c *,PhiExact + common /ar3/ x1(7),a1(7) +c double precision dgx1,dga1 +c common /dga20/ dgx1(10),dga1(10) + + GammaGauss=0.d0 + xp=1.d0 + xm=1.d0 + xmin=1.d-13 + eps=1.d-15 + + if(mtmp.eq.0)then + nmax1=0 + jmax1=0 + nmax2=0 + jmax2=0 + nmax3=0 + jmax3=0 + elseif(mtmp.eq.1)then + nmax1=2 + jmax1=7 + nmax2=0 + jmax2=0 + nmax3=0 + jmax3=0 + elseif(mtmp.eq.2)then + nmax1=2 + jmax1=7 + nmax2=2 + jmax2=7 + nmax3=0 + jmax3=0 + elseif(mtmp.eq.3)then + nmax1=2 + jmax1=7 + nmax2=2 + jmax2=7 + nmax3=2 + jmax3=7 + else + write(*,*)"m not between 0 and 3, return ..." + return + endif + + xpmin=xmin + xmmin=xmin + xpmax=1.d0 + xmmax=1.d0 + do i=1,mmax + zp(i)=0.d0 + zm(i)=0.d0 + dzp(i)=0.d0 + dzm(i)=0.d0 + zmmin(i)=0.d0 + zpmax(i)=0.d0 + zpmin(i)=0.d0 + zmmax(i)=0.d0 + enddo + + G0=1.d0 + + if(mtmp.eq.0)then + sxp=xp + sxm=xm + G0=Phiexpo(0.,0.,1.,sxp,sxm,sy,b) + endif + + +c write(*,*)'x+/-',xmmin,xmmax,xpmin,xpmax + + + dzm(1)=0.d0 + if(abs(xmmin-xmmax).ge.eps.and.mtmp.ge.1)then + zmmax(1)=-log(xmmin) + zmmin(1)=-log(xmmax) + if(abs(xmmin-xmin).lt.eps)then + zmmin(1)=-log(min(xmmax,1.d0-xmmin-xmmin)) + zmmax(1)=-log(max(xmmin,1.d0-xmmax-xmmax)) + endif + dzm(1)=(zmmax(1)-zmmin(1))/2.d0 + endif + + dzp(1)=0.d0 + if(abs(xpmin-xpmax).ge.eps.and.mtmp.ge.1)then + zpmax(1)=-log(xpmin) + zpmin(1)=-log(xpmax) + if(abs(xpmin-xmin).lt.eps)then + zpmin(1)=-log(min(xpmax,1.d0-xpmin-xpmin)) + zpmax(1)=-log(max(xpmin,1.d0-xpmax-xpmax)) + endif + dzp(1)=(zpmax(1)-zpmin(1))/2.d0 + endif + +c write(*,*)'bornes1=',exp(-zpmax(1)),exp(-zpmin(1)) +c &,exp(-zmmax(1)),exp(-zmmin(1)) + + Gp1=0.d0 + do np1=1,nmax1 + do jp1=1,jmax1 + zp(1)=zpmin(1)+dzp(1)*(1.d0+dble(2.*np1-3.)*dble(x1(jp1))) + Gm1=0.d0 + if(dzm(1).eq.0.d0)then + nmax1=1 + jmax1=1 + endif + do nm1=1,nmax1 + do jm1=1,jmax1 + if(dzm(1).ne.0.d0)then + zm(1)=zmmin(1)+dzm(1)*(1.d0+dble(2.*nm1-3.)*dble(x1(jm1))) + else + zm(1)=zp(1) + endif + + if(mtmp.eq.1)then + sxp=xp + sxm=xm + do i=1,mtmp + sxp=sxp-exp(-zp(i)) + sxm=sxm-exp(-zm(i)) + enddo + pGtab=1.d0 + k=0 + do l=1,mtmp + k=k+1 + if(dzp(k).ge.0.d0.and.dzm(k).ge.0.d0)then + Gst=omGam(exp(-zp(k)),exp(-zm(k)),b) + pGtab=pGtab*Gst + if(Gst.eq.0.d0) + & write(*,*)'j1=',k,exp(-zp(k)),exp(-zm(k)) + & ,exp(-zpmin(k)),exp(-zpmax(k)),dzp(k),dzm(k),jp1 + else + pGtab=0.d0 + write(*,*)'error1 ?',dzp(k),dzm(k) + endif + enddo + if(sxp.gt.0.d0.and.sxm.gt.0.d0)then + if(dzm(1).ne.0.d0)then + Gm1=Gm1+pGtab* + &dble(a1(jm1))*Phiexpo(0.,0.,1.,sxp,sxm,sy,b) + &*exp(-zm(1)) +c &dble(a1(jm1))*Phiexact(0.,0.,1.,sxp,sxm,sy,b) +c &*exp(-zm(1)) + else + Gp1=Gp1+pGtab* + &dble(a1(jp1))*Phiexpo(0.,0.,1.,sxp,sxm,sy,b) + &*exp(-zp(1)) +c &dble(a1(jp1))*Phiexact(0.,0.,1.,sxp,sxm,sy,b) +c &*exp(-zp(1)) + endif +c write(*,*)'m=1',mtmp,Gm1,Gp1,pGtab,sxp,sxm + endif + endif + + dzp(2)=0.d0 + if(abs(xpmin-xpmax).ge.eps.and.mtmp.ge.2)then + zpmin(2)=-log(min(min(xpmax,1.d0-exp(-zp(1))), + & 1.d0-xpmin-exp(-zp(1)))) + zpmax(2)=-log(max(xpmin,1.d0-xpmax-exp(-zp(1)))) + if(abs(xpmax+xpmax+xpmax-3.d0*dble(1./delx)).lt.eps)then + zpmin(2)=-log(xpmax) + zpmax(2)=-log(xpmin) + endif + dzp(2)=(zpmax(2)-zpmin(2))/2.d0 + endif + + dzm(2)=0.d0 + if(abs(xmmin-xmmax).ge.eps.and.mtmp.ge.2)then + zmmin(2)=-log(min(min(xmmax,1.d0-exp(-zm(1))), + & 1.d0-xmmin-exp(-zm(1)))) + zmmax(2)=-log(max(xmmin,1.d0-xmmax-exp(-zm(1)))) + if(abs(xmmax+xmmax+xmmax-3.d0*dble(1./delx)).lt.eps)then + zmmin(2)=-log(xmmax) + zmmax(2)=-log(xmmin) + endif + dzm(2)=(zmmax(2)-zmmin(2))/2.d0 + endif +c write(*,*)'bornes2=',exp(-zpmax(2)),exp(-zpmin(2)) +c &,exp(-zmmax(2)),exp(-zmmin(2)),xpmax(2),1.d0-exp(-zp(1)) +c &,1.d0-xpmin(3)-exp(-zp(1)),xpmin(2),1.d0-xpmax(3)-exp(-zp(1)) + + Gp2=0.d0 + do np2=1,nmax2 + do jp2=1,jmax2 + zp(2)=zpmin(2)+dzp(2)*(1.d0+dble(2.*np2-3.)*dble(x1(jp2))) + Gm2=0.d0 + if(dzm(2).eq.0.d0)then + nmax2=1 + jmax2=1 + endif + do nm2=1,nmax2 + do jm2=1,jmax2 + if(dzm(2).ne.0.d0)then + zm(2)=zmmin(2)+dzm(2)*(1.d0+dble(2.*nm2-3.)*dble(x1(jm2))) + else + zm(2)=zp(2) + endif + + if(mtmp.eq.2)then + sxp=xp + sxm=xm + do i=1,mtmp + sxp=sxp-exp(-zp(i)) + sxm=sxm-exp(-zm(i)) + enddo + pGtab=1.d0 + k=0 + do l=1,mtmp + k=k+1 + if(dzp(k).ge.0.d0.and.dzm(k).ge.0.d0)then + Gst=omGam(exp(-zp(k)),exp(-zm(k)),b) + pGtab=pGtab*Gst + if(Gst.eq.0.d0) + & write(*,*)'j2=',k,exp(-zp(k)),exp(-zm(k)) + & ,exp(-zpmin(k)),exp(-zpmax(k)),dzp(k),dzm(k),jp1,jp2 + else + pGtab=0.d0 + write(*,*)'error2 ?',dzp(k),dzm(k) + endif + enddo + if(sxp.gt.0.d0.and.sxm.gt.0.d0)then + if(dzm(2).ne.0.d0)then + Gm2=Gm2+pGtab* + &dble(a1(jm2))*Phiexpo(0.,0.,1.,sxp,sxm,sy,b) + &*exp(-zm(2)) +c &dble(a1(jm2))*Phiexact(0.,0.,1.,sxp,sxm,sy,b,mk) +c &*exp(-zm(2)) + else + Gp2=Gp2+pGtab* + &dble(a1(jp2))*Phiexpo(0.,0.,1.,sxp,sxm,sy,b) + &*exp(-zp(2)) +c &dble(a1(jp2))*Phiexact(0.,0.,1.,sxp,sxm,sy,b,mk) +c &*exp(-zp(2)) + endif +c write(*,*)'m=2',mtmp,Gm2,Gp2,pGtab,sxp,sxm + endif + endif + + dzp(3)=0.d0 + if(abs(xpmin-xpmax).ge.eps.and.mtmp.ge.3)then + zpmin(3)=-log(min(xpmax,1.d0-exp(-zp(1))-exp(-zp(2)))) + zpmax(3)=-log(xpmin) + dzp(3)=(zpmax(3)-zpmin(3))/2.d0 + endif + + dzm(3)=0.d0 + if(abs(xmmin-xmmax).ge.eps.and.mtmp.ge.3)then + zmmin(3)=-log(min(xmmax,1.d0-exp(-zm(1))-exp(-zm(2)))) + zmmax(3)=-log(xmmin) + dzm(3)=(zmmax(3)-zmmin(3))/2.d0 + endif + +c write(*,*)'bornes3=',exp(-zpmax(3)),exp(-zpmin(3)) +c &,exp(-zmmax(3)),exp(-zmmin(3)) + + Gp3=0.d0 + do np3=1,nmax3 + do jp3=1,jmax3 + zp(3)=zpmin(3)+dzp(3)*(1.d0+dble(2.*np3-3.)*dble(x1(jp3))) + Gm3=0.d0 + if(dzm(3).eq.0.d0)then + nmax3=1 + jmax3=1 + endif + do nm3=1,nmax3 + do jm3=1,jmax3 + if(dzm(3).ne.0.d0)then + zm(3)=zmmin(3)+dzm(3)*(1.d0+dble(2.*nm3-3.)*dble(x1(jm3))) + else + zm(3)=zp(3) + endif + + sxp=xp + sxm=xm + do i=1,mtmp + sxp=sxp-exp(-zp(i)) + sxm=sxm-exp(-zm(i)) + enddo + pGtab=1.d0 + k=0 + do l=1,mtmp + k=k+1 + if(dzp(k).ge.0.d0.and.dzm(k).ge.0.d0)then + Gst=omGam(exp(-zp(k)),exp(-zm(k)),b) + pGtab=pGtab*Gst + if(Gst.eq.0.d0) + & write(*,*)'j3=',k,exp(-zp(k)),exp(-zm(k)) + & ,exp(-zpmin(k)),exp(-zpmax(k)),dzp(k),dzm(k),jp1,jp2,jp3 + else + pGtab=0.d0 + write(*,*)'error3 ?',k,dzp(k),dzm(k) + endif + enddo + if(sxp.gt.0.d0.and.sxm.gt.0.d0)then + if(dzm(3).ne.0.d0)then + Gm3=Gm3+pGtab + &*dble(a1(jm3))*Phiexpo(0.,0.,1.,sxp,sxm,sy,b) + &*exp(-zm(3)) + else + Gp3=Gp3+pGtab + &*dble(a1(jp3))*Phiexpo(0.,0.,1.,sxp,sxm,sy,b) + &*exp(-zp(3)) + endif + endif + enddo + enddo + if(dzm(3).ne.0.d0)Gp3=Gp3+Gm3*dble(a1(jp3))*exp(-zp(3))*dzm(3) + nmax3=2 + jmax3=7 + enddo + enddo + if(mtmp.gt.2.and.dzm(2).ne.0.d0)then + Gm2=Gm2+Gp3*dble(a1(jm2))*exp(-zm(2))*dzp(3) + elseif(mtmp.gt.2)then + Gp2=Gp2+Gp3*dble(a1(jp2))*exp(-zp(2))*dzp(3) + endif + enddo + enddo + if(dzm(2).ne.0.d0)Gp2=Gp2+Gm2*dble(a1(jp2))*exp(-zp(2))*dzm(2) + nmax2=2 + jmax2=7 + enddo + enddo + if(mtmp.gt.1.and.dzm(1).ne.0.d0)then + Gm1=Gm1+Gp2*dble(a1(jm1))*exp(-zm(1))*dzp(2) + elseif(mtmp.gt.1)then + Gp1=Gp1+Gp2*dble(a1(jp1))*exp(-zp(1))*dzp(2) + endif + enddo + enddo + if(dzm(1).ne.0.d0)Gp1=Gp1+Gm1*dble(a1(jp1))*exp(-zp(1))*dzm(1) + nmax1=2 + jmax1=7 + enddo + enddo + + if(mtmp.gt.0)G0=Gp1*dzp(1) + write(*,*)"int:",G0 + + GammaGauss=GammaGauss+G0 + + return + + end + +c----------------------------------------------------------------------- + double precision function omWi(sy,b) !---check--- +c----------------------------------------------------------------------- +c cut enhanced diagram integrated over xp, xm, xpr,xmr +c (with ideal G) +c b - impact parameter between the pomeron ends; +c sy- total energy +c----------------------------------------------------------------------- + include "epos.inc" + include "epos.incpar" + include "epos.incsem" + include "epos.incems" + common /psar7/ delx,alam3p,gam3p + double precision xpmin,xmmin,zp,zm,alpp,alpm,xjacp,xjacm + *,xpmax,xmmax,zpmin,zmmin,zpmax,chg + double precision xp,xm,pGtab,omGam,dzp,Gp1,Gm1,xmin,eps + *,sxp,sxm,PhiExpo,zmmax,dzm!,gamp,gamm,gampp,gammp +c *,PhiExact + common /ar3/ x1(7),a1(7) +c double precision dgx1,dga1 +c common /dga20/ dgx1(10),dga1(10) + + omWi=0.d0 + + xmin=1.d-30 + eps=1.d-15 + chg=1.d0/dble(delx) + b2=b*b + gamb=gamD(1,iclpro,icltar) +ctp060829 gamp=dble(gamb*b2/2.-alppar) +ctp060829 gamm=dble(gamb*b2/2.-alppar) +ctp060829 gampp=1.d0+2.d0*gamp +ctp060829 gammp=1.d0+2.d0*gamm + + nmax=2 + jmax=7 + + xpmin=xmin + xmmin=xmin + xpmax=1.d0 + xmmax=1.d0 + zpmin=0.d0 + zmmin=0.d0 + zpmax=0.d0 + zmmax=0.d0 + zp=0.d0 + zm=0.d0 + dzp=0.d0 + dzm=0.d0 + + + + do intp=1,2 + do intm=1,2 + + if(intp.eq.1)then + + xpmin=xmin + xpmax=chg + alpp=(1.d0+2.d0*dble(gamb*b2/2.)) + + else + + xpmin=chg + xpmax=1.d0 + alpp=1.d0!(1.d0+2.d0*dble(gamb*b2/2.)) + + endif + + if(intm.eq.1)then + + xmmin=xmin + xmmax=chg + alpm=(1.d0+2.d0*dble(gamb*b2/2.)) + + else + + xmmin=chg + xmmax=1.d0 + alpm=1.d0!(1.d0+2.d0*dble(gamb*b2/2.)) + + endif +c write(*,*)'x+/-',intp,intm,xmmin,xmmax,xpmin,xpmax,alpp,alpm + + + dzm=0.d0 + if(abs(xmmin-xmmax).ge.eps)then + if(alpm.eq.0.d0)then + zmmax=-log(xmmin) + zmmin=-log(xmmax) + else + zmmin=xmmin**alpm + zmmax=xmmax**alpm + endif + dzm=(zmmax-zmmin)/2.d0 + endif + + dzp=0.d0 + if(abs(xpmin-xpmax).ge.eps)then + if(alpp.eq.0.d0)then + zpmax=-log(xpmin) + zpmin=-log(xpmax) + else + zpmin=xpmin**alpp + zpmax=xpmax**alpp + endif + dzp=(zpmax-zpmin)/2.d0 + endif + + + Gp1=0.d0 + + if(abs(dzp).gt.eps.and.abs(dzm).gt.eps)then +c write(*,*)'Ca passe ...' + + do np1=1,nmax + do jp1=1,jmax + zp=zpmin+dzp*(1.d0+dble(2.*np1-3.)*dble(x1(jp1))) +c zp=zpmin+dzp*(1.d0+dble(2.*np1-3.)*dgx1(jp1)) + if(alpp.eq.0.d0)then + xp=exp(-zp) + xjacp=xp + else + xp=zp**(1.d0/alpp) + xjacp=zp**(1.d0/alpp-1.d0)/alpp + endif + + Gm1=0.d0 + do nm1=1,nmax + do jm1=1,jmax + zm=zmmin+dzm*(1.d0+dble(2.*nm1-3.)*dble(x1(jm1))) +c zm=zmmin+dzm*(1.d0+dble(2.*nm1-3.)*dgx1(jm1)) + if(alpm.eq.0.d0)then + xm=exp(-zm) + xjacm=xm + else + xm=zm**(1.d0/alpm) + xjacm=zm**(1.d0/alpm-1.d0)/alpm + endif + + sxp=1.d0-xp + sxm=1.d0-xm + pGtab=1.d0 + if(dzp.ge.0.d0.and.dzm.ge.0.d0)then + pGtab=omGam(xp,xm,b) + if(pGtab.eq.0.d0) + & write(*,*)'j1=',xp,xm,xmmin,xmmax,dzp,dzm,jp1 + else + pGtab=0.d0 + write(*,*)'error ?',dzp,dzm + endif + if(sxp.gt.0.d0.and.sxm.gt.0.d0)then + if(dzm.ne.0.d0)then + Gm1=Gm1+pGtab* + &dble(a1(jm1))*Phiexpo(0.,0.,1.,sxp,sxm,sy,b)*xjacm +c &dga1(jm1)*Phiexpo(0.,0.,1.,sxp,sxm,sy,b)*xjacm +c &dble(a1(jm1))*Phiexact(0.,0.,1.,sxp,sxm,sy,b)*xjacm + else + Gp1=Gp1+pGtab* + &dble(a1(jp1))*Phiexpo(0.,0.,1.,sxp,sxm,sy,b)*xjacp +c &dga1(jp1)*Phiexpo(0.,0.,1.,sxp,sxm,sy,b)*xjacp +c &dble(a1(jp1))*Phiexact(0.,0.,1.,sxp,sxm,sy,b)*xjacp + endif +c write(*,*)'m=1',mtmp,Gm1,Gp1,pGtab,sxp,sxm + endif + + enddo + enddo + if(dzm.ne.0.d0)Gp1=Gp1+Gm1*dble(a1(jp1))*dzm*xjacp +c if(dzm.ne.0.d0)Gp1=Gp1+Gm1*dga1(jp1)*dzm*xjacp + enddo + enddo + endif + + omWi=omWi+Gp1*dzp + + enddo + enddo + + + return + end + +c----------------------------------------------------------------------- + double precision function Womint(sy,bh) !---check--- +c----------------------------------------------------------------------- +c - chi~(xp,xm)/2. for group of cut enhanced diagram giving +c the same final state integrated over xpr and xmr (with ideal G) +c bh - impact parameter between the pomeron ends; +c xh - fraction of the energy squared s for the pomeron; +c yp - rapidity for the pomeron; +c----------------------------------------------------------------------- + include 'epos.inc' + double precision omWi + + Womint=omWi(sy,bh) + + return + end + + + +c----------------------------------------------------------------------- + double precision function WomGamint(bh) !---check--- +c----------------------------------------------------------------------- +c - chi~(xp,xm)/2. for group of integrated cut enhanced diagram giving +c the same final for proposal. +c bh - impact parameter between the pomeron ends; +c xh - fraction of the energy squared s for the pomeron; +c yp - rapidity for the pomeron; +c----------------------------------------------------------------------- + include 'epos.inc' + double precision omGamint + + WomGamint=omGamint(bh) + + return + end + diff --git a/modules/epos/epos-par-lhc.f b/modules/epos/epos-par-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..4f5a9a1f74eacca418b6c22a20d24994e817abea --- /dev/null +++ b/modules/epos/epos-par-lhc.f @@ -0,0 +1,1364 @@ +c 15/02/2005 epos 1.03 + + +c---------------------------------------------------------------------- + subroutine paramini(imod) +c---------------------------------------------------------------------- +c Set parameters of the parametrisation of the eikonals. +c +c xDfit=Sum(i=0,1)(alpD(i)*xp**betDp(i)*xm**betDpp(i)*s**betD(i) +c *xs**(gamD(i)*b2)*exp(-b2/delD(i)) +c +c Parameters stored in /Dparam/ (epos.inc) +c if imod=0, do settings only for iclpro, if imod=1, do settings +c for iclpro=2 and iclpro +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + include 'epos.incpar' + double precision PhiExact,y!,Dsoftshval + call utpri('parini',ish,ishini,3) + +c Initialisation of the variables + + call Class('paramini ') + +c Variables used for xparg (only graphical application) + + spmin=4.*q2min !Definition of spmin in psvin (epos-sha) + sfshlim=3.*spmin !transition energy for soft->hard + emaxDf=engy !energy for fit subroutines + smaxDf=emaxDf**2 !energy squared for fit subroutines +c sfshlim=100. + nptf=10 !number of point for the fit + xmaxDf=1.d0 !maximum limit for the fit + xminDf=1.d0/dble(smaxDf) !minimum limit + xggfit=xminDf*sfshlim + xshmin=3.d-2 !minimum limit for sh variance fit + if(smaxDf.lt.sfshlim) xshmin=1.d0 + xfitmin=0.1d0 !sh fitted between f(1) and f(1)*xfitmin + if(smaxDf.lt.sfshlim) xfitmin=1.d0 + + bmaxDf=2. !maximum b for variance fit + + idxDmin=idxD0 !minimum indice for parameters + ntymin=ntymi !minimum indice for diagram type + + ucfpro=utgam1(1.+alplea(iclpro)) + ucftar=utgam1(1.+alplea(icltar)) + + + + iiiclegy=iclegy + +c for pi or K - p crosse section calculation, we need alpD, ... for +c iclpro=1 or 3 and iclpro=2 + iiiclpro1=iclpro + iiidirec=1 + if(imod.eq.0)then + iiiclpro2=iclpro + else + iiiclpro2=2 + if(iiiclpro1.lt.iiiclpro2)iiidirec=-1 + endif + iclprosave=iclpro + + do iiipro=iiiclpro2,iiiclpro1,iiidirec + + iclpro=iiipro + + if(ish.ge.4)write(ifch,*)'gamini' + & ,iscreen,iclpro,icltar,iclegy,smaxDf,sfshlim,spmin + + if(isetcs.le.1)then !if set mode, do fit + +c First try for fit parameters + +c linear fit of the 2 components of G as a function of x + call pompar(alpsf,betsf,0) !soft (taking into account hard) + call pompar(alpsh,betsh,1) !sh +c betsh=0.31 +c alpsh0=sngl(Dsoftshval(smaxDf,1d0,0.d0,0.,2))*smaxDf**(-betsh) +c alpsh1=sngl(Dsoftshval(smaxDf,1d0,0.d0,0.,0))*smaxDf**(-betsh) +c if(alpsh0.lt.alpsf)alpsh1=alpsh0 +c if(alpsh0*smaxDf**betsh.lt.alpsf*smaxDf**betsf)alpsh1=alpsh0 +c if(smaxDf.gt.100.*sfshlim)then +c xfmin=1.e-2 +c alpsh2=sngl(Dsoftshval(xfmin*smaxDf,dble(xfmin),0.d0,0.,0)) +c & *(xfmin*smaxDf)**(-betsh) +c else +c alpsh2=-1e10 +c endif +c alpsh=max(alpsh1,alpsh2) +c alpsh=max(alpsh0,alpsh2) +c Gaussian fit of the 2 components of G as a function of x and b + call variance(delsf,gamsf,0) + call variance(delsh,gamsh,1) + gamsf=max(0.,gamsf) + gamsh=max(0.,gamsh) + + +c Fit GFF + + +c fit parameters + numminDf=3 !minimum indice + numparDf=4 !maximum indice + betac=100. !temperature for chi2 + betae=1. !temperature for error + fparDf=0.8 !variation amplitude for range + + nmcxDf=20000 !number of try for x fit + +c starting values + + parDf(1,3)=alpsf + parDf(2,3)=betsf + parDf(3,3)=alpsh + parDf(4,3)=betsh + +c if(smaxDf.ge.sfshlim)then +c call paramx !alpD and betD + +c call pompar(alpsf,betsf,-1) !soft (taking into account hard) +c parDf(1,3)=alpsf +c parDf(2,3)=max(-0.95+alppar,betsf) +c parDf(2,3)=max(0.,betsf) + +c endif + + alpsf=parDf(1,3) + betsf=parDf(2,3) + alpsh=parDf(3,3) + betsh=parDf(4,3) + + + else !else parameters from table (inirj) + nbpsf=iDxD0 + if(iclegy2.gt.1)then + al=1.+(log(engy)-log(egylow))/log(egyfac) !energy class + i2=min(iiiclegy+1,iclegy2) + i1=i2-1 + else + i1=iclegy + i2=iclegy + al=float(iclegy) + endif + dl=al-i1 + dl1=max(0.,1.-dl) + !linear interpolation + alpsf=alpDs(nbpsf,i2,iclpro,icltar)*dl + & +alpDs(nbpsf,i1,iclpro,icltar)*dl1 + alpsh=alpDs(1,i2,iclpro,icltar)*dl + & +alpDs(1,i1,iclpro,icltar)*dl1 + betsf=betDs(nbpsf,i2,iclpro,icltar)*dl + & +betDs(nbpsf,i1,iclpro,icltar)*dl1 + betsh=betDs(1,i2,iclpro,icltar)*dl + & +betDs(1,i1,iclpro,icltar)*dl1 + gamsf=gamDs(nbpsf,i2,iclpro,icltar)*dl + & +gamDs(nbpsf,i1,iclpro,icltar)*dl1 + gamsh=gamDs(1,i2,iclpro,icltar)*dl + & +gamDs(1,i1,iclpro,icltar)*dl1 + delsf=delDs(nbpsf,i2,iclpro,icltar)*dl + & +delDs(nbpsf,i1,iclpro,icltar)*dl1 + delsh=delDs(1,i2,iclpro,icltar)*dl + & +delDs(1,i1,iclpro,icltar)*dl1 + + +c For the Plots + parDf(1,3)=alpsf + parDf(2,3)=betsf + parDf(3,3)=alpsh + parDf(4,3)=betsh + + endif + +c if energy too small to have semi-hard interaction -> only soft diagram + + if(smaxDf.lt.sfshlim.and.idxD0.eq.0)then !no hard: soft+hard=soft + alpsf=alpsf/2. + alpsh=alpsf + betsh=betsf + gamsh=gamsf + delsh=delsf + endif + + + +c Print results + + if(ish.ge.4)then + write(ifch,*)"parameters for iclpro:",iclpro + write(ifch,*)"alp,bet,gam,del sf:",alpsf,betsf,gamsf,delsf + write(ifch,*)"alp,bet,gam,del sh:",alpsh,betsh,gamsh,delsh + endif + + +c Record parameters + + + alpD(idxD0,iclpro,icltar)=alpsf + alpDp(idxD0,iclpro,icltar)=0. + alpDpp(idxD0,iclpro,icltar)=0. + betD(idxD0,iclpro,icltar)=betsf + betDp(idxD0,iclpro,icltar)=betsf + betDpp(idxD0,iclpro,icltar)=betsf + gamD(idxD0,iclpro,icltar)=gamsf + delD(idxD0,iclpro,icltar)=delsf + + alpD(1,iclpro,icltar)=alpsh + alpDp(1,iclpro,icltar)=0. + alpDpp(1,iclpro,icltar)=0. + betD(1,iclpro,icltar)=betsh + betDp(1,iclpro,icltar)=betsh + betDpp(1,iclpro,icltar)=betsh + gamD(1,iclpro,icltar)=gamsh + delD(1,iclpro,icltar)=delsh + + if(iomega.lt.2.and.alpdif.ne.1.)then + alpDp(2,iclpro,icltar)=0. + alpDpp(2,iclpro,icltar)=0. + betD(2,iclpro,icltar)=0. !max(0.,betsf) + alpdifs=alpdif +c alpdif=0.99 + betDp(2,iclpro,icltar)=-alpdifs+alppar + betDpp(2,iclpro,icltar)=-alpdifs+alppar +c alpD(2,iclpro,icltar)=(alpsf+alpsh)*wdiff(iclpro)*wdiff(icltar) + alpD(2,iclpro,icltar)=wdiff(iclpro)*wdiff(icltar) + & /utgam1(1.-alpdifs)**2 + & *utgam1(2.-alpdifs+alplea(iclpro)) + & *utgam1(2.-alpdifs+alplea(icltar)) + & /chad(iclpro)/chad(icltar) +c alpdif=alpdifs + gamD(2,iclpro,icltar)=0. + delD(2,iclpro,icltar)=4.*.0389*(gwidth*(r2had(iclpro) + & +r2had(icltar))+slopoms*log(smaxDf)) + else + alpD(2,iclpro,icltar)=0. + alpDp(2,iclpro,icltar)=0. + alpDpp(2,iclpro,icltar)=0. + betD(2,iclpro,icltar)=0. + betDp(2,iclpro,icltar)=0. + betDpp(2,iclpro,icltar)=0. + gamD(2,iclpro,icltar)=0. + delD(2,iclpro,icltar)=1. + endif + if(ish.ge.4)write(ifch,*)"alp,bet,betp,del dif:" + & ,alpD(2,iclpro,icltar),betD(2,iclpro,icltar) + & ,betDp(2,iclpro,icltar),delD(2,iclpro,icltar) + + + bmxdif(iclpro,icltar)=conbmxdif() !important to do it before kfit, because it's used in. +c call Kfit(-1) !xkappafit not used : if arg=-1, set xkappafit to 1 + if(isetcs.le.1)then + if(isetcs.eq.0)then + call Kfit(-1) !xkappafit not used : if arg=-1, set xkappafit to 1) + else +c call Kfit(-1) !xkappafit not used : if arg=-1, set xkappafit to 1) + call Kfit(iclegy) + endif +c for plots record alpDs, betDs, etc ... + alpDs(idxD0,iclegy,iclpro,icltar)=alpsf + alpDps(idxD0,iclegy,iclpro,icltar)=0. + alpDpps(idxD0,iclegy,iclpro,icltar)=0. + betDs(idxD0,iclegy,iclpro,icltar)=betsf + betDps(idxD0,iclegy,iclpro,icltar)=betsf + betDpps(idxD0,iclegy,iclpro,icltar)=betsf + gamDs(idxD0,iclegy,iclpro,icltar)=gamsf + delDs(idxD0,iclegy,iclpro,icltar)=delsf + + alpDs(1,iclegy,iclpro,icltar)=alpsh + alpDps(1,iclegy,iclpro,icltar)=0. + alpDpps(1,iclegy,iclpro,icltar)=0. + betDs(1,iclegy,iclpro,icltar)=betsh + betDps(1,iclegy,iclpro,icltar)=betsh + betDpps(1,iclegy,iclpro,icltar)=betsh + gamDs(1,iclegy,iclpro,icltar)=gamsh + delDs(1,iclegy,iclpro,icltar)=delsh + endif + + enddo + + if(iclpro.ne.iclprosave)stop'problem in parini with iclpro' + +c initialize some variable for screening + if(iscreen.ne.0)then + fegypp=epscrw*fscra(engy/egyscr) + b2xscr=2.*epscrp*4.*.0389 + & *(r2had(iclpro)+r2had(icltar)+slopom*log(engy**2)) +c caculate the radius where Z is saturated at epscrx to define the bases +c of nuclear shadowing + satrad=0. + if(fegypp.gt.0.)satrad=-b2xscr*log(epscrx/fegypp) + bglaubx=zbrads*sqrt(max(0.1,satrad)) + zbcutx=zbcut*bglaubx +c print *,'---->',bglaubx,zbcutx + endif + + if(ish.ge.4)then !check PhiExact value for x=1 + y=Phiexact(0.,0.,1.,1.d0,1.d0,smaxDf,0.) + write(ifch,*)'PhiExact=',y + endif + + call utprix('parini',ish,ishini,3) + + return + end + +c---------------------------------------------------------------------- + subroutine Class(text) +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incpar' + parameter (eps=1.e-5) !to correct for precision problem) + character*10 text + if(iclegy1.eq.iclegy2)then + iclegy=iclegy1 + else + iclegy=1+int( (log(engy)-log(egylow))/log(egyfac) + eps ) !energy class + if(iclegy.gt.iclegy2)then + write(ifch,*)'***********************************************' + write(ifch,*)'Warning in ',text + write(ifch,*)'Energy above the range used for the fit of D:' + write(ifch,*)egylow*egyfac**(iclegy1-1),egylow*egyfac**iclegy2 + write(ifch,*)'***********************************************' + iclegy=iclegy2 + endif + if(iclegy.lt.iclegy1)then + write(ifch,*)'***********************************************' + write(ifch,*)'Warning in ',text + write(ifch,*)'Energy below the range used for the fit of D:' + write(ifch,*)egylow*egyfac**(iclegy1-1),egylow*egyfac**iclegy2 + write(ifch,*)'***********************************************' + iclegy=iclegy1 + endif + endif + end + +c---------------------------------------------------------------------- + subroutine param +c---------------------------------------------------------------------- +c Set the parameter of the parametrisation of the eikonale. +c We group the parameters into 4 array with a dimension of idxD1(=1) +c to define xDfit (see below). +c +c xDfit=Sum(i,0,1)(alpD(i)*xp**betDp(i)*xm**betDpp(i)*s**betD(i) +c *xs**(gamD(i)*b2)*exp(-b2/delD(i)) +c +c subroutine used for tabulation. +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + +c Initialisation of the variables + + emaxDf=egyfac**(iclegy-1)*egylow + smaxDf=emaxDf**2 + + spmin=4.*q2min !Definition of spmin in psvin (epos-sha) + sfshlim=3.*spmin + nptf=10 + xmaxDf=1.d0 + xminDf=1d0/dble(smaxDf) + xshmin=3.d-2 !minimum limit for sh variance fit + if(smaxDf.lt.sfshlim) xshmin=1.d0 + xfitmin=0.1d0 !sh fitted between f(1) and f(1)*xfitmin + if(smaxDf.lt.sfshlim) xfitmin=1.d0 + bmaxDf=2. + + + if(idxD0.ne.0.and.idxD1.ne.1) stop "* idxD0/1 are not good! *" + + engytmp=engy + engy=emaxDf + +c Initialisation of the parameters + + do i=1,nbpf + do j=1,4 + parDf(i,j)=1. + enddo + enddo + +c.......Calculations of the parameters + +c First try for fit parameters + +c linear fit of the 2 components of G as a function of x + call pompar(alpsf,betsf,0) !soft + call pompar(alpsh,betsh,1) !sh +c Gaussian fit of the 2 components of G as a function of x and b + call variance(delsf,gamsf,0) + call variance(delsh,gamsh,1) + gamsf=max(0.,gamsf) + gamsh=max(0.,gamsh) + +c Fit GFF + +c fit parameters + numminDf=3 !minimum indice + numparDf=4 !maximum indice + betac=100. !temperature for chi2 + betae=1. !temperature for error + fparDf=0.8 !variation amplitude for range + + nmcxDf=20000 !number of try for x fit + +c starting values + + parDf(1,3)=alpsf + parDf(2,3)=betsf + parDf(3,3)=alpsh + parDf(4,3)=betsh + +c if(smaxDf.ge.3.*sfshlim)then +c call paramx !alpD and betD +c +c call pompar(alpsf,betsf,-1) !soft (taking into account hard) +c parDf(1,3)=alpsf +c parDf(2,3)=max(-0.95+alppar,betsf) +c +c endif + + alpsf=parDf(1,3) + betsf=parDf(2,3) + alpsh=parDf(3,3) + betsh=parDf(4,3) + + if(ish.ge.4)then + write(ifch,*)"param: fit parameters :",iscreen,iclpro,icltar + * ,iclegy,engy + write(ifch,*)"alp,bet,gam,del sf:",alpsf,betsf,gamsf,delsf + write(ifch,*)"alp,bet,gam,del sh:",alpsh,betsh,gamsh,delsh + endif + + alpDs(idxD0,iclegy,iclpro,icltar)=alpsf + alpDps(idxD0,iclegy,iclpro,icltar)=betsf + alpDpps(idxD0,iclegy,iclpro,icltar)=0. + betDs(idxD0,iclegy,iclpro,icltar)=betsf + betDps(idxD0,iclegy,iclpro,icltar)=betsf + betDpps(idxD0,iclegy,iclpro,icltar)=betsf + gamDs(idxD0,iclegy,iclpro,icltar)=gamsf + delDs(idxD0,iclegy,iclpro,icltar)=delsf + + alpDs(1,iclegy,iclpro,icltar)=alpsh + alpDps(1,iclegy,iclpro,icltar)=betsh + alpDpps(1,iclegy,iclpro,icltar)=0. + betDs(1,iclegy,iclpro,icltar)=betsh + betDps(1,iclegy,iclpro,icltar)=betsh + betDpps(1,iclegy,iclpro,icltar)=betsh + gamDs(1,iclegy,iclpro,icltar)=gamsh + delDs(1,iclegy,iclpro,icltar)=delsh + + engy=engytmp + + return + end + + +c---------------------------------------------------------------------- + + subroutine pompar(alpha,beta,iqq) + +c---------------------------------------------------------------------- +c Return the power beta and the factor alpha of the fit of the eikonal +c of a pomeron of type iqq : D(X)=alpha*(X)**beta +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + double precision X,D1,D0,X0,D,droot + double precision Dsoftshval,xmax + dimension xlnXs(maxdataDf),xlnD(maxdataDf),sigma(maxdataDf) + + do i=1,nptf + sigma(i)=1.e-2 + enddo + + if(iqq.le.0) then + + iscr=iqq + xmax=min(0.1d0,10.d0*xminDf) + X0=xminDf + if(ish.ge.4)write (ifch,*) 'pompar (0) x0,xmax=',X0,xmax + + do i=0,nptf-1 + X=X0 + if (i.ne.0) X=X*(xmax/X0)**(dble(i)/dble(nptf-1)) + D=max(1.d-10,Dsoftshval(sngl(X)*smaxDf,X,0.d0,0.,iscr)) + if(D.eq.1.d-10)then + write(ifch,*) + & "Warning in pompar ! Dsoftshval(0) could be negative" + sigma(i+1)=1.e5 + endif + xlnXs(i+1)=sngl(dlog(X*dble(smaxDf))) + xlnD(i+1)=sngl(dlog(D)) + enddo + + +c Fit of D(X) between X0 and xmax + + call fit(xlnXs,xlnD,nptf,sigma,0,a,beta) + if(beta.gt.10.)beta=10. + + alpha=exp(a) +c alpha=sngl(Dsoftshval(sngl(X0)*smaxDf,X0,0.d0,0.,iscr)) +c & *(sngl(X0)*smaxDf)**(-beta) + + + elseif(iqq.eq.1.and.xfitmin.ne.1.d0) then + + iscr=2 +c xmax=max(0.01d0,min(1d0,dble(sfshlim*100./smaxDf))) + xmax=1d0!min(1d0,dble(sfshlim*1000./smaxDf)) + +c Definition of D0=D(X0) + + D1=Dsoftshval(sngl(xmax)*smaxDf,xmax,0.d0,0.,iscr) + + D0=xfitmin*D1 + +c Calculation of X0 and D(X) + + X0=droot(D0,D1,xmax,iscr) + if(ish.ge.4)write (ifch,*) 'pompar (1) x0,xmax=',X0,xmax + + do i=0,nptf-1 + X=X0 + if (i.ne.0) X=X*(xmax/X0)**(dble(i)/dble(nptf-1)) + D=max(1.d-10,Dsoftshval(sngl(X)*smaxDf,X,0.d0,0.,iscr)) + if(D.eq.1.d-10)then + write(ifch,*) + & "Warning in pompar ! Dsoftshval(1) could be negative" + sigma(i+1)=1.e5 + endif + xlnXs(i+1)=sngl(dlog(X*dble(smaxDf))) + xlnD(i+1)=sngl(dlog(D)) + enddo + + +c Fit of D(X) between X0 and xmax + + call fit(xlnXs,xlnD,nptf,sigma,0,a,beta) + if(beta.gt.10.)beta=10. + + alpha=exp(a) +c alpha=sngl(Dsoftshval(sngl(xmax)*smaxDf,xmax,0.d0,0.,iscr)) +c & *(sngl(xmax)*smaxDf)**(-beta) + + + elseif(iqq.eq.10.and.xfitmin.ne.1.d0) then ! iqq=10 + + iscr=0 + xmax=1.d0 !2.d0/max(2.d0,dlog(dble(smaxDf)/1.d3)) + +c Definition of D0=D(X0) + + D1=Dsoftshval(sngl(xmax)*smaxDf,xmax,0.d0,0.,iscr) + + D0=xfitmin*D1 + +c Calculation of X0 and D(X) + + X0=droot(D0,D1,xmax,iscr) + if(ish.ge.4)write (ifch,*) 'pompar (1) x0,xmax=',X0,xmax + + do i=0,nptf-1 + X=X0 + if (i.ne.0) X=X*(xmax/X0)**(dble(i)/dble(nptf-1)) + D=max(1.d-10,Dsoftshval(sngl(X)*smaxDf,X,0.d0,0.,iscr)) + if(D.eq.1.d-10)then + write(ifch,*) + & "Warning in pompar ! Dsoftshval(10) could be negative" + sigma(i+1)=1.e5 + endif + xlnXs(i+1)=sngl(dlog(X*dble(smaxDf))) + xlnD(i+1)=sngl(dlog(D)) + enddo + + +c Fit of D(X) between X0 and xmax + + call fit(xlnXs,xlnD,nptf,sigma,0,a,beta) + if(beta.gt.10.)beta=10. + + alpha=sngl(Dsoftshval(sngl(xmax)*smaxDf,xmax,0.d0,0.,iscr)) + & *(sngl(xmax)*smaxDf)**(-beta) + + + + else !iqq=-1 or iqq=1 and xfitmin=1 + +c Calculation of X0 and D(X) + iscr=0 + + X0=1.d0/dble(smaxDf) + xmax=max(2.d0/dble(smaxDf), + & min(max(0.03d0,dble(smaxDf)/2.d5),0.1d0)) + + if(ish.ge.4)write (ifch,*) 'pompar (-1) x0,xmax=',X0,xmax + + do i=0,nptf-1 + X=X0 + if (i.ne.0) X=X*(xmax/X0)**(dble(i)/dble(nptf-1)) + D=max(1.d-10,Dsoftshval(sngl(X)*smaxDf,X,0.d0,0.,iscr)) + if(D.eq.1.d-10)then + write(ifch,*) + & "Warning in pompar ! Dsoftshval(-1) could be negative" + sigma(i+1)=1.e5 + endif + xlnXs(i+1)=sngl(dlog(X*dble(smaxDf))) + xlnD(i+1)=sngl(dlog(D)) + enddo + +c Fit of D(X) between X0 and xmax + + call fit(xlnXs,xlnD,nptf,sigma,0,a,beta) + if(beta.gt.10.)beta=10. + + + alpha=exp(a) +c alpha=sngl(Dsoftshval(sngl(xmax)*smaxDf,xmax,0.d0,0.,iscr)) +c & *(sngl(xmax)*smaxDf)**(-beta) + endif + + if(ish.ge.4)write(ifch,*) '%%%%%%%%%%%%% pompar %%%%%%%%%%%%%' + if(ish.ge.4)write(ifch,*) 'alpD ini =',alpha,' betD ini=',beta + + return + end + +c---------------------------------------------------------------------- + + double precision function droot(d0,d1,xmax,iscr) + +c---------------------------------------------------------------------- +c Find x0 which gives f(x0)=D(x0*S)-d0=0 +c iqq=0 soft pomeron +c iqq=1 semi-hard pomeron +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + double precision Dsoftshval,d0,d1,d2,x0,x1,x2,f0,f1,f2,xmax + parameter (kmax=1000) + + + k=0 + x0=max(1.d0/dble(sfshlim),1d-5) + x1=xmax + 5 d2=dabs(Dsoftshval(sngl(x0)*smaxDf,x0,0.d0,0.,iscr)) + if(d2.lt.1.d-10.and.x0.lt.x1)then + x0=dsqrt(x0*x1) +c write(ifch,*)"droot",x0,x1,d0,d1,d2 + goto 5 + elseif(d2.gt.d0)then + droot=x0 +c write(ifch,*)"droot",x0,x1,d0,d1,d2 + return + endif + f0=d2-d0 + f1=d1-d0 + if(f0*f1.lt.0.d0)then + + + 10 x2=dsqrt(x0*x1) + d2=dabs(Dsoftshval(sngl(x2)*smaxDf,x2,0.d0,0.,iscr)) + f2=d2-d0 + k=k+1 +c write (ifch,*) '******************* droot **************' +c write (ifch,*) x0,x1,x2,f0,f1,f2 + + if (f0*f2.lt.0.D0) then + x1=x2 + f1=f2 + else + x0=x2 + f0=f2 + endif + + if (dabs((x1-x0)/x1).gt.(1.D-5).and.k.le.kmax.and.x1.ne.x0) then + goto 10 + else + if (k.gt.kmax) then + write(ifch,*)'??? Warning in Droot: Delta=',dabs((x1-x0)/x1) +c.........stop 'Error in Droot, too many steps' + endif + droot=dsqrt(x1*x0) + endif + + else + droot=dsqrt(x1*x0) + endif + + return + end + +c---------------------------------------------------------------------- + + double precision function drootom(d0,dmax,bmax,eps) + +c---------------------------------------------------------------------- +c Find b0 which gives f(b0)=(1-exp(-om(b0,iqq)))/dmax-d0=0 + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + double precision om1intbc,d0,d1,d2,f0,f1,f2,dmax + parameter (kmax=1000) + + + k=0 + b0=0. + b1=bmax + d2=(1.d0-exp(-om1intbc(b1)))/dmax + if(d2.gt.d0)then + drootom=b1 +c write(*,*)"drootom exit (1)",b0,b1,d0,d1,d2 + return + endif + d1=(1.d0-exp(-om1intbc(b0)))/dmax + f0=d1-d0 + f1=d2-d0 + if(f0*f1.lt.0.d0)then + + + 10 b2=0.5*(b0+b1) + d2=(1.d0-dexp(-om1intbc(b2)))/dmax + f2=d2-d0 + k=k+1 +c write (*,*) '******************* drootom **************' +c write (*,*) b0,b1,b2,f0,f1,f2 + + if (f1*f2.lt.0.D0) then + b0=b2 + f0=f2 + else + b1=b2 + f1=f2 + endif + + if (abs(f2).gt.eps.and.k.le.kmax.and.b1.ne.b0) then + goto 10 + else + if (k.gt.kmax) then + write(ifch,*)'??? Warning in Drootom: Delta=',abs((b1-b0)/b1) +c.........stop 'Error in Droot, too many steps' + endif + drootom=0.5*(b1+b0) + endif + + else +c write(*,*)"drootom exit (2)",b0,b1,d0,d1,d2 + drootom=0.5*(b1+b0) + endif + + return + end + +c---------------------------------------------------------------------- + subroutine variance(r2,alp,iqq) +c---------------------------------------------------------------------- +c fit sigma2 into : 1/sigma2(x)=1/r2-alp*log(x*s) +c iqq=0 -> soft pomeron +c iqq=1 -> semi-hard pomeron +c iqq=2 -> sum +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + dimension Xs(maxdataDf),vari(maxdataDf),sigma(maxdataDf) + double precision X,X0,xmax + + do i=1,nptf + sigma(i)=1.e-2 + enddo + + if(iqq.eq.0.or.xshmin.gt.0.95d0)then + X0=xminDf + xmax=xmaxDf + elseif(iqq.eq.2)then + X0=xshmin + xmax=xmaxDf + else + X0=1d0/dlog(max(exp(2.d0),dble(smaxDf)/1.d3)) +c if(smaxDf.lt.100.*q2min)X0=.95d0 + xmax=xmaxDf + endif + if(iqq.ne.3.and.iqq.ne.4)then + + do i=0,nptf-1 + X=X0 + if (i.ne.0) X=X*(xmax/X0)**(dble(i)/dble(nptf-1)) + Xs(i+1)=log(sngl(X)*smaxDf) + sig2=sigma2(X,iqq) + if(sig2.le.0.) call utstop + & ('In variance, initial(1) sigma2 not def!&') + vari(i+1)=1./sig2 + enddo + +c Fit of the variance of D(X,b) between X0 and xmaxDf + + call fit(Xs,vari,nptf,sigma,0,tr2,talp) + r2=1./tr2 + alp=-talp +c in principle, the formula to convert 1/(del+eps*log(sy)) into +c 1/del*(1-eps/del*log(sy)) is valid only if eps/del*log(sy)=alp*r2*log(sy) +c is small. In practice, since the fit of G(x) being an approximation, each +c component of the fit should not be taken separatly but we should consider +c G as one function. Then it works even with large alp (gamD). +c ttt=alp*r2*log(smaxDf) +c if(ttt.gt.0.5) +c & write(ifmt,*)'Warning, G(b) parametrization not optimal : ', +c & 'gamD too large compared to delD !',ttt + else + if(iqq.eq.3)r2=sigma2(xmaxDf,3) + if(iqq.eq.4)r2=sigma2(xshmin,3) + if(r2.le.0.) call utstop + &('In variance, initial(2) sigma2 not def!&') + alp=0. + endif + + if(ish.ge.4)then + write(ifch,*) '%%%%%%%%%% variance ini %%%%%%%%%%%%' + write(ifch,*) 'X0=',X0 + write(ifch,*) 'delD ini=',r2 + write(ifch,*) 'gamD ini=',alp + endif + + return + end + + + +c---------------------------------------------------------------------- + + function sigma2(x,iqq) + +c---------------------------------------------------------------------- +c Return the variance for a given x of : +c For G : +c iqq=0 the soft pomeron +c iqq=1 the semi-hard and valence quark pomeron +c iqq=2 the sum +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + double precision x,Dsoftshval,sfsh,om51p,eps,range,sig2!,omNpuncut + external varifit + double precision varifit,Db(maxdataDf),bf(maxdataDf) + + bmax=bmaxDf + sig2=bmax*0.5 + bmin=-bmax + eps=1.d-10 + ierro=0 + + if(iqq.eq.0)then + range=sig2 + sfsh=om51p(sngl(x)*smaxDf,x,0.d0,0.,0) + if (dabs(sfsh).gt.eps) then + do i=0,nptf-1 + bf(i+1)=dble(bmin+float(i)*(bmax-bmin)/float(nptf-1)) + Db(i+1)=om51p(sngl(x)*smaxDf,x,0.d0,sngl(bf(i+1)),0)/sfsh + enddo + else + ierro=1 + endif + elseif(iqq.eq.1.and.xshmin.lt..95d0)then + range=sig2 + sfsh=0.d0 + do j=1,4 + sfsh=sfsh+om51p(sngl(x)*smaxDf,x,0.d0,0.,j) + enddo + if (dabs(sfsh).gt.eps) then + do i=0,nptf-1 + bf(i+1)=dble(bmin+float(i)*(bmax-bmin)/float(nptf-1)) + Db(i+1)=0.d0 + do j=1,4 + Db(i+1)=Db(i+1)+om51p(sngl(x)*smaxDf,x,0.d0,sngl(bf(i+1)),j) + enddo + Db(i+1)=Db(i+1)/sfsh + enddo + else + ierro=1 + endif + else + sig2=2.d0*sig2 + range=sig2 + iscr=0 + sfsh=Dsoftshval(sngl(x)*smaxDf,x,0.d0,0.,iscr) + if (dabs(sfsh).gt.eps) then + do i=0,nptf-1 + bf(i+1)=dble(bmin+float(i)*(bmax-bmin)/float(nptf-1)) + Db(i+1)=Dsoftshval(sngl(x)*smaxDf,x,0.d0,sngl(bf(i+1)),iscr) + & /sfsh + enddo + else + ierro=1 + endif + endif + +c Fit of D(X,b) between -bmaxDf and bmaxDf + + if(ierro.ne.1)then + nptft=nptf + call minfit(varifit,bf,Db,nptft,sig2,range) + sigma2=sngl(sig2) + else + sigma2=0. + endif + + return + end + +c---------------------------------------------------------------------- + + subroutine paramx + +c---------------------------------------------------------------------- +c updates the 4 parameters alpsf,betsf,alpsh,betsh by fitting GFF +c parDf(1,3) parDf(2,3) ... alp, bet soft +c parDf(3,3) parDf(4,3) ... alp, bet semihard +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + + double precision Dsoftshpar + + external Dsoftshpar + + dimension range(nbpf) + + call givedatax + + !determine parameter range + do i=numminDf,numparDf + range(i)=fparDf*parDf(i,3) + parDf(i,1)=parDf(i,3)-range(i) + parDf(i,2)=parDf(i,3)+range(i) + enddo + + + ! write(ifch,*) '%%%%%%%%%%%%%%%%%%% fitx %%%%%%%%%%%%%%%%%%%%%%%' + + call fitx(Dsoftshpar,nmcxDf,chi2,err) + + ! write(ifch,*) 'chi2=',chi2 + ! write(ifch,*) 'err=',err + ! write(ifch,*) 'alpD(1)=',parDf(1,3),' betD(1)=',parDf(2,3) + ! write(ifch,*) 'alpD(2)=',parDf(3,3),' betD(2)=',parDf(4,3) + + return + end + + +c---------------------------------------------------------------------- + subroutine givedatax +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + double precision X,X0,X1,Dsoftshval,Xseuil + + numdataDf=nptf + + X0=xminDf + X1=xmaxDf + Xseuil=1d0 !min(1.d0,dble(sfshlim*1e4)*XminDf) +c print *,'--------------->',Xseuil + +c Fit of G(X) between X0 and X1 + do i=0,nptf-1 + X=X0 + if (i.ne.0) X=X*(X1/X0)**(dble(i)/dble(nptf-1)) + datafitD(i+1,2)=max(1.e-10, + & sngl(Dsoftshval(sngl(X)*smaxDf,X,0.d0,0.,1))) + datafitD(i+1,1)=sngl(X) + datafitD(i+1,3)=1. + if (X.gt.Xseuil) + & datafitD(i+1,3)=exp(-min((sngl(Xseuil/X)-1.),50.)) + enddo + + return + end + + + + + +c---------------------------------------------------------------------- + + function sigma1i(x) + +c---------------------------------------------------------------------- +c Return the variance of the sum of the soft pomeron and the semi-hard +c pomeron for a given x. +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + double precision x,Dsoftshval,Dint + + + iscr=0 + Dint=Dsoftshval(sngl(x)*smaxDf,x,0.d0,0.,iscr) + + sigma1i=0. + if(Dint.ne.0.) + &sigma1i=sngl(-1.d0/dlog(Dsoftshval(sngl(x)*smaxDf,x,0.d0,1.,iscr) + & /Dint)) + + + return + end + + +c---------------------------------------------------------------------- + + SUBROUTINE minfit(func,x,y,ndata,a,range) + +c---------------------------------------------------------------------- +c Given a set of data points x(1:ndata),y(1:ndata), and the range of +c the parameter a, fit it on function func by minimizing chi2. +c In input a define the expected value of a, and on output they +c correspond to the fited value. +c --------------------------------------------------------------------- + include 'epos.inc' + double precision x(ndata),y(ndata),func,a,range,Smin,Som,a1,a2,eps + *,amin,rr,yp + parameter (eps=1.d-5) + external func + + + Smin=1.d20 + amin=a + + + + a1=a-range + a2=a+range + + do j=1,2000 + rr=dble(rangen()) + a=a1+(a2-a1)*rr + k=0 + + 10 if(a.lt.0.d0.and.k.lt.100) then + rr=dble(rangen()) + a=a1+(a2-a1)*rr + k=k+1 + goto 10 + endif + if(k.ge.100) call utstop + &('Always negative variance in minfit ...&') + + Som=0.d0 + do k=1,ndata + yp=min(1.d10,func(x(k),a)) !proposal function + Som=Som+(yp-y(k))**2.d0 + enddo + if(Som.lt.Smin)then + + if(Smin.lt.1.)then + if(a.gt.amin)then + a1=amin + else + a2=amin + endif + endif + amin=a + Smin=Som + endif + if(Smin.lt.eps)goto 20 + enddo + + 20 continue + a=amin + + return + end + + + +c---------------------------------------------------------------------- + subroutine fitx(func,nmc,chi2,err) +c---------------------------------------------------------------------- +c Determines parameters of the funcion func +c representing the best fit of the data. +c At the end of the run, the "best" parameters are stored in parDf(n,3). +c The function func has to be defined via "function" using the parameters +c parDf(n,3), n=1,numparDf . +c Parameters as well as data are stored on /fitpar/: +c numparDf: number of parameters (input) +c parDf: array containing parameters: +c parDf(n,1): lower limit (input) +c parDf(n,2): upper limit (input) +c parDf(n,3): current parameter (internal and output = final result) +c parDf(n,4): previous parameter (internal) +c numdataDf: number of data points (input) +c datafitD: array containing data: +c datafitD(i,1): x value (input) +c datafitD(i,2): y value (input) +c datafitD(i,3): error (input) +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + double precision func,x + external func + + ! write (ifch,*) 'numparDf,numminDf',numparDf,numminDf + + +c initial configuration (better if one start directly with initial one) + +c do n=numminDf,numparDf +c parDf(n,3)=parDf(n,1)+rangen()*(parDf(n,2)-parDf(n,1)) +c enddo + + chi2=0. + err=0. + do i=1,numdataDf + x=dble(datafitD(i,1)) + fx=sngl(func(x)) + chi2=chi2+(log(fx)-log(datafitD(i,2)))**2/datafitD(i,3)**2 + err=err+(log(fx)-log(datafitD(i,2)))/datafitD(i,3)**2 + enddo + err=abs(err)/float(numdataDf) + +c metropolis iteration + + do i=1,nmc +c if(mod(i,int(float(nmc)/1000.)).eq.0)then + betac=betac*(1.+1./float(nmc))!1.05 + betae=betae*(1.+1./float(nmc))!1.05 +c endif +c if(mod(i,int(float(nmc)/20.)).eq.0)write(ifch,*)i,chi2,err + + do n=numminDf,numparDf + parDf(n,4)=parDf(n,3) + enddo + chi2x=chi2 + errx=err + + n=numminDf+int(rangen()*(numparDf-numminDf+1)) + n=max(n,numminDf) + n=min(n,numparDf) +c if(mod(i,int(float(nmc)/20.)).eq.0)write(ifch,*)n + + parDf(n,3)=parDf(n,1)+rangen()*(parDf(n,2)-parDf(n,1)) + chi2=0 + err=0 + do j=1,numdataDf + x=dble(datafitD(j,1)) + fx=sngl(func(x)) + chi2=chi2+(log(fx)-log(datafitD(j,2)))**2/datafitD(j,3)**2 + err=err+(log(fx)-log(datafitD(j,2)))/datafitD(j,3)**2 + enddo + err=abs(err)/float(numdataDf) + + if(chi2.gt.chi2x.and.rangen() + $ .gt.exp(-min(50.,max(-50.,betac*(chi2-chi2x)))) + & .or.err.gt.errx.and.rangen() + $ .gt.exp(-min(50.,max(-50.,betae*(err-errx)))) + & ) then + do n=numminDf,numparDf + parDf(n,3)=parDf(n,4) + enddo + chi2=chi2x + err=errx + endif + + enddo + + return + end + + +c---------------------------------------------------------------------- + + SUBROUTINE fit(x,y,ndata,sig,mwt,a,b) + +c---------------------------------------------------------------------- +c Given a set of data points x(1:ndata),y(1:ndata) with individual standard +c deviations sig(1:ndata), fit them to a straight line y = a + bx by +c minimizing chi2 . +c Returned are a,b and their respective probable uncertainties siga and sigb, +c the chiÂsquare chi2, and the goodness-of-fit probability q (that the fit +c would have chi2 this large or larger). If mwt=0 on input, then the standard +c deviations are assumed to be unavailable: q is returned as 1.0 and the +c normalization of chi2 is to unit standard deviation on all points. +c --------------------------------------------------------------------- + + implicit none + INTEGER mwt,ndata + REAL sig(ndata),x(ndata),y(ndata) + REAL a,b,siga,sigb,chi2 !,q + INTEGER i + REAL sigdat,ss,st2,sx,sxoss,sy,t,wt + + + sx=0. !Initialize sums to zero. + sy=0. + st2=0. + b=0. + if(mwt.ne.0) then ! Accumulate sums ... + ss=0. + do i=1,ndata !...with weights + wt=1./(sig(i)**2) + ss=ss+wt + sx=sx+x(i)*wt + sy=sy+y(i)*wt + enddo + else + do i=1,ndata !...or without weights. + sx=sx+x(i) + sy=sy+y(i) + enddo + ss=float(ndata) + endif + sxoss=sx/ss + if(mwt.ne.0) then + do i=1,ndata + t=(x(i)-sxoss)/sig(i) + st2=st2+t*t + b=b+t*y(i)/sig(i) + enddo + else + do i=1,ndata + t=x(i)-sxoss + st2=st2+t*t + b=b+t*y(i) + enddo + endif + b=b/st2 !Solve for a, b, oe a , and oe b . + a=(sy-sx*b)/ss + siga=sqrt((1.+sx*sx/(ss*st2))/ss) + sigb=sqrt(1./st2) + chi2=0. !Calculate chi2 . +c q=1. + if(mwt.eq.0) then + do i=1,ndata + chi2=chi2+(y(i)-a-b*x(i))**2 + enddo + +c For unweighted data evaluate typical sig using chi2, and adjust +c the standard deviations. + + sigdat=sqrt(chi2/(ndata-2)) + siga=siga*sigdat + sigb=sigb*sigdat + else + do i=1,ndata + chi2=chi2+((y(i)-a-b*x(i))/sig(i))**2 + enddo + endif + + if(chi2.ge.0.2)then + b=(y(ndata)-y(1))/(x(ndata)-x(1)) + a=y(ndata)-b*x(ndata) + endif + + +c write(*,*) '$$$$$$$$ fit : a,b,siga,sigb,chi2,q $$$$$$$$$' +c write(*,*) a,b,siga,sigb,chi2!??????????????? + + + return + END + + + +c---------------------------------------------------------------------- + + double precision function varifit(x,var) + +c---------------------------------------------------------------------- + double precision x,var + + varifit=dexp(-min(50.d0,x**2.d0/var)) + + return + end + + + +c---------------------------------------------------------------------- + + double precision function Dsoftshval(sy,x,y,b,iscr) + +c---------------------------------------------------------------------- +c iscr=-1 sum of om5p (i), i from 0 to 4 - fit of hard +c iscr=0 sum of om5p (i), i from 0 to 4 +c iscr=1 sum of om5p (i), i from 0 to 4 * F * F +c iscr=2 sum of om5p (i), i from 1 to 4 (semihard + valence quark) +c---------------------------------------------------------------------- + double precision x,om51p,y,xp,xm + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + + Dsoftshval=0.d0 + + if(iscr.le.0)then + do i=0,4 + Dsoftshval=Dsoftshval+om51p(sy,x,y,b,i) + enddo + + + elseif(iscr.eq.1)then + xp=dsqrt(x)*dexp(y) + if(dabs(xp).ge.1.d-15)then + xm=x/xp + else + xm=1.d0 + write(ifch,*)'Warning in Dsoftshval in epos-par' + endif + do i=0,4 + Dsoftshval=Dsoftshval+om51p(sy,x,y,b,i) + enddo + Dsoftshval=Dsoftshval*(1.d0-xm)**dble(alplea(icltar)) + & *(1.d0-xp)**dble(alplea(iclpro)) + elseif(iscr.eq.2)then + do i=1,4 + Dsoftshval=Dsoftshval+om51p(sy,x,y,b,i) + enddo + endif + + + Dsoftshval=2.d0*Dsoftshval + & /(x**dble(-alppar)*dble(chad(iclpro)*chad(icltar))) + + if(iscr.eq.-1.and.parDf(3,3).lt.parDf(1,3))Dsoftshval=Dsoftshval + & -dble(parDf(3,3)*sy**parDf(4,3)) + + return + end + +c---------------------------------------------------------------------- + + double precision function Dsoftshpar(x) + +c---------------------------------------------------------------------- + double precision x,xp,xm + include 'epos.inc' + include 'epos.incpar' + + Dsoftshpar=dble( + & parDf(1,3)*(sngl(x)*smaxDf)**parDf(2,3) + & +parDf(3,3)*(sngl(x)*smaxDf)**parDf(4,3) ) + xp=dsqrt(x) + xm=xp + Dsoftshpar=Dsoftshpar*(1.d0-xm)**dble(alplea(icltar)) + & *(1.d0-xp)**dble(alplea(iclpro)) + Dsoftshpar=min(max(1.d-15,Dsoftshpar),1.d15) + + return + end diff --git a/modules/epos/epos-qsh-lhc.f b/modules/epos/epos-qsh-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..d2ad9f049efffc07090bf208d25f76f366b3581a --- /dev/null +++ b/modules/epos/epos-qsh-lhc.f @@ -0,0 +1,3172 @@ +c reshuffled from sem, sto, sha + +c contains DIS, and unused 3P stuff +c --- --------------- + + + + +c########################################################################### +c########################################################################### +c########################################################################### +c########################################################################### +c +c DIS +c +c########################################################################### +c########################################################################### +c########################################################################### +c########################################################################### + + + + +CDECK ID>, PHO_GPHERA from phojet by Ralph Engel + SUBROUTINE phoGPHERAepo(imod) +C********************************************************************** +C +C interface to call PHOJET (variable energy run) with +C HERA kinematics, photon as particle 2 +C +C equivalent photon approximation to get photon flux +C +C input: imod=0 Main initialization +C 1 Event initialization +C from /photrans/ and /lept1/ +C EE1=ebeam proton energy (LAB system) +C EE2=elepti electron energy (LAB system) +C from /psar12/: +C YMIN2=ydmin lower limit of Y +C (energy fraction taken by photon from electron) +C YMAX2=ydmax upper limit of Y +C Q2MN2=qdmin lower limit of photon virtuality +C Q2MX2=qdmax upper limit of photon virtuality +C +C********************************************************************** + include 'epos.inc' + include 'epos.incsem' + common/photrans/phoele(4),ebeam + double precision pgampr,rgampr + common/cgampr/pgampr(5),rgampr(4) + +c PHOJET common + PARAMETER ( phoPI = 3.14159265359D0 ) + + DOUBLE PRECISION EE1,EE2,PROM2,YMIN2,YMAX2,THMIN2,THMAX2 + & ,ELEM,ELEM2,Q2MN,Q2MX,XIMAX,XIMIN,XIDEL,DELLY + & ,FLUXT,FLUXL,Q2LOW,Y,FFT,FFL,AY,AY2,YY,WGMAX + & ,ECMIN2,ECMAX2,Q22MIN,Q22AVE,Q22AV2,Q22MAX,AN2MIN + & ,AN2MAX,YY2MIN,YY2MAX,EEMIN2,gamNsig0 + & ,Q21MIN,Q21MAX,AN1MIN,AN1MAX,YY1MIN,YY1MAX + SAVE EE1,EE2,PROM2,YMIN2,YMAX2,THMIN2,THMAX2 + & ,ELEM,ELEM2,Q2MN,Q2MX,XIMAX,XIMIN,XIDEL,DELLY + & ,FLUXT,FLUXL,Q2LOW,Y,FFT,FFL,AY,AY2,YY,WGMAX + & ,ECMIN2,ECMAX2,Q22MIN,Q22AVE,Q22AV2,Q22MAX,AN2MIN + & ,AN2MAX,YY2MIN,YY2MAX,EEMIN2,gamNsig0 + & ,Q21MIN,Q21MAX,AN1MIN,AN1MAX,YY1MIN,YY1MAX + INTEGER ITRY,ITRW + SAVE ITRY,ITRW + +C LOCAL VARIABLES + DOUBLE PRECISION PINI(5),PFIN(5),GGECM,PFTHE,YQ2,YEFF,Q2LOG,WGH,Q2 + & ,WEIGHT,Q2E,E1Y,PHI,COF,SIF,WGY,DAY,P1(5),P2(4) + & ,drangen,ALLM97,gamNsig + + + + if(imod.eq.0)then !initialization + + EE1=dble(ebeam) !proton energy (LAB system) + EE2=dble(elepti) !electron energy (LAB system) + + + if(ish.ge.2)WRITE(ifch,*) 'phoGPHERAepo: energy to process' + * ,EE1,EE2 +C assign particle momenta according to HERA kinematics +C proton data + + if(idtarg.ne.0)then + call idmass(idtarg,ams) + else + call idmass(1120,ams) + endif + PROM2 = dble(ams)**2 +C electron data + call idmass(12,ams) + ELEM = dble(ams) + ELEM2 = ELEM**2 +C + Q2MN = dble(qdmin) + Q2MX = dble(qdmax) +C + YMIN2=dble(ydmin) + YMAX2=dble(ydmax) + XIMAX = LOG(YMAX2) + XIMIN = LOG(YMIN2) + XIDEL = XIMAX-XIMIN +C + THMIN2=dble(themin*pi/180.) + THMAX2=dble(themax*pi/180.) +C + IF(Q2MN.GT.ELEM2*YMIN2**2/(1.D0-YMIN2)) + & WRITE(*,'(/1X,A,1P2E11.4)') + & 'phoGPHERAepo: lower Q2 cutoff larger than kin. limit:', + & Q2MN,ELEM2*YMIN2**2/(1.D0-YMIN2) +C + IF(ish.GE.6)THEN + Max_tab = 50 + DELLY = LOG(YMAX2/YMIN2)/DBLE(Max_tab-1) + FLUXT = 0.D0 + FLUXL = 0.D0 + + WRITE(ifch,'(1X,A,I5)') + & 'phoGPHERAepo: table of photon flux (trans/long)',Max_tab + DO 100 I=1,Max_tab + Y = EXP(XIMIN+DELLY*DBLE(I-1)) + Q2LOW = MAX(Q2MN,ELEM2*Y**2/(1.D0-Y)) + FFT = ((1.D0+(1.D0-Y)**2)/Y*LOG(Q2MX/Q2LOW) + & -2.D0*ELEM2*Y*(1.D0/Q2LOW-1.D0/Q2MX))/(2.D0*phoPI*137.D0) + FFL = 2.D0*(1.D0-Y)/Y*LOG(Q2MX/Q2LOW)/(2.D0*phoPI*137.D0) + FLUXT = FLUXT + Y*FFT + FLUXL = FLUXL + Y*FFL + WRITE(ifch,'(5X,1P3E14.4)') Y,FFT,FFL + 100 CONTINUE + FLUXT = FLUXT*DELLY + FLUXL = FLUXL*DELLY + WRITE(ifch,'(1X,A,1P2E12.4)') + & 'PHOGPHERA: integrated flux (trans./long.):',FLUXT,FLUXL + ENDIF +C + + YY = YMIN2 + Q2LOW = MAX(Q2MN,ELEM2*YY**2/(1.D0-YY)) + WGMAX = (1.D0+(1.D0-YY)**2)*LOG(Q2MX/Q2LOW) + & -2.D0*ELEM2*YY*(1.D0/Q2LOW-1.D0/Q2MX)*YY + WGMAX = WGMAX+2.D0*(1.D0-YY)*LOG(Q2MX/Q2LOW) + + ECMIN2 = dble(egymin)**2 + ECMAX2 = dble(egymax)**2 + EEMIN2 = dble(elomin) + AY = 0.D0 + AY2 = 0.D0 + Q22MIN = 1.D30 + Q22AVE = 0.D0 + Q22AV2 = 0.D0 + Q22MAX = 0.D0 + AN2MIN = 1.D30 + AN2MAX = 0.D0 + YY2MIN = 1.D30 + YY2MAX = 0.D0 + ITRY = 0 + ITRW = 0 + gamNsig0 = 5d0 * ALLM97(Q2LOW,WGMAX) + + elseif(imod.eq.1)then !event + +C +C sample y + ITRY = ITRY+1 + ntry=0 + 175 CONTINUE + ntry=ntry+1 + IF(ntry.ge.1000) THEN + WRITE(*,'(1X,A,2E12.5,2(1X,1A,1X,3E13.5))') + & 'phoGPHERAepo: problem with cuts:',PFIN(4),EEMIN2,'|' + & ,THMIN2,PFTHE,THMAX2,'|',ECMIN2,GGECM,ECMAX2 + call utstop("Problem with cuts in phoGPHERAepo !&") + ENDIF + ITRW = ITRW+1 + YY = EXP(XIDEL*drangen(AY)+XIMIN) + YEFF = 1.D0+(1.D0-YY)**2+2.D0*(1.D0-YY) + Q2LOW = MAX(Q2MN,ELEM2*YY**2/(1.D0-YY)) + Q2LOG = LOG(Q2MX/Q2LOW) + WGH = YEFF*Q2LOG-2.D0*ELEM2*YY**2*(1.D0/Q2LOW-1.D0/Q2MX) + IF(WGMAX.LE.WGH) THEN + WRITE(*,'(1X,A,3E12.5)') + & 'phoGPHERAepo: inconsistent weight:',YY,WGMAX,WGH + call utstop("Problem with YY in phoGPHERAepo !$") + ENDIF + IF(drangen(AY2)*WGMAX.GT.WGH) GOTO 175 +C sample Q2 + 185 CONTINUE + Q2 = Q2LOW*EXP(Q2LOG*drangen(YY)) + WEIGHT = (YEFF-2.D0*ELEM2*YY**2/Q2)/YEFF + IF(WEIGHT.GE.1d0) THEN + WRITE(*,'(1X,A,3E12.5)') + & 'phoGPHERAepo: inconsistent weight:',YY,Q2,YEFF,WEIGHT + call utstop("Problem with Q2 in phoGPHERAepo !$") + ENDIF + IF(WEIGHT.LT.drangen(Q2)) GOTO 185 +C + if(ish.ge.2)WRITE(ifch,*) 'phoGPHERAepo: event with Q2,Y:',Q2,YY + +C incoming electron + PINI(1) = 0.D0 + PINI(2) = 0.D0 + PINI(3) = sqrt((EE2+ELEM)*(EE2-ELEM)) + PINI(4) = EE2 + PINI(5) = ELEM +C outgoing electron + YQ2 = SQRT((1.D0-YY)*Q2) + Q2E = Q2/(4.D0*EE2) + E1Y = EE2*(1.D0-YY) + phi=2d0*phoPI*drangen(E1Y) + COF=cos(phi) + SIF=sin(phi) + PFIN(1) = YQ2*COF + PFIN(2) = YQ2*SIF + PFIN(4) = E1Y+Q2E + PFIN(5) = ELEM +c PFIN(3) = E1Y+Q2E + PFIN(3)=(PFIN(4)+sqrt(YQ2*YQ2+ELEM2)) + * *(PFIN(4)-sqrt(YQ2*YQ2+ELEM2)) + if(PFIN(3).ge.0d0)then + PFIN(3) = sqrt(PFIN(3)) + else + PFIN(3) = E1Y+Q2E + endif + GQ2 = sngl(Q2) + GWD = 4.*ebeam*elepti*sngl(YY) +C polar angle + PFTHE = ACOS(PFIN(3)/PFIN(4)) +C electron tagger + IF(PFIN(4).GT.EEMIN2) THEN + IF((PFTHE.LT.THMIN2).OR.(PFTHE.GT.THMAX2)) GOTO 175 + ENDIF +C photon momentum + P2(1) = -PFIN(1) + P2(2) = -PFIN(2) + P2(3) = PINI(3)-PFIN(3) + P2(4) = PINI(4)-PFIN(4) +C proton momentum + P1(1) = 0.D0 + P1(2) = 0.D0 + P1(3) = -SQRT(EE1**2-PROM2) + P1(4) = EE1 + P1(5) = sqrt(prom2) +C ECMS cut + GGECM = (P1(4)+P2(4))**2-(P1(1)+P2(1))**2 + & -(P1(2)+P2(2))**2-(P1(3)+P2(3))**2 + IF((GGECM.LT.ECMIN2).OR.(GGECM.GT.ECMAX2)) GOTO 175 + GGECM = SQRT(GGECM) +C accept A2 and W according to gamma-p cross section (function of F2) + gamNsig=ALLM97(Q2,GGECM)/gamNsig0 + if(gamNsig.ge.1d0)print *,'R>1 in DIS',gamNsig + if(drangen(gamNsig).gt.gamNsig)goto 175 !no interaction +C output + engy=sngl(GGECM) + xbjevt=GQ2/GWD + qsqevt=GQ2 +c gamma + rgampr(1) = P2(1) + rgampr(2) = P2(2) + rgampr(3) = P2(3) + rgampr(4) = P2(4) +c boost gamma in proton rest frame to get the rotation vector + call utlob2(1,P1(1),P1(2),P1(3),P1(4),P1(5) + * ,rgampr(1),rgampr(2),rgampr(3),rgampr(4),99) +c array to define boost needed to put proton from lab to rest frame + pgampr(1) = P1(1) + pgampr(2) = P1(2) + pgampr(3) = P1(3) + pgampr(4) = P1(4) + pgampr(5) = P1(5) +c electron + elepto=sngl(PFIN(4)) + phoele(1) = sngl(PFIN(1)) + phoele(2) = sngl(PFIN(2)) + phoele(3) = sngl(PFIN(3)) + phoele(4) = sngl(PFIN(4)) + + if(ish.ge.2)then !statistic +C statistics + AY = AY+YY + AY2 = AY2+YY*YY + YY1MIN = YY2MIN + YY1MAX = YY2MAX + YY2MIN = MIN(YY2MIN,YY) + YY2MAX = MAX(YY2MAX,YY) + Q21MIN = Q22MIN + Q21MAX = Q22MAX + Q22MIN = MIN(Q22MIN,Q2) + Q22MAX = MAX(Q22MAX,Q2) + Q22AVE = Q22AVE+Q2 + Q22AV2 = Q22AV2+Q2*Q2 + AN1MIN = AN2MIN + AN1MAX = AN2MAX + AN2MIN = MIN(AN2MIN,PFTHE) + AN2MAX = MAX(AN2MAX,PFTHE) + endif +C + elseif(ish.ge.2)then !statistic + + NITER=nrevt + + WGY = WGMAX*DBLE(ITRY)/DBLE(ITRW)/(137.D0*2.D0*phoPI) + WGY = WGY*LOG(YMAX2/YMIN2) + AY = AY/DBLE(NITER) + AY2 = AY2/DBLE(NITER) + Q22AVE = Q22AVE/DBLE(NITER) + Q22AV2 = Q22AV2/DBLE(NITER) + if(NITER.gt.1)then + DAY = SQRT((AY2-AY**2)/DBLE(NITER)) + Q22AV2 = SQRT((Q22AV2-Q22AVE**2)/DBLE(NITER)) + else + DAY = 0d0 + Q22AV2 = 0d0 + endif + SIGMAX = 1d0 + WEIGHT = WGY*SIGMAX*DBLE(NITER)/DBLE(ITRY) +C output of histograms + WRITE(ifch,'(//1X,A,/1X,A,1PE12.3,A,/1X,A)') + &'=========================================================', + &' ***** simulated cross section: ',WEIGHT,' mb *****', + &'=========================================================' + WRITE(ifch,'(//1X,A,3I10)') + & 'PHOGPHERA:SUMMARY:NITER,ITRY,ITRW',NITER,ITRY,ITRW + WRITE(ifch,'(1X,A,1P2E12.4)') 'EFFECTIVE WEIGHT (FLUX,TOTAL)', + & WGY,WEIGHT + WRITE(ifch,'(1X,A,1P2E12.4)') 'AVERAGE Y,DY ',AY + & ,DAY + WRITE(ifch,'(1X,A,1P2E12.4)') 'SAMPLED Y RANGE PHOTON ', + & YY2MIN,YY2MAX + WRITE(ifch,'(1X,A,1P2E12.4)') 'AVERAGE Q2,DQ2 ', + & Q22AVE,Q22AV2 + WRITE(ifch,'(1X,A,1P2E12.4)') 'SAMPLED Q2 RANGE PHOTON ', + & Q22MIN,Q22MAX + WRITE(ifch,'(1X,A,1P4E12.4)') 'SAMPLED THETA RANGE ELECTRON ', + & AN2MIN,AN2MAX,phoPI-AN2MAX,phoPI-AN2MIN +C + + endif + + + END + + +CDECK ID>, from PHO_ALLM97 in Phojet + DOUBLE PRECISION FUNCTION ALLM97(Q2,W) +C********************************************************************** +C +C ALLM97 parametrization for gamma*-p cross section +C (for F2 see comments, code adapted from V. Shekelyan, H1) +C +C********************************************************************** + + IMPLICIT NONE + + SAVE + + DOUBLE PRECISION Q2,W + DOUBLE PRECISION M02,M12,LAM2,M22 + DOUBLE PRECISION S11,S12,S13,A11,A12,A13,B11,B12,B13 + DOUBLE PRECISION S21,S22,S23,A21,A22,A23,B21,B22,B23 + DOUBLE PRECISION ALFA,XMP2,W2,Q02,S,T,T0,Z,CIN, + & AP,BP,AR,BR,XP,XR,SR,SP,F2P,F2R + DATA ALFA,XMP2 /112.2D0 , .8802D0 / + + W2=W*W + ALLM97 = 0.D0 + +C pomeron + S11 = 0.28067D0 + S12 = 0.22291D0 + S13 = 2.1979D0 + A11 = -0.0808D0 + A12 = -0.44812D0 + A13 = 1.1709D0 + B11 = 0.60243D0 + B12 = 1.3754D0 + B13 = 1.8439D0 + M12 = 49.457D0 + +C reggeon + S21 = 0.80107D0 + S22 = 0.97307D0 + S23 = 3.4942D0 + A21 = 0.58400D0 + A22 = 0.37888D0 + A23 = 2.6063D0 + B21 = 0.10711D0 + B22 = 1.9386D0 + B23 = 0.49338D0 + M22 = 0.15052D0 +C + M02 = 0.31985D0 + LAM2 = 0.065270D0 + Q02 = 0.46017D0 +LAM2 + +C + S=0. + T=LOG((Q2+Q02)/LAM2) + T0=LOG(Q02/LAM2) + IF(Q2.GT.0.D0) S=LOG(T/T0) + Z=1.D0 + + IF(Q2.GT.0.D0) Z=(W2-XMP2)/(Q2+W2-XMP2) + + IF(S.LT.0.01D0) THEN + +C pomeron part + + XP=1.D0 /(1.D0 +(W2-XMP2)/(Q2+M12)) + + AP=A11 + BP=B11**2 + + SP=S11 + F2P=SP*XP**AP*Z**BP + +C reggeon part + + XR=1.D0 /(1.D0 +(W2-XMP2)/(Q2+M22)) + + AR=A21 + BR=B21**2 + + SR=S21 + F2R=SR*XR**AR*Z**BR + + ELSE + +C pomeron part + + XP=1.D0 /(1.D0 +(W2-XMP2)/(Q2+M12)) + + AP=A11+(A11-A12)*(1.D0 /(1.D0 +S**A13)-1.D0 ) + + BP=B11**2+B12**2*S**B13 + + SP=S11+(S11-S12)*(1.D0 /(1.D0 +S**S13)-1.D0 ) + + F2P=SP*XP**AP*Z**BP + +C reggeon part + + XR=1.D0 /(1.D0 +(W2-XMP2)/(Q2+M22)) + + AR=A21+A22*S**A23 + BR=B21**2+B22**2*S**B23 + + SR=S21+S22*S**S23 + F2R=SR*XR**AR*Z**BR + + ENDIF + +* F2 = (F2P+F2R)*Q2/(Q2+M02) + + CIN=ALFA/(Q2+M02)*(1.D0 +4.D0*XMP2*Q2/(Q2+W2-XMP2)**2)/Z + ALLM97 = CIN*(F2P+F2R) + + END + + + + + + +c----------------------------------------------------------------------- + subroutine lepexp(rxbj,rqsq) +c----------------------------------------------------------------------- +c generates x_bjorken and q**2 according to an experimental +c distribution ( given in array xq(nxbj,nqsq) ). +c----------------------------------------------------------------------- + parameter (nxbj=10,nqsq=10) + parameter (xbjmin=0.,qsqmin=4.) + parameter (xbjwid=0.025, qsqwid=4.) + dimension xq(nxbj,nqsq),vxq(nxbj*nqsq) + equivalence (xq(1,1),vxq(1)) + + data (vxq(i),i=1,50)/ + & 1304.02, 366.40, 19.84, 10.79, 6.42, + & 4.54, 4.15, 3.38, 2.03, 1.56, + & 241.63, 1637.26, 427.36, 164.51, 73.72, + & 43.07, 20.73, 12.78, 9.34, 5.83, + & 0.01, 724.66, 563.79, 275.08, 176.13, + & 106.44, 85.82, 54.52, 37.12, 28.65, + & 0.01, 202.40, 491.10, 245.13, 157.07, + & 104.43, 61.05, 49.42, 37.84, 26.79, + & 0.01, 3.77, 316.38, 226.92, 133.45, + & 90.30, 63.67, 48.42, 35.73, 28.04/ + data (vxq(i),i=51,100)/ + & 0.01, 0.01, 153.74, 213.09, 114.14, + & 76.26, 60.02, 43.15, 43.47, 25.60, + & 0.01, 0.01, 39.31, 185.74, 108.56, + & 88.40, 47.29, 39.35, 31.80, 22.91, + & 0.01, 0.01, 0.01, 104.61, 107.01, + & 66.24, 45.34, 37.45, 33.44, 23.78, + & 0.01, 0.01, 0.01, 56.58, 99.39, + & 67.78, 43.28, 35.98, 34.63, 18.31, + & 0.01, 0.01, 0.01, 13.56, 76.25, + & 64.30, 42.80, 28.56, 21.19, 20.75 / + + data init/0/ + init=init+1 + if(init.eq.1) then + n=nxbj*nqsq + sum=0. + do 1 i=1,n + sum=sum+vxq(i) +1 continue + do 2 i=2,n +2 vxq(i)=vxq(i)+vxq(i-1) + do 3 i=1,n +3 vxq(i)=vxq(i)/sum + endif + + n=nxbj*nqsq + r=rangen() + call utloc(vxq,n,r,iloc) + if(iloc.ge.n) iloc=iloc-1 + i=mod(iloc,nxbj)+1 + if(i.eq.0) i=nxbj + j=iloc/nxbj + 1 + dxint=vxq(1) + if(iloc.gt.0) dxint=vxq(iloc+1)-vxq(iloc) + dxbj=xbjwid*abs(r-vxq(iloc+1))/dxint + dy=qsqwid*rangen() + rxbj=xbjmin+xbjwid*float(i-1)+dxbj + rqsq=qsqmin+qsqwid*float(j-1)+dy + return + end + +c----------------------------------------------------------------------- + subroutine fremny(wp1,wm1,pnx,pny,sm,ic1,ic2,ic3,ic4,coord,ey0) +c----------------------------------------------------------------------- +c treats remnant from deep inelastic process; +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + dimension coord(6),ic(2),ep(4),ey(3),ey0(3),ep3(4) + double precision ept(4),ept1(4) + + call utpri('fremny',ish,ishini,5) + if(ish.ge.5)write(ifch,*)'writing remnant' + if(ish.ge.5)write(ifch,*) + *'wp1,wm1,pnx,pny,sm,ic1,ic2,ic3,ic4,coord,ey0:' + if(ish.ge.5)write(ifch,*) + *wp1,wm1,pnx,pny,sm,ic1,ic2,ic3,ic4,coord,ey0 + + if(ic3.eq.0.and.ic4.eq.0)then + + ic(1)=ic1 + ic(2)=ic2 + nptl=nptl+1 + ep3(3)=pnx + ep3(4)=pny + ep3(2)=(wp1-wm1)/2 + ep3(1)=(wp1+wm1)/2 + call pstrans(ep3,ey0,-1) + pptl(1,nptl)=ep3(3) + pptl(2,nptl)=ep3(4) + pptl(3,nptl)=ep3(2) + pptl(4,nptl)=ep3(1) + pptl(5,nptl)=sqrt(sm) + idptl(nptl)=idtra(ic,0,0,3) + iorptl(nptl)=1 + istptl(nptl)=0 + jorptl(nptl)=0 + do i=1,4 + xorptl(i,nptl)=coord(i) + enddo + tivptl(1,nptl)=coord(5) + tivptl(2,nptl)=coord(6) + ityptl(nptl)=40 + + if(ish.ge.7)then + write(ifch,*)'proj: nptl, mass**2,id',nptl,sm,idptl(nptl) + write(ifch,*)'ept', + *pptl(1,nptl),pptl(2,nptl),pptl(3,nptl),pptl(4,nptl) + endif + + else + + ic(1)=ic1 + ic(2)=ic2 + nptl=nptl+1 + idptl(nptl)=idtra(ic,0,0,3) + istptl(nptl)=20 + iorptl(nptl)=1 + jorptl(nptl)=0 + do i=1,4 + xorptl(i,nptl)=coord(i) + enddo + tivptl(1,nptl)=coord(5) + tivptl(2,nptl)=coord(6) + ityptl(nptl)=40 + + ic(1)=ic3 + ic(2)=ic4 + idptl(nptl+1)=idtra(ic,0,0,3) + istptl(nptl+1)=20 + iorptl(nptl+1)=1 + jorptl(nptl+1)=0 + do i=1,4 + xorptl(i,nptl+1)=coord(i) + enddo + tivptl(1,nptl+1)=coord(5) + tivptl(2,nptl+1)=coord(6) + ityptl(nptl+1)=40 + + ep3(3)=pnx + ep3(4)=pny + ep3(2)=(wp1-wm1)/2 + ep3(1)=(wp1+wm1)/2 + call pstrans(ep3,ey0,-1) !boost to hadronic c.m.s. + ept(1)=ep3(3) + ept(2)=ep3(4) + ept(3)=ep3(2) + ept(4)=ep3(1) + do i=1,4 + ept1(i)=ep3(i) + enddo + + sww=sqrt(sm) + call psdeftr(sm,ept1,ey) + ep(1)=.5*sww + ep(2)=.5*sww + ep(3)=0. + ep(4)=0. + call pstrans(ep,ey,1) + pptl(1,nptl)=ep(3) + pptl(2,nptl)=ep(4) + pptl(3,nptl)=ep(2) + pptl(4,nptl)=ep(1) + do i=1,4 + pptl(i,nptl+1)=ept(i)-pptl(i,nptl) + enddo + nptl=nptl+1 + endif + + if(ish.ge.5)write(ifch,*)'fremny: final nptl',nptl + call utprix('fremny',ish,ishini,5) + return + end + +c----------------------------------------------------------------------- + subroutine psadis(iret) +c----------------------------------------------------------------------- +c psadis - DIS interaction +c----------------------------------------------------------------------- + double precision ept(4),ept1(4),xx,wpt(2),eprt,pl,plprt,psutz + *,psuds + dimension ep3(4),ey(3),ey0(3),bx(6), + *qmin(2),iqc(2),nqc(2),ncc(2,2),gdv(2),gds(2),dfp(4) + parameter (mjstr=20000) + common /psar29/ eqj(4,mjstr),iqj(mjstr),ncj(2,mjstr),ioj(mjstr),nj + common /psar30/ iorj(mjstr),ityj(mjstr),bxj(6,mjstr),q2j(mjstr) + double precision pgampr,rgampr + common/cgampr/pgampr(5),rgampr(4) + parameter (ntim=1000) + common/cprt/pprt(5,ntim),q2prt(ntim),idaprt(2,ntim),idprt(ntim) + &,iorprt(ntim),jorprt(ntim),nprtj + common/ciptl/iptl + include 'epos.inc' + include 'epos.incsem' + + call utpri('psadis',ish,ishini,3) + if(ish.ge.3)write (ifch,*)'engy,elepti,iolept:' + if(ish.ge.3)write (ifch,*)engy,elepti,iolept + nptl=nptl+1 + idptl(nptl)=1220 + istptl(nptl)=1 + nptlh=nptl + iptl=nptl + s00=1. + + pptl(1,nptl)=0. + pptl(2,nptl)=0. + pptl(3,nptl)=-engy/2 + pptl(4,nptl)=engy/2 + pptl(5,nptl)=0 + +1 continue + if(iolept.eq.1)then + wtot=engy**2 + engypr=wtot/4./elepti + gdv01=psdh(ydmax*wtot,qdmin,iclpro,0) + gdv02=psdh(ydmax*wtot,qdmin,iclpro,1) + gds01=psdsh(ydmax*wtot,qdmin,iclpro,dqsh,0) + gds02=psdsh(ydmax*wtot,qdmin,iclpro,dqsh1,1) + gb0=(1.+(1.-ydmax)**2)*(gdv01+gds01) + * +2.*(1.-ydmax)*(gdv02+gds02) + +2 continue + qq=qdmin*(qdmax/qdmin)**rangen() + yd=ydmin*(ydmax/ydmin)**rangen() + wd=yd*wtot + if(ish.ge.4)write (ifch,*)'qq,wd,yd,ydmin,ydmax:' + if(ish.ge.4)write (ifch,*)qq,wd,yd,ydmin,ydmax + if(wd.lt.qq)goto 2 + + gdv(1)=psdh(wd,qq,iclpro,0) + gdv(2)=psdh(wd,qq,iclpro,1) + gds(1)=psdsh(wd,qq,iclpro,dqsh,0) + gds(2)=psdsh(wd,qq,iclpro,dqsh1,1) + gbtr=(1.+(1.-yd)**2)*(gdv(1)+gds(1)) + gblong=2.*(1.-yd)*(gdv(2)+gds(2)) +c gblong=0. !??????? + gb=(gbtr+gblong)/gb0*.7 + if(ish.ge.4)then + if(gb.gt.1.)write(ifmt,*)'gb,qq,yd,wd',gb,qq,yd,wd + write (ifch,*)'gb,gdv,gds,gdv0,gds0,yd:' + write (ifch,*)gb,gdv,gds,gdv01,gds01, + * gdv02,gds02,yd + endif + if(rangen().gt.gb)goto 2 + + long=int(rangen()+gblong/(gbtr+gblong)) + elepto=qq/elepti/4.+elepti*(1.-yd) + costhet=1.-qq/elepti/elepto/2. + theta=acos(costhet) + if(theta/pi*180..lt.themin)goto 2 + if(theta/pi*180..gt.themax)goto 2 + if(elepto.lt.elomin)goto 2 + if(ish.ge.3)write (ifch,*)'theta,elepto,elepti,iclpro:' + if(ish.ge.3)write (ifch,*)theta/pi*180.,elepto,elepti,iclpro + xbjevt=qq/wd + qsqevt=qq + + call pscs(bcos,bsin) + rgampr(1)=-elepto*sin(theta)*bcos + rgampr(2)=-elepto*sin(theta)*bsin + rgampr(3)=elepti-elepto*costhet + rgampr(4)=elepti-elepto + + pgampr(1)=rgampr(1) + pgampr(2)=rgampr(2) + pgampr(3)=rgampr(3)-engypr + pgampr(4)=rgampr(4)+engypr + sm2=pgampr(4)*pgampr(4) + * -pgampr(1)*pgampr(1)-pgampr(2)*pgampr(2)-pgampr(3)*pgampr(3) + pgampr(5)=sqrt(sm2) + call utlob2(1,pgampr(1),pgampr(2),pgampr(3),pgampr(4),pgampr(5) + * ,rgampr(1),rgampr(2),rgampr(3),rgampr(4),40) + if(ish.ge.4)write (ifch,*)'rgampr:',rgampr + + elseif(iolept.lt.0)then +21 call lepexp(xbjevt,qsq) + qq=qsq + wd=qq/xbjevt + if(qq.lt.qdmin.or.qq.gt.qdmax)goto21 + + gdv(1)=psdh(wd,qq,iclpro,0) + gdv(2)=psdh(wd,qq,iclpro,1) + gds(1)=psdsh(wd,qq,iclpro,dqsh,0) + gds(2)=psdsh(wd,qq,iclpro,dqsh1,1) + yd=wd/engy**2 + gbtr=(1.+(1.-yd)**2)*(gdv(1)+gds(1)) + gblong=2.*(1.-yd)*(gdv(2)+gds(2)) + gblong=0. !???????????? + long=int(rangen()+gblong/(gbtr+gblong)) + else + stop'wrong iolept' + endif + if(ish.ge.3)write (ifch,*)'qq,xbj,wd,gdv,gds,dqsh:' + if(ish.ge.3)write (ifch,*)qq,xbjevt,wd,gdv,gds,dqsh + + egyevt=sqrt(wd-qq) + pmxevt=.5*egyevt + + wp0=sqrt(qq) !breit frame + wm0=(wd-qq)/wp0 + ey0(1)=egyevt/wp0 !boost to the hadronic c.m.s. + ey0(2)=1. + ey0(3)=1. + do i=1,6 + bx(i)=0. + enddo + + if(long.eq.0)then + sdmin=qq/(1.-sqrt(q2ini/qq)) + sqmin=sdmin + else + sdmin=4.*max(q2min,qcmass**2)+qq !minimal mass for born + xmm=(5.*sdmin-qq)/4. + sqmin=1.1*(xmm+sqrt(xmm**2-qq*(sdmin-qq-4.*q2ini))) + * /2./(1.-4.*q2ini/(sdmin-qq)) + endif + if(long.eq.1.and.wd.lt.1.001*sdmin)goto 1 + + proja=210000. + projb=0. + call fremnu(ammin,proja,projb,proja,projb, + *icp1,icp2,icp3,icp4) + + nj=0 + + if((rangen().lt.gdv(long+1)/(gdv(long+1)+gds(long+1)).or. + *egyevt.lt.1.0001*(ammin+sqrt(sdmin-qq))).and. + *(long.eq.0.or.wd.gt.sqmin))then + if(long.eq.0)then + xd=qq/wd + tu=psdfh4(xd,q2min,0.,iclpro,1)/2.25 + td=psdfh4(xd,q2min,0.,iclpro,2)/9. + gdv0=(tu+td)*4.*pi**2*alfe/qq + * *sngl(psuds(qq,1)/psuds(q2min,1)) + if(ish.ge.4)write (ifch,*)'gdv0:',gdv0,sdmin + + if(rangen().lt.gdv0/gdv(1).or.wd.le.1.0001*sdmin)then !????? + if(ish.ge.3)write (ifch,*)'no cascade,gdv0,gdv',gdv0,gdv + if(rangen().lt.tu/(tu+td))then + iq1=1 + izh=3 + else + iq1=2 + izh=6 + endif + jq=1 + if(ish.ge.8)write (ifch,*)'before call timsh2: ', + * 'qq,egyevt,iq1',qq,egyevt,iq1 + call timsh2(qq,0.,egyevt,iq1,-iq1,iq1,-iq1) + + nj=nj+1 + iqj(nj)=izh + nqc(1)=nj + nqc(2)=0 + + ep3(1)=pprt(4,2) + ep3(2)=pprt(3,2) + ep3(3)=0. + ep3(4)=0. + call pstrans(ep3,ey0,1) + do i=1,4 + eqj(i,nj)=ep3(i) + enddo + s0h=0. + c0h=1. + s0xh=0. + c0xh=1. + call psreti(nqc,jq,1,ey0,s0xh,c0xh,s0h,c0h) + goto 17 + endif + endif + + call psdint(wd,qq,sds0,sdn0,sdb0,sdt0,sdr0,1,long) + if(ish.ge.3)write (ifch,*)'wd,qq,sds0,sdn0,sdb0,sdt0,sdr0:' + if(ish.ge.3)write (ifch,*)wd,qq,sds0,sdn0,sdb0,sdt0 + gb10=(sdn0+sdt0)*(1.-qq/wd) + xdmin=sqmin/wd + +3 continue + xd=(xdmin-qq/wd)/((xdmin-qq/wd)/(1.-qq/wd)) + * **rangen()+qq/wd + call psdint(xd*wd,qq,sds,sdn,sdb,sdt,sdr,1,long) + if(ish.ge.3)write (ifch,*)'wdhard,qq,sds,sdn,sdb,sdt:' + if(ish.ge.3)write (ifch,*)xd*wd,qq,sds,sdn,sdb,sdt + tu=psdfh4(xd,q2min,0.,iclpro,1) + td=psdfh4(xd,q2min,0.,iclpro,2) + gb1=(sdn*(tu/2.25+td/9.)+sdt*(tu+td)/4.5) + * *(1.-qq/wd/xd)/gb10 + if(gb1.gt.1..and.ish.ge.1)write(ifmt,*)'gb1,xd,wd,qq,sdt0,sdt', + * gb1,xd,wd,qq,sdt0,sdt + if(ish.ge.6)write (ifch,*)'gb1,xd,wd,qq,sdt0,sdt:' + if(ish.ge.6)write (ifch,*)gb1,xd,wd,qq,sdt0,sdt + if(rangen().gt.gb1)goto 3 + + gdres=(sdt-sds)/4.5 + gdrga=sdr/4.5 + gdsin=sds/4.5 + dtu=tu*(sdn/2.25+sdt/4.5) + dtd=td*(sdn/9.+sdt/4.5) + if(rangen().lt.dtu/(dtu+dtd))then + iq1=1 + izh=3 + gdbor=sdb/2.25 + gdnon=sdn/2.25 + else + iq1=2 + izh=6 + gdbor=sdb/9. + gdnon=sdn/9. + endif + + wpi=wp0 + wmi=(xd*wd-qq)/wpi + iqc(2)=iq1 + nj=nj+1 + iqj(nj)=izh + eqj(1,nj)=.5*(wm0-wmi) + eqj(2,nj)=-eqj(1,nj) + eqj(3,nj)=0. + eqj(4,nj)=0. + ncc(1,2)=nj + ncc(2,2)=0 + if(ish.ge.3)write (ifch,*)'wp0,wm0,wpi,wmi,iqc(2),eqj' + if(ish.ge.3)write (ifch,*)wp0,wm0,wpi,wmi,iqc(2),eqj(2,nj) + + else + xdmin=sdmin/wd + xpmax=((egyevt-ammin)**2+qq)/wd + iq1=int(3.*rangen()+1.)*(2.*int(.5+rangen())-1.) + + aks=rangen() + if(long.eq.0.and.aks.lt.dqsh/gds(1).and. + * egyevt.gt.ammin+sqrt(s00))then + if(ish.ge.3)write (ifch,*)'no cascade for q_s', + * aks,dqsh/gds(1) + xd=qq/wd + xpmin=xd+s00/wd + jcasc=0 + if(iq1.gt.0)then + jq=1 + else + jq=2 + endif + else + jcasc=1 + call psdint(xpmax*wd,qq,sds0,sdn0,sdb0,sdt0,sdr0,0,long) + call psdint(xpmax*wd,qq,sdsq0,sdnq0,sdbq0,sdtq0,sdrq0,1,long) + if(ish.ge.3)write (ifch,*) + * 'xpmax*wd,qq,sds0,sdn0,sdb0,sdt0,sdr0:' + if(ish.ge.3)write (ifch,*) + * xpmax*wd,qq,sds0,sdn0,sdb0,sdt0,sdr0 + gb10=sdt0*fzeroGluZZ(0.,iclpro)+(sdnq0+sdtq0) + * *fzeroSeaZZ(0.,iclpro) + gb10=gb10*15. + +4 xd=xdmin*(xpmax/xdmin)**rangen() + xpmin=xd + call psdint(xd*wd,qq,sds,sdn,sdb,sdt,sdr,0,long) + call psdint(xd*wd,qq,sdsq,sdnq,sdbq,sdtq,sdrq,1,long) + if(ish.ge.3)write (ifch,*)'xd*wd,qq,sds,sdn,sdb,sdt,sdr:' + if(ish.ge.3)write (ifch,*)xd*wd,qq,sds,sdn,sdb,sdt,sdr + wwg=sdt*fzeroGluZZ(xd,iclpro) + wwq=(sdnq+sdtq)*fzeroSeaZZ(xd,iclpro) + gb12=(wwq+wwg)/gb10*(xpmax/xd)**dels + if(gb12.gt.1..and.ish.ge.1)write(ifmt,*) + * 'gb12,xpmax*wd,xd*wd,sdt0,sdnq0+sdtq0,sdt,sdnq+sdtq', + * gb12,xpmax*wd,xd*wd,sdt0,sdnq0+sdtq0,sdt,sdnq+sdtq, + * wwq,wwg,(xpmax/xd)**dels,gb10 + if(ish.ge.5)write (ifch,*)'gb12,xd,xpmax,wwq,wwg:' + if(ish.ge.5)write (ifch,*)gb12,xd,xpmax,wwq,wwg + if(rangen().gt.gb12)goto 4 + endif + + if(jcasc.ne.0)then + gb20=(1.-xd/xpmax)**betpom*sdt*(1.-glusea)+ + * EsoftQZero(xd/xpmax)*(sdnq+sdtq)*glusea + else + gb20=EsoftQZero(xd/xpmax) + endif + if(1.+2.*(-alpqua)+dels.ge.0.)then + xpminl=(1.-xpmax)**(alplea(iclpro)+1.) + xpmaxl=(1.-xpmin)**(alplea(iclpro)+1.) + +5 xp=1.-(xpminl+(xpmaxl-xpminl)*rangen())** + * (1./(alplea(iclpro)+1.)) + if(jcasc.ne.0)then + gb2=((1.-xd/xp)**betpom*sdt*(1.-glusea)+ + * EsoftQZero(xd/xp)*(sdnq+sdtq)*glusea)*(xp/xpmax)** + * (1.+2.*(-alpqua)+dels)/gb20 + else + gb2=EsoftQZero(xd/xp)*(xp/xpmax)**(1.+2.*(-alpqua)+dels)/gb20 + endif + if(gb2.gt.1..and.ish.ge.1)then + write(ifmt,*)'gb2,xp:',gb2,xp +c read (*,*) + endif + if(rangen().gt.gb2)goto 5 + else + xpmaxl=xpmax**(2.+2.*(-alpqua)+dels) + xpminl=xpmin**(2.+2.*(-alpqua)+dels) + +6 xp=(xpminl+(xpmaxl-xpminl)*rangen())** + * (1./(2.+2.*(-alpqua)+dels)) + if(jcasc.ne.0)then + gb21=((1.-xd/xp)**betpom*sdt*(1.-glusea)+ + * EsoftQZero(xd/xp)*(sdnq+sdtq)*glusea)* + * ((1.-xp)/(1.-xd))**alplea(iclpro)/gb20 + else + gb21=EsoftQZero(xd/xp)*((1.-xp)/(1.-xd))**alplea(iclpro)/gb20 + endif + if(gb21.gt.1..and.ish.ge.1)then + write(ifmt,*)'gb21,xp:',gb21,xp +c read (*,*) + endif + if(rangen().gt.gb21)goto 6 + endif + + wwh=xd*wd-qq + wwsh=xp*wd-qq + ammax=(egyevt-sqrt(wwsh))**2 +22 call fremnx(ammax,ammin,sm,icp3,icp4,iret) + if(iret.ne.0.and.ish.ge.1)write(ifmt,*)'iret.ne.0!' + * ,ammax,ammin**2 + wmn=(1.-xp)*wd/wp0 + wpn=sm/wmn + pnx=0. + pny=0. + wpp=wp0-wpn + wmp=wm0-wmn + if(ish.ge.5)write(ifch,*)'wp0,wm0,wpn,wmn,wpp,wmp:' + if(ish.ge.5)write(ifch,*)wp0,wm0,wpn,wmn,wpp,wmp + + if(jcasc.eq.0.or.rangen().lt.wwq/(wwg+wwq). + * and.xd*wd.gt.sqmin.and.wwsh.gt. + * (sqrt(wwh)+sqrt(s00))**2)then + zgmin=xd/xp + zgmax=1./(1.+wp0/xd/wd/(wpp-wwh/wmp)) + if(zgmin.gt.zgmax)goto 22 +23 zg=zgmin-rangen()*(zgmin-zgmax) + if(rangen().gt.zg**dels*((1.-xd/xp/zg)/ (1.-xd/xp))**betpom) + * goto 23 + xg=xd/zg !w- share for the struck quark + wmq=wd/wp0*(xg-xd) !w- for its counterpart + wpq=s00/wmq !1. gev^2 / wmq + wmq=0. + wpp=wpp-wpq + wmp=wmp-wmq + sxx=wpp*wmp + if(ish.ge.5)write (ifch,*)'wpq,wmq,wpp,wmp,sxx:' + if(ish.ge.5)write (ifch,*)wpq,wmq,wpp,wmp,sxx + + if(jcasc.eq.0)then + if(ish.ge.6)write (ifch,*)'before call timsh2: qq,sxx,iq1', + * qq,sxx,iq1 + call timsh2(qq,0.,sqrt(sxx),iq1,-iq1,iq1,-iq1) + ept(1)=.5*(wpp+wmp) + ept(2)=.5*(wpp-wmp) + ept(3)=0. + ept(4)=0. + call psdeftr(sxx,ept,ey) + ep3(1)=pprt(4,2) + ep3(2)=pprt(3,2) + ep3(3)=0. + ep3(4)=0. + + call pstrans(ep3,ey,1) + wmp=ep3(1)-ep3(2) + goto 24 + endif + else + iq1=0 + sxx=wpp*wmp + endif + + if(ish.ge.3)write (ifch,*)'wwh,wwsh,sxx,wpp,wmp:', + * wwh,wwsh,sxx,wpp,wmp + + wpi=wpp + wmi=wwh/wpp + wmp=wmp-wmi +24 call fremny(wpn,wmn,pnx,pny,sm,icp1,icp2,icp3,icp4,bx,ey0) + + if((-alpqua).eq.-1.)stop'dis does not work for 1/x' +25 aks=rangen() + z=.5*aks**(1./(1.+(-alpqua))) + if(z.lt.1.e-5.or.rangen().gt.(2.*(1.-z))**(-alpqua))goto 25 + if(rangen().gt..5)z=1.-z + wm2=wmp*z + wm1=wmp-wm2 + + iqc(2)=iq1 + nj=nj+1 + iqj(nj)=-int(2.*rangen()+1.) + iqj(nj+1)=-iqj(nj) + eqj(1,nj)=.5*wm1 + eqj(2,nj)=-eqj(1,nj) + eqj(3,nj)=0. + eqj(4,nj)=0. + eqj(1,nj+1)=.5*wm2 + eqj(2,nj+1)=-eqj(1,nj+1) + eqj(3,nj+1)=0. + eqj(4,nj+1)=0. + nj=nj+1 + + if(iq1.eq.0)then + ncc(1,2)=nj-1 + ncc(2,2)=nj + gdres=sdt-sds + gdrga=sdr + gdsin=sds + gdbor=sdb + gdnon=sdn + else + nj=nj+1 + if(iabs(iq1).eq.3)then + iqj(nj)=-iq1*4/3 + else + iqj(nj)=-iq1 + endif + eqj(1,nj)=.5*(wpq+wmq) + eqj(2,nj)=.5*(wpq-wmq) + eqj(3,nj)=0. + eqj(4,nj)=0. + if(iq1.gt.0)then + ncj(1,nj)=nj-1 + ncj(1,nj-1)=nj + ncj(2,nj)=0 + ncj(2,nj-1)=0 + else + ncj(1,nj)=nj-2 + ncj(1,nj-2)=nj + ncj(2,nj)=0 + ncj(2,nj-2)=0 + endif + + if(jcasc.eq.0)then + if(iq1.gt.0)then + nqc(1)=nj-2 + nqc(2)=0 + else + nqc(1)=nj-1 + nqc(2)=0 + endif + s0h=0. + c0h=1. + s0xh=0. + c0xh=1. + call psreti(nqc,jq,1,ey,s0xh,c0xh,s0h,c0h) + goto 17 + else + gdres=(sdtq-sdsq)/4.5 + gdrga=sdrq/4.5 + gdsin=sdsq/4.5 + gdbor=sdbq/4.5 + gdnon=sdnq/4.5 + if(iq1.gt.0)then + ncc(1,2)=nj-2 + ncc(2,2)=0 + else + ncc(1,2)=nj-1 + ncc(2,2)=0 + endif + endif + endif + + if(ish.ge.3)write (ifch,*)'wpn,wmn,wpi,wmi,wm1,wm2,nj' + if(ish.ge.3)write (ifch,*)wpn,wmn,wpi,wmi,wm1,wm2,nj + endif + + si=wpi*wmi+qq + qmin(2)=q2min !effective momentum cutoff below + s2min=max(4.*qq,16.*q2min) !mass cutoff for born scattering + + if(rangen().gt.gdres/(gdres+gdsin+gdnon).or. + *si.lt.(s2min+qq))goto 12 + +c--------------------------------------- +c hard pomeron (resolved photon) +c--------------------------------------- + if(ish.ge.3)write(ifmt,*)'resolved,gdrga,gdres',gdrga,gdres + + jj=1 + if(rangen().gt.gdrga/gdres.and.si.gt.1.1*s2min+qq)then + if(ish.ge.3)write(ifmt,*)'dir-res,si,qq',si,qq + pt=0. + pt2=0. + iqc(1)=0 + ept(1)=.5*(wpi+wmi) + ept(2)=.5*(wpi-wmi) + ept(3)=0. + ept(4)=0. + wpt(1)=wpi !lc+ for the current jet emission + wpt(2)=si/wpi !lc- for the current jet emission + + qqmin=max(q2min,s2min/(si/qq-1.)) + qqmax=min(si/2.,si-s2min) + qmin(1)=qqmin + xmax=1. + xmin=(s2min+qq)/si + if(qqmin.ge.qqmax.or.xmin.ge.xmax)stop'min>max' + gb0=psjti(qmin(1),qq,si-qq,7,iqc(2),1)*psfap(1.d0,0,1) + + ncc(1,1)=0 + ncc(2,1)=0 + jgamma=1 + ntry=0 + xmin1=0. + xmin2=0. + xmax1=0. + djl=0. + goto 9 + else + if(ish.ge.3)write(ifmt,*)'res,si,qq',si,qq + qmin(1)=q2min !effective momentum cutoff above + si=si-qq + zmin=s2min/si + dft0=psdfh4(zmin,q2min,qq,0,0)*psjti(q2min,qq,si,0,iqc(2),1) + * +(psdfh4(zmin,q2min,qq,0,1)+psdfh4(zmin,q2min,qq,0,2)+ + * psdfh4(zmin,q2min,qq,0,3))*psjti(q2min,qq,si,7,iqc(2),1) + +7 continue + z=zmin**rangen() + do i=1,4 + dfp(i)=psdfh4(z,q2min,qq,0,i-1) + enddo + dfp(1)=dfp(1)*psjti(q2min,qq,z*si,0,iqc(2),1) + dfptot=dfp(1) + if(iqc(2).eq.0)then + sjq=psjti(q2min,qq,z*si,1,0,1) + do i=2,4 + dfp(i)=dfp(i)*sjq + dfptot=dfptot+dfp(i) + enddo + else + sjqqp=psjti(q2min,qq,z*si,1,2,1) + do i=2,4 + if(iabs(iqc(2)).eq.i-1)then + dfp(i)=dfp(i)*(psjti(q2min,qq,z*si,1,1,1)+ + * psjti(q2min,qq,z*si,1,-1,1))/2. + else + dfp(i)=dfp(i)*sjqqp + endif + dfptot=dfptot+dfp(i) + enddo + endif + + if(rangen().gt.dfptot/dft0)goto 7 + + wpq=wpi*(1.-z) + wpi=wpi*z + aks=dfptot*rangen() + if(aks.lt.dfp(1))then + iqc(1)=0 + nj=nj+1 + ncc(1,1)=nj + ncc(2,1)=nj+1 + + iqj(nj)=-int(2.*rangen()+1.) + iqj(nj+1)=-iqj(nj) + wpq1=wpq*rangen() + eqj(1,nj)=.5*wpq1 + eqj(2,nj)=eqj(1,nj) + eqj(3,nj)=0. + eqj(4,nj)=0. + eqj(1,nj+1)=.5*(wpq-wpq1) + eqj(2,nj+1)=eqj(1,nj+1) + eqj(3,nj+1)=0. + eqj(4,nj+1)=0. + nj=nj+1 + + else + if(aks.lt.dfp(1)+dfp(2))then + iqc(1)=1 + elseif(aks.lt.dfp(1)+dfp(2)+dfp(3))then + iqc(1)=2 + else + iqc(1)=3 + endif + iqc(1)=iqc(1)*(2*int(2.*rangen())-1) + nj=nj+1 + ncc(1,1)=nj + ncc(2,1)=0 + + iqj(nj)=-iqc(1) + eqj(1,nj)=.5*wpq + eqj(2,nj)=eqj(1,nj) + eqj(3,nj)=0. + eqj(4,nj)=0. + endif + + ept(1)=.5*(wpi+wmi) + ept(2)=.5*(wpi-wmi) + ept(3)=0. + ept(4)=0. + jgamma=0 + ntry=0 + endif + +8 continue + +c ladder rung +c--------------------------------------- + pt2=ept(3)**2+ept(4)**2 + pt=sqrt(pt2) + + wpt(1)=ept(1)+ept(2) !lc+ for the current jet emissi + wpt(2)=ept(1)-ept(2) !lc- for the current jet emissi + + s2min=max(qmin(1),16.*qmin(2)) !mass cutoff for born + s2min=max(s2min,4.*qq) + + if(jj.eq.1)then + wwmin=2.*s2min-2.*pt*sqrt(q2ini) + wwmin=(wwmin+sqrt(wwmin**2+4.*pt2*(s2min-q2ini))) + * /(1.-q2ini/s2min)/2. + sj=psjti(qmin(1),qq,si,iqc(1),iqc(2),1) !total jet + sj2=psjti1(q2min,qmin(1),qq,si,iqc(2),iqc(1),1) + if(ish.ge.3)write(ifch,*)'resolved - si,wwmin,s2min,sj,sj2:' + if(ish.ge.3)write(ifch,*)si,wwmin,s2min,sj,sj2 + if(sj.eq.0.)stop'sj=0' + if(rangen().gt.sj2/sj.and.si.gt.1.1*wwmin)goto 26 + jj=2 + endif + sj=psjti1(qmin(2),qmin(1),qq,si,iqc(2),iqc(1),1) + sjb=psbint(qmin(1),qmin(2),qq,si,iqc(1),iqc(2),1) !born parton-parton + wwmin=17./16*s2min-2.*pt*sqrt(q2ini) + wwmin=(wwmin+sqrt(wwmin**2+pt2*(s2min/4.-4.*q2ini))) + */(1.-16.*q2ini/s2min)/2. + if(rangen().lt.sjb/sj.or.si.lt.1.1*wwmin)goto 10 + +26 continue + wpt(jj)=wpt(jj)-pt2/wpt(3-jj) + + if(jj.eq.1)then + discr=(si+2.*pt*sqrt(q2ini))**2-4.*q2ini*(2.*si+pt2) + if(discr.lt.0..and.ish.ge.1)write(ifmt,*)'discr,si,pt,wwmin', + * discr,si,pt,wwmin + discr=sqrt(discr) + qqmax=(si+2.*pt*sqrt(q2ini)+discr)/2./(2.+pt2/si) + else + discr=(si+2.*pt*sqrt(q2ini))**2-4.*q2ini*(17.*si+pt2) + if(discr.lt.0..and.ish.ge.1)write(ifmt,*)'discr,si,pt,wwmin', + * discr,si,pt,wwmin + discr=sqrt(discr) + qqmax=(si+2.*pt*sqrt(q2ini)+discr)/2./(17.+pt2/si) + endif + qqmin=2.*q2ini*si/(si+2.*pt*sqrt(q2ini)+discr) + if(jj.eq.1.and.s2min.gt.qqmin.or. + *jj.eq.2.and.s2min.gt.16.*qqmin)then + xmm=.5*(si-s2min+2.*pt*sqrt(q2ini)) + discr=xmm**2-q2ini*(si+pt2) + if(discr.lt.0..and.ish.ge.1)write(ifmt,*)'discr1,si,pt,wwmin', + * discr,si,pt,wwmin + qqmin=q2ini*si/(xmm+sqrt(discr)) + endif + + xmin=1.-q2ini/qqmin + xmax=1.-q2ini/qqmax + if(ish.ge.6)write(ifch,*)'qqmin,qqmax,xmin,xmax', + *qqmin,qqmax,xmin,xmax + if(qqmin.lt.qmin(jj))then + qqmin=qmin(jj) + xmi=max(1.-((pt*sqrt(qqmin)+sqrt(pt2*qqmin+ + * si*(si-s2min-qqmin*(1.+pt2/si))))/si)**2, + * (s2min+qqmin*(1.+pt2/si)-2.*pt*sqrt(qqmin))/si) + xmin=max(xmin,xmi) + if(xmin.le.0.)xmin=(s2min+qqmin*(1.+pt2/si))/si + if(ish.ge.6)write(ifch,*)'qqmin,qmin(jj),xmin,s2min', + * qqmin,qmin(jj),xmin,s2min + endif + + qm0=qmin(jj) + xm0=1.-q2ini/qm0 + if(xm0.gt.xmax.or.xm0.lt.xmin)then + xm0=.5*(xmax+xmin) + endif +c s2max=xm0*si + s2max=xm0*si-qm0*(1.+pt2/si)+2.*pt*sqrt(q2ini) !new ladder mass squared + xx=xm0 + + if(jj.eq.1)then + sj0=psjti(qm0,qq,s2max,0,iqc(2),1)*psfap(xx,iqc(1),0)+ + * psjti(qm0,qq,s2max,7,iqc(2),1)*psfap(xx,iqc(1),1) + gb0=sj0/log(q2ini/qcdlam)*sngl(psuds(qm0,iqc(1)))*qm0*2. + else + sj0=psjti1(qm0,qmin(1),qq,s2max,0,iqc(1),1)*psfap(xx,iqc(2),0) + * +psjti1(qm0,qmin(1),qq,s2max,7,iqc(1),1)*psfap(xx,iqc(2),1) + gb0=sj0/log(q2ini/qcdlam)*sngl(psuds(qm0,iqc(2)))*qm0*2. + endif + if(gb0.le.0.)then + write(ifmt,*)'gb0.le.0. si,qq,pt2:',si,qq,pt2 + iret=1 + goto 9999 + endif + if(xm0.le..5)then + gb0=gb0*xm0**(1.-delh) + else + gb0=gb0*(1.-xm0)*2.**delh + endif + + xmin2=max(.5,xmin) + xmin1=xmin**delh !xmin, xmax are put into powe + xmax1=min(xmax,.5)**delh !to simulate x value below + if(xmin.ge..5)then + djl=1. + elseif(xmax.lt..5)then + djl=0. + else + djl=1./(1.+((2.*xmin)**delh-1.)/delh/ + * log(2.*(1.-xmax))) + endif + + ntry=0 +9 continue + ntry=ntry+1 + if(ntry.ge.10000)then + print *,"ntry.ge.10000" + iret=1 + goto 9999 + endif + if(jgamma.ne.1)then + if(rangen().gt.djl)then !lc momentum share in the cur + x=(xmin1+rangen()*(xmax1-xmin1))**(1./delh) + else + x=1.-(1.-xmin2)*((1.-xmax)/(1.-xmin2))**rangen() + endif + q2=qqmin/(1.+rangen()*(qqmin/qqmax-1.)) + qt2=q2*(1.-x) + if(ish.ge.6)write(ifch,*)'jj,q2,x,qt2',jj,q2,x,qt2 + if(qt2.lt.q2ini)goto 9 + else + x=xmin+rangen()*(xmax-xmin) + q2=qqmin*(qqmax/qqmin)**rangen() + qt2=(q2-x*qq)*(1.-x) + if(ish.ge.6)write(ifch,*)'jj,q2,x,qt2',jj,q2,x,qt2 + if(qt2.lt.0.)goto 9 + endif + + qt=sqrt(qt2) + call pscs(bcos,bsin) +c ep3 is now 4-vector for s-channel gluon produced in current ladder run + ep3(3)=qt*bcos + ep3(4)=qt*bsin + ptnew=(ept(3)-ep3(3))**2+(ept(4)-ep3(4))**2 + if(jj.eq.1)then + s2min2=max(q2,s2min) + else + s2min2=max(s2min,16.*q2) + endif + + if(jgamma.ne.1)then + s2=x*si-q2*(1.+pt2/si)-ptnew+pt2+qt2 !new ladder mass squared + if(s2.lt.s2min2)goto 9 !rejection in case of too low mass + xx=x + + if(jj.eq.1)then + sj1=psjti(q2,qq,s2,0,iqc(2),1) + if(iqc(1).ne.0)then + sj2=psjti(q2,qq,s2,iqc(1),iqc(2),1) + elseif(iqc(2).eq.0)then + sj2=psjti(q2,qq,s2,1,0,1) + else + sj2=psjti(q2,qq,s2,1,1,1)/6.+ + * psjti(q2,qq,s2,-1,1,1)/6.+ + * psjti(q2,qq,s2,2,1,1)/1.5 + endif + else + sj1=psjti1(q2,qmin(1),qq,s2,0,iqc(1),1) + if(iqc(2).ne.0)then + sj2=psjti1(q2,qmin(1),qq,s2,iqc(2),iqc(1),1) + elseif(iqc(1).eq.0)then + sj2=psjti1(q2,qmin(1),qq,s2,1,0,1) + else + sj2=psjti1(q2,qmin(1),qq,s2,1,1,1)/6.+ + * psjti1(q2,qmin(1),qq,s2,-1,1,1)/6.+ + * psjti1(q2,qmin(1),qq,s2,2,1,1)/1.5 + endif + endif +c gb7 is the rejection function for x and q**2 simulation + gb7=(sj1*psfap(xx,iqc(jj),0)+sj2*psfap(xx,iqc(jj),1)) + * /log(qt2/qcdlam)*sngl(psuds(q2,iqc(jj)))*q2/gb0 + + if(x.le..5)then + gb7=gb7*x**(1.-delh) + else + gb7=gb7*(1.-x)*2.**delh + endif + else + s2=x*si-q2 !new ladder mass squared + if(s2.lt.s2min2)goto 9 !rejection in case of too low mass + + sj1=0. + xx=x + if(iqc(2).eq.0)then + sj2=psjti(q2,qq,s2,1,0,1) + else + sj2=psjti(q2,qq,s2,1,1,1)/naflav/2.+ + * psjti(q2,qq,s2,-1,1,1)/naflav/2.+ + * psjti(q2,qq,s2,2,1,1)*(1.-1./naflav) + endif + gb7=sj2*psfap(xx,0,1)/gb0 !????*(1.-x*qq/q2) + endif + if(gb7.gt.1..or.gb7.lt.0..and.ish.ge.1)write(ifmt,*)'gb7,q2,x,gb0' + *,gb7,q2,x,gb0 + if(rangen().gt.gb7)goto 9 + + if(ish.ge.6)write(ifch,*)'res: jj,iqc,ncc:', + *jj,iqc(jj),ncc(1,jj),ncc(2,jj) + + nqc(2)=0 + iqnew=iqc(jj) + if(jgamma.ne.1)then + if(rangen().lt.sj1/(sj1+sj2))then + if(iqc(jj).eq.0)then + jt=1 + jq=int(1.5+rangen()) + nqc(1)=ncc(jq,jj) + else + jt=2 + if(iqc(jj).gt.0)then + jq=1 + else + jq=2 + endif + nqc(1)=0 + iqnew=0 + endif + iq1=iqc(jj) + else + if(iqc(jj).ne.0)then + iq1=0 + jt=3 + if(iqc(jj).gt.0)then + jq=1 + else + jq=2 + endif + nqc(1)=ncc(1,jj) + else + jt=4 + jq=int(1.5+rangen()) + iq1=int(naflav*rangen()+1.)*(3-2*jq) + nqc(1)=ncc(jq,jj) + iqnew=-iq1 + endif + endif + else + jt=5 + jq=int(1.5+rangen()) + iq1=int(naflav*rangen()+1.)*(3-2*jq) + iqnew=-iq1 + nqc(1)=0 + endif + eprt=max(1.d0*qt, + *.5d0*((1.d0-x)*wpt(jj)+qt2/(1.d0-x)/wpt(jj))) + pl=((1.d0-x)*wpt(jj)-eprt)*(3-2*jj) + zeta=sqrt(qt2/si)/sqrt(x*(1.-x)) + if(iq1.eq.0)then + iq2ini=9 + jo=iq2ini + if(zeta.gt.zetacut)jo=-jo + else + iq2ini=iq1 + jo=iq2ini + endif +27 call timsh1(q2,sngl(eprt),iq2ini,jo) + amprt=pprt(5,1)**2 + plprt=eprt**2-amprt-qt2 + if(plprt.lt.-1d-6)goto 27 + ep3(1)=eprt + ep3(2)=dsqrt(max(0.d0,plprt)) + if(pl.lt.0.d0)ep3(2)=-ep3(2) + ey(1)=1. + ey(2)=1. + ey(3)=1. + do i=1,4 + ept1(i)=ept(i)-ep3(i) + enddo + call psdefrot(ep3,s0xh,c0xh,s0h,c0h) + if(ish.ge.6)then + write(ifch,*)'q2,amprt,qt2',q2,amprt,qt2 + write(ifch,*)'eprt,plprt',eprt,plprt + write(ifch,*)'ep3',ep3 + write(ifch,*)'ept',ept + write(ifch,*)'ept1',ept1 + endif + s2new=psnorm(ept1) + + if(s2new.gt.s2min2)then + if(jj.eq.1)then + gb=psjti(q2,qq,s2new,iqnew,iqc(2),1) + else + gb=psjti1(q2,qmin(1),qq,s2new,iqnew,iqc(1),1) + endif + if(iqnew.eq.0)then + gb=gb/sj1 + else + gb=gb/sj2 + endif + if(ish.ge.1)then + if(gb.gt.1.)write (ifch,*)'gb,s2new,s2,q2,iqnew', + * gb,s2new,s2,q2,iqnew + endif + if(rangen().gt.gb)goto 9 + else + goto 9 + endif + jgamma=0 + + call psreti(nqc,jq,1,ey,s0xh,c0xh,s0h,c0h) + + if(jt.eq.1)then + ncc(jq,jj)=nqc(2) + elseif(jt.eq.2)then + ncc(jq,jj)=ncc(1,jj) + ncc(3-jq,jj)=nqc(1) + elseif(jt.eq.3)then + ncc(1,jj)=nqc(2) + elseif(jt.eq.4)then + ncc(1,jj)=ncc(3-jq,jj) + elseif(jt.eq.5)then + ncc(1,jj)=nqc(1) + ncc(2,jj)=0 + endif + iqc(jj)=iqnew + if(ish.ge.6)write(ifch,*)'qt2,amprt,ncc:', + *qt2,amprt,ncc(1,jj),ncc(2,jj) + + do i=1,4 + ept(i)=ept1(i) + enddo +c c.m. energy squared, minimal 4-momentum transfer square and gluon 4-v +c for the next ladder run + qmin(jj)=q2 + si=s2new + if(ish.ge.3)write (ifch,*)'res: new jet - iqj,ncj,ep3,ept', + *iqj(nj),ncj(1,nj),ncj(2,nj),ep3,ept + + goto 8 !next simulation step will be considered + +10 continue + if(ish.ge.3)write(ifch,*)'res: iqc,si,ept:',iqc,si,ept + +c highest virtuality subprocess in the ladder +c--------------------------------------- + qqs=max(qmin(1)/4.,4.*qmin(2)) + qqs=max(qqs,qq) + call psabor(si,qqs,iqc,ncc,ept,1,nptlh,bx) + goto 17 + +12 continue +c--------------------------------------- +c hard pomeron (direct photon) +c--------------------------------------- + ept(1)=.5*(wpi+wmi) + ept(2)=.5*(wpi-wmi) + ept(3)=0. + ept(4)=0. + if(ish.ge.3)write (ifch,*)'direct photon - ept,si,qq:',ept,si,qq + +13 continue + +c ladder rung +c--------------------------------------- + pt2=ept(3)**2+ept(4)**2 + pt=sqrt(pt2) + wpt(1)=ept(1)+ept(2) + wpt(2)=si/wpt(1) + + gdbor=psdbin(qmin(2),qq,si,iqc(2),long) + gdtot=psdsin(qmin(2),qq,si,iqc(2),long) + if(iqc(2).ne.0)then + if(ish.ge.8)write (ifch,*)'qmin(2),qq,si',qmin(2),qq,si + gdnon=psdnsi(qmin(2),qq,si,long) + if(iabs(iqc(2)).eq.1.or.iabs(iqc(2)).eq.4)then + gdbor=gdbor/2.25 + gdtot=gdnon/2.25+gdtot/4.5 + else + gdbor=gdbor/9. + gdtot=gdnon/9.+gdtot/4.5 + endif + else + gdnon=0. + endif + + if(long.ne.0.or.qmin(2).ge.qq)then + s2min=qq+4.*max(qmin(2),qcmass**2) + wwmin=(5.*s2min-qq)/4.-2.*pt*sqrt(q2ini) + wwmin=(wwmin+sqrt(wwmin**2-(qq-pt2)*(s2min-qq-4.*q2ini))) + * /2./(1.-4.*q2ini/(s2min-qq)) + else + s2min=qq/(1.-sqrt(q2ini/qq)) + wwmin=s2min+qq-2.*pt*sqrt(q2ini) + wwmin=(wwmin+sqrt(wwmin**2-4.*(qq-pt2)*(qq-q2ini))) + * /2./(1.-q2ini/qq) + endif + + if(ish.ge.3)write(ifch,*)'si,s2min,wwmin,qmin(2),gdtot,gdbor:' + if(ish.ge.3)write(ifch,*)si,s2min,wwmin,qmin(2),gdtot,gdbor + + if((rangen().lt.gdbor/gdtot.or.si.lt.1.1*wwmin).and. + *(long.eq.0.and.qmin(2).lt.qq.or.iqc(2).eq.0))goto 15 + if(si.lt.1.1*wwmin)stop'si<1.1*wwmin' + + qqmax=0. + qqmin=0. + + xmm=si+2.*sqrt(q2ini)*pt-qq + discr=xmm**2-4.*q2ini*(5.*si-qq+pt2) + if(discr.lt.0.)goto 29 + discr=sqrt(discr) + qqmax=(xmm+discr)/2./(5.-(qq-pt2)/si) + qqmin=2.*q2ini*si/(xmm+discr) + +29 continue + if(4.*qqmin.lt.s2min-qq.or.long.eq.0.and. + *qmin(2).lt.qq)then + xmm=si-s2min+2.*sqrt(q2ini)*pt + qqmin=2.*q2ini*si/(xmm+sqrt(xmm**2-4.*q2ini*(si-qq+pt2))) + endif + xmin=1.-q2ini/qqmin + + if(qqmin.lt.qmin(2))then + qqmin=qmin(2) + xmi=max(1.-((pt*sqrt(qqmin)+sqrt(pt2*qqmin+ + * si*(si-s2min-qqmin*(1.-(qq-pt2)/si))))/si)**2, + * (s2min+qqmin*(1.-(qq-pt2)/si)-2.*pt*sqrt(qqmin))/si) + xmin=max(xmin,xmi) + endif + if(xmin.le.qq/si)xmin=1.001*qq/si + + if(long.eq.0.and.qmin(2).lt.qq)qqmax=max(qqmax,qq) + xmax=1.-q2ini/qqmax + + if(ish.ge.6)write(ifch,*)'qqmax,qqmin,xmax,xmin:', + *qqmax,qqmin,xmax,xmin + if(qqmax.lt.qqmin)stop'qqmax<qqmin' + + qm0=qqmin + xm0=1.-q2ini/qm0 + s2max=si*xm0-qm0*(1.-qq/si) + + sds=psdsin(qm0,qq,s2max,0,long)/4.5 + sdv=psdsin(qm0,qq,s2max,1,long)/4.5 + + sdn=psdnsi(qm0,qq,s2max,long) + if(iqc(2).eq.0)then + sdn=sdn/4.5 + elseif(iabs(iqc(2)).eq.1.or.iabs(iqc(2)).eq.4)then + sdn=sdn/2.25 + else + sdn=sdn/9. + endif + sdv=sdv+sdn + xx=xm0 + + sj0=sds*psfap(xx,iqc(2),0)+sdv*psfap(xx,iqc(2),1) + gb0=sj0/log(q2ini/qcdlam)*sngl(psuds(qm0,iqc(2)))*qm0*5. + if(gb0.le.0.)then + write(ifmt,*)'gb0.le.0. si,qq,pt2:',si,qq,pt2 + iret=1 + goto 9999 + endif + + if(xm0.le..5)then + gb0=gb0*(xm0-qq/si)/(1.-2.*qq/si) + else + gb0=gb0*(1.-xm0) + endif + + xmin2=max(.5,xmin) + xmax1=min(xmax,.5) + if(xmin.ge..5)then + djl=1. + elseif(xmax.lt..5)then + djl=0. + else + djl=1./(1.-(1.-2.*qq/si)*log((.5-qq/si)/(xmin-qq/si))/ + * log(2.*(1.-xmax))) + endif + +14 continue + if(rangen().gt.djl)then !lc momentum share in the cur + x=(xmin-qq/si)*((xmax1-qq/si)/(xmin-qq/si))**rangen()+qq/si + else + x=1.-(1.-xmin2)*((1.-xmax)/(1.-xmin2))**rangen() + endif + + q2=qqmin/(1.+rangen()*(qqmin/qqmax-1.)) + + qt2=q2*(1.-x) + if(ish.ge.9)write(ifch,*)'q2,x,qt2,qq,qqmin,qqmax:', + *q2,x,qt2,qq,qqmin,qqmax + if(qt2.lt.q2ini)goto 14 !p_t check + + if(long.ne.0.or.q2.ge.qq)then + s2min2=max(4.*q2+qq,s2min) + else + s2min2=s2min + endif + qt=sqrt(qt2) + call pscs(bcos,bsin) +c ep3 is now 4-vector for s-channel gluon produced in current ladder run + ep3(3)=qt*bcos + ep3(4)=qt*bsin + ptnew=(ept(3)-ep3(3))**2+(ept(4)-ep3(4))**2 + + s2=x*si-ptnew+pt2-q2*(x-(qq-pt2)/si) + if(s2.lt.s2min2)goto 14 !check of the kinematics + sds=psdsin(q2,qq,s2,0,long)/4.5 + sdv0=psdsin(q2,qq,s2,1,long)/4.5 + if(ish.ge.8)write (ifch,*)'q2,qq,s2',q2,qq,s2 + sdn0=psdnsi(q2,qq,s2,long) + + if(iqc(2).eq.0)then + sdn=sdn0/4.5 + else + if(iabs(iqc(2)).eq.1.or.iabs(iqc(2)).eq.4)then + sdn=sdn0/2.25 + else + sdn=sdn0/9. + endif + endif + sdv=sdv0+sdn + + xx=x + sj1=sds*psfap(xx,iqc(2),0) + sj2=sdv*psfap(xx,iqc(2),1) + +c gb7 is the rejection function for x and q**2 simulation. + gb7=(sj1+sj2)/log(qt2/qcdlam)*sngl(psuds(q2,iqc(2)))/gb0*q2 + if(x.le..5)then + gb7=gb7*(x-qq/si)/(1.-2.*qq/si) + else + gb7=gb7*(1.-x) + endif + + if(gb7.gt.1..and.ish.ge.1)write(ifmt,*)'gb7,q2,x,qt2,iqc(2),' + * ,'gb0,sj1,sj2',gb7,q2,x,qt2,iqc(2),gb0,sj1,sj2 + if(ish.ge.3)write (ifch,*)'gb7,q2,x,qt2,iqc(2),gb0,sj1,sj2,long', + * gb7,q2,x,qt2,iqc(2),gb0,sj1,sj2,long + if(rangen().gt.gb7)goto 14 + + + if(ish.ge.6)write(ifch,*)'iqc,ncc:',iqc(2),ncc(1,2),ncc(2,2) + iqcnew=iqc(2) + nqc(2)=0 !emitted parton color connections + if(rangen().lt.sj1/(sj1+sj2).or.(long.ne.0.or.q2.ge.qq).and. + *s2.lt.1.5*s2min2)then + if(iqc(2).eq.0)then + jt=1 + jq=int(1.5+rangen()) + nqc(1)=ncc(jq,2) + else + jt=2 + if(iqc(2).gt.0)then + jq=1 + else + jq=2 + endif + nqc(1)=0 + endif + iq1=iqc(2) + iqcnew=0 + + else + if(iqc(2).ne.0)then + jt=3 + iq1=0 + if(iqc(2).gt.0)then + jq=1 + else + jq=2 + endif + nqc(1)=ncc(1,2) + + else + tu=sdn0/2.25+sdv0 + if(naflav.eq.4)tu=tu*2. + td=sdn0/9.+sdv0 + if(rangen().lt.tu/(tu+2.*td))then + if(naflav.eq.3)then + iq1=1 + else + iq1=1+3*int(.5+rangen()) + endif + else + iq1=int(2.5+rangen()) + endif + jq=int(1.5+rangen()) + iq1=iq1*(3-2*jq) + iqcnew=-iq1 + jt=4 + nqc(1)=ncc(jq,2) + endif + endif + + eprt=max(1.d0*qt, + *.5d0*((1.d0-x)*wpt(2)+qt2/(1.d0-x)/wpt(2))) + pl=eprt-(1.d0-x)*wpt(2) + zeta=sqrt(qq/si)/sqrt(x*(1.-x)) + if(iq1.eq.0)then + iq2ini=9 + jo=iq2ini + if(zeta.gt.zetacut)jo=-jo + else + iq2ini=iq1 + jo=iq2ini + endif +28 call timsh1(q2,sngl(eprt),iq2ini,jo) + amprt=pprt(5,1)**2 + plprt=eprt**2-amprt-qt2 + if(plprt.lt.-1d-6)goto 28 + ep3(1)=eprt + ep3(2)=dsqrt(max(0.d0,plprt)) + if(pl.lt.0.d0)ep3(2)=-ep3(2) + ey(1)=1. + ey(2)=1. + ey(3)=1. + do i=1,4 + ept1(i)=ept(i)-ep3(i) + enddo + call psdefrot(ep3,s0xh,c0xh,s0h,c0h) + call psrotat(ep3,s0xh,c0xh,s0h,c0h) + s2new=psnorm(ept1)+qq + + if((long.ne.0.or.q2.ge.qq).and.iqcnew.ne.0)then + xmm=(5.*s2min2-qq)/4.-2.*sqrt(ptnew*q2ini) + s2min2=1.1*(xmm+sqrt(xmm**2-(qq-ptnew)* + * (s2min2-qq-4.*q2ini)))/2./(1.-4.*q2ini/(s2min2-qq)) + endif + if(s2new.gt.s2min2)then + sds1=psdsin(q2,qq,s2new,iqcnew,long)/4.5 + if(iqcnew.eq.0)then + gb=sds1/sds + else + if(ish.ge.8)write (ifch,*)'q2,qq,s2new',q2,qq,s2new + sdn1=psdnsi(q2,qq,s2new,long) + if(iabs(iqcnew).eq.1.or.iabs(iqcnew).eq.4)then + sdn1=sdn1/2.25 + sdv=sdv0+sdn0/2.25 + else + sdn1=sdn1/9. + sdv=sdv0+sdn0/9. + endif + gb=.9999*(sds1+sdn1)/sdv + endif + if(ish.ge.3.and.gb.gt.1..and.ish.ge.1)write(ifmt,*)'gbs2',gb + if(rangen().gt.gb)goto 14 + else + goto 14 + endif + + call psreti(nqc,jq,1,ey,s0xh,c0xh,s0h,c0h) + + iqc(2)=iqcnew + if(jt.eq.1)then !current parton color connections + ncc(jq,2)=nqc(2) + elseif(jt.eq.2)then + ncc(jq,2)=ncc(1,2) + ncc(3-jq,2)=nqc(1) + elseif(jt.eq.3)then + ncc(1,2)=nqc(2) + elseif(jt.eq.4)then + ncc(1,2)=ncc(3-jq,2) + ncc(2,2)=0 + endif + + do i=1,4 + ept(i)=ept1(i) + enddo + if(ish.ge.3)write (ifch,*)'new jet - iqj,ncj,ep3,ept', + *iqj(nj),ncj(1,nj),ncj(2,nj),ep3,ept +c c.m. energy squared, minimal 4-momentum transfer square and gluon 4-v +c for the next ladder run + qmin(2)=q2 + si=s2new + goto 13 !next simulation step will be considered + +15 continue + if(ish.ge.3)write(ifch,*)'iqc,si,qmin(2),nj:', + *iqc(2),si,qmin(2),nj +c highest virtuality subprocess in the ladder +c--------------------------------------- + gb01=0. + tmax=0. + tmin=si + if(iqc(2).eq.0.and.si.gt.qq+4.*max(qcmass**2,qmin(2)))then + qminn=max(qcmass**2,qmin(2)) + tmin1=2.*qminn/(1.-qq/si)/(1.+sqrt(1.-4.*qminn/(si-qq))) + tmin=tmin1 + tmax=si/2. + fb01=psdbom(si,si/2.,si/2.,qq,long) + if(long.eq.0)fb01=fb01*si/2. + gb01=fb01/log(qminn/qcdlam)*sngl(psuds(qminn,iqc(2)))/si**2 + gb0=gb01 + else + tmin1=0. + endif + + if(long.eq.0.and.qmin(2).lt.qq)then + tmax=max(tmax,qq) + tmin=max(qmin(2), + * 2.*q2ini/(1.-qq/si)/(1.+sqrt(1.-4.*q2ini/(si-qq)))) + ze=qq/si+tmin/si*(1.-qq/si) + xx=ze + qt2=tmin*(1.-ze) + if(qt2.lt..999*q2ini.and.ish.ge.1)write(ifmt,*)'bor-dir:qt20' + * ,qt2 + gb0=gb01+psfap(xx,iqc(2),1)/log(qt2/qcdlam) + * *sngl(psuds(tmin,iqc(2))/psuds(tmin,1)*psuds(qq,1)) + * /si*(1.-tmin*qq/si**2/ze) + endif + gb0=gb0*2. + + call psdeftr(si-qq,ept,ey) + + if(ish.ge.6)write(ifch,*)'tmin,tmax,qq,si-qq,gb0:' + if(ish.ge.6)write(ifch,*)tmin,tmax,qq,si-qq,psnorm(ept),gb0 + +c------------------------------------------------ +16 continue + if(long.eq.0)then + t=tmin*(tmax/tmin)**rangen() + else + t=tmin+(tmax-tmin)*rangen() + endif + + u=si-t + ze=qq/si+t/si*(1.-qq/si) + qt2=t*(1.-ze) + if(t.le.qq.and.long.eq.0)then + xx=ze + gb=psfap(xx,iqc(2),1)/log(qt2/qcdlam)*sngl(psuds(t,iqc(2)) + * /psuds(t,1)*psuds(qq,1))/si*(1.-t*qq/si**2/ze)/gb0 + else + gb=0. + endif + + gb1=0. + if(iqc(2).eq.0..and.si.gt.qq+4.*max(qcmass**2,qmin(2)). + *and.qt2.gt.qcmass**2.and.t.le.si/2..and.t.ge.tmin1)then + fb1=psdbom(si,t,u,qq,long) + if(long.eq.0)fb1=fb1*t + gb1=fb1/log(qt2/qcdlam)*sngl(psuds(qt2,iqc(2)))/si**2/gb0 +c gb1=0. !??????????????????????? + gb=gb+gb1 + endif + + + if(ish.ge.6)write(ifch,*)'gb,t,iqc(2),si,qq,qmin(2),long:', + *gb,t,iqc(2),si,qq,qmin(2),long + if (ish.ge.1) then + if(gb.gt.1.)write(*,*)'gb,gb1,gb0,gb01', + * ',t,iqc(2),si,qq,qmin(2),long:', + * gb,gb1,gb0,gb01,fb1,fb01,t,iqc(2),si,qq,qmin(2),long + endif + + if(rangen().gt.gb)goto 16 + if(ish.ge.3)write(ifch,*)'born:t,qt2:',t,qt2 + + nqc(2)=0 + if(iqc(2).eq.0)then + jq=int(1.5+rangen()) + jq2=3-jq + if(rangen().gt.gb1/gb)then + iq1=(1+int(3.*rangen()))*(3-2*jq) + else + iq1=4*(3-2*jq) + endif + iq2=-iq1 !quark flavors + nqc(1)=ncc(jq,2) + else + if(iqc(2).gt.0)then + jq=1 + else + jq=2 + endif + jq2=jq + iq1=0 + iq2=iqc(2) + nqc(1)=ncc(1,2) + endif + + call pscs(bcos,bsin) + z=sngl(psutz(dble(si-qq),dble(qt2),dble(qt2))) + if(t.lt..5*si)z=1.-z + wp3=z*sqrt(si-qq) + wm3=qt2/wp3 + if(iabs(iq1).eq.4)qt2=qt2-qcmass**2 + qt=sqrt(qt2) + ep3(1)=.5*(wp3+wm3) + ep3(2)=.5*(wp3-wm3) + ep3(3)=qt*bcos + ep3(4)=qt*bsin + call psdefrot(ep3,s0xh,c0xh,s0h,c0h) + zeta=2. + if(iq1.eq.0)then + iq2ini1=9 + jo1=iq2ini1 + if(zeta.gt.zetacut)jo1=-jo1 + else + iq2ini1=iq1 + jo1=iq2ini1 + endif + if(iq2.eq.0)then + iq2ini2=9 + jo2=iq2ini2 + if(zeta.gt.zetacut)jo2=-jo2 + else + iq2ini2=iq2 + jo2=iq2ini2 + endif + if(ish.ge.5)write (ifch,*)'jq,jt,iq2ini1,iq2ini2', + *jq,jt,iq2ini1,iq2ini2 + + if(t.lt.qq.and.iabs(iq1).ne.4)then + qq1=t*(1.-ze) + qq2=qq + else + qq1=qt2 + qq2=qt2 + endif + call timsh2(qq1,qq2,sqrt(si-qq),iq2ini1,iq2ini2,jo1,jo2) + nfprt=1 + call psreti(nqc,jq,nfprt,ey,s0xh,c0xh,s0h,c0h) + + if(iqc(2).eq.0)then + nqc(1)=ncc(3-jq,2) + nqc(2)=0 + else + nqc(1)=nqc(2) + nqc(2)=0 + endif + + nfprt=2 + call psreti(nqc,jq2,nfprt,ey,s0xh,c0xh,s0h,c0h) + +17 continue + if(ish.ge.3)write (ifch,*)'nj',nj + if(nj.gt.0)then + + ityj(i)=30 + iorj(i)=nptlh + do n=1,nj + do i=1,4 + ep3(i)=eqj(i,n) + enddo + call pstrans(ep3,ey0,-1) !boost to the c.m. system + do i=1,4 + eqj(i,n)=ep3(i) + enddo + do l=1,6 + bxj(l,n)=bx(l) + enddo + ityj(n)=0 + iorj(n)=1 + enddo + endif + call psjarr(jfl) !kinky strings formation + if(ish.ge.3)write (ifch,*)'jfl',jfl + if(jfl.eq.0)then + iret=1 + else + iret=0 + ep3(4)=egyevt + ep3(2)=0. + ep3(3)=0. + ep3(1)=0. + do i=2,nptl + do l=1,4 + ep3(l)=ep3(l)-pptl(l,i) + enddo + enddo + if(ish.ge.3)write(ifch,*)'energy-momentum balance:' + if(ish.ge.3)write(ifch,*)ep3 + if(abs(ep3(4)).gt.3.e-2)write(*,*)'energy-momentum balance:',ep3 + endif + 9999 call utprix('psadis',ish,ishini,3) + return + end + +c----------------------------------------------------------------------- + subroutine psaevc +c----------------------------------------------------------------------- + include 'epos.inc' +c structure functions calculation + logical lcalc + double precision xx,xmax + dimension evs(21,21,135) + common /psar2/ edmax,epmax + common /psar31/ evk0(21,21,54) + common /psar32/ evk(21,21,135) + common/producetab/ producetables !used to link with CRMC + logical producetables + include 'epos.incsem' + + inquire(file=fnie(1:nfnie),exist=lcalc) + if(lcalc)then + if(inicnt.eq.1)then + write(ifmt,'(3a)')'read from ',fnie(1:nfnie),' ...' + open(1,file=fnie(1:nfnie),status='old') + read (1,*)qcdlam0,q2min0,q2ini0,naflav0,epmax0 + if(qcdlam0.ne.qcdlam)write(ifmt,'(a)')'iniev: wrong qcdlam' + if(q2min0 .ne.q2min )write(ifmt,'(a)')'iniev: wrong q2min' + if(q2ini0 .ne.q2ini )write(ifmt,'(a)')'iniev: wrong q2ini' + if(naflav0.ne.naflav)write(ifmt,'(a)')'iniev: wrong naflav' + if(epmax0 .ne.epmax )write(ifmt,'(a)')'iniev: wrong epmax' + if(qcdlam0.ne.qcdlam.or.q2min0.ne.q2min.or.q2ini0.ne.q2ini + * .or.naflav0.ne.naflav.or.epmax0.ne.epmax)then + write(6,'(//a//)')' iniev has to be reinitialized!!!' + stop + endif + read (1,*)evk0,evk + close(1) + endif + goto 101 + + elseif(.not.producetables)then + write(ifmt,*) "Missing epos.iniev file !" + write(ifmt,*) "Please correct the defined path ", + &"or force production ..." + stop + + endif + + write(ifmt,'(a)')'iniev does not exist -> calculate tables ...' + xmax=1.d0-2.d0*q2ini/epmax + do l=1,27 + if(l.le.12)then + xx=.1d0*exp(l-13.d0) + elseif(l.le.21)then + xx=.1d0*(l-12.d0) + else + xx=1.d0-.1d0*(10.d0*(1.d0-xmax))**((l-21)/6.) + endif + + qmin=max(1.d0*q2min,q2ini/(1.-xx)) + do i=1,21 + qq=qmin*(.5*epmax/qmin)**((i-1)/20.) + do j=1,21 + qj=qmin*(qq/qmin)**((j-1)/20.) + if(l.eq.27.or.i.eq.1.or.j.eq.21)then + evk0(i,j,l)=0. + evk0(i,j,l+27)=0. + do k=1,5 + evk(i,j,l+27*(k-1))=0. + enddo + else + do k=1,2 + evk0(i,j,l+27*(k-1))=log(psev0(qj,qq,xx,k)) + enddo + endif + enddo + enddo + enddo + + n=1 + +1 n=n+1 + write(ifmt,2)n +2 format(5x,i2,'-th order contribution') + + do l=1,26 + write(ifmt,*)'l',l + if(l.le.12)then + xx=.1d0*exp(l-13.d0) + elseif(l.le.21)then + xx=.1d0*(l-12.d0) + else + xx=1.d0-.1d0*(10.d0*(1.d0-xmax))**((l-21)/6.) + endif + + qmin=max(1.d0*q2min,q2ini/(1.d0-xx)) + do i=2,21 + qq=qmin*(.5*epmax/qmin)**((i-1)/20.) + do j=1,20 + qj=qmin*(qq/qmin)**((j-1)/20.) + do m=1,3 + do k=1,2 + if(m.ne.3)then + ev=psev(qj,qq,xx,m,k,n) + ev0=psevi0(qj,qq,xx,m,k) + evs(i,j,l+27*(m-1)+54*(k-1))=log((ev+ev0)/psfap(xx,m-1,k-1) + * /log(log(qq*(1.d0-xx)/qcdlam)/log(qj*(1.d0-xx)/qcdlam))*4.5) + elseif(k.ne.1)then + evs(i,j,l+108)=log((psev(qj,qq,xx,m,k,n)+ + * psevi0(qj,qq,xx,2,2))/psfap(xx,2,2) + * /log(log(qq*(1.d0-xx)/qcdlam)/log(qj*(1.d0-xx)/qcdlam))*4.5) + endif + enddo + enddo + enddo + enddo + enddo + + jec=0 + do i=2,21 + do j=1,20 + do l=1,26 + do k=1,5 + if(n.eq.2.or.evs(i,j,l+27*(k-1)).ne.0..and. + * abs(1.-evk(i,j,l+27*(k-1))/evs(i,j,l+27*(k-1))).gt.1.e-2)then + jec=1 + evk(i,j,l+27*(k-1))=evs(i,j,l+27*(k-1)) + endif + enddo + enddo + enddo + enddo + + if(jec.ne.0)goto 1 + + write(ifmt,'(a)')'write to iniev ...' + open(1,file=fnie(1:nfnie),status='unknown') + write (1,*)qcdlam,q2min,q2ini,naflav,epmax + write (1,*)evk0,evk + close(1) + +101 continue + return + end + +c------------------------------------------------------------------------ + function psdbom(s,t,u,qq,long) +c----------------------------------------------------------------------- +c psdbom - integrand for DIS c-quark cross-sections (matrix element squared) +c s - total c.m. energy squared for the scattering (for n=2: s+qq), +c t - invariant variable for the scattering |(p1-p3)**2| +c u - invariant variable for the scattering |(p1-p4)**2| +c qq - photon virtuality +c long: 0 - contr. to (F2-F_L), 1 - contr. to F_L +c----------------------------------------------------------------------- + include 'epos.incsem' + if(long.eq.0)then !F2-F_L + psdbom=(2.*(t/u+u/t)*(qq**2+(s-qq)**2)/s**2+ + * 4.*(qcmass*s/t/u)**2*(qq-2.*qcmass**2)+ + * 8.*qcmass**2/t/u*(s-2.*qq)) *2. !=4.5/2.25 + else !F_L_C + psdbom=16.*qq*((s-qq)/s**2-qcmass**2/t/u) *2. !=4.5/2.25 + endif + return + end + +c------------------------------------------------------------------------ + function psdbin(q1,qq,s,m1,long) +c----------------------------------------------------------------------- +c psdbin - DIS born cross-section +c q1 - virtuality cutoff for current end of the ladder +c qq - photon virtuality +c s=2(pq) - s_true + qq +c s2min - mass cutoff for born scattering +c m1 - incoming parton type (0 - g, 1,2 - q) +c----------------------------------------------------------------------- + double precision xx + include 'epos.incsem' + include 'epos.inc' + + psdbin=0. + q2mass=qcmass**2 + s2min=4.*max(q1,q2mass)+qq + if(m1.eq.0.and.s.gt.s2min.and.(idisco.eq.0.or.idisco.eq.2))then + tmax=s/2. + qtq=4.*max(q2mass,q1)/(s-qq) + if(qtq.lt.1.)then + tmin=.5*s*qtq/(1.+sqrt(1.-qtq)) + else + tmin=.5*s + endif + psdbin=psdbin+psdbor(q1,qq,s,long)*(1./tmin-1./tmax) + endif + + if(long.eq.0.and.q1.lt.qq.and.s.gt.qq/(1.-q2ini/qq) + *.and.(idisco.eq.0.or.idisco.eq.1))then + m=min(1,iabs(m1))+1 + xx=qq/s + psdbin=psdbin+psevi0(q1,qq,xx,m,2)*4.*pi**2*alfe/s + endif + return + end + +c------------------------------------------------------------------------ + function psdbor(q1,qq,s,long) +c----------------------------------------------------------------------- +c psdbor - DIS born cross-section +c q1 - virtuality cutoff for current end of the ladder +c qq - photon virtuality +c s=2(pq) - s_true + qq +c s2min - mass cutoff for born scattering +c----------------------------------------------------------------------- + common /ar3/ x1(7),a1(7) + include 'epos.inc' + include 'epos.incsem' + double precision psuds + + psdbor=0. + q2mass=qcmass**2 + qtq=4.*max(q2mass,q1)/(s-qq) + j=0 !Gluon + + tmax=s/2. + if(qtq.lt.1.)then + tmin=.5*s*qtq/(1.+sqrt(1.-qtq)) + else + tmin=.5*s + endif + if(tmax.lt.tmin.and.ish.ge.1)write(ifmt,*)'s,q1,qq,tmin,tmax', + *s,q1,qq,tmin,tmax + + ft=0. + do i=1,7 + do m=1,2 + t=2.*tmin/(1.+tmin/tmax+(2*m-3)*x1(i)*(1.-tmin/tmax)) + u=s-t + + qt=t*u/s*(1.-qq/s) + if(qt.lt..999*max(q2mass,q1).and.ish.ge.1) + & write(ifmt,*)'psdbor:qt,q1',qt,q1 + fb=psdbom(s,t,u,qq,long)*t**2 + ft=ft+a1(i)*fb*pssalf(qt/qcdlam)*sngl(psuds(qt,j)) + enddo + enddo + psdbor=ft/s**2*pi**2*alfe/sngl(psuds(q1,j)) + return + end + +c------------------------------------------------------------------------ + subroutine psdint(s,qq,sds,sdn,sdb,sdt,sdr,m1,long) +c----------------------------------------------------------------------- +c psdint - dis cross-sections interpolation - for minimal +c effective momentum cutoff in the ladder +c s - total c.m. energy squared for the ladder, +c qq - photon virtuality, +c sds - dis singlet cross-section, +c sdn - dis nonsinglet cross-section, +c sdb - dis born cross-section, +c sdt - dis singlet+resolved cross-section, +c m1 - parton type at current end of the ladder (0 - g, 1,2 - q) +c----------------------------------------------------------------------- + double precision xx + dimension wk(3),wj(3) + common /psar2/ edmax,epmax + common /psar27/ csds(21,26,4),csdt(21,26,2),csdr(21,26,2) + include 'epos.incsem' + include 'epos.inc' + + sds=0. + sdn=0. + sdt=0. + sdr=0. + sdb=psdbin(q2min,qq,s,m1,long) + + m=min(1,iabs(m1))+1 + qlj=log(qq/q2min)*2.+1. + j=int(qlj) + if(j.lt.1)j=1 + if(j.gt.19)j=19 + wj(2)=qlj-j + wj(3)=wj(2)*(wj(2)-1.)*.5 + wj(1)=1.-wj(2)+wj(3) + wj(2)=wj(2)-2.*wj(3) + + s2min=4.*max(q2min,qcmass**2)+qq + if(m1.ne.0)s2min=s2min/(1.-4.*q2ini/(s2min-qq)) + if(s.le.s2min.or.idisco.ne.0.and.idisco.ne.2)goto 1 + + qtq=4.*max(q2min,qcmass**2)/(s-qq) + if(qtq.lt.1.)then + tmin=.5*s*qtq/(1.+sqrt(1.-qtq)) + else + tmin=.5*s + endif + tmax=s/2. + + sl=log(s/s2min)/log(edmax/s2min)*25.+1. + k=int(sl) + if(k.lt.1)k=1 + if(k.gt.24)k=24 + wk(2)=sl-k + wk(3)=wk(2)*(wk(2)-1.)*.5 + wk(1)=1.-wk(2)+wk(3) + wk(2)=wk(2)-2.*wk(3) + + do k1=1,3 + k2=k+k1-1 + do j1=1,3 + sds=sds+csds(j+j1-1,k2,m+2*long)*wj(j1)*wk(k1) + enddo + enddo + if(m.eq.1)then + sds=exp(sds)*(1./tmin-1./tmax) + else + sds=max(sds,0.) + endif + +1 continue + s2min=max(4.*qq,16.*q2min)+qq + if(s.le.s2min.or.long.ne.0.or.idisco.ne.0.and.idisco.ne.3)then + sdt=sds + goto 2 + endif + + sl=log(s/s2min)/log(edmax/s2min)*25.+1. + k=int(sl) + if(k.lt.1)k=1 + if(k.gt.24)k=24 + wk(2)=sl-k + wk(3)=wk(2)*(wk(2)-1.)*.5 + wk(1)=1.-wk(2)+wk(3) + wk(2)=wk(2)-2.*wk(3) + + do k1=1,3 + k2=k+k1-1 + do j1=1,3 + sdr=sdr+csdr(j+j1-1,k2,m)*wj(j1)*wk(k1) + sdt=sdt+csdt(j+j1-1,k2,m)*wj(j1)*wk(k1) + enddo + enddo + + sdr=max(sdr,0.) + sdt=max(sds,sds+sdt) + sdt=sdt+sdr + +2 continue + if(long.eq.0.and.q2min.lt.qq.and.s.gt.qq/(1.-q2ini/qq) + *.and.(idisco.eq.0.or.idisco.eq.1))then + xx=qq/s + dsi=psevi(q2min,qq,xx,m,2)*4.*pi**2*alfe/s + if(m1.eq.0)then + sds=sds+dsi + sdt=sdt+dsi + else + dnsi=psevi(q2min,qq,xx,3,2)*4.*pi**2*alfe/s + sdn=sdn+dnsi + sds=sds+max(dsi-dnsi,0.) + sdt=sdt+max(dsi-dnsi,0.) + endif + endif + + if(m1.eq.0)then + sds=max(sds,sdb) + sdt=max(sdt,sdb) + else + sdn=max(sdn,sdb) + endif + return + end + +c----------------------------------------------------------------------- + function psdnsi(q1,qq,s,long) +c----------------------------------------------------------------------- +c psdnsi - DIS nonsinglet cross-section interpolation +c q1 - effective momentum cutoff for current end of the ladder, +c qq - photon virtuality, +c s - total c.m. energy squared for the ladder, +c----------------------------------------------------------------------- + double precision xx + include 'epos.incsem' + include 'epos.inc' + + psdnsi=0. + if(long.eq.0.and.q1.lt.qq.and.s.gt.qq/(1.-q2ini/qq))then + xx=qq/s + psdnsi=psdnsi+max(0.,psevi(q1,qq,xx,3,2)*4.*pi**2*alfe/s) + endif + return + end + +c----------------------------------------------------------------------- + function psdrga(qq,s,s2min,j) +c----------------------------------------------------------------------- +c psdrga - DIS resolved cross-section (photon sf) +c qq - photon virtuality +c s - total c.m. energy squared for the process +c s2min - mass cutoff for born scattering +c j - parton type at current end of the ladder (0 - g, 1,2 etc. - q) +c----------------------------------------------------------------------- + common /ar3/ x1(7),a1(7) + include 'epos.incsem' + + psdrga=0. + if(s.le.s2min)return + + xmin=s2min/s + do i=1,7 + do m=1,2 + z=xmin**(.5+(m-1.5)*x1(i)) + tu=psdfh4(z,q2min,qq,0,1) + td=psdfh4(z,q2min,qq,0,2) + ts=psdfh4(z,q2min,qq,0,3) + tg=psdfh4(z,q2min,qq,0,0) + if(j.eq.0)then + sj=tg*psjti(q2min,qq,z*s,0,j,1)+ + * (tu+td+ts)*psjti(q2min,qq,z*s,1,j,1) + else + sj=tg*psjti(q2min,qq,z*s,0,j,1)+ + * (tu+td)*(psjti(q2min,qq,z*s,1,1,1)/4.+ + * psjti(q2min,qq,z*s,-1,1,1)/4.+ + * psjti(q2min,qq,z*s,2,1,1)/2.)+ + * ts*psjti(q2min,qq,z*s,2,1,1) + endif + psdrga=psdrga+a1(i)*sj + enddo + enddo + psdrga=-psdrga*log(xmin)*alfe/2. *4.5 !mean e^2 is taken out + return + end + +c----------------------------------------------------------------------- + function psdres(qq,s,s2min,j) +c----------------------------------------------------------------------- +c psdres - DIS resolved photon cross-section +c qq - photon virtuality +c s - total w squared for the ladder (s+qq) +c s2min - mass cutoff for born scattering +c j - parton type at current end of the ladder (0 - g, 1,2 etc. - q) +c----------------------------------------------------------------------- + double precision xx + common /ar3/ x1(7),a1(7) + include 'epos.inc' + include 'epos.incsem' + + psdres=0. + if(s.le.s2min+qq)return + + qmin=max(q2min,s2min/(s/qq-1.)) + qmax=min(s-s2min,s/2.) + +c numerical integration over transverse momentum squared; +c gaussian integration is used + do i=1,7 + do m=1,2 + qi=2.*qmin/(1.+qmin/qmax+(2*m-3)*x1(i)*(1.-qmin/qmax)) + + zmax=min(1.,qi/qq) + zmin=(max(qi,s2min)+qi)/s + + fsj=0. + if(zmax.gt.zmin)then + do i1=1,7 + do m1=1,2 + z=.5*(zmax+zmin+(2*m1-3)*x1(i1)*(zmax-zmin)) + s2=z*s-qi + xx=z + if(j.eq.0)then + sj=psfap(xx,0,1)*psjti(qi,qq,s2,1,j,1) + else + sj=psfap(xx,0,1)*(psjti(qi,qq,s2,1,1,1)/6.+ + * psjti(qi,qq,s2,-1,1,1)/6.+ + * psjti(qi,qq,s2,2,1,1)/1.5) + endif + fsj=fsj+a1(i1)*sj*qi !????????(qi-z*qq) + enddo + enddo + fsj=fsj*(zmax-zmin) + elseif(ish.ge.1)then + write(ifmt,*)'psdres:zmax,zmin',zmax,zmin + endif + psdres=psdres+a1(i)*fsj + enddo + enddo + psdres=psdres*(1./qmin-1./qmax)*alfe*.75/pi !alpha_s -> 6 alpha_e + return + end + +c------------------------------------------------------------------------ + function psds(q1,qq,s,j,long) +c----------------------------------------------------------------------- +c psds - DIS singlet cross-section +c q1 - virtuality cutoff for current end of the ladder +c qq - photon virtuality +c s=2(pq) - s_true + qq +c s2min - mass cutoff for born scattering +c----------------------------------------------------------------------- + double precision xxe,xmax,xmin,xmax1,xmin1 + common /ar3/ x1(7),a1(7) + include 'epos.inc' + include 'epos.incsem' + + psds=0. + q2mass=qcmass**2 + s2min=4.*max(q1,q2mass) + smin=(s2min+qq)/(1.-4.*q2ini/s2min) + if(s.le.1.001*smin)return + + xmax=.5d0*(1.d0+qq/s+dsqrt((1.d0-qq/s)**2-16.d0*q2ini/s)) + xmin=max(1.d0+qq/s-xmax,1.d0*(s2min+qq)/s) + if(xmin.gt.xmax.and.ish.ge.1)write(ifmt,*)'xmin,xmax,q1,qq,s,smin' + *,xmin,xmax,q1,qq,s,smin + + fx1=0. + fx2=0. + if(xmax.gt..9d0)then + xmin1=max(xmin,.9d0) + do i=1,7 + do m=1,2 + xxe=1.d0-(1.d0-xmax)*((1.d0-xmin1)/(1.d0-xmax))** + * (.5d0-x1(i)*(m-1.5)) + xx=xxe + + sh=xx*s + qtmin=max(1.d0*max(q2mass,q1),q2ini/(1.d0-xxe)) + qtq=4.*qtmin/(sh-qq) + + tmin=.5*sh*qtq/(1.+sqrt(1.-qtq)) + tmax=.5*sh + if(tmin.gt.tmax.and.ish.ge.1)write(ifmt,*)'psds:tmin,tmax' + & ,tmin,tmax + + ft=0. + do i1=1,7 + do m1=1,2 + t=.5*(tmin+tmax+(2*m1-3)*x1(i1)*(tmin-tmax)) + u=sh-t + qt=t*u/sh*(1.-qq/sh) + if(qt.lt.qtmin.and.ish.ge.1)write(ifmt,*)'psds:qt,qtmin' + & ,qt,qtmin + + fb=psdsj(q1,xxe,sh,qt,t,u,qq,j,long) + ft=ft+a1(i1)*fb*pssalf(qt/qcdlam) + enddo + enddo + ft=ft*(tmax-tmin) + fx1=fx1+a1(i)*ft*(1.-xx)/sh**2 + enddo + enddo + fx1=fx1*log((1.d0-xmin1)/(1.d0-xmax)) + endif + + if(xmin.lt..9d0)then + xmax1=min(xmax,.9d0) + do i=1,7 + do m=1,2 + xxe=xmin*(xmax1/xmin)**(.5-x1(i)*(m-1.5)) + xx=xxe + + sh=xx*s + qtmin=max(1.d0*max(q2mass,q1),q2ini/(1.d0-xxe)) + qtq=4.*qtmin/(sh-qq) + + tmin=.5*sh*qtq/(1.+sqrt(1.-qtq)) + tmax=.5*sh + if(tmin.gt.tmax.and.ish.ge.1)write(ifmt,*)'psds:tmin,tmax' + * ,tmin,tmax + + ft=0. + do i1=1,7 + do m1=1,2 + t=(.5*(tmin+tmax+(2*m1-3)*x1(i1)* + * (tmin-tmax))) + u=sh-t + qt=t*u/sh*(1.-qq/sh) + if(qt.lt.qtmin.and.ish.ge.1)write(ifmt,*)'psds:qt,qtmin' + * ,qt,qtmin + + fb=psdsj(q1,xxe,sh,qt,t,u,qq,j,long) + ft=ft+a1(i1)*fb*pssalf(qt/qcdlam) + enddo + enddo + ft=ft*(tmax-tmin) + fx2=fx2+a1(i)*ft*xx/sh**2 + enddo + enddo + fx2=fx2*log(xmax1/xmin) + endif + psds=(fx1+fx2)*pi**2*alfe + return + end + +c----------------------------------------------------------------------- + function psdsj(q1,xx,s,qt,t,u,qq,j,long) +c----------------------------------------------------------------------- +c psdsj - integrand for dis singlet cross-section +c q1 - virtuality cutoff for current end of the ladder +c xx - lc momentum ratio between initial (j) and final (l) partons +c s - c.m. energy squared for the born scattering, +c t - invariant variable for the born scattering |(p1-p3)**2| +c u - invariant variable for the born scattering |(p1-p4)**2| +c qq - photon virtuality +c j - initial parton at the end of the ladder (0 - g, 1,2 - q) +c----------------------------------------------------------------------- + double precision xx + include 'epos.incsem' + + fb=psdbom(s,t,u,qq,long) + psdsj=psevi(q1,qt,xx,min(1,iabs(j))+1,1)*fb + return + end + +c------------------------------------------------------------------------ + function psdsin(q1,qq,s,m1,long) +c----------------------------------------------------------------------- +c psdsin - DIS singlet cross-section interpolation +c q1 - effective momentum cutoff for current end of the ladder, +c qq - photon virtuality, +c s - total c.m. energy squared for the ladder, +c m1 - parton type at current end of the ladder (0 - g, 1,2 - q) +c----------------------------------------------------------------------- + double precision xx + dimension wi(3),wj(3),wk(3) + common /psar2/ edmax,epmax + common /psar25/ csdsi(21,21,104) + include 'epos.incsem' + include 'epos.inc' + + psdsin=0. + m=min(1,iabs(m1))+1 + + q2mass=qcmass**2 + s2min=4.*max(q2min,q2mass)+qq + sdmin=4.*max(q1,q2mass)+qq + if(m1.ne.0)then + s2min=s2min/(1.-4.*q2ini/(s2min-qq)) + sdmin=sdmin/(1.-4.*q2ini/(sdmin-qq)) + endif +c if(s.le.1.e8*sdmin)goto 2 !???????????????? + if(s.le.sdmin)goto 2 + + qmin=q2min + qmax=(s-qq)/4. + if(m1.ne.0)qmax=(s-qq+sqrt((s-qq)**2-16.*s*q2ini))/8. + qtq=4.*max(q2mass,q1)/(s-qq) + if(qtq.lt.1.)then + tmin=.5*s*qtq/(1.+sqrt(1.-qtq)) + else + tmin=.5*s + endif + tmax=s/2. + + qlj=log(qq/q2min)*2.+1. + j=int(qlj) + if(j.lt.1)j=1 + if(j.gt.19)j=19 + wj(2)=qlj-j + wj(3)=wj(2)*(wj(2)-1.)*.5 + wj(1)=1.-wj(2)+wj(3) + wj(2)=wj(2)-2.*wj(3) + + qli=log(q1/qmin)/log(qmax/qmin)*20.+1. + i=int(qli) + if(i.lt.1)i=1 + if(i.gt.19)i=19 + wi(2)=qli-i + wi(3)=wi(2)*(wi(2)-1.)*.5 + wi(1)=1.-wi(2)+wi(3) + wi(2)=wi(2)-2.*wi(3) + + sl=log(s/s2min)/log(edmax/s2min)*25.+1. + k=int(sl) + if(k.lt.1)k=1 + if(k.gt.24)k=24 + wk(2)=sl-k + wk(3)=wk(2)*(wk(2)-1.)*.5 + wk(1)=1.-wk(2)+wk(3) + wk(2)=wk(2)-2.*wk(3) + + dsin1=0. + do k1=1,3 + k2=k+k1-1+26*(m-1)+52*long + do i1=1,3 + do j1=1,3 + dsin1=dsin1+csdsi(i+i1-1,j+j1-1,k2)*wi(i1)*wj(j1)*wk(k1) + enddo + enddo + enddo + if(m1.eq.0)then + psdsin=psdsin+exp(dsin1)*(1./tmin-1./tmax) + else + psdsin=psdsin+max(0.,dsin1) + endif + +2 continue + if(long.eq.0.and.q1.lt.qq.and.s.gt.qq/(1.-q2ini/qq))then + xx=qq/s + dsi=psevi(q1,qq,xx,m,2)*4.*pi**2*alfe/s + if(m1.eq.0)then + psdsin=psdsin+max(dsi,0.) + else + dnsi=psevi(q1,qq,xx,3,2)*4.*pi**2*alfe/s + psdsin=psdsin+max(dsi-dnsi,0.) + endif + endif + return + end + + + + + + + + + + + + + + +c########################################################################### +c########################################################################### +c########################################################################### +c########################################################################### +c +c unused 3P +c +c########################################################################### +c########################################################################### +c########################################################################### +c########################################################################### + + +cc------------------------------------------------------------------------ +c function psvy(xpp0,xpr0,xpm0,xmr0,b,iqq) +cc----------------------------------------------------------------------- +cc psvy - 3p-contributions to the interaction eikonal +cc xpp - lc+ for the pomeron, +cc xpr - lc+ for the remnant, +cc xpm - lc- for the pomeron, +cc xpr - lc- for the remnant, +cc b - impact parameter, +cc iqq=1 - Y-proj-uncut +cc iqq=2 - Y-proj-1-cut +cc iqq=3 - Y-proj-2-cut +cc iqq=4 - Y-proj-soft-cut +cc iqq=5 - Y-proj-gss-cut +cc iqq=6 - Y-proj-qss-cut +cc iqq=7 - Y-proj-ssg-cut +cc iqq=8 - Y-proj-ssq-cut +cc iqq=9 - Y-proj-difr +cc iqq=-1 - Y-targ-uncut +cc iqq=-2 - Y-targ-1-cut +cc iqq=-3 - Y-targ-2-cut +cc iqq=-4 - Y-targ-soft-cut +cc iqq=-5 - Y-targ-gss-cut +cc iqq=-6 - Y-targ-qss-cut +cc iqq=-7 - Y-targ-ssg-cut +cc iqq=-8 - Y-targ-ssq-cut +cc iqq=-9 - Y-targ-difr +cc------------------------------------------------------------------------ +c +c psvy=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function psvx(xpp,xpr,xpm,xmr,b,iqq) +cc----------------------------------------------------------------------- +cc psvx - 4p-contributions to the interaction eikonal +cc xpp - lc+ for the pomeron, +cc xpr - lc+ for the remnant, +cc xpm - lc- for the pomeron, +cc xpr - lc- for the remnant, +cc b - impact parameter, +cc iqq=0 - X-uncut +cc iqq=1 - X-1-cut +cc iqq=2 - X-Y+cut +cc iqq=-2 - X-Y-cut +cc iqq=3 - X-1-cut-soft +cc iqq=4 - X-1-cut-gss +cc iqq=-4 - X-1-cut-gss +cc iqq=5 - X-1-cut-qss +cc iqq=-5 - X-1-cut-qss +cc iqq=6 - X-difr+ +cc iqq=-6 - X-difr- +cc------------------------------------------------------------------------ +c +c psvx=0. +c return +c end +c +c +c +c +c +c +c +c +c +c +cc------------------------------------------------------------------------ +c function psftig(x,xpomr,jj) +cc----------------------------------------------------------------------- +c +c psftig=0. +c end +c +c +cc------------------------------------------------------------------------ +c function psftih(zz,ddd) +cc----------------------------------------------------------------------- +c +c psftih=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function psftij(zz,ddd) +cc------------------------------------------------------------------------ +c +c psftij=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function psftik(xp,del1,rh1,rh2,rh3,rp,z) +cc----------------------------------------------------------------------- +c +c psftik=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function psftim(xp1,xp,del1,rh1,rh2,rh3,rp,z) +cc----------------------------------------------------------------------- +c +c psftim=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function psftil(xp,del1,rh1,rh2,rh3,rp,z) +cc------------------------------------------------------------------------ +c +c psftil=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function psftigt(x) +cc----------------------------------------------------------------------- +c +c psftigt=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function psftist(x) +cc----------------------------------------------------------------------- +c psftist=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function psftig1(x,xpomr,jj) +cc----------------------------------------------------------------------- +c psftig1=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function psftis1(x,xpomr,jj) +cc----------------------------------------------------------------------- +c psftis1=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function psd3p1(xd,xpomr,qq,jj) +cc----------------------------------------------------------------------- +cc psd3p1 - df2difr/dx_pomr +cc xd - bjorken x, +cc xpomr - pomeron x, +cc qq - photon virtuality +cc jj=1 - 1st order +cc----------------------------------------------------------------------- +c +c psd3p1=0. +c +c return +c end +c +cc------------------------------------------------------------------------ +c function psv3p(sy,xpp,xpm,zb) +cc----------------------------------------------------------------------- +cc psv3p - 3p-contributions to the interaction eikonal +cc sy - energy squared for the hard interaction, +cc xpp - lc+ for the sh pomeron, +cc xpm - lc- for the sh pomeron, +cc z - impact parameter factor, z=exp(-b**2/4*rp), +cc------------------------------------------------------------------------ +c +c psv3p=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function psfro(xpomr,zb,iclp,icdpro) +cc----------------------------------------------------------------------- +cc psfro - generalized froissaron between proj. and 3p-vertex +cc xpp - lc+ for the proj. side, +cc xpomr - lc+ for the vertex, +cc zb - impact parameter factor, z=exp(-b**2/4*rp), +cc------------------------------------------------------------------------ +c psfro=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function psv2(xpomr,zb,iclp,iqq) +cc----------------------------------------------------------------------- +cc psv2 - 2-pom contribution to the froissaron +cc xpomr - lc+ for the vertex, +cc zb - impact parameter factor, z=exp(-b**2/4*rp), +cc------------------------------------------------------------------------ +c +c psv2=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function psvfro(xpp,xpr,xpomr,zb,iclp,icdpro,iqq) +cc----------------------------------------------------------------------- +cc psvfro - effective froissaron contributions +cc xpomr - lc+ for the vertex, +cc zb - impact parameter factor, z=exp(-b**2/4*rp), +cc iqq=0 - total uncut +cc iqq=1 - total 1-cut +cc iqq=2 - total 2-cut +cc iqq=3 - soft 1-cut +cc iqq=4 - gg 1-cut +cc iqq=5 - qg 1-cut +cc iqq=6 - difr +cc------------------------------------------------------------------------ +c +c psvfro=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function psfroin(xpomr,z,iclp,icdpro) +cc----------------------------------------------------------------------- +cc psfroin - interpolation of effective froissaron corrections +cc xpomr - lc+ for the 3p-vertex, +cc z - impact parameter factor, z=exp(-b**2/4*rp), +cc----------------------------------------------------------------------- +c +c psfroin=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function psvnorm(b) +cc----------------------------------------------------------------------- +cc psvnorm - X-contribution normalization +cc b - impact parameter +cc----------------------------------------------------------------------- +c +c psvnorm=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function psvxb(dxpp,dxpr,dxpm,dxmr,dxpomr,bb1,bb2 +c *,iclp,iclt,icdpro,icdtar,iqq) +cc----------------------------------------------------------------------- +cc psvxb - integrand for X-contributions +cc dxpomr - lc+ for the vertex, +cc bb1,bb2 - impact parameters to proj(targ), +cc iqq=0 - uncut +cc iqq=1 - 1-cut +cc iqq=2 - Y-cut +cc iqq=3 - soft 1-cut +cc iqq=4 - gg 1-cut +cc iqq=5 - qg 1-cut +cc iqq=6 - difr +cc------------------------------------------------------------------------ +c double precision dxpp,dxpr,dxpm,dxmr,dxpomr +c +c psvxb=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function pscoef(zz,alp1,alp2,iclp,iqq) +cc----------------------------------------------------------------------- +cc pscoef - integrated vertexes +cc zz=xpomr/xpr(xpp) +cc iqq=0 - 2-cut +cc iqq=1 - 1-uncut +cc iqq=2 - 2-uncut +cc------------------------------------------------------------------------ +c +c pscoef=0. +c return +c end +c +cc------------------------------------------------------------------------ +c function pscoefi(z,i1,i2,iclp,iqq) +cc----------------------------------------------------------------------- +cc pscoefi - interpolation of integrated vertexes +cc z=xpomr/xpr(xpp) +cc iqq=0 - 2-cut +cc iqq=1 - 1-uncut +cc iqq=2 - 2-uncut +cc------------------------------------------------------------------------ +c pscoefi=0. +c return +c end +c +c diff --git a/modules/epos/epos-rsh-lhc.f b/modules/epos/epos-rsh-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..b3db1b9e5320c1b998af399f03f52ea12586a84c --- /dev/null +++ b/modules/epos/epos-rsh-lhc.f @@ -0,0 +1,3126 @@ +c reshuffled from sem, sto, sha + +c contains psahot and related stuff +c ------ + + + +c----------------------------------------------------------------------- + subroutine psahot(kcol,ncolp,iret) +c----------------------------------------------------------------------- +c psahot - showering (semihard parton-parton interaction) +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + include 'epos.incpar' + double precision ept(4),ept1(4),xx,wpt(2),eprt,pl,plprt,wplc + *,wp0,wm0,s,si,smin,xmin,xp1,wpi,wmi,xp,xm,wp1,wm1,wp2,wm2 + *,wpq,wmq,wpi1,wmi1,pxh,pyh,pth,xmm,xp2,xg,zg,smax,xmax + *,xmax1,xmin1,zp0,psutz,xpmax0,xpmin0,gb0,tmax0,tmin0,zpm,gb + *,gbyj,tmax,tmin,t,gb7,x,s2,discr,qt,qt2,x1min,x1max,t1min,t1max + *,t1,xq1,qq,qqmax,qqmin,pt2,xmin2,ptnew,xpmin,xpmax,xm0,psuds +c *,xprh,xmrh + dimension ep3(4),ey(3),bx(6) + *,qmin(2),iqc(2),nqc(2),ncc(2,2),amqt(4) + parameter (mjstr=20000) + common /psar7/ delx,alam3p,gam3p + common /psar29/eqj(4,mjstr),iqj(mjstr),ncj(2,mjstr),ioj(mjstr),nj + common /psar30/iorj(mjstr),ityj(mjstr),bxj(6,mjstr),q2j(mjstr) + common /testj/ ajeth(4),ajete(5),ajet0(7) + parameter (ntim=1000) + common/cprt/pprt(5,ntim),q2prt(ntim),idaprt(2,ntim),idprt(ntim) + &,iorprt(ntim),jorprt(ntim),nprtj + common/emsptl/nppr(npommx,kollmx),npproj(mamx),nptarg(mamx) + integer icp(2),ict(2),nemis(2) + integer icp1(2),icp2(2),icm1(2),icm2(2) + integer jcp(nflav,2),jct(nflav,2),jcpr(nflav,2),jctr(nflav,2) + common/cprtx/nprtjx,pprtx(5,2)/ciptl/iptl + + call utpri('psahot',ish,ishini,3) + + iret=0 + alpq=-(alppar+1.)/2. + qqcut=q2min !????????????pt2cut + + + nptl1=nptl + iptl=nppr(ncolp,kcol) + ip=iproj(kcol) + it=itarg(kcol) + do i=1,2 + icp(i)=icproj(i,ip) + ict(i)=ictarg(i,it) + enddo + idpomr=idhpr(ncolp,kcol) + bpomr=bhpr(ncolp,kcol) + + q2finsave=q2fin + zzzz=zparpro(kcol)+zpartar(kcol) + nnn=ltarg3(it)+lproj3(ip) + zz=1.+zoeinc*zzzz**2 !<----- + q2fin=q2fin*zz + +c print *,kcol,zzzz,zz,q2fin + + ajeth(idpomr+1)=ajeth(idpomr+1)+1. +c write(*,*)ajeth + idfpomr=idfpr(ncolp,kcol) + if(ish.ge.3)write(ifch,*)'Start psahot (icp,ict):',ip,icp,it,ict + *,ncolp,kcol,iptl,idpomr,idfpomr,bpomr + + + if(idfpomr.eq.0)stop'idfpomr??????' + if(ish.ge.3)then + write(ifch,20)iptl + * ,sqrt(pptl(1,iptl)**2+pptl(2,iptl)**2),pptl(3,iptl) + * ,pptl(4,iptl),pptl(5,iptl) + * ,istptl(iptl),ityptl(iptl) +20 format(1x,i4,3x,4(e11.5,1x),i2,1x,i3) + endif + istptl(iptl)=31 + +csp initialise to 0 +1 do i=1,nj + ncj(1,i)=0 + ncj(2,i)=0 + enddo +csp end initialisation + + nj=0 + nptl=nptl1 + if(iremn.ge.2)then + call iddeco(icp,jcp) + call iddeco(ict,jct) + endif + + wp0=dsqrt(xpr(ncolp,kcol))*dexp(ypr(ncolp,kcol))*dble(engy) !???? new + wm0=dsqrt(xpr(ncolp,kcol))*dexp(-ypr(ncolp,kcol))*dble(engy) !double + + + amqt(1)=sqrt(sngl(xxp1pr(ncolp,kcol)**2+xyp1pr(ncolp,kcol)**2)) + amqt(2)=sqrt(sngl(xxp2pr(ncolp,kcol)**2+xyp2pr(ncolp,kcol)**2)) + amqt(3)=sqrt(sngl(xxm2pr(ncolp,kcol)**2+xym2pr(ncolp,kcol)**2)) + amqt(4)=sqrt(sngl(xxm1pr(ncolp,kcol)**2+xym1pr(ncolp,kcol)**2)) + amqpt=amqt(1)+amqt(2)+amqt(3)+amqt(4) + + s2min=4.*q2min + if(sngl(wp0*wm0).le.(sqrt(s2min)+amqpt)**2)then + if(ish.ge.1)then + call utmsg('psahot: insufficient pomeron mass&') + write (ifch,*)'mass:',dsqrt(wp0*wm0),amqpt+sqrt(s2min) + call utmsgf + endif + iret=1 + goto 16 + endif + + ih=iproj(kcol) + jh=itarg(kcol) +c xprh=xpp(ih) +c xmrh=xmt(jh) + rp=r2had(iclpro)+r2had(icltar)+slopom*log(engy**2) + z=exp(-bpomr**2/(4.*.0389*rp)) !coef for rejection + + if(z.eq.0)then + write(ifch,*)'psahot : z,ih,jh ! -> ',z,ih,jh + call gakli2(ih,ih) + call gakli2(jh,jh) + call gakli2(iptl,iptl) + stop + endif + + do l=1,4 + bx(l)=xorptl(l,iptl) + enddo + bx(5)=tivptl(1,iptl) + bx(6)=tivptl(2,iptl) + ity=ityptl(iptl) + + if(idpomr.eq.0)then !gg-pomeron + iqq=0 !type of the hard interaction: 0 - gg, 1 - qg, 2 - gq, 3 - qq + pxh=0.d0 !p_x for sh pomeron + pyh=0.d0 !p_y for sh pomeron + elseif(idpomr.eq.1)then !qg-pomeron + iqq=1 + pxh=xxp1pr(ncolp,kcol) + pyh=xyp1pr(ncolp,kcol) + amqpt=amqpt-amqt(1) + elseif(idpomr.eq.2)then !gq-pomeron + iqq=2 + pxh=xxm2pr(ncolp,kcol) + pyh=xym2pr(ncolp,kcol) + amqpt=amqpt-amqt(3) + elseif(idpomr.eq.3)then !qq-pomeron + iqq=3 + pxh=xxp1pr(ncolp,kcol)+xxm2pr(ncolp,kcol) + pyh=xyp1pr(ncolp,kcol)+xym2pr(ncolp,kcol) + amqpt=amqpt-amqt(1)-amqt(3) + else + stop'unknown pomeron' + endif + pth=pxh**2+pyh**2 + + nj0=nj + if(ish.ge.6)then + write(ifch,*)'iptl,nptl,wp0,wm0,z,iqq,bx:' + write(ifch,*) iptl,nptl,wp0,wm0,z,iqq,bx + endif + + s=wp0*wm0 !lc+*lc- for the semihard interaction + smin=dble(s2min)+pth !mass cutoff for the hard pomeron + xmin=smin/s + smax=(dsqrt(s)-dble(amqpt))**2 !max mass for the hard pomeron + xmax=smax/s + !wwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwww + if(iLHC.eq.1.and.iqq.ne.3)then !not for val-val +c xmin is the minimum value of zpm which is the fraction of the Pomeron +c energy going into the hard part. If zpm=1 nothing left is the soft +c preevolution part (momentum of soft string ends) +c take into account z (impact parameter) dependence to avoid hard Pom +c at large b (lot of rejection and not realistic) +c print *,xmin,zopinc*fegypp*exp(-bpomr**2/b2xscr),xmax +c *,smin,max(xmin,min(0.99*xmax,zzzz*zzsoft))*ss + xmin=max(xmin,min((sqrt(s)-dble(amqpt+ammsdd))**2/s + & ,dble(max(nnn*fegypp*exp(-bpomr**2/b2xscr),zzzz)*zopinc*z))) +c xmin=max(xmin,1d0-exp(-dble(zzsoft*zzzz**2))) !??????????????? + smin=xmin*s + endif + !wwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwwww + if(smax.le.smin)then + write (ifmt,*)'smax,smin',smax,smin + iret=1 + goto 16 + endif + xpmax0=psutz(s,smin,dble(amqpt**2)) !max x+ for the hard pomeron + xpmin0=xmin/xpmax0 !min x+ for the hard pomeron + xp1=wp0/dble(engy) !lc+ share for the semihard interaction + xp2=wm0/dble(engy) !lc- share for the semihard interaction + + +c----------------------------------------------------------------- +c determine LC momenta wpi,wmi for hard Pomeron +c----------------------------------------------------------------- + + if(ish.ge.4)write(ifch,*) + & 'determine LC momenta wpi,wmi for hard Pomeron' + + if(iremn.ge.2)then + if(iclpro.eq.2)then + if(iabs(idptl(ip)).eq.1120)then !proj=proton + nquu1=jcp(1,1)+jcp(1,2) + nqud1=jcp(2,1)+jcp(2,2) + elseif(iabs(idptl(ip)).eq.1220)then !proj=neutron + nquu1=jcp(2,1)+jcp(2,2) + nqud1=jcp(1,1)+jcp(1,2) + else !to avoid flavor problem with exotic projectile (but should not happen (only gg) + nquu1=0 + nqud1=0 + endif + elseif(iclpro.eq.1)then + if(iabs(idptl(ip)).eq.120)then + nquu1=jcp(1,1)+jcp(1,2) + nqud1=jcp(2,1)+jcp(2,2) + else !to avoid flavor problem with exotic projectile (but should not happen (only gg) + nquu1=0 + nqud1=0 + endif + elseif(iclpro.eq.3)then + if(iabs(idptl(ip)).eq.130)then !proj=Kch + nquu1=jcp(1,1)+jcp(1,2) + nqud1=jcp(3,1)+jcp(3,2) + elseif(iabs(idptl(ip)).eq.230)then !proj=K0 + nquu1=jcp(2,1)+jcp(2,2) + nqud1=jcp(3,1)+jcp(3,2) + else !to avoid flavor problem with exotic projectile (but should not happen (only gg) + nquu1=0 + nqud1=0 + endif + else !charm + if(iabs(idptl(ip)).eq.140)then + nquu1=jcp(1,1)+jcp(1,2) + nqud1=jcp(4,1)+jcp(4,2) + elseif(iabs(idptl(ip)).eq.240)then + nquu1=jcp(2,1)+jcp(2,2) + nqud1=jcp(4,1)+jcp(4,2) + elseif(iabs(idptl(ip)).eq.340)then + nquu1=jcp(3,1)+jcp(3,2) + nqud1=jcp(4,1)+jcp(4,2) + else + nquu1=jcp(4,1) + nqud1=jcp(4,2) + endif + endif + if(iabs(idptl(maproj+it)).eq.1220)then !targ=neutron + nquu2=jct(2,1)+jct(2,2) + nqud2=jct(1,1)+jct(1,2) + else + nquu2=jct(1,1)+jct(1,2) + nqud2=jct(2,1)+jct(2,2) + endif + endif + + iq1=0 + iq2=0 + wwgg=0. + wwgq=0. + wwqg=0. + wwqq=0. + wwdd=0. + + !------------------------------------------ + if(iqq.eq.3)then ! val-val + !------------------------------------------ + + if(ish.ge.4)write(ifch,*)'val-val' + xmin1=xmin**dble(delh+.4) + xmax1=xmax**dble(delh+.4) + zp0=dsqrt(xmin) + if(zp0.ge.1.d0)call utstop('zp0 in sem&') + !........ kinematical bounds + tmax0=dlog((1.d0+dsqrt(1.d0-zp0))/(1.d0-dsqrt(1.d0-zp0))) + tmin0=dlog((1.d0+dsqrt(1.d0-xpmax0)) + * /(1.d0-dsqrt(1.d0-xpmax0))) + if(iclpro.ne.4)then + call psjti0(sngl(smax-pth),sqq,sqqb,1,1) + call psjti0(sngl(smax-pth),sqqp,sqqpb,1,2) + call psjti0(sngl(smax-pth),sqaq,sqaqb,-1,1) + else + call psjti0(sngl(smax-pth),sqqp,sqqpb,4,2) + sqq=0. + sqaq=0. + endif + if(iremn.ge.2)then + if(nquu1.gt.nqud1.or.iclpro.ne.2)then + uv1=psdfh4(sngl(zp0*xp1),q2min,0.,iclpro,1) + dv1=psdfh4(sngl(zp0*xp1),q2min,0.,iclpro,2) + else !if nquu<nqud => no u or no d + uv1=psdfh4(sngl(zp0*xp1),q2min,0.,1,1) + dv1=uv1 + endif + if(nquu1.eq.0)uv1=0d0 + if(nqud1.eq.0)dv1=0d0 + if(nquu2.gt.nqud2)then + uv2=psdfh4(sngl(zp0*xp2),q2min,0.,icltar,1) + dv2=psdfh4(sngl(zp0*xp2),q2min,0.,icltar,2) + else !if nquu<nqud => no u or no d + uv2=psdfh4(sngl(zp0*xp2),q2min,0.,1,1) + dv2=uv2 + endif + if(nquu2.eq.0)uv2=0d0 + if(nqud2.eq.0)dv2=0d0 + else + uv1=psdfh4(sngl(zp0*xp1),q2min,0.,iclpro,1) + dv1=psdfh4(sngl(zp0*xp1),q2min,0.,iclpro,2) + uv2=psdfh4(sngl(zp0*xp2),q2min,0.,icltar,1) + dv2=psdfh4(sngl(zp0*xp2),q2min,0.,icltar,2) + endif + wwuu=uv1*uv2*sqq + if(iclpro.eq.2)then + wwdd=dv1*dv2*sqq + elseif(iclpro.eq.1)then + wwdd=dv1*dv2*sqaq + elseif(iclpro.eq.3)then + wwdd=dv1*dv2*sqqp + elseif(iclpro.eq.4)then + wwuu=uv1*uv2*sqqp + wwdd=0. + endif + wwud=uv1*dv2*sqqp + wwdu=dv1*uv2*sqqp + wudt=wwuu+wwdd+wwud+wwdu + gb0=dble(wudt)/xmax**dble(delh)/xmin**0.4* + * (1.d0-zp0*xp1)**dble(-1.-alpq-alplea(iclpro))* + * (1.d0-zp0*xp2)**dble(-1.-alpq-alplea(icltar))*(tmax0-tmin0) + * *(1.d0-zp0)**dble(.5+alpq)*(1.d0-zp0)**dble(alpq) *5.d0 + +3 zpm=(xmin1+dble(rangen())*(xmax1-xmin1))**dble(1./(delh+.4)) !zpm + if(iclpro.ne.4)then + call psjti0(sngl(zpm*s-pth),sqq,sqqb,1,1) + call psjti0(sngl(zpm*s-pth),sqqp,sqqpb,1,2) + call psjti0(sngl(zpm*s-pth),sqaq,sqaqb,-1,1) + else + call psjti0(sngl(zpm*s-pth),sqqp,sqqpb,4,2) + sqq=0. + sqaq=0. + endif + xpmax=psutz(s,zpm*s,dble(amqpt**2)) !max x+ for sh pomeron + tmax=dlog((1.d0+dsqrt(1.d0-dsqrt(zpm))) + * /(1.d0-dsqrt(1.d0-dsqrt(zpm)))) + tmin=dlog((1.d0+dsqrt(1.d0-xpmax))/(1.d0-dsqrt(1.d0-xpmax))) + + t=(tmin+dble(rangen())*(tmax-tmin)) + xp=1.d0-((1.d0-dexp(-t))/(1.d0+dexp(-t)))**2 !x+_v + xm=zpm/xp !x-_v + if(xm.gt.xp.and.ish.ge.1)write(ifmt,*)'xm,xp',xm,xp + gb=(1.d0-xm)**alpq*(1.d0-xp)**(.5+alpq)*(tmax-tmin) + if(rangen().lt..5)then + xp=xm + xm=zpm/xp + endif + + if(iremn.ge.2)then + if(nquu1.gt.nqud1.or.iclpro.ne.2)then + uv1=psdfh4(sngl(xp*xp1),q2min,0.,iclpro,1) + dv1=psdfh4(sngl(xp*xp1),q2min,0.,iclpro,2) + else !if nquu<nqud => no u or no d + uv1=psdfh4(sngl(xp*xp1),q2min,0.,1,1) + dv1=uv1 + endif + if(nquu1.eq.0)uv1=0d0 + if(nqud1.eq.0)dv1=0d0 + if(nquu2.gt.nqud2)then + uv2=psdfh4(sngl(xm*xp2),q2min,0.,icltar,1) + dv2=psdfh4(sngl(xm*xp2),q2min,0.,icltar,2) + else !if nquu<nqud => no u or no d + uv2=psdfh4(sngl(xm*xp2),q2min,0.,1,1) + dv2=uv2 + endif + if(nquu2.eq.0)uv2=0d0 + if(nqud2.eq.0)dv2=0d0 + else + uv1=psdfh4(sngl(xp*xp1),q2min,0.,iclpro,1) + dv1=psdfh4(sngl(xp*xp1),q2min,0.,iclpro,2) + uv2=psdfh4(sngl(xm*xp2),q2min,0.,icltar,1) + dv2=psdfh4(sngl(xm*xp2),q2min,0.,icltar,2) + endif + + wwuu=uv1*uv2*sqq + if(iclpro.eq.2)then + wwdd=dv1*dv2*sqq + elseif(iclpro.eq.1)then + wwdd=dv1*dv2*sqaq + elseif(iclpro.eq.3)then + wwdd=dv1*dv2*sqqp + elseif(iclpro.eq.4)then + wwuu=uv1*uv2*sqqp + wwdd=0. + endif + wwud=uv1*dv2*sqqp + wwdu=dv1*uv2*sqqp + wudt=wwuu+wwdd+wwud+wwdu + if(wudt.lt.1d-16)then + if(ish.ge.1)write(ifmt,*)'No more valence quark for psahot !' + write(ifch,*)'No more valence quark for psahot !' + & ,ip,it,nquu1,nqud1,nquu2,nqud2 + iret=1 + goto 16 + endif + + gb=gb*dble(wudt)/zpm**dble(delh+0.4) + * *(1.d0-xp*xp1)**dble(-1.-alpq-alplea(iclpro)) + * *(1.d0-xm*xp2)**dble(-1.-alpq-alplea(icltar))/gb0 +c if(ish.ge.4)then + if(gb.gt.1.d0.and.ish.ge.1)write (ifch,*) + * 'gb-qq,iclpro,zpm,xp,tmax,tmin,xpmax', + * gb,iclpro,zpm,xp,tmax,tmin,xpmax +c endif + if(dble(rangen()).gt.gb)goto 3 + + aks=rangen()*wudt + if(aks.le.wwuu)then + if(iclpro.le.2)then + iq1=1 + elseif(iclpro.eq.3)then + if(iabs(idptl(ip)).eq.130)then !proj=Kch + iq1=1 + else !proj=K0 + iq1=2 + endif + else !charm + if(iabs(idptl(ip)).eq.140)then + iq1=1 + elseif(iabs(idptl(ip)).eq.240)then + iq1=2 + elseif(iabs(idptl(ip)).eq.340)then + iq1=3 + else + iq1=4 + endif + endif + iq2=1 + elseif(aks.le.wwuu+wwdd)then + if(iclpro.eq.2)then + iq1=2 + elseif(iclpro.eq.1)then + iq1=-2 + elseif(iclpro.eq.3)then + iq1=-3 + else + iq1=-4 + endif + iq2=2 + elseif(aks.le.wwuu+wwdd+wwud)then + if(iclpro.le.2)then + iq1=1 + elseif(iclpro.eq.3)then + if(iabs(idptl(ip)).eq.130)then !proj=Kch + iq1=1 + else !proj=K0 + iq1=2 + endif + else !charm + if(iabs(idptl(ip)).eq.140)then + iq1=1 + elseif(iabs(idptl(ip)).eq.240)then + iq1=2 + elseif(iabs(idptl(ip)).eq.340)then + iq1=3 + else + iq1=4 + endif + endif + iq2=2 + else + if(iclpro.eq.2)then + iq1=2 + elseif(iclpro.eq.1)then + iq1=-2 + elseif(iclpro.eq.3)then + iq1=-3 + else + iq1=-4 + endif + iq2=1 + endif + + wpi=xp*wp0 !lc+ for the semihard interaction + wmi=xm*wm0 !lc- for the semihard interaction + wp1=(wp0-wpi) + wm1=(wm0-wmi) + wp1=wp1*psutz(wp1*wm1,dble(amqt(2)**2),dble(amqt(4)**2)) + wm1=wm1-amqt(2)**2/wp1 + + !------------------------------------- + else ! sea-sea val-sea sea-val + !------------------------------------- + + if(ish.ge.4)write(ifch,*)'sea-sea val-sea sea-val' + xmin1=xmin**(delh-dels) + xmax1=xmax**(delh-dels) + + if(iqq.eq.0)then !rejection function normalization + gb0=dlog(xpmax0/xpmin0)*(1.d0-dsqrt(xmin))**(2.*betpom) !y_soft = + else + tmax0=acos(dsqrt(xpmin0)) !kinematical limits for t=cos(x+-)**2 + tmin0=acos(dsqrt(xpmax0)) + if(iqq.eq.1)then + uv1=psdfh4(sngl(xpmin0*xp1),q2min,0.,iclpro,1) + * *sngl(1.d0-xpmin0*xp1)**(-1.-alpq-alplea(iclpro)) + dv1=psdfh4(sngl(xpmin0*xp1),q2min,0.,iclpro,2) + * *sngl(1.d0-xpmin0*xp1)**(-1.-alpq-alplea(iclpro)) + else + uv1=psdfh4(sngl(xpmin0*xp2),q2min,0.,icltar,1) + * *sngl(1.d0-xpmin0*xp2)**(-1.-alpq-alplea(icltar)) + dv1=psdfh4(sngl(xpmin0*xp2),q2min,0.,icltar,2) + * *sngl(1.d0-xpmin0*xp2)**(-1.-alpq-alplea(icltar)) + endif + gb0=(1.d0-xmin/xpmax0)**betpom*dble(uv1+dv1) + * *xpmin0**(-0.5+dels) + * *(1.d0-xpmin0)**(0.5+alpq)*(tmax0-tmin0) + if(ish.ge.6)write (ifch,*) + * 'gb0,tmax0,tmin0,xpmax0,xpmin0,xmin,xp1,xp2', + * gb0,tmax0,tmin0,xpmax0,xpmin0,xmin,xp1,xp2 + endif + if(iclpro.ne.4.or.iqq.ne.1)then + call psjti0(sngl(smax-pth),sj,sjb,iqq,0) !inclusive (sj) and born + else + call psjti0(sngl(smax-pth),sj,sjb,4,0) + endif + gb0=gb0*dble(sj)/xmax**delh *1.5d0 !rejection function norm. + if(ish.ge.6)write (ifch,*)'gb0,sj,z',gb0,sj,z + + if(gb0.le.0.)then + write (ifmt,*)'gb0<0, smax,pth',smax,pth + iret=1 + goto 16 + endif + + ! sharing of light cone momenta between soft preevolution and + ! hard interaction: ( first energy-momentum is shared according to + ! f_hard(yj)~zpm**(delh-dels-1) and then rejected as + ! w_rej ~sigma_hard_tot(yj) / exp(delh*yj) + + 4 continue + zpm=(xmin1+dble(rangen())*(xmax1-xmin1))**dble(1./(delh-dels)) !zpm + if(iclpro.ne.4.or.iqq.ne.1)then + call psjti0(sngl(zpm*s-pth),sgg,sggb,0,0)!inclusive (sgg) and born + call psjti0(sngl(zpm*s-pth),sgq,sgqb,0,1) + call psjti0(sngl(zpm*s-pth),sqq,sqqb,1,1) + call psjti0(sngl(zpm*s-pth),sqaq,sqaqb,-1,1) + call psjti0(sngl(zpm*s-pth),sqqp,sqqpb,1,2) + sqq=(sqq+sqaq+2.*(naflav-1)*sqqp)/naflav/2. + else + call psjti0(sngl(zpm*s-pth),sgq,sgqb,4,0) + call psjti0(sngl(zpm*s-pth),sqq,sqqb,4,1) + endif + xpmax=psutz(s,zpm*s,dble(amqpt**2)) !max x+ for sh pomeron + xpmin=zpm/xpmax + if(ish.ge.8)write (ifch,*)'zpm,xpmax,xpmin',zpm,xpmax,xpmin + + if(iqq.eq.0)then + xp=xpmin*(xpmax/xpmin)**rangen() !lc+ share for the hard interaction + xm=zpm/xp !lc- share for the hard interaction + else + tmax=acos(dsqrt(xpmin)) !kinematical limits for t=cos(x+-)**2 + tmin=acos(dsqrt(xpmax)) + t=tmin+dble(rangen())*(tmax-tmin) + xp=cos(t)**2 + xm=zpm/xp + endif + + if(ish.ge.8)write(ifch,*)'zpm,xp,xm,xpmax,xpmin:', + * zpm,xp,xm,xpmax,xpmin + + + if(iqq.eq.0)then ! --------- sea-sea ----------- + + dwwgg1=0. + dwwgq1=0. + dwwqg1=0. + dwwqq1=0. + + dwwgg2=0. + dwwgq2=0. + dwwqg2=0. + dwwqq2=0. + + wwgg=sngl((1.d0-xp)*(1.d0-xm))**betpom + wwgq=sngl(1.d0-xp)**betpom*EsoftQZero(sngl(xm)) + wwqg=sngl(1.d0-xm)**betpom*EsoftQZero(sngl(xp)) + wwqq=EsoftQZero(sngl(xp))*EsoftQZero(sngl(xm)) + + if(idfpomr.eq.1)then + rh=r2had(iclpro)+r2had(icltar)-slopom*sngl(dlog(zpm)) + wwgg=(wwgg*z**(rp/rh)/rh+dwwgg1+dwwgg2) + * *(r2had(iclpro)+r2had(icltar))/z + wwgq=(wwgq*z**(rp/rh)/rh+dwwgq1+dwwgq2) + * *(r2had(iclpro)+r2had(icltar))/z + wwqg=(wwqg*z**(rp/rh)/rh+dwwqg1+dwwqg2) + * *(r2had(iclpro)+r2had(icltar))/z + wwqq=(wwqq*z**(rp/rh)/rh+dwwqq1+dwwqq2) + * *(r2had(iclpro)+r2had(icltar))/z + elseif(idfpomr.eq.2)then + rh=r2had(iclpro)+alam3p/2.-slopom*sngl(dlog(zpm)) + wwgg=wwgg/rh*(r2had(iclpro)+alam3p/2.)*z**(rp/rh-1.) + wwqg=wwqg/rh*(r2had(iclpro)+alam3p/2.)*z**(rp/rh-1.) + wwgq=wwgq/rh*(r2had(iclpro)+alam3p/2.)*z**(rp/rh-1.) + wwqq=wwqq/rh*(r2had(iclpro)+alam3p/2.)*z**(rp/rh-1.) + elseif(idfpomr.eq.3)then + rh=r2had(icltar)+alam3p/2.-slopom*sngl(dlog(zpm)) + wwgg=wwgg/rh*(r2had(icltar)+alam3p/2.)*z**(rp/rh-1.) + wwqg=wwqg/rh*(r2had(icltar)+alam3p/2.)*z**(rp/rh-1.) + wwgq=wwgq/rh*(r2had(icltar)+alam3p/2.)*z**(rp/rh-1.) + wwqq=wwqq/rh*(r2had(icltar)+alam3p/2.)*z**(rp/rh-1.) + elseif(idfpomr.eq.4)then + rh=alam3p-slopom*sngl(dlog(zpm)) + wwgg=wwgg/rh*alam3p*z**(rp/rh-1.) + wwqg=wwqg/rh*alam3p*z**(rp/rh-1.) + wwgq=wwgq/rh*alam3p*z**(rp/rh-1.) + wwqq=wwqq/rh*alam3p*z**(rp/rh-1.) + else + stop'psahot-idfpomr????' + endif + + wwgg=wwgg*sgg*(1.-glusea)**2 + wwgq=wwgq*sgq*(1.-glusea)*glusea + wwqg=wwqg*sgq*(1.-glusea)*glusea + wwqq=wwqq*sqq*glusea**2 + gbyj=dlog(xpmax/xpmin)*dble(wwgg+wwgq+wwqg+wwqq) + wpi=wp0*xp !lc+ for the hard interaction + wmi=wm0*xm !lc+-for the hard interaction + gbyj=gbyj/zpm**dble(delh)/gb0 !rejection fu + if(gbyj.ge.1.d0.and.ish.ge.2)write(ifmt,*)'gbyj',gbyj + if(dble(rangen()).gt.gbyj)goto 4 !rejection + wp1=wp0-wpi + wm1=wm0-wmi + call pslcsh(wp1,wm1,wp2,wm2,amqt,dble(amqpt)) + + else ! --------- val-sea sea-val ----------- + + dwwg=0. + dwwq=0. + + wwgq=sngl(1.d0-xm)**betpom + wwqq=EsoftQZero(sngl(xm)) + if(idfpomr.eq.1)then + rh=r2had(iclpro)+r2had(icltar)-slopom*sngl(dlog(xm)) + wwgq=(wwgq*z**(rp/rh)/rh+dwwg) + * *(r2had(iclpro)+r2had(icltar))/z + wwqq=(wwqq*z**(rp/rh)/rh+dwwq) + * *(r2had(iclpro)+r2had(icltar))/z + else !tp071031 not used anymore + if(iqq.eq.1)then + rh=r2had(iclpro)+alam3p/2.-slopom*sngl(dlog(xm)) + wwgq=wwgq/rh*(r2had(iclpro)+alam3p/2.)*z**(rp/rh-1.) + wwqq=wwqq/rh*(r2had(iclpro)+alam3p/2.)*z**(rp/rh-1.) + else + rh=r2had(icltar)+alam3p/2.-slopom*sngl(dlog(xm)) + wwgq=wwgq/rh*(r2had(icltar)+alam3p/2.)*z**(rp/rh-1.) + wwqq=wwqq/rh*(r2had(icltar)+alam3p/2.)*z**(rp/rh-1.) + endif + endif + + wwgq=wwgq*sgq*(1.-glusea)*sngl(xp)**(-0.5+dels) + * *sngl(1.d0-xp)**(0.5+alpq) + wwqq=wwqq*sqq*glusea*sngl(xp)**(-0.5+dels) + * *sngl(1.d0-xp)**(0.5+alpq) + + if(iqq.eq.1)then !valence quark-gluon hard interaction + if(iremn.ge.2)then + if(nquu1.gt.nqud1.or.iclpro.ne.2)then + uv1=psdfh4(sngl(xp*xp1),q2min,0.,iclpro,1) + dv1=psdfh4(sngl(xp*xp1),q2min,0.,iclpro,2) + else !if nquu<nqud => no u or no d + uv1=psdfh4(sngl(xp*xp1),q2min,0.,1,1) + dv1=uv1 + endif + if(nquu1.eq.0)uv1=0d0 + if(nqud1.eq.0)dv1=0d0 + else + uv1=psdfh4(sngl(xp*xp1),q2min,0.,iclpro,1) + dv1=psdfh4(sngl(xp*xp1),q2min,0.,iclpro,2) + endif + if(uv1+dv1.lt.1d-16)then + if(ish.ge.1)write(ifmt,*)'No more valence quark for psahot !' + write(ifch,*)'No more valence quark in projectile for psahot !' + & ,ip,nquu1,nqud1 + iret=1 + goto 16 + endif + wpi=wp0*xp !lc+ for the hard interaction + wmi=wm0*xm !lc+-for the hard interaction + aks=rangen() + if(aks.le.uv1/(uv1+dv1))then + if(iclpro.le.2)then + iq1=1 + elseif(iclpro.eq.3)then + if(iabs(idptl(ip)).eq.130)then !proj=Kch + iq1=1 + else !proj=K0 + iq1=2 + endif + else !charm + if(iabs(idptl(ip)).eq.140)then + iq1=1 + elseif(iabs(idptl(ip)).eq.240)then + iq1=2 + elseif(iabs(idptl(ip)).eq.340)then + iq1=3 + else + iq1=4 + endif + endif + else + if(iclpro.eq.2)then + iq1=2 + elseif(iclpro.eq.1)then + iq1=-2 + elseif(iclpro.eq.3)then + iq1=-3 + else + iq1=-4 + endif + endif + gbyj=dble((wwgq+wwqq)*(uv1+dv1))*(1.d0-xp*xp1)** + * (-1.-alpq-alplea(iclpro)) + else !gluon-valence quark hard interaction + xm=xp + xp=zpm/xm + if(iremn.ge.2)then + if(nquu2.gt.nqud2)then + uv1=psdfh4(sngl(xm*xp2),q2min,0.,icltar,1) + dv1=psdfh4(sngl(xm*xp2),q2min,0.,icltar,2) + else !if nquu<nqud => no u or no d + uv1=psdfh4(sngl(xm*xp2),q2min,0.,1,1) + dv1=uv1 + endif + if(nquu2.eq.0)uv1=0d0 + if(nqud2.eq.0)dv1=0d0 + else + uv1=psdfh4(sngl(xm*xp2),q2min,0.,icltar,1) + dv1=psdfh4(sngl(xm*xp2),q2min,0.,icltar,2) + endif + if(uv1+dv1.lt.1d-16)then + if(ish.ge.1)write(ifmt,*)'No more valence quark for psahot !' + write(ifch,*)'No more valence quark in target for psahot !' + & ,it,nquu2,nqud2 + iret=1 + goto 16 + endif + wpi=wp0*xp !lc+ for the hard interaction + wmi=wm0*xm !lc+-for the hard interaction + aks=rangen() + if(aks.le.uv1/(uv1+dv1))then + iq2=1 + else + iq2=2 + endif + gbyj=dble(wwgq+wwqq)*dble(uv1+dv1)* + * (1.d0-xm*xp2)**(-1.-alpq-alplea(icltar)) + endif + + gbyj=gbyj*(tmax-tmin)/zpm**delh /gb0 /2.1d0 !rejection + if(ish.ge.6)write (ifch,*) + * 'gbyj,zpm,xp,tmax,tmin,xpmax,xpmin', + * gbyj,zpm,xp,tmax,tmin,xpmax,xpmin + if(dble(rangen()).gt.gbyj)goto 4 + + wp1=wp0-wpi + wm1=wm0-wmi + if(ish.ge.8)write (ifch,*)'q_sea mass check',wp1*wm1,amqpt + if(iqq.eq.1)then !valence quark-gluon hard interaction + amq1=amqt(3)**2 + s24=(amqt(2)+amqt(4))**2 + else + amq1=amqt(1)**2 + s24=(amqt(2)+amqt(4))**2 + xp=xm + xm=zpm/xp + endif + x1max=psutz(wp1*wm1,dble(amq1),dble(s24)) + x1min=dble(amq1)/x1max/wp1/wm1 + t1min=(1.d0/x1max-1.d0) + t1max=(1.d0/x1min-1.d0) +5 t1=t1min*(t1max/t1min)**dble(rangen()) + if(ish.ge.8)write (ifch,*)'t1,t1min,t1max',t1,t1min,t1max + xq1=1.d0/(1.d0+t1) + if(dble(rangen()).gt.(xq1*(1.d0-xq1))**(1.+(-alpqua)))goto 5 + if(iqq.eq.1)then !valence quark-gluon hard interacti + wm2=wm1*(1.d0-xq1) + wm1=wm1*xq1 + wp1=wp1-dble(amq1)/wm1 + if(ish.ge.8)write (ifch,*)'q_sea+ mass check', + * wp1*wm2,s24 + wp1=wp1*psutz(wp1*wm2,dble(amqt(2)**2),dble(amqt(4)**2)) + wm2=wm2-dble(amqt(2))**2/wp1 + else + wp2=wp1*(1.d0-xq1) + wp1=wp1*xq1 + wm1=wm1-dble(amq1)/wp1 + if(ish.ge.8)write (ifch,*)'q_sea- mass check', + * wp2*wm1,s24 + wm1=wm1*psutz(wm1*wp2,dble(amqt(4)**2),dble(amqt(2)**2)) + wp2=wp2-amqt(4)**2/wm1 + endif + + endif ! ------------------- + + !------------------------------- + endif + !------------------------------- + +c------------------------------------------------------------------------- +c flavor and momenta of end partons of the hard Pomeron +c------------------------------------------------------------------------- + + if(ish.ge.4)write(ifch,*) + & 'flavor and momenta of end partons of the hard Pomeron' + + 6 continue + wpi1=wpi + wmi1=wmi + nj=nj0 !initialization for the number of jets + if(ish.ge.8)write (ifch,*)'5-ww,smin',wpi*wmi,smin + + rrr=rangen() + jqq=0 + + call iddeco(icp,jcp) !save valence quarks in jcp and jct + call iddeco(ict,jct) + if(iremn.ge.2)then + do j=1,2 + do n=1,nrflav + jcpr(n,j)=jcpref(n,j,ip) !remnant sea quarks in jcpr and jctr + jctr(n,j)=jctref(n,j,it) + enddo + do n=nrflav+1,nflav + jcpr(n,j)=0 + jctr(n,j)=0 + enddo + enddo + endif + do i=1,2 + icp1(i)=0 + icp2(i)=0 + icm1(i)=0 + icm2(i)=0 + enddo + + iret1=0 + iret2=0 + +c if one or 2 of the 2 initial pomeron ends is sea, choose whether the first +c emitted parton is a gluon or a quark to define the hard interaction +c jqq=0 : gg interaction after soft emission +c jqq=1 : qg interaction after soft emission +c jqq=2 : gq interaction after soft emission +c jqq=3 : qq interaction after soft emission +c If the initial parton is a quark, the flavor has to be defined and the +c antiflavor remains as string end. + + if(iqq.eq.1.or.iqq.eq.2)then + if(rrr.lt.wwqq/(wwgq+wwqq))jqq=1 + elseif(iqq.eq.0)then + if(rrr.lt.wwqg/(wwgg+wwqg+wwgq+wwqq))then + jqq=1 + elseif(rrr.lt.(wwqg+wwgq)/(wwgg+wwqg+wwgq+wwqq))then + jqq=2 + elseif(rrr.lt.(wwqg+wwgq+wwqq)/(wwgg+wwqg+wwgq+wwqq))then + jqq=3 + endif + endif + + if(iLHC.eq.1)then + + if((iqq-1)*(iqq-3).eq.0)then !valence quark on projectile side +c valence quark used to start space like cascade + iqc(1)=iq1 !proj=particle + if(iabs(idptl(ip)).eq.1220)iqc(1)=3-iq1 !proj=neutron + if(idptl(ip).lt.0)iqc(1)=-iqc(1) !proj=antiparticle + ifl1=iabs(iqc(1)) + +c check string ends for mesons : +c switch q<->aq if needed (done randomly in ProSeTyp) + if(iabs(idptl(ip)).lt.1000)then + if(iqc(1).gt.0.and.idp1pr(ncolp,kcol).ne.2)then + idp2pr(ncolp,kcol)=idp1pr(ncolp,kcol) + idp1pr(ncolp,kcol)=2 + elseif(iqc(1).lt.0.and.idp2pr(ncolp,kcol).ne.2)then + idp1pr(ncolp,kcol)=idp2pr(ncolp,kcol) + idp2pr(ncolp,kcol)=2 + endif + endif + +c store flavor of used valence quark in icp1(1) (quark) or icp2(2) (antiquark) + idsp=100 + if(iqc(1).gt.0)then + icp1(1)=ifl1 + if(idp1pr(ncolp,kcol).ne.2) + & call utstop("psahot: Problem with SE (1)!&") + else + icp2(2)=ifl1 + if(idp2pr(ncolp,kcol).ne.2) + & call utstop("psahot: Problem with SE (2)!&") + endif + else + idsp=idsppr(ncolp,kcol) + endif + + if((iqq-2)*(iqq-3).eq.0)then !valence quark on target side +c valence quark used to start space like cascade + iqc(2)=iq2 !tar=particle (can not be pion or kaon !) + if(iabs(idptl(maproj+it)).eq.1220)iqc(2)=3-iq2 !targ=neutron + if(idptl(maproj+it).lt.0)iqc(2)=-iqc(2) !targ=antiparticle + ifl2=iabs(iqc(2)) + +c store flavor of used valence quark in icm1(1) (quark) or icm2(2) (antiquark) + idst=100 + if(iqc(2).gt.0)then + icm1(1)=ifl2 + if(idm1pr(ncolp,kcol).ne.2) + & call utstop("psahot: Problem with SE (3)!&") + else + icm2(2)=ifl2 + if(idm2pr(ncolp,kcol).ne.2) + & call utstop("psahot: Problem with SE (4)!&") + endif + else + idst=idstpr(ncolp,kcol) + endif + +c determine soft string end flavors + + iret=0 + + call fstrfl(jcpr,jctr,jcp,jct,icp1,icp2,icm1,icm2 + * ,idp1pr(ncolp,kcol),idp2pr(ncolp,kcol) + * ,idm1pr(ncolp,kcol),idm2pr(ncolp,kcol) + * ,idsp,idst,iret) + + if(iret.ne.0)goto 16 + +c put partons in stack for cascades + + if((iqq-1)*(iqq-3).eq.0)then !valence quark on projectile side + + +c define the second string end from sea + if(iqc(1).gt.0)then + ifl=idtra(icp2,1,0,2) + elseif(iqc(1).lt.0)then + ifl=idtra(icp1,1,0,2) + else + call utstop('No quark for hard Pomeron+ in psahot!&') + endif + + if(ish.ge.5)write(ifch,*)'flavor vq+,sqb+',iqc(1) + & ,ifl + + nj=nj+1 +c put the sea quark (or diquark) into the parton list as string end + if(abs(ifl).eq.3)then + iqj(nj)=ifl*4/3 + elseif(abs(ifl).ge.4)then + iqj(nj)=ifl*10 + else + iqj(nj)=ifl + endif + ioj(nj)=7 + + eqj(1,nj)=.5*sngl(wp1+dble(amqt(2))**2/wp1) + eqj(2,nj)=wp1-eqj(1,nj) + eqj(3,nj)=xxp2pr(ncolp,kcol) + eqj(4,nj)=xyp2pr(ncolp,kcol) + if(ish.ge.8)write (ifch,*)'q_v+ mass check',(eqj(1,nj)- + * eqj(2,nj))*(eqj(1,nj)+eqj(2,nj))-eqj(3,nj)**2-eqj(4,nj)**2 + eqj(1,nj)=sqrt(eqj(2,nj)**2+eqj(3,nj)**2+eqj(4,nj)**2) + ncc(1,1)=nj + ncc(2,1)=0 + + else !gluon (soft sea) parton on projectile side + + +c define the 2 string ends from sea + + iflq=idtra(icp1,1,0,2) + iflqb=idtra(icp2,1,0,2) + + + if(ish.ge.5)write(ifch,*)'flavor sq+,sqb+',iflq,iflqb + + nj=nj+1 +c put the sea quarks (or diquarks) into the parton list as string end + if(abs(iflqb).eq.3)then + iqj(nj)=iflqb*4/3 + elseif(abs(iflqb).ge.4)then + iqj(nj)=iflqb*10 + else + iqj(nj)=iflqb + endif + ioj(nj)=7 + if(abs(iflq).eq.3)then + iqj(nj+1)=iflq*4/3 + elseif(abs(iflq).ge.4)then + iqj(nj+1)=iflq*10 + else + iqj(nj+1)=iflq + endif + ioj(nj+1)=7 + + eqj(1,nj)=.5*sngl(wp1+dble(amqt(1))**2/wp1) + eqj(2,nj)=wp1-eqj(1,nj) + eqj(3,nj)=xxp1pr(ncolp,kcol) + eqj(4,nj)=xyp1pr(ncolp,kcol) + if(ish.ge.8)write (ifch,*)'q_s1+ mass check',(eqj(1,nj)- + * eqj(2,nj))*(eqj(1,nj)+eqj(2,nj))-eqj(3,nj)**2-eqj(4,nj)**2 + eqj(1,nj)=sqrt(eqj(2,nj)**2+eqj(3,nj)**2+eqj(4,nj)**2) + eqj(1,nj+1)=.5*sngl(wp2+dble(amqt(2))**2/wp2) + eqj(2,nj+1)=wp2-eqj(1,nj+1) + eqj(3,nj+1)=xxp2pr(ncolp,kcol) + eqj(4,nj+1)=xyp2pr(ncolp,kcol) + nj=nj+1 + if(ish.ge.8)write (ifch,*)'q_s2+ mass check',(eqj(1,nj)- + * eqj(2,nj))*(eqj(1,nj)+eqj(2,nj))-eqj(3,nj)**2-eqj(4,nj)**2 + eqj(1,nj)=sqrt(eqj(2,nj)**2+eqj(3,nj)**2+eqj(4,nj)**2) + +c gluon initiate space like cascade + if(jqq.eq.0.or.iqq.eq.0.and.jqq.eq.2)then + iqc(1)=0 + ncc(1,1)=nj-1 + ncc(2,1)=nj +c quark initiate space like cascade + else +c choose the first parton for the space like cascade (projectile) + iqc(1)=int(3*rangen()+1.)*(2.*int(.5+rangen())-1.) + if(1.-1./(wp0*(wmi1-smin/wpi1)).le.xp)goto 1 +7 zg=1d0-dble(rangen())*(1.d0-xp) + if(ish.ge.8)write (ifch,*)'6-zg,xp',zg,xp + if(dble(rangen()).gt.zg**dels*((1.d0-xp/zg)/(1.d0-xp)) + * **betpom)goto 7 + xg=xp/zg + wpq=wp0*(xg-xp) + wmq=1.d0/wpq + wmi1=wmi1-wmq + if(wmi1*wpi1.le.smin)goto 1 + + +c add the corresponding anti-parton in the list to compensate the emitted one + nj=nj+1 + if(iabs(iqc(1)).eq.3)then + iqj(nj)=-iqc(1)*4/3 + elseif(iabs(iqc(1)).ge.3)then + iqj(nj)=-iqc(1)*10 + else + iqj(nj)=-iqc(1) + endif + ioj(nj)=-7 + eqj(1,nj)=.5*wmq + eqj(2,nj)=-eqj(1,nj) + eqj(3,nj)=0. + eqj(4,nj)=0. + if(ish.ge.8)write (ifch,*)'q_s3+ mass check',eqj(1,nj)**2- + * eqj(2,nj)**2-eqj(3,nj)**2-eqj(4,nj)**2 + if(iqc(1).gt.0)then + ncj(1,nj)=nj-1 + ncj(1,nj-1)=nj + ncj(2,nj)=0 + ncj(2,nj-1)=0 + ncc(1,1)=nj-2 + ncc(2,1)=0 + else + ncj(1,nj)=nj-2 + ncj(1,nj-2)=nj + ncj(2,nj)=0 + ncj(2,nj-2)=0 + ncc(1,1)=nj-1 + ncc(2,1)=0 + endif + endif + endif + + + + if((iqq-2)*(iqq-3).eq.0)then !valence quark on target side + +c define the second string end from sea + if(iqc(2).gt.0)then + ifl=idtra(icm2,1,0,2) + elseif(iqc(2).lt.0)then + ifl=idtra(icm1,1,0,2) + else + call utstop('No quark for hard Pomeron- in psahot!&') + endif + + if(ish.ge.5)write(ifch,*)'flavor vq-,sqb-',iqc(2) + & ,ifl + + nj=nj+1 +c put the sea quark (or diquark) into the parton list as string end + if(abs(ifl).eq.3)then + iqj(nj)=ifl*4/3 + elseif(abs(ifl).ge.4)then + iqj(nj)=ifl*10 + else + iqj(nj)=ifl + endif + ioj(nj)=8 + + eqj(1,nj)=.5*sngl(wm1+dble(amqt(4))**2/wm1) + eqj(2,nj)=eqj(1,nj)-sngl(wm1) + eqj(3,nj)=xxm1pr(ncolp,kcol) + eqj(4,nj)=xym1pr(ncolp,kcol) + if(ish.ge.8)write (ifch,*)'q_v- mass check',(eqj(1,nj) + * +eqj(2,nj))*(eqj(1,nj)-eqj(2,nj))-eqj(3,nj)**2-eqj(4,nj)**2 + eqj(1,nj)=sqrt(eqj(2,nj)**2+eqj(3,nj)**2+eqj(4,nj)**2) + ncc(1,2)=nj + ncc(2,2)=0 + + else !gluon (soft sea) parton on target side + +c define the 2 string ends from sea + + iflq=idtra(icm1,1,0,2) + iflqb=idtra(icm2,1,0,2) + + + if(ish.ge.5)write(ifch,*)'flavor sq-,sqb-',iflq,iflqb + + nj=nj+1 +c put the sea quarks (or diquarks) into the parton list as string end + if(abs(iflqb).eq.3)then + iqj(nj)=iflqb*4/3 + elseif(abs(iflqb).ge.4)then + iqj(nj)=iflqb*10 + else + iqj(nj)=iflqb + endif + ioj(nj)=8 + if(abs(iflq).eq.3)then + iqj(nj+1)=iflq*4/3 + elseif(abs(iflq).ge.4)then + iqj(nj+1)=iflq*10 + else + iqj(nj+1)=iflq + endif + ioj(nj+1)=8 + + eqj(1,nj)=.5*sngl(wm1+dble(amqt(3))**2/wm1) + eqj(2,nj)=eqj(1,nj)-sngl(wm1) + eqj(3,nj)=xxm2pr(ncolp,kcol) + eqj(4,nj)=xym2pr(ncolp,kcol) + if(ish.ge.8)write (ifch,*)'q_s1- mass check',(eqj(1,nj)- + * eqj(2,nj))*(eqj(1,nj)+eqj(2,nj))-eqj(3,nj)**2-eqj(4,nj)**2 + eqj(1,nj)=sqrt(eqj(2,nj)**2+eqj(3,nj)**2+eqj(4,nj)**2) + eqj(1,nj+1)=.5*sngl(wm2+dble(amqt(4))**2/wm2) + eqj(2,nj+1)=eqj(1,nj+1)-wm2 + eqj(3,nj+1)=xxm1pr(ncolp,kcol) + eqj(4,nj+1)=xym1pr(ncolp,kcol) + nj=nj+1 + if(ish.ge.8)write (ifch,*)'q_s2- mass check',(eqj(1,nj)- + * eqj(2,nj))*(eqj(1,nj)+eqj(2,nj))-eqj(3,nj)**2-eqj(4,nj)**2 + eqj(1,nj)=sqrt(eqj(2,nj)**2+eqj(3,nj)**2+eqj(4,nj)**2) + +c gluon initiate space like cascade + if(jqq.eq.0.or.iqq.eq.0.and.jqq.eq.1)then + iqc(2)=0 + ncc(1,2)=nj-1 + ncc(2,2)=nj +c quark initiate space like cascade + else +c choose the first parton for the space like cascade (target) + iqc(2)=int(3*rangen()+1.)*(2.*int(.5+rangen())-1.) + if(1.-1./(wm0*(wpi1-smin/wmi1)).le.xm)goto 1 +8 zg=1.d0-dble(rangen())*(1.d0-xm) + if(ish.ge.8)write (ifch,*)'7-zg,xm',zg,xm + if(rangen().gt.zg**dels*((1.d0-xm/zg)/(1.d0-xm))**betpom) + * goto 8 + xg=xm/zg + wmq=wm0*(xg-xm) + wpq=1.d0/wmq + wpi1=wpi1-wpq + if(wmi1*wpi1.le.smin)goto 1 + +c add the corresponding anti-parton in the list to compensate the emitted one + nj=nj+1 + if(iabs(iqc(2)).eq.3)then + iqj(nj)=-iqc(2)*4/3 + elseif(iabs(iqc(2)).ge.4)then + iqj(nj)=-iqc(2)*10 + else + iqj(nj)=-iqc(2) + endif + ioj(nj)=-8 + + eqj(1,nj)=.5*sngl(wpq) + eqj(2,nj)=eqj(1,nj) + eqj(3,nj)=0. + eqj(4,nj)=0. + if(ish.ge.8)write (ifch,*)'q_s3- mass check',(eqj(1,nj)- + * eqj(2,nj))*(eqj(1,nj)+eqj(2,nj))-eqj(3,nj)**2-eqj(4,nj)**2 + if(iqc(2).gt.0)then + ncj(1,nj)=nj-1 + ncj(1,nj-1)=nj + ncj(2,nj)=0 + ncj(2,nj-1)=0 + ncc(1,2)=nj-2 + ncc(2,2)=0 + else + ncj(1,nj)=nj-2 + ncj(1,nj-2)=nj + ncj(2,nj)=0 + ncj(2,nj-2)=0 + ncc(1,2)=nj-1 + ncc(2,2)=0 + endif + endif + endif + + else + +c put partons in stack for cascades + + if((iqq-1)*(iqq-3).eq.0)then !valence quark on projectile side +c valence quark used to start space like cascade + iqc(1)=iq1 !proj=particle + if(iabs(idptl(ip)).eq.1220)iqc(1)=3-iq1 !proj=neutron + if(idptl(ip).lt.0)iqc(1)=-iqc(1) !proj=antiparticle + ifl1=iabs(iqc(1)) + + nj=nj+1 + + if(iqc(1).gt.0)then + if(iremn.ne.0)then + if(iremn.eq.3)then + call idsufl3(ifl1,1,jcp) !remove valence quark from remnant + ifl=idrafl(iclpro,jcpr,2,'v',1,iret3) !take sea antiquark from jcpr + elseif(iremn.eq.2)then + call idsufl3(ifl1,1,jcp) !remove valence quark from remnant + ifl=idrafl(iclpro,jcpr,2,'s',0,iret3) !take sea antiquark freely + call idsufl3(ifl,2,jcpr) !remove sea antiquark from remnant + else + call idsufl(ifl1,1,jcp,iret1) !remove valence quark from remnant + if(iret1.ne.1)then + ifl=idrafl(iclpro,jcp,2,'s',1,iret2) !take sea antiquark + endif + endif + else + ifl=ifl1 + endif + elseif(iqc(1).lt.0)then + if(iremn.ne.0)then + if(iremn.eq.3)then + call idsufl3(ifl1,2,jcp) + ifl=idrafl(iclpro,jcpr,1,'v',1,iret3) !take sea quark + elseif(iremn.eq.2)then + call idsufl3(ifl1,2,jcp) + ifl=idrafl(iclpro,jcpr,1,'s',0,iret3) !take sea quark + call idsufl3(ifl,1,jcpr) !remove sea quark from remnant + else + call idsufl(ifl1,2,jcp,iret1) + if(iret1.ne.1)then + ifl=idrafl(iclpro,jcp,1,'s',1,iret2) + endif + endif + else + ifl=ifl1 + endif + else + call utstop('No quark for hard Pomeron+ in psahot!&') + endif + + if(iret1.eq.1.or.iret2.eq.1)then + ifl=ifl1 + if(ish.ge.3)write(ifmt,*)'Not enough space in rem (psahot 1)' + if(ish.ge.5)write(ifch,*)'Not enough space in rem (psahot 1)' + call iddeco(icp,jcp) + iret1=0 + iret2=0 + endif + + if(ish.ge.5)write(ifch,*)'flavor vq+,sqb+',iqc(1) + & ,-isign(ifl,iqc(1)) + + if(ifl.eq.3)then + iqj(nj)=-isign(ifl,iqc(1))*4/3 + elseif(ifl.eq.4)then + iqj(nj)=-isign(ifl,iqc(1))/4 + else + iqj(nj)=-isign(ifl,iqc(1)) + endif + eqj(1,nj)=.5*sngl(wp1+dble(amqt(2))**2/wp1) + eqj(2,nj)=wp1-eqj(1,nj) + eqj(3,nj)=xxp2pr(ncolp,kcol) + eqj(4,nj)=xyp2pr(ncolp,kcol) + if(ish.ge.8)write (ifch,*)'q_v+ mass check',(eqj(1,nj)- + * eqj(2,nj))*(eqj(1,nj)+eqj(2,nj))-eqj(3,nj)**2-eqj(4,nj)**2 + eqj(1,nj)=sqrt(eqj(2,nj)**2+eqj(3,nj)**2+eqj(4,nj)**2) + ncc(1,1)=nj + ncc(2,1)=0 + + else + + nj=nj+1 + if(idfpomr.lt.3.and.iremn.ne.0)then + if(iremn.eq.3)then + iflq=idrafl(iclpro,jcpr,1,'v',1,iret3) !take sea quark + iflqb=idrafl(iclpro,jcpr,2,'v',1,iret3) !take sea antiquark + elseif(iremn.eq.2)then + iflq=idrafl(iclpro,jcpr,1,'s',0,iret3) !take sea quark + call idsufl3(iflq,1,jcpr) !remove sea quark from remnant + iflqb=idrafl(iclpro,jcpr,2,'s',0,iret3) !take sea antiquark + call idsufl3(iflqb,2,jcpr) !remove sea antiquark from remnant + else + iflq=idrafl(iclpro,jcp,1,'s',1,iret1) !Choose flavor of sea quark. + if(iret1.ne.1)iflqb=idrafl(iclpro,jcp,2,'s',1,iret2) !Choose antiquark. + endif + else + iflq=idrafl(iclpro,jcp,0,'s',0,iret1) !Choose flavor of sea quark. + iflqb=iflq !antiquark=quark (vertex end) + endif + + if(iret1.eq.1.or.iret2.eq.1)then + iflqb=iflq + if(ish.ge.3)write(ifmt,*)'Not enough space in rem (psahot 2)' + if(ish.ge.5)write(ifch,*)'Not enough space in rem (psahot 2)' + call iddeco(icp,jcp) + iret1=0 + iret2=0 + endif + + if(ish.ge.5)write(ifch,*)'flavor sq+,sqb+',iflq,-iflqb + + if(iflqb.eq.3)then + iqj(nj)=-iflqb*4/3 + elseif(iflqb.eq.4)then + iqj(nj)=-iflqb/4 + else + iqj(nj)=-iflqb + endif + ioj(nj)=7 + if(iflq.eq.3)then + iqj(nj+1)=iflq*4/3 + elseif(iflq.eq.4)then + iqj(nj+1)=iflq/4 + else + iqj(nj+1)=iflq + endif + ioj(nj+1)=7 + + eqj(1,nj)=.5*sngl(wp1+dble(amqt(1))**2/wp1) + eqj(2,nj)=wp1-eqj(1,nj) + eqj(3,nj)=xxp1pr(ncolp,kcol) + eqj(4,nj)=xyp1pr(ncolp,kcol) + if(ish.ge.8)write (ifch,*)'q_s1+ mass check',(eqj(1,nj)- + * eqj(2,nj))*(eqj(1,nj)+eqj(2,nj))-eqj(3,nj)**2-eqj(4,nj)**2 + eqj(1,nj)=sqrt(eqj(2,nj)**2+eqj(3,nj)**2+eqj(4,nj)**2) + eqj(1,nj+1)=.5*sngl(wp2+dble(amqt(2))**2/wp2) + eqj(2,nj+1)=wp2-eqj(1,nj+1) + eqj(3,nj+1)=xxp2pr(ncolp,kcol) + eqj(4,nj+1)=xyp2pr(ncolp,kcol) + nj=nj+1 + if(ish.ge.8)write (ifch,*)'q_s2+ mass check',(eqj(1,nj)- + * eqj(2,nj))*(eqj(1,nj)+eqj(2,nj))-eqj(3,nj)**2-eqj(4,nj)**2 + eqj(1,nj)=sqrt(eqj(2,nj)**2+eqj(3,nj)**2+eqj(4,nj)**2) + +c gluon initiate space like cascade + if(jqq.eq.0.or.iqq.eq.0.and.jqq.eq.2)then + iqc(1)=0 + ncc(1,1)=nj-1 + ncc(2,1)=nj +c quark initiate space like cascade + else +c choose the first parton for the space like cascade (projectile) + iqc(1)=int(3*rangen()+1.)*(2.*int(.5+rangen())-1.) + if(1.-1./(wp0*(wmi1-smin/wpi1)).le.xp)goto 1 + 17 zg=1d0-dble(rangen())*(1.d0-xp) + if(ish.ge.8)write (ifch,*)'6-zg,xp',zg,xp + if(dble(rangen()).gt.zg**dels*((1.d0-xp/zg)/(1.d0-xp)) + * **betpom)goto 17 + xg=xp/zg + wpq=wp0*(xg-xp) + wmq=1.d0/wpq + wmi1=wmi1-wmq + if(wmi1*wpi1.le.smin)goto 1 + + +c add the corresponding anti-parton in the list to compensate the emitted one + nj=nj+1 + if(iabs(iqc(1)).eq.3)then + iqj(nj)=-iqc(1)*4/3 + else + iqj(nj)=-iqc(1) + endif + ioj(nj)=-7 + eqj(1,nj)=.5*wmq + eqj(2,nj)=-eqj(1,nj) + eqj(3,nj)=0. + eqj(4,nj)=0. + if(ish.ge.8)write (ifch,*)'q_s3+ mass check',eqj(1,nj)**2- + * eqj(2,nj)**2-eqj(3,nj)**2-eqj(4,nj)**2 + if(iqc(1).gt.0)then + ncj(1,nj)=nj-1 + ncj(1,nj-1)=nj + ncj(2,nj)=0 + ncj(2,nj-1)=0 + ncc(1,1)=nj-2 + ncc(2,1)=0 + else + ncj(1,nj)=nj-2 + ncj(1,nj-2)=nj + ncj(2,nj)=0 + ncj(2,nj-2)=0 + ncc(1,1)=nj-1 + ncc(2,1)=0 + endif + endif + endif + + if((iqq-2)*(iqq-3).eq.0)then + iqc(2)=iq2 !tar=particle (can not be pion or kaon !) + if(iabs(idptl(maproj+it)).eq.1220)iqc(2)=3-iq2 !targ=neutron + if(idptl(maproj+it).lt.0)iqc(2)=-iqc(2) !targ=antiparticle + ifl2=iabs(iqc(2)) + + nj=nj+1 + if(iqc(2).gt.0)then + if(iremn.ne.0)then + if(iremn.eq.3)then + call idsufl3(ifl2,1,jct) !remove valence quark from remnant + ifl=idrafl(icltar,jctr,2,'v',1,iret3) !take sea antiquark from jctr + elseif(iremn.eq.2)then + call idsufl3(ifl2,1,jct) !remove valence quark from remnant + ifl=idrafl(icltar,jctr,2,'s',0,iret3) !take sea antiquark freely + call idsufl3(ifl,2,jctr) !remove sea antiquark from remnant + else + call idsufl(ifl2,1,jct,iret1) !remove valence quark from remnant + if(iret1.ne.1)then + ifl=idrafl(icltar,jct,2,'s',1,iret2) !take sea antiquark + endif + endif + else + ifl=ifl2 + endif + elseif(iqc(2).lt.0)then + if(iremn.ne.0)then + if(iremn.eq.3)then + call idsufl3(ifl2,2,jct) + ifl=idrafl(icltar,jctr,1,'v',1,iret3) !take sea quark + elseif(iremn.eq.2)then + call idsufl3(ifl2,2,jct) + ifl=idrafl(icltar,jctr,1,'s',0,iret3) !take sea quark + call idsufl3(ifl,1,jctr) !remove sea quark from remnant + else + call idsufl(ifl2,2,jct,iret1) + if(iret1.ne.1)then + ifl=idrafl(icltar,jct,1,'s',1,iret2) + endif + endif + else + ifl=ifl2 + endif + else + call utstop('No quark for hard Pomeron- in psahot!&') + endif + + if(iret1.eq.1.or.iret2.eq.1)then + ifl=ifl2 + if(ish.ge.3)write(ifmt,*)'Not enough space in rem (psahot 3)' + if(ish.ge.5)write(ifch,*)'Not enough space in rem (psahot 3)' + call iddeco(ict,jct) + iret1=0 + iret2=0 + endif + + if(ish.ge.5)write(ifch,*)'flavor vq-,sqb-',iqc(2) + & ,-isign(ifl,iqc(2)) + + if(ifl.eq.3)then + iqj(nj)=-isign(ifl,iqc(2))*4/3 + elseif(ifl.eq.4)then + iqj(nj)=-isign(ifl,iqc(2))/4 + else + iqj(nj)=-isign(ifl,iqc(2)) + endif + + eqj(1,nj)=.5*sngl(wm1+dble(amqt(4))**2/wm1) + eqj(2,nj)=eqj(1,nj)-sngl(wm1) + eqj(3,nj)=xxm1pr(ncolp,kcol) + eqj(4,nj)=xym1pr(ncolp,kcol) + if(ish.ge.8)write (ifch,*)'q_v- mass check',(eqj(1,nj) + * +eqj(2,nj))*(eqj(1,nj)-eqj(2,nj))-eqj(3,nj)**2-eqj(4,nj)**2 + eqj(1,nj)=sqrt(eqj(2,nj)**2+eqj(3,nj)**2+eqj(4,nj)**2) + ncc(1,2)=nj + ncc(2,2)=0 + else + nj=nj+1 + if(mod(idfpomr,2).ne.0.and.iremn.ne.0)then + if(iremn.eq.3)then + iflq=idrafl(icltar,jctr,1,'v',1,iret3) !take sea quark + iflqb=idrafl(icltar,jctr,2,'v',1,iret3) !take sea antiquark + elseif(iremn.eq.2)then + iflq=idrafl(icltar,jctr,1,'s',0,iret3) !take sea quark + call idsufl3(iflq,1,jctr) !remove sea antiquark from remnant + iflqb=idrafl(icltar,jctr,2,'s',0,iret3) !take sea antiquark + call idsufl3(iflqb,2,jctr) !remove sea antiquark from remnant + else + iflq=idrafl(icltar,jct,1,'s',1,iret2) !Choose flavor of sea quark. + if(iret1.ne.1)iflqb=idrafl(icltar,jct,2,'s',1,iret2) !Choose antiquark. + endif + else + iflq=idrafl(iclpro,jcp,0,'s',0,iret1) !Choose flavor of sea quark. + iflqb=iflq !antiquark=quark (vertex end) + endif + + if(iret1.eq.1.or.iret2.eq.1)then + iflqb=iflq + if(ish.ge.3)write(ifmt,*)'Not enough space in rem (psahot 4)' + if(ish.ge.5)write(ifch,*)'Not enough space in rem (psahot 4)' + call iddeco(ict,jct) + iret1=0 + iret2=0 + endif + + if(ish.ge.5)write(ifch,*)'flavor sq-,sqb-',iflq,-iflqb + + if(iflqb.eq.3)then + iqj(nj)=-iflqb*4/3 + elseif(iflqb.eq.4)then + iqj(nj)=-iflqb/4 + else + iqj(nj)=-iflqb + endif + if(iflq.eq.3)then + iqj(nj+1)=iflq*4/3 + elseif(iflq.eq.4)then + iqj(nj+1)=iflq/4 + else + iqj(nj+1)=iflq + endif + ioj(nj+1)=8 + + eqj(1,nj)=.5*sngl(wm1+dble(amqt(3))**2/wm1) + eqj(2,nj)=eqj(1,nj)-sngl(wm1) + eqj(3,nj)=xxm2pr(ncolp,kcol) + eqj(4,nj)=xym2pr(ncolp,kcol) + if(ish.ge.8)write (ifch,*)'q_s1- mass check',(eqj(1,nj)- + * eqj(2,nj))*(eqj(1,nj)+eqj(2,nj))-eqj(3,nj)**2-eqj(4,nj)**2 + eqj(1,nj)=sqrt(eqj(2,nj)**2+eqj(3,nj)**2+eqj(4,nj)**2) + eqj(1,nj+1)=.5*sngl(wm2+dble(amqt(4))**2/wm2) + eqj(2,nj+1)=eqj(1,nj+1)-wm2 + eqj(3,nj+1)=xxm1pr(ncolp,kcol) + eqj(4,nj+1)=xym1pr(ncolp,kcol) + nj=nj+1 + if(ish.ge.8)write (ifch,*)'q_s2- mass check',(eqj(1,nj)- + * eqj(2,nj))*(eqj(1,nj)+eqj(2,nj))-eqj(3,nj)**2-eqj(4,nj)**2 + eqj(1,nj)=sqrt(eqj(2,nj)**2+eqj(3,nj)**2+eqj(4,nj)**2) + +c gluon initiate space like cascade + if(jqq.eq.0.or.iqq.eq.0.and.jqq.eq.1)then + iqc(2)=0 + ncc(1,2)=nj-1 + ncc(2,2)=nj +c quark initiate space like cascade + else +c choose the first parton for the space like cascade (target) + iqc(2)=int(3*rangen()+1.)*(2.*int(.5+rangen())-1.) + if(1.-1./(wm0*(wpi1-smin/wmi1)).le.xm)goto 1 + 18 zg=1.d0-dble(rangen())*(1.d0-xm) + if(ish.ge.8)write (ifch,*)'7-zg,xm',zg,xm + if(rangen().gt.zg**dels*((1.d0-xm/zg)/(1.d0-xm))**betpom) + * goto 18 + xg=xm/zg + wmq=wm0*(xg-xm) + wpq=1.d0/wmq + wpi1=wpi1-wpq + if(wmi1*wpi1.le.smin)goto 1 + +c add the corresponding anti-parton in the list to compensate the emitted one + nj=nj+1 + if(iabs(iqc(2)).eq.3)then + iqj(nj)=-iqc(2)*4/3 + else + iqj(nj)=-iqc(2) + endif + ioj(nj)=-8 + + eqj(1,nj)=.5*sngl(wpq) + eqj(2,nj)=eqj(1,nj) + eqj(3,nj)=0. + eqj(4,nj)=0. + if(ish.ge.8)write (ifch,*)'q_s3- mass check',(eqj(1,nj)- + * eqj(2,nj))*(eqj(1,nj)+eqj(2,nj))-eqj(3,nj)**2-eqj(4,nj)**2 + if(iqc(2).gt.0)then + ncj(1,nj)=nj-1 + ncj(1,nj-1)=nj + ncj(2,nj)=0 + ncj(2,nj-1)=0 + ncc(1,2)=nj-2 + ncc(2,2)=0 + else + ncj(1,nj)=nj-2 + ncj(1,nj-2)=nj + ncj(2,nj)=0 + ncj(2,nj-2)=0 + ncc(1,2)=nj-1 + ncc(2,2)=0 + endif + endif + endif + + endif !iLHC + + if(jqq.ne.0)then + if(iqq.ne.0.or.iqq.eq.0.and.jqq.eq.3)then + if(iclpro.ne.4.or.iqq.ne.1)then + call psjti0(sngl(wpi1*wmi1-pth),sqq1,sqqb1,1,1) + call psjti0(sngl(wpi1*wmi1-pth),sqaq1,sqaqb1,-1,1) + call psjti0(sngl(wpi1*wmi1-pth),sqqp1,sqqpb1,1,2) + sqq1=(sqq1+sqaq1+2.*(naflav-1)*sqqp1)/naflav/2. + else + call psjti0(sngl(wpi1*wmi1-pth),sqq1,sqqb1,4,1) + endif + gbs=sqq1/sqq + else + call psjti0(sngl(wpi1*wmi1-pth),sgq1,sgqb1,0,1) + gbs=sgq1/sgq + endif + if(ish.ge.8)write (ifch,*)'gbs',gbs + if(rangen().gt.gbs)goto 6 + endif + + +c--------------------------------------------------------------- +c inner partons of the hard Pomeron +c--------------------------------------------------------------- + + if(ish.ge.4)write(ifch,*) + & 'inner partons of the hard Pomeron' + nj00=nj + wpi=wpi1 + wmi=wmi1 + si=wpi*wmi-pxh**2-pyh**2 !total energy squared for the hard + if(ish.ge.7)write (ifch,*)'si,wpi,wmi',si,wpi,wmi + + ept(1)=.5d0*(wpi+wmi) + ept(2)=.5d0*(wpi-wmi) + ept(3)=pxh + ept(4)=pyh + qmin(1)=q2min !effective momentum cutoff above current la + qmin(2)=q2min !effective momentum cutoff below current la + qminn=max(qmin(1),qmin(2)) !effective momentum cutoff for the bo +c si=psnorm(ept) !4-momentum squared for the hard pomeron + jfirst=1 + jj=int(1.5+rangen()) + nemis(1)=0 + nemis(2)=0 + + 9 continue ! <<<<----------- ladder rung --------------------------- + + if(ish.ge.4)write(ifch,*)'ladder rung' + pt2=ept(3)**2+ept(4)**2 + pt=sqrt(sngl(pt2)) + if(iabs(iqc(1)).ne.4)then + q2mass=0. + else + q2mass=qcmass**2 + si=si-dble(q2mass) + endif + s2min=4.*qminn+q2mass !mass cutoff for born scattering + wwmin=5.*qminn+q2mass-2.*pt*sqrt(q2ini) + wwmin=(wwmin+sqrt(wwmin**2+4.*(q2mass+pt2)*(qminn-q2ini))) + */(1.-q2ini/qminn)/2. + if(ish.ge.5)write(ifch,*)'qminn,q2mass,pt,wwmin,iqc(1):' + if(ish.ge.5)write(ifch,*)qminn,q2mass,pt,wwmin + + wpt(1)=ept(1)+ept(2) !lc+ for the current jet emissi + wpt(2)=ept(1)-ept(2) !lc- for the current jet emissi + + sjord=0. + if(iabs(iqc(1)).ne.4)then + if(jfirst.eq.1)then + sj=psjti(qmin(jj),qqcut,sngl(si),iqc(jj),iqc(3-jj),0) + sj2=psjti1(qmin(3-jj),qmin(jj),qqcut + * ,sngl(si),iqc(3-jj),iqc(jj),0) + if(ish.ge.5)write(ifch,*)'si,sj,sj2:',si,sj,sj2 + if(rangen().gt.sj2/sj.and.si.gt.1.1d0*dble(wwmin))goto 112 + jfirst=0 + jj=3-jj + sj=sj2 + goto 111 + endif + sj=psjti1(qmin(jj),qmin(3-jj),qqcut,sngl(si),iqc(jj),iqc(3-jj),0) +111 sjb=psbint(qmin(1),qmin(2),qqcut,sngl(si),iqc(1),iqc(2),0) !born parton-parton + else + sjord=psjci(qmin(2),sngl(si),iqc(2)) + sj=sjord + sjb=psbint(qmin(1),qmin(2),qqcut,sngl(si)+q2mass,iqc(1),iqc(2),0) + if(qmin(2).eq.q2min)then + wwmins=2.5*q2min*(1.+sqrt(1.+ + * 4.*(pt2+q2mass)/q2min)) + if(si.gt.dble(wwmins))call psjti0(sngl(si)+q2mass,sj,sjb + * ,iqc(1),iqc(2)) + endif + endif + if(ish.ge.5)write(ifch,*)'si,pt2,wwmin,s2min,sj,sjb,iqc:' + if(ish.ge.5)write(ifch,*)si,pt2,wwmin,s2min,sj,sjb,iqc + + if(si.lt.1.1d0*dble(wwmin))goto 12 !------>>>>>>> + if(rangen().lt.sjb/sj)goto 12 !------>>>>>>> + + if(iabs(iqc(1)).eq.4)jj=min(2,int(sjord/sj+rangen())+1) !????????? + +112 continue + + if(iabs(iqc(jj)).ne.4)then + + discr=dble((sngl(si)+2.*pt*sqrt(q2ini)-q2mass)**2 + * -4.*q2ini*(5.*sngl(si)+q2mass+sngl(pt2))) + if(discr.lt.0.d0.and.ish.ge.1)write(ifmt,*)'discr,si,pt,wwmin', + * discr,si,pt,wwmin + discr=dsqrt(discr) + qqmax=(si+2.d0*dble(pt*sqrt(q2ini))-dble(q2mass)+discr)/2.d0 + * /(5.d0+(dble(q2mass)+pt2)/si) + qqmin=qqmax-discr/(5.d0+(dble(q2mass)+pt2)/si) + if(s2min.gt.4.d0*qqmin+dble(q2mass))then + xmm=.5d0*(si-s2min+2.d0*dble(pt*sqrt(q2ini))) + discr=xmm**2-si*dble(q2ini)*(1.d0+(dble(q2mass)+pt2)/si) + if(discr.lt.0..and.ish.ge.1)write(ifmt,*)'discr1,si,pt,wwmin', + * discr,si,pt,wwmin + qqmin=(xmm-dsqrt(discr))/(1.d0+(dble(q2mass)+pt2)/si) + endif + + xmax=min(1.d0-dble(q2ini)/qqmax,.9999d0) + if(qqmin.lt.dble(qmin(jj)))then + qqmin=dble(qmin(jj)) + xmin=max(1.d0-((dble(pt)*dsqrt(qqmin)+dsqrt(pt2*qqmin+ + * si*(si-s2min-qqmin*(1.d0+(dble(q2mass)+pt2)/si))))/si)**2, + * (s2min+qqmin*(1.d0+(dble(q2mass)+pt2)/si)-2.d0*dble(pt) + * *dsqrt(qqmin))/si) + if(xmin.le.0.d0)xmin=s2min/si + else + xmin=1.d0-dble(q2ini)/qqmin + endif + + qm0=qmin(jj) + xm0=1.0-dble(q2ini/qm0) + if(xm0.gt..999*xmax.or.xm0.lt.1.001*xmin)then + xm0=.5d0*(xmax+xmin) + endif + s2max=sngl(xm0*si-qm0*(dble(q2mass)+pt2)/si) + * +2.*pt*sqrt(q2ini) + xx=xm0 + + if(iabs(iqc(1)).ne.4)then + if(jfirst.eq.1)then + sj0=psjti(qm0,qqcut,s2max,0,iqc(3-jj),0)* + * psfap(xx,iqc(jj),0)+ + * psjti(qm0,qqcut,s2max,7,iqc(3-jj),0) + * *psfap(xx,iqc(jj),1) + else + sj0=psjti1(qm0,qmin(3-jj),qqcut,s2max,0,iqc(3-jj),0)* + * psfap(xx,iqc(jj),0)+ + * psjti1(qm0,qmin(3-jj),qqcut,s2max,7,iqc(3-jj),0) + * *psfap(xx,iqc(jj),1) + endif + else + sj0=psjci(qm0,s2max,0)*psfap(xx,iqc(jj),0)+ + * psjci(qm0,s2max,1)*psfap(xx,iqc(jj),1) + endif + + gb0=dble(sj0/log(q2ini/qcdlam)*qm0*5.)*psuds(qm0,iqc(jj)) + if(ish.ge.5)write(ifch,*)'gb0,qm0,xm0,s2max:', + * gb0,qm0,xm0,s2max +c if(gb0.le.0.)stop'gb0<=0' + if(gb0.le.0.d0)then + write(ifmt,*)'gb0.le.0. si,pt2:',si,pt2 + iret=1 + goto 16 + endif + + if(xm0.le..5d0)then + gb0=gb0*xm0**(1.-delh) + else + gb0=gb0*(1.d0-xm0)*2.d0**delh + endif + + xmin2=max(.5d0,xmin) + xmin1=xmin**delh + xmax1=min(xmax,.5d0)**delh + if(xmin.ge..5d0)then + djl=1. + elseif(xmax.le..5d0)then + djl=0. + else + djl=1./(1.+((2.*sngl(xmin))**delh-1.)/delh/ + * log(2.*(1.-sngl(xmax)))) + endif + + else + + xmin=5.d0*dble(q2min)/si + xmax=min(si/(si+5.0*(pt2+dble(q2mass))),.9999d0) + qqmax=xmax*si/5.d0 + qqmin=dble(q2min) + + qm0=sngl(qqmin) + xm0=2.d0/(1.d0+sqrt(1.d0+4.d0*(pt2+dble(q2mass))/qm0)) + if(xm0.gt..999d0*xmax.or.xm0.lt.1.001d0*xmin)then + xm0=.5d0*(xmax+xmin) + endif + s2max=sngl(xm0*si) + xx=xm0 + + sj0=psjti(qm0,qmin(3-jj),s2max,0,iqc(3-jj),0)* + * psfap(xx,iqc(jj),0) + gb0=dble(sj0/log(qm0/qcdlam)*qm0 *5.) + gb0=gb0*xm0**(1.-delh) + if(gb0.le.0.d0)then + if(ish.ge.2)write(ifch,*)'gb0.le.0. (charm) si,pt2:',si,pt2 + iret=1 + goto 16 + endif + djl=0. + xmin2=0d0 + xmin1=xmin**delh + xmax1=xmax**delh + + endif + + if(ish.ge.5)write(ifch,*)'xmin,xmax,qqmin,qqmax:', + *xmin,xmax,qqmin,qqmax + + ntry=0 +10 continue + ntry=ntry+1 + if(ntry.gt.5000000)then + if(ish.ge.1)write(*,*)'Reject hard string (too many rejection)' + &,kcol,ncolp,nptl,gb7 + iret=1 + goto 16 + endif + if(rangen().gt.djl)then !lc momentum share in the cur + x=(xmin1+dble(rangen())*(xmax1-xmin1))**(1./delh) + else + x=1.d0-(1.d0-xmin2)*((1.d0-xmax)/(1.d0-xmin2))**rangen() + endif + qq=qqmin/(1.d0+dble(rangen())*(qqmin/qqmax-1.d0)) + if(ish.ge.7)write(ifch,*)'x,qq:',x,qq,ntry + + if(iabs(iqc(jj)).ne.4)then + + qt2=qq*(1.d0-x) + if(qt2.lt.dble(q2ini))then + if(ish.ge.7)write(ifch,*)'qt2:',qt2 + goto 10 + endif + + qmin2=max(qminn,sngl(qq)) + qt=dsqrt(qt2) + call pscs(bcos,bsin) + ep3(3)=sngl(qt)*bcos !new parton pt-s + ep3(4)=sngl(qt)*bsin + ptnew=(ept(3)-dble(ep3(3)))**2+(ept(4)-dble(ep3(4)))**2 + s2min2=4.*qmin2+q2mass + + s2=x*(si-qq)-ptnew-qq*(dble(q2mass)+pt2)/si+pt2 !new ladder mass + if(s2.lt.dble(s2min2))then + if(ish.ge.7)write(ifch,*)'s2,s2min2:',s2,s2min2 + goto 10 !rejection in case of too low mass + endif + + xx=x + if(iabs(iqc(1)).ne.4)then + if(jfirst.eq.1)then + sj1=psjti(sngl(qq),qqcut,sngl(s2),0,iqc(3-jj),0) + if(iqc(jj).ne.0)then !f1 - f2 + sj2=psjti(sngl(qq),qqcut,sngl(s2),iqc(jj),iqc(3-jj),0) + elseif(iqc(3-jj).eq.0)then !f1 - g + sj2=psjti(sngl(qq),qqcut,sngl(s2),1,0,0) + else !g - f2 + sj2=psjti(sngl(qq),qqcut,sngl(s2),1,1,0)/naflav/2. !q - q + * +psjti(sngl(qq),qqcut,sngl(s2),-1,1,0)/naflav/2. !q~ - q + * +psjti(sngl(qq),qqcut,sngl(s2),1,2,0)*(1.-1./naflav) !q' - q + endif + else + sj1=psjti1(sngl(qq),qmin(3-jj),qqcut,sngl(s2),0,iqc(3-jj),0) + if(iqc(jj).ne.0)then !f1 - f2 + sj2=psjti1(sngl(qq),qmin(3-jj),qqcut + * ,sngl(s2),iqc(jj),iqc(3-jj),0) + elseif(iqc(3-jj).eq.0)then !f1 - g + sj2=psjti1(sngl(qq),qmin(3-jj),qqcut,sngl(s2),1,0,0) + else !g - f2 + sj2=psjti1(sngl(qq),qmin(3-jj),qqcut + * ,sngl(s2),1,1,0)/naflav/2. !q - q + * +psjti1(sngl(qq),qmin(3-jj),qqcut + * ,sngl(s2),-1,1,0)/naflav/2. !q~ - q + * +psjti1(sngl(qq),qmin(3-jj),qqcut + * ,sngl(s2),1,2,0)*(1.-1./naflav)!q' - q + endif + endif + else + sj1=psjci(sngl(qq),sngl(s2),0) + sj2=psjci(sngl(qq),sngl(s2),1) + endif + + !...gb7 - rejection function for x and q**2 simulation + gb7=dble((sj1*psfap(xx,iqc(jj),0)+sj2*psfap(xx,iqc(jj),1))/ + * log(sngl(qt2)/qcdlam))*psuds(sngl(qq),iqc(jj))*qq/gb0 + + if(x.le..5d0)then + gb7=gb7*x**(1.-delh) + else + gb7=gb7*(1.d0-x)*2.d0**delh + endif + if(gb7.gt.1..and.ish.ge.2)write(ifmt,*)'gb7,qq,x,qm0,xm0', + * gb7,qq,x,qm0,xm0 + if(ish.ge.7)write(ifch,*)'gb7:',gb7 + if(dble(rangen()).gt.gb7)goto 10 + else + qmin2=max(qminn,sngl(qq)) + s2min2=4.*qmin2 + s2=x*si-qq !new ladder mass + if(s2.lt.dble(s2min2))goto 10 !rejection in case of too low mass + + call pscs(bcos,bsin) + xmm=x*(ept(3)*dble(bcos)+ept(4)*dble(bsin)) + discr=xmm**2+qq*(1.d0-x)-x**2*(pt2+dble(q2mass)) + if(discr.lt.0.d0)goto 10 + qt=xmm+dsqrt(discr) + ep3(3)=sngl(ept(3)-qt*dble(bcos)) !new parton pt-s + ep3(4)=sngl(ept(4)-qt*dble(bsin)) + qt2=dble(ep3(3)**2+ep3(4)**2) + + xx=x + sj1=psjti(sngl(qq),qqcut,sngl(s2),0,iqc(3-jj),0) + sj2=0. + !.... gb7 - rejection function for x and q**2 simulation + gb7=dble(sj1*psfap(xx,iqc(jj),0)/ + * log(sngl(qq)/qcdlam))*qq/gb0 + gb7=gb7*x**(1.-delh) + if(gb7.gt.1..and.ish.ge.2)write(ifmt,*)'gb7,qq,x,qm0,xm0', + * gb7,qq,x,qm0,xm0 + if(ish.ge.7)write(ifch,*)'gb7:',gb7 + if(dble(rangen()).gt.gb7)goto 10 + endif + +! parton type selection iqc -> iqnew (space like) + iq1 (time like) + nqc(2)=0 + iqnew=iqc(jj) + if(rangen().lt.sj1/(sj1+sj2))then + if(iqc(jj).eq.0)then !g -> g + g (jt=1) + jt=1 + jq=int(1.5+rangen()) + nqc(1)=ncc(jq,jj) + else !q -> g + q (jt=2) + jt=2 + if(iqc(jj).gt.0)then + jq=1 + else + jq=2 + endif + nqc(1)=0 + iqnew=0 + endif + iq1=iqc(jj) + jo=ncc(jq,jj) !parton origin + if(jo.ne.0)then + jo=ioj(jo) + else + jo=ioj(ncc(3-jq,jj)) + endif + else + if(iqc(jj).ne.0)then !q -> q + g (jt=3) + iq1=0 + jt=3 + if(iqc(jj).gt.0)then + jq=1 + else + jq=2 + endif + nqc(1)=ncc(1,jj) + else !g -> q + q (jt=4) + jt=4 + jq=int(1.5+rangen()) + iq1=int(naflav*rangen()+1.)*(3-2*jq) + iqnew=-iq1 + nqc(1)=ncc(jq,jj) + endif + jo=ncc(1,jj) !parton origin + if(jo.ne.0)then + jo=ioj(jo) + else + jo=ioj(ncc(2,jj)) + endif + endif + if(jo.ge.70.and.jo.ne.99)jo=jo/10 + if(ish.ge.5)write(ifch,'(a,i3,a4,i3,a4,i3)')' Process :' + * ,iqc(jj),' -> ',iqnew,' + ',iq1 + + if(iabs(iqc(jj)).ne.4)then + q2part=0. +c write(*,*)'sem:',wpt(jj),pt2,q2mass,wpt(3-jj),jj + if(dabs(wpt(3-jj)).gt.1.d-20)then + wplc=wpt(jj)-(pt2+dble(q2mass))/wpt(3-jj) + else + if(ish.gt.1)write(ifmt,*)'Problem with wpt in sem',wpt(3-jj) + wplc=wpt(jj)-(pt2+dble(q2mass)) + endif + qp2max=max(0.,sngl(qt2)) + else + q2part=q2mass + wplc=wpt(jj) + qp2max=max(0.,sngl(qq)) + endif + eprt=max(dsqrt(qt2+dble(q2part)),.5d0*((1.d0-x)*wplc+ + *(qt2+dble(q2part))/(1.d0-x)/wplc)) + pl=((1.d0-x)*wplc-eprt)*dble(3-2*jj) + zeta=sqrt(qp2max/si)/sqrt(x*(1.-x)) + if(iq1.eq.0)then + iq2ini=9 + jo=iq2ini + if(zeta.gt.zetacut)jo=-jo + else + iq2ini=iq1 + jo=iq2ini + endif + if(ish.ge.5)write(ifch,*)'qq,eprt,iq2ini,jo,E2-Q2',qp2max,eprt + *,iq2ini,jo,eprt**2-qt2 + ntest=0 +11 ntest=ntest+1 + call timsh1(qp2max,sngl(eprt),iq2ini,jo) + amprt=pprt(5,1)**2 + plprt=max(0.d0,eprt**2-qt2)-dble(amprt) + if(plprt.lt.0.d0)then + if(ntest.lt.10000)then + goto 11 + else + iret=1 + goto 16 + endif + endif + ep3(1)=sngl(eprt) + ep3(2)=sngl(dsqrt(plprt)) + if(pl.lt.0.d0)ep3(2)=-ep3(2) + ey(1)=1. + ey(2)=1. + ey(3)=1. + do i=1,4 + ept1(i)=ept(i)-dble(ep3(i)) + enddo + call psdefrot(ep3,s0xh,c0xh,s0h,c0h) + s2new=psnorm(ept1) + + if(iabs(iqc(jj)).ne.4.and.s2new-q2mass.gt.s2min2.or. + *iabs(iqc(jj)).eq.4.and.s2new.gt.s2min2)then + if(iabs(iqc(1)).ne.4.or.jj.eq.1)then + if(jfirst.eq.1)then + gb=dble(psjti(sngl(qq),qqcut,s2new,iqnew,iqc(3-jj),0)) + else + gb=dble(psjti1(sngl(qq),qmin(3-jj),qqcut,s2new,iqnew, + * iqc(3-jj),0)) + endif + else + gb=dble(psjci(sngl(qq),s2new-q2mass,iqnew)) + endif + if(iqnew.eq.0)then + gb=gb/dble(sj1) + else + gb=gb/dble(sj2) + endif + if(dble(rangen()).gt.gb)goto 10 + else + goto 10 + endif + + if(ish.ge.6)write(ifch,*)'jt,jj,jq,nqc:',jt,jj,jq,nqc + nprtjx=0 + call psreti(nqc,jq,1,ey,s0xh,c0xh,s0h,c0h) + + if(jt.eq.1)then + ncc(jq,jj)=nqc(2) + elseif(jt.eq.2)then + ncc(jq,jj)=ncc(1,jj) + ncc(3-jq,jj)=nqc(1) + elseif(jt.eq.3)then + ncc(1,jj)=nqc(2) + elseif(jt.eq.4)then + ncc(1,jj)=ncc(3-jq,jj) + endif + iqc(jj)=iqnew + + do i=1,4 + ept(i)=ept1(i) + enddo + ! c.m. energy squared, minimal 4-momentum transfer square and gluon 4-v + ! for the next ladder run + qmin(jj)=sngl(qq) + qminn=qmin2 + si=dble(s2new) + nemis(jj)=nemis(jj)+1 + + goto 9 ! ---------------next ladder rung ------------>>>>>>>>>>> + + + 12 continue !------------------- Born process------------------------ + + if(ish.ge.4)write(ifch,*)'Born process' + if(ish.ge.6)write(ifch,*)'iqc,si:',iqc,si + qq=dble(qminn) + + !kkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkk + xpprbor(ncolp,kcol)=(ept(1)+ept(2))/dble(engy) + xmprbor(ncolp,kcol)=(ept(1)-ept(2))/dble(engy) + nemispr(1,ncolp,kcol)=nemis(1) + nemispr(2,ncolp,kcol)=nemis(2) + ! write(*,'(a,2f8.3,i3,3x,2i3)')'------------' + ! * ,xpprbor(ncolp,kcol),xmprbor(ncolp,kcol),nj-nj00,nemis + !kkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkk + + call psabor(sngl(si),sngl(qq),iqc,ncc,ept,0,iptl,bx) + + !kkkkkkkkkkkkk out Born partons without timelike cascade + if(nprtjx.eq.2)then + do ii=1,2 + ptprboo(ii,ncolp,kcol)=sqrt(pprtx(1,ii)**2+pprtx(2,ii)**2) + enddo + else + stop'psahot: should not happen!!!! ' + endif + !kkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkk + ! ptxxx=max( ptprboo(1,ncolp,kcol) , ptprboo(2,ncolp,kcol) ) + ! print*,sqrt(wm0*wp0),sqrt(wmi*wpi),ptxxx !++++++++++++++++++++++++++ + ! if(ptxxx.lt.10)goto1 + ! print*,' ++++++++++++++++++++++++++++++++++++ ' + !kkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkkk + if(nj.ne.0.)then + do i=1,nj + do l=1,6 + bxj(l,i)=bx(l) + enddo + ityj(i)=ity + iorj(i)=iptl + enddo + endif + + call psjarr(jfl) !kinky strings formation + + if(jfl.eq.0.and.ish.ge.4)write(ifch,*) + *'jfl,nj,nptl',jfl,nj,nptl + if(jfl.eq.0)goto 1 + +c --- update remnant flavour --- + + iret1=0 + call idenco(jcp,icp,iret1) + if(iret1.eq.1)call utstop('Problem with proj rem in psahot !&') + iret2=0 + call idenco(jct,ict,iret2) + if(iret2.eq.1)call utstop('Problem with targ rem in psahot !&') + + do i=1,2 + icproj(i,ip)=icp(i) + ictarg(i,it)=ict(i) + enddo + + if(ish.ge.3)write(ifch,*)'End psahot (icp,ict):',icp,ict + + if(iremn.ge.2)then !uses precalculated flavors + + do j=1,2 + do n=1,nrflav + jcpref(n,j,ip)=jcpr(n,j) + jctref(n,j,it)=jctr(n,j) + enddo + enddo + if(ish.ge.3)then + write(ifch,'(a,6i3,2x,6i3)')' proj: ',jcpr + write(ifch,'(a,6i3,2x,6i3)')' targ: ',jctr + endif + + endif + + +c ------------------------------ + +16 continue + call utprix('psahot',ish,ishini,3) + + q2fin=q2finsave + return + end + +c------------------------------------------------------------------------ + subroutine psjarr(jfl) +c----------------------------------------------------------------------- +c +c final jets rearrangement according to their colour connection +c and write to /cptl/ +c +c jfl - flag for the rejection (in case of jfl=0) +c----------------------------------------------------------------------- +c Input: + + parameter (mjstr=20000) + common /psar29/ eqj(4,mjstr),iqj(mjstr),ncj(2,mjstr),ioj(mjstr),nj + +c eqj(1:4,k) - 4-momentum (qgs) for k-th parton; +c bxj(1:4,k) - coordinates for k-th parton formation point; +c iqj(k) - ID (qgs) for k-th parton; +c ncj(1:2,k) - colour connected partons indexes for k-th parton; +c nj - number of partons +c----------------------------------------------------------------------- + dimension mark(mjstr) + double precision ept(4),eptot(2) + include 'epos.inc' + include 'epos.incsem' + + if(nj.eq.0)then + jfl=1 + return + endif +csp : TEST if string are full + + do k=1,nj + if(iqj(k).eq.0)then !gluon must have two neighbours + if(ncj(1,k).eq.0)then !first neigbour missing +csp write(*,*)'correction' + do kk=1,nj !look to which parton he is connected + if(ncj(1,kk).eq.k)then + if(ncj(2,k).ne.kk)ncj(1,k)=kk !if not already connected : connection + elseif(ncj(2,kk).eq.k)then + if(ncj(1,k).ne.kk)ncj(1,k)=kk + endif + enddo + endif + if(ncj(2,k).eq.0)then !second neigbour missing +csp write(*,*)'correction' + do kk=1,nj + if(ncj(2,kk).eq.k)then + if(ncj(1,k).ne.kk)ncj(2,k)=kk + elseif(ncj(1,kk).eq.k)then + if(ncj(2,k).ne.kk)ncj(2,k)=kk + endif + enddo + endif + endif + enddo + + +csp END OF TEST +c do k=1,nj !??????????????? +c eqj(1,k)=dsqrt(0d0+eqj(2,k)**2+eqj(3,k)**2+eqj(4,k)**2) +c enddo + if(ish.ge.3)then + write (ifch,*)'psjarr: nj',nj + do k=1,nj + if(iqj(k).ne.0)ncj(2,k)=0 + write(ifch,'(a,i4)')' parton',k + write(ifch,'(i6,2x,4e10.3,2x,2i3)')iqj(k) + * ,(eqj(j,k),j=1,4),(ncj(j,k),j=1,2) + enddo + endif + + jfl=0 + do i=1,nj + mark(i)=1 + enddo + nptl0=nptl +c total energy of the two half of the Pomeron + eptot(1)=0d0 + eptot(2)=0d0 + +1 continue + do ij=1,nj + if(mark(ij).ne.0.and.iqj(ij).ne.0)goto 2 + enddo +2 continue + jfirst=1 +c to calculate the total energy of the 2 big strings produce by a pomeron +c we first fix to which string (1 or 2) the sub-string belong to + ij0=ncj(1,ij) + kkk=1 + if(ij0.gt.0)then + if(ncj(1,ij0).eq.ij)kkk=1 + if(ncj(2,ij0).eq.ij)kkk=2 + endif + if(iabs(iqj(ij)).le.2)then + am1=amhadr(1) + elseif(iabs(iqj(ij)).eq.4)then + am1=amhadr(3) + elseif(iabs(iqj(ij)).eq.40)then + am1=qcmass + else + am1=amhadr(2) + endif + + do i=1,4 + ept(i)=0. + enddo + +3 continue + call pspawr(ij,kkk) + + mark(ij)=0 + + do i=1,4 + ept(i)=ept(i)+eqj(i,ij) + enddo + eptot(kkk)=eptot(kkk)+eqj(1,ij) + + if(iqj(ij).ne.0)then + if(jfirst.ne.1)then + if(iabs(iqj(ij)).le.2)then + am2=amhadr(1) + elseif(iabs(iqj(ij)).eq.4)then + am2=amhadr(3) + elseif(iabs(iqj(ij)).eq.40)then + am2=qcmass + else + am2=amhadr(2) + endif + amj=(am1+am2+stmass)**2 + sm=psnorm(ept) + if(sm.lt.amj)then + nptl=nptl0 + goto 999 + endif + + if(nptl-nptl0.lt.nj)then + goto 1 + else + if(iLHC.ne.1)then +c at the end of the process, save eptot(kkk) is qsqptl of each particle + do k=nptl0+1,nptl + qsqptl(k)=sngl(eptot(nint(qsqptl(k)))**2) + enddo + endif + + if(ish.ge.3)then + write (ifch,*)'psjarr: nptl',nptl + do k=nptl0+1,nptl + write(ifch,'(a,i4)')' particle',k + write(ifch,'(i5,2x,6e10.3)')idptl(k) + * ,(pptl(j,k),j=1,5),sqrt(qsqptl(k)) + enddo + endif + jfl=1 + goto 999 + endif + else + jfirst=0 + njpar=ij + ij=ncj(1,ij) + if(ij.eq.0)write(ifch,*) + &'IN PSJARR ij=0 :parton,',njpar,'with no connection' + goto 3 + endif + + else + if(ncj(1,ij).eq.njpar)then + njdau=ncj(2,ij) + else + njdau=ncj(1,ij) + endif + njpar=ij + ij=njdau + if(ij.eq.0)write(ifch,*) + &'IN PSJARR ij=0 :parton,',njpar, 'with no connection' + goto 3 + endif + + + 999 continue + + end + +c------------------------------------------------------------------------ + subroutine pspawr(kj,kkk) +c----------------------------------------------------------------------- +c pspawr - writing final parton kj into particle list +c------------------------------------------------------------------------ +c Input: + parameter (mjstr=20000) + common /psar29/ eqj(4,mjstr),iqj(mjstr),ncj(2,mjstr),ioj(mjstr),nj + common /psar30/ iorj(mjstr),ityj(mjstr),bxj(6,mjstr),q2j(mjstr) + +c eqj(1:4,k) - 4-momentum (qgs) for k-th parton; +c bxj(1:4,k) - coordinates for k-th parton formation point; +c iqj(k) - ID (qgs) for k-th parton; +c ncj(1:2,k) - colour connected partons indexes for k-th parton; +c nj - number of partons +c kkk is the indice of the original half of the pomeron +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + common/ciptl/iptl + + nptl=nptl+1 + if(ish.ge.9)write (ifch,*)'nptl,kj (sto)',nptl,kj + if(nptl.ge.mxptl.or.kj.le.0)then + write (ifmt,*)'nptl,kj',nptl,kj + call alist('Error in pspawr: nptl or kj out of bounds &',1,nptl) + call utstop('nptl or kj out of bounds&') + endif + + if(ifrptl(1,iptl).eq.0)ifrptl(1,iptl)=nptl + ifrptl(2,iptl)=nptl + + pptl(1,nptl)=eqj(3,kj) + pptl(2,nptl)=eqj(4,kj) + pptl(3,nptl)=eqj(2,kj) + pptl(4,nptl)=eqj(1,kj) + pptl(5,nptl)=0. + idptl(nptl)=psidd(iqj(kj)) + iorptl(nptl)=iorj(kj) + jorptl(nptl)=ioj(kj) + istptl(nptl)=20 + do i=1,4 + xorptl(i,nptl)=bxj(i,kj) + enddo + tivptl(1,nptl)=bxj(5,kj) + tivptl(2,nptl)=bxj(6,kj) + ityptl(nptl)=ityj(kj) +c register to which big string the particle belongs to + if(iLHC.eq.1)then + qsqptl(nptl)=q2j(kj) + else + qsqptl(nptl)=float(kkk) + endif + !kkkkkkkkkkkkkkkkkkkkkkk + ! write(*,'(a,2i4,i6,f8.3)')'.... ',kj,nptl,idptl(nptl) + !* ,sqrt(pptl(1,nptl)**2+pptl(2,nptl)**2) + return + end + +c------------------------------------------------------------------------ + subroutine psabor(si,qq,iqc,ncc,ept,jdis,iptl,coordo) +c------------------------------------------------------------------------ +c psabor - highest virtuality subprocess in the ladder +c si - c.m. energy squared for the process, +c qq - p_t-cutoff for the process due to the evolution, +c iqc(i), i=1,2 - incoming parton types(0-g,(+-)1-u(u~),(+-)2-d(d~)etc.), +c ncc(i,j), i,j=1,2 - incoming partons color connections, +c ept(4) - total 4-momentum for the system of the 2 partons +c jdis=0 - hadronic process in pp; 1 - resolved photon process +c------------------------------------------------------------------------ + double precision ept(4),psutz,psuds + dimension ep3(4),ey(3),wsub(5),iqc(2),ncc(2,2),nqc(2),coordo(6) + parameter (mjstr=20000) + common /psar29/eqj(4,mjstr),iqj(mjstr),ncj(2,mjstr),ioj(mjstr),nj + parameter (ntim=1000) + common/cprt/pprt(5,ntim),q2prt(ntim),idaprt(2,ntim),idprt(ntim) + &,iorprt(ntim),jorprt(ntim),nprtj + common/cprtx/nprtjx,pprtx(5,2) + include 'epos.incsem' + include 'epos.inc' + call utpri('psabor',ish,ishini,5) + + if(iabs(iqc(1)).ne.4)then !gluon or light quark + q2mass=0. + else !c-quark + q2mass=qcmass**2 + endif + p1=si/(1.+q2mass/si) + if(p1.gt.4.*qq)then !|t|-cutoff (p^2_t>qq) + tmin=2.*qq/(1.+sqrt(1.-4.*qq/p1)) + else + tmin=2.*qq + endif + tmax=.5*p1 + + fborn=0. + qt2=tmin*(1.d0-tmin/p1) + if(qt2.lt..999d0*qq.and.ish.ge.2)write(ifmt,*)'qt20,qq',qt2,qq + if(iqc(1).ne.0.or.iqc(2).ne.0)then + do l=1,5 !sum over different subprocesses + wsub(l)=psbori(si,tmin,iqc(1),iqc(2),l) !matrix element + if(l.le.3)then + wsub(l)=wsub(l)*pssalf(qt2/qcdlam)**2 + elseif(l.le.4)then + wsub(l)=wsub(l)*pssalf(qt2/qcdlam)*alfe/2/pi + else + wsub(l)=wsub(l)*(alfe/2/pi)**2 + endif + fborn=fborn+wsub(l) + enddo + fborn=tmin**2*fborn + else + do l=1,5 + wsub(l)=psbori(si,.5*si,iqc(1),iqc(2),l) + if(l.le.3)then + wsub(l)=wsub(l)*pssalf(qt2/qcdlam)**2 + elseif(l.le.4)then + wsub(l)=wsub(l)*pssalf(qt2/qcdlam)*alfe/2/pi + else + wsub(l)=wsub(l)*(alfe/2/pi)**2 + endif + fborn=fborn+wsub(l) + enddo + fborn=.25*si**2*fborn + endif + if(jdis.eq.0)then + scale1=qt2 + else + scale1=4.*qt2 + endif + gb0=dble(fborn)*psuds(scale1,iqc(1))*psuds(qt2,iqc(2)) + if(ish.ge.7)write(ifch,*)'tmin,gb0:',tmin,gb0 + +c------------------------------------------------ +c 4-momentum transfer squared is simulated first as dq_t**2/q_t**4 from +c tmin to s/2 +14 q2=tmin/(1.-rangen()*(1.-tmin/tmax)) !q2=min(|t|,|u|) + qt2=q2*(1.-q2/p1) !qt2=p_t^2 for the process + if(qt2.lt.qq.and.ish.ge.2)write(ifmt,*)'qt2,qq',qt2,qq + if(rangen().lt..5)then !|u|=q2, |t|=p1-q2 + jm=2 !first parton to be considered + tq=p1-q2 + else !|t|=q2, |u|=p1-q2 + jm=1 !first parton to be considered + tq=q2 + endif + + fborn=0. + do l=1,5 !sum over different subprocesses + wsub(l)=psbori(si,tq,iqc(1),iqc(2),l) + if(l.le.3)then + wsub(l)=wsub(l)*pssalf(qt2/qcdlam)**2 + elseif(l.le.4)then + wsub(l)=wsub(l)*pssalf(qt2/qcdlam)*alfe/2/pi + else + wsub(l)=wsub(l)*(alfe/2/pi)**2 + endif + fborn=fborn+wsub(l) + enddo + if(jdis.eq.0)then + scale1=qt2 + else + scale1=4.*qt2 + endif + gb=dble(q2**2*fborn) + &*psuds(scale1,iqc(1))*psuds(qt2,iqc(2))/gb0 !rejection function + if(ish.ge.7)write(ifch,*)'q2,qt2,gb:',q2,qt2,gb + + if(dble(rangen()).gt.gb)goto 14 !rejection + +c determination of the color configuration + nqc(2)=0 + if(iqc(1).eq.0.and.iqc(2).eq.0)then !g+g + jq=int(1.5+rangen()) !jq=1(2) - transfer of color (anticolor) + nqc(1)=ncc(jq,jm) + + if(rangen().lt.wsub(1)/fborn)then !gg->gg + if(rangen().lt..5)then + jt=1 !anticolor-color annihilation + nqc(2)=0 + njc1=ncc(3-jq,jm) + njc2=ncc(jq,3-jm) + if(iqj(njc1).ne.0)then + ncj(1,njc1)=njc2 + else + ncj(jq,njc1)=njc2 + endif + if(iqj(njc2).ne.0)then + ncj(1,njc2)=njc1 + else + ncj(3-jq,njc2)=njc1 + endif + else + jt=2 !produced gluons get color and + nqc(2)=ncc(3-jq,3-jm) !anticolor from the 2 parents + endif + else !gg->qq~ + jt=9 !anticolor-color annihilation + iqc(jm)=int(naflav*rangen()+1)*(3-2*jq) !(anti)quark flavor + iqc(3-jm)=-iqc(jm) + njc1=ncc(3-jq,jm) + njc2=ncc(jq,3-jm) + if(iqj(njc1).ne.0)then + ncj(1,njc1)=njc2 + else + ncj(jq,njc1)=njc2 + endif + if(iqj(njc2).ne.0)then + ncj(1,njc2)=njc1 + else + ncj(3-jq,njc2)=njc1 + endif + endif + + elseif(iqc(1)*iqc(2).eq.0)then !q(q~)+g + if(iqc(1)+iqc(2).gt.0)then + jq=1 !q + else + jq=2 !q~ + endif + if(rangen().lt.wsub(1)/fborn)then !q(q~)g->q(q~)g + if(rangen().lt..5)then !anticolor-color annihilation + if(iqc(jm).eq.0)then + jt=3 !first parton=g + nqc(1)=ncc(jq,jm) + njc1=ncc(3-jq,jm) + njc2=ncc(1,3-jm) + if(iqj(njc1).ne.0)then + ncj(1,njc1)=njc2 + else + ncj(jq,njc1)=njc2 + endif + if(iqj(njc2).ne.0)then + ncj(1,njc2)=njc1 + else + ncj(3-jq,njc2)=njc1 + endif + + else + jt=4 !first parton=q(q~) + nqc(1)=0 + njc1=ncc(1,jm) + njc2=ncc(3-jq,3-jm) + if(iqj(njc1).ne.0)then + ncj(1,njc1)=njc2 + else + ncj(3-jq,njc1)=njc2 + endif + if(iqj(njc2).ne.0)then + ncj(1,njc2)=njc1 + else + ncj(jq,njc2)=njc1 + endif + endif + + else !color transfer + if(iqc(jm).eq.0)then + jt=5 !first parton=g + nqc(2)=ncc(3-jq,jm) + nqc(1)=ncc(1,3-jm) + else !first parton=q(q~) + jt=6 + nqc(1)=ncc(jq,3-jm) + endif + endif + + else !q(q~)g->q(q~)-gamma (+-color annihilation) + if(iqc(jm).eq.0)then + jt=11 !first parton=g + nqc(1)=ncc(jq,jm) + njc1=ncc(3-jq,jm) + njc2=ncc(1,3-jm) + if(iqj(njc1).ne.0)then + ncj(1,njc1)=njc2 + else + ncj(jq,njc1)=njc2 + endif + if(iqj(njc2).ne.0)then + ncj(1,njc2)=njc1 + else + ncj(3-jq,njc2)=njc1 + endif + iqc(jm)=iqc(3-jm) + iqc(3-jm)=10 !make the second output is gamma. + + else + jt=12 !first parton=q(q~) + nqc(1)=ncc(jq,3-jm) !here nqc(1) is gluon. + njc1=ncc(1,jm) + njc2=ncc(3-jq,3-jm) + if(iqj(njc1).ne.0)then + ncj(1,njc1)=njc2 + else + ncj(3-jq,njc1)=njc2 + endif + if(iqj(njc2).ne.0)then + ncj(1,njc2)=njc1 + else + ncj(jq,njc2)=njc1 + endif + iqc(3-jm)=10 + endif + endif + + elseif(iqc(1)*iqc(2).gt.0)then + jt=7 !qq->qq (q~q~->q~q~) + if(iqc(1).gt.0)then + jq=1 + else + jq=2 + endif + nqc(1)=ncc(1,3-jm) + + else ! qq~ -> + if(iqc(jm).gt.0)then + jq=1 + else + jq=2 + endif + aks=rangen() + if(aks.lt.(wsub(1)+wsub(2))/fborn)then + jt=8 ! qq~->qq~ (anticolor-color annihilation) + if(aks.gt.wsub(1)/fborn)then + iqa=iabs(iqc(jm)) + iq=int((naflav-1)*rangen())+1 + if(iq.eq.iqa)iq=naflav + iqc(jm)=iq*iqc(jm)/iqa + iqc(3-jm)=-iqc(jm) + endif + nqc(1)=0 + njc1=ncc(1,jm) + njc2=ncc(1,3-jm) + if(iqj(njc1).ne.0)then + ncj(1,njc1)=njc2 + else + ncj(3-jq,njc1)=njc2 + endif + if(iqj(njc2).ne.0)then + ncj(1,njc2)=njc1 + else + ncj(jq,njc2)=njc1 + endif + elseif(aks.lt.(wsub(1)+wsub(2)+wsub(3))/fborn)then + jt=10 !color transfer qq~->gg + iqc(1)=0 + iqc(2)=0 + nqc(1)=ncc(1,jm) + nqc(2)=0 + elseif(aks.lt.(wsub(1)+wsub(2)+wsub(3)+wsub(4))/fborn)then + jt=13 ! qq~->g+gamma + nqc(1)=ncc(1,jm) + nqc(2)=ncc(1,3-jm) + iqc(jm)=0 + iqc(3-jm)=10 + else + jt=14 ! qq~->gamma+gamma + njc1=ncc(1,jm) + njc2=ncc(1,3-jm) + if(iqj(njc1).ne.0)then + ncj(jq,njc1)=njc2 + else + ncj(3-jq,njc1)=njc2 + endif + if(iqj(njc2).ne.0)then + ncj(3-jq,njc2)=njc1 + else + ncj(jq,njc2)=njc1 + endif + iqc(jm)=10 + iqc(3-jm)=10 + endif + endif + + if(jt.ne.8.and.jt.ne.9)then + jq2=jq + else + jq2=3-jq + endif + + call psdeftr(si+q2mass,ept,ey) !lorentz boost to c.m. frame + + qt=sqrt(qt2) !p_t + call pscs(bcos,bsin) !cos and sin of the polar angle + if(iabs(iqc(1)).ne.4)then +clight cone momentum share for the first parton + z=sngl(psutz(dble(si),dble(qt2),dble(qt2))) + if((jt.eq.11.and.jm.eq.1).or.(jt.eq.12.and.jm.eq.2) + $ .or.(jt.eq.13.and.jm.eq.2))z=1-z + wp3=z*sqrt(si) + wm3=qt2/wp3 + elseif(jm.eq.1)then + z=sngl(psutz(dble(si),dble(qt2+q2mass),dble(qt2))) + wp3=z*sqrt(si) + wm3=(qt2+q2mass)/wp3 + else + z=sngl(psutz(dble(si),dble(qt2),dble(qt2+dble(q2mass)))) + wp3=z*sqrt(si) + wm3=qt2/wp3 + endif + ep3(1)=.5*(wp3+wm3) !parton 4-momentum + ep3(2)=.5*(wp3-wm3) + ep3(3)=qt*bcos + ep3(4)=qt*bsin + call psdefrot(ep3,s0xh,c0xh,s0h,c0h) !spacial rotation to z-axis + + zeta=2. !2=back-to-back emission (angle=pi) + if(iqc(jm).eq.0)then + iq2ini1=9 + jo1=iq2ini1 + if(zeta.gt.zetacut)jo1=-jo1 +c q2fin=q2fin+zoeinc + else + iq2ini1=iqc(jm) + jo1=iq2ini1 + endif + if(iqc(3-jm).eq.0)then + iq2ini2=9 + jo2=iq2ini2 + if(zeta.gt.zetacut)jo2=-jo2 +c q2fin=q2fin+zoeinc + else + iq2ini2=iqc(3-jm) + jo2=iq2ini2 + endif + if(jt.le.10)then + qq1=qt2 + qq2=qt2 + elseif(jt.le.13)then + qq1=qt2 + qq2=0 + else + qq1=0 + qq2=0 + endif + + call timsh2(qq1,qq2,sqrt(si),iq2ini1,iq2ini2,jo1,jo2) !final state cascade + + if(jt.le.10)then !color connection for the 2nd parton + if(ish.ge.6)write(ifch,*)'jt,jq,nqc:',jt,jq,nqc + call psreti(nqc,jq,1,ey,s0xh,c0xh,s0h,c0h) !color conn. reconstruction + if(jt.eq.1)then + nqc(1)=nqc(2) + nqc(2)=ncc(3-jq,3-jm) + elseif(jt.eq.2)then + nqc(2)=ncc(3-jq,jm) + nqc(1)=ncc(jq,3-jm) + elseif(jt.eq.3)then + nqc(1)=nqc(2) + elseif(jt.eq.4)then + nqc(2)=nqc(1) + nqc(1)=ncc(jq,3-jm) + elseif(jt.eq.5)then + nqc(1)=ncc(jq,jm) + elseif(jt.eq.6)then + nqc(2)=ncc(3-jq,3-jm) + nqc(1)=ncc(1,jm) + elseif(jt.eq.7)then + nqc(1)=ncc(1,jm) + elseif(jt.eq.9)then + nqc(1)=ncc(3-jq,3-jm) + elseif(jt.eq.10)then + nqc(1)=nqc(2) + nqc(2)=ncc(1,3-jm) + endif + if(ish.ge.6)write(ifch,*)'jt,jq2,nqc:',jt,jq2,nqc + call psreti(nqc,jq2,2,ey,s0xh,c0xh,s0h,c0h) !color conn. reconstr. + elseif(jt.le.13)then + if(ish.ge.6)write(ifch,*)'jt,jq,nqc:',jt,jq,nqc + call psreti(nqc,jq,1,ey,s0xh,c0xh,s0h,c0h) !color conn. reconstruction + ep3(1)=pprt(4,2) + ep3(2)=pprt(3,2) + ep3(3)=pprt(1,2) + ep3(4)=pprt(2,2) + call psrotat(ep3,s0xh,c0xh,s0h,c0h) !special rotation for photon. + call pstrans(ep3,ey,1) + nptl=nptl+1 + pptl(1,nptl)=ep3(3) + pptl(2,nptl)=ep3(4) + pptl(3,nptl)=ep3(2) + pptl(4,nptl)=ep3(1) + pptl(5,nptl)=0 + idptl(nptl)=10 + iorptl(nptl)=iptl + istptl(nptl)=0 + jorptl(nptl)=0 + do i=1,4 + xorptl(i,nptl)=coordo(i) + enddo + tivptl(1,nptl)=coordo(5) + tivptl(2,nptl)=coordo(6) + ityptl(nptl)=71 + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + else + if(ish.ge.6)write(ifch,*)'jt,iqc:',jt,iqc + do j=1,2 + ep3(1)=pprt(4,j) + ep3(2)=pprt(3,j) + ep3(3)=pprt(1,j) + ep3(4)=pprt(2,j) + call psrotat(ep3,s0xh,c0xh,s0h,c0h) !special rotation for photon. + call pstrans(ep3,ey,1) + nptl=nptl+1 + pptl(1,nptl)=ep3(3) + pptl(2,nptl)=ep3(4) + pptl(3,nptl)=ep3(2) + pptl(4,nptl)=ep3(1) + pptl(5,nptl)=0 + idptl(nptl)=10 + iorptl(nptl)=iptl + istptl(nptl)=0 + jorptl(nptl)=0 + do i=1,4 + xorptl(i,nptl)=coordo(i) + enddo + tivptl(1,nptl)=coordo(5) + tivptl(2,nptl)=coordo(6) + ityptl(nptl)=72 + ifrptl(1,nptl)=0 + ifrptl(2,nptl)=0 + enddo + endif + call utprix('psabor',ish,ishini,5) + return + end + +c------------------------------------------------------------------------ + subroutine psreti(nqc,jort,nfprt,ey,s0xh,c0xh,s0h,c0h) +c----------------------------------------------------------------------- +c jet reconstructuring procedure - 4-momenta for all final jets +c nqc(i) - colour connections for the jet +c jort - color orientation for gluons (=1 if +color goes first, =-1 otherwise) + + parameter (ntim=1000) + common/cprt/pprt(5,ntim),q2prt(ntim),idaprt(2,ntim),idprt(ntim) + &,iorprt(ntim),jorprt(ntim),nprtj +c nprtj - number of partons in the jet (including virtual ones) +c pprt - 5-momenta for the partons +c idprt - parton id +c iorprt - parent parton position in the list +c idaprt - daughter partons positions in the list + +c output: + parameter (mjstr=20000) + common /psar29/ eqj(4,mjstr),iqj(mjstr),ncj(2,mjstr),ioj(mjstr),nj +c nj - number of final jets +c eqj(i,j) - 4-momentum for the final jet j +c iqj(j) - flavour for the final jet j +c ncj(m,j) - colour connections for the final jet j + common /psar30/ iorj(mjstr),ityj(mjstr),bxj(6,mjstr),q2j(mjstr) +c----------------------------------------------------------------------- + dimension ep3(4),nqc(2),ncc(2,ntim),ey(3) + include 'epos.inc' + include 'epos.incsem' + common/cprtx/nprtjx,pprtx(5,2) + + if(ish.ge.6)then + write (ifch,*)'nprtj',nprtj + do i=1,nprtj + write (ifch,*)'i,ic,np,ndd',i,idprt(i),iorprt(i), + * idaprt(1,i),idaprt(2,i) + enddo + endif + + ncc(1,nfprt)=nqc(1) + if(idprt(nfprt).eq.9)ncc(2,nfprt)=nqc(2) + iprt=nfprt + + if(nprtjx.eq.2)then !out Born before timelike cascade + ep3(1)=pprtx(4,iprt) + ep3(2)=pprtx(3,iprt) + ep3(3)=pprtx(1,iprt) + ep3(4)=pprtx(2,iprt) + call psrotat(ep3,s0xh,c0xh,s0h,c0h) + call pstrans(ep3,ey,1) + pprtx(4,iprt)=ep3(1) + pprtx(3,iprt)=ep3(2) + pprtx(1,iprt)=ep3(3) + pprtx(2,iprt)=ep3(4) + endif + +1 continue + + idau1=idaprt(1,iprt) + idau2=idaprt(2,iprt) + icp=idprt(iprt) + + if(ish.ge.6)then + write (ifch,*)'1-iprt,icp,idau1,idau2',iprt,icp,idau1,idau2, + * ncc(1,iprt) + if(icp.eq.9)write (ifch,*)'ncc2',ncc(2,iprt) + endif + + if(idau1.ne.0.)then !virtual parton + icd1=idprt(idau1) + + if(icp.eq.9)then + if(icd1.ne.9)then !g -> qq~ + ncc(1,idau1)=ncc(jort,iprt) + ncc(1,idau2)=ncc(3-jort,iprt) + else !g -> gg + ncc(1,idau1)=ncc(1,iprt) + ncc(2,idau1)=0 + ncc(2,idau2)=ncc(2,iprt) + ncc(1,idau2)=0 + endif + else !q -> qg + ncc(1,idau1)=0 + if(icp*(3-2*jort).gt.0)then + ncc(1,idau2)=ncc(1,iprt) + ncc(2,idau2)=0 + else + ncc(1,idau2)=0 + ncc(2,idau2)=ncc(1,iprt) + endif + endif + iprt=idau1 + goto 1 + else + + nj=nj+1 + ep3(1)=pprt(4,iprt) + ep3(2)=pprt(3,iprt) + ep3(3)=pprt(1,iprt) + ep3(4)=pprt(2,iprt) + call psrotat(ep3,s0xh,c0xh,s0h,c0h) + call pstrans(ep3,ey,1) + do i=1,4 + eqj(i,nj)=ep3(i) + enddo + + if(icp.eq.9)then + iqj(nj)=0 + elseif(iabs(icp).lt.3)then + iqj(nj)=icp + elseif(iabs(icp).eq.3)then + iqj(nj)=icp*4/3 + else + iqj(nj)=icp*10 + endif + + ioj(nj)=jorprt(iprt) !flavor of mother parton + q2j(nj)=q2prt(iprt) + + if(iqj(nj).ne.0)then + njc=ncc(1,iprt) + if(njc.ne.0)then + ncj(1,nj)=njc + iqc=iqj(njc) + if(iqc.ne.0)then + ncj(1,njc)=nj + else + if(iqj(nj).gt.0)then + ncj(2,njc)=nj + else + ncj(1,njc)=nj + endif + endif + else + ncc(1,iprt)=nj + endif + else + + do m=1,2 + if(jort.eq.1)then + m1=m + else + m1=3-m + endif + njc=ncc(m1,iprt) + if(njc.ne.0)then + ncj(m,nj)=njc + iqc=iqj(njc) + if(iqc.ne.0)then + ncj(1,njc)=nj + else + ncj(3-m,njc)=nj + endif + else + ncc(m1,iprt)=nj + endif + enddo + endif + if(ish.ge.6)then + write (ifch,*)'jet-nj,iprt,icp,iqj(nj),ioj(nj),ncj', + * nj,iprt,icp,iqj(nj),ioj(nj),ncj(1,nj) + if(icp.eq.9)write (ifch,*)'ncj2',ncj(2,nj) + endif + endif + +2 continue + if(iprt.ne.nfprt)then + icp=idprt(iprt) + ipar=iorprt(iprt) + idau1=idaprt(1,ipar) + idau2=idaprt(2,ipar) + if(ish.ge.6)then + write (ifch,*)'2-iprt,icp,idau1,idau2,ipar', + * iprt,icp,idau1,idau2,ipar,ncc(1,iprt) + if(icp.eq.9)write (ifch,*)ncc(2,iprt) + endif + + if(idau1.eq.iprt)then + if(icp.eq.9)then !g -> gg + ncc(1,ipar)=ncc(1,iprt) + ncc(1,idau2)=ncc(2,iprt) + else + icpar=idprt(ipar) + if(icpar.eq.9)then !g -> qq~ + ncc(jort,ipar)=ncc(1,iprt) + else !q -> qg + if(icp*(3-2*jort).gt.0)then + ncc(2,idau2)=ncc(1,iprt) + else + ncc(1,idau2)=ncc(1,iprt) + endif + endif + endif + iprt=idau2 + goto 1 + + else + if(icp.eq.9)then + icpar=idprt(ipar) + if(icpar.eq.9)then !g -> gg + ncc(2,ipar)=ncc(2,iprt) + ncc(2,idau1)=ncc(1,iprt) + else !q -> qg + if(icpar*(3-2*jort).gt.0)then + ncc(1,ipar)=ncc(1,iprt) + ncc(1,idau1)=ncc(2,iprt) + else + ncc(1,ipar)=ncc(2,iprt) + ncc(1,idau1)=ncc(1,iprt) + endif + endif + else + ncc(3-jort,ipar)=ncc(1,iprt) + endif + iprt=ipar + goto 2 + endif + else + if(ish.ge.6)write (ifch,*)'3-iprt,ncc',iprt,ncc(1,iprt) + nqc(1)=ncc(1,nfprt) + if(idprt(nfprt).eq.9)nqc(2)=ncc(2,nfprt) + endif + return + end + diff --git a/modules/epos/epos-sem-lhc.f b/modules/epos/epos-sem-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..c02b67f582929499c1b89a80ac5f138a069e5985 --- /dev/null +++ b/modules/epos/epos-sem-lhc.f @@ -0,0 +1,7804 @@ +c------------------------------------------------------------------------ + function ffsigiut(xx1,xx2,jpp,je1,je2) +c------------------------------------------------------------------------ +c +c \int(dt) \int(du) ffsig *s/sh**3 *2*pi*alpha**2 *delta(uh+th+sh) +c +c----------------------------------------------------------------------- + common /ar3/ x1(7),a1(7) + include 'epos.incsem' + include 'epos.inc' + double precision tmin,tmax,t,sh2,sqrtq2s + + ig=3 + s=engy**2 + sh=s*xx1*xx2 + ffsigiut=0. + if(sh.le.4.*q2min)return + sh2=dble(sh/2.) +c tmin=sh/2-sqrt(sh*sh/4-q2min*sh) + sqrtq2s=sqrt(dble(q2min*sh)) + tmin=sh2-sqrt((sh2-sqrtq2s)*(sh2+sqrtq2s)) + tmax=sh2 + do i=1,ig + do m=1,2 + t=2d0*tmin/(1d0+tmin/tmax-dble(tgss(ig,i)*(2*m-3)) + & *(1d0-tmin/tmax)) + qq=sngl(t*(1d0-t/dble(sh))) + ft=ffsigj(sngl(t),qq,xx1,xx2,jpp,je1,je2)/sh**3 + * * (2*pi*pssalf(qq/qcdlam))**2 + ffsigiut=ffsigiut+wgss(ig,i)*ft*sngl(t)**2 + enddo + enddo + ffsigiut=ffsigiut + * *0.5*sngl(1d0/tmin-1d0/tmax) + * *2*pi*s + * /2 !CS for parton pair + return + end + +c----------------------------------------------------------------------- + function ffsigj(t,qt,x1,x2,jpp,je1,je2) +c----------------------------------------------------------------------- +c +c \sum x1*f_i(x1,qt) * x2*f_k(x2,qt) * B_ik +c +c B_ik = psbori = contribution to Born xsection: +c dsigmaBorn/d2pt/dy +c = s/pi * delta(s+t+u) * 2*pi*alpha**2 /s**2 * B_ik +c +c qt = virtuality scale +c x1, x2 = light cone momentum fractions +c +c x*f_j(x,qt) = function fparton(x,qt,j) +c +c----------------------------------------------------------------------- +c jpp: type of Pomeron +c 1 ... sea-sea +c 2 ... val-sea +c 3 ... sea-val +c 4 ... val-val +c 5 ... all +c je = emission type +c 0 ... no emissions +c 1 ... emissions +c 2 ... all +c----------------------------------------------------------------------- + include 'epos.incsem' + include 'epos.inc' + + s=engy**2*x1*x2 + + if(jpp.ne.5)then + ji1=mod(jpp+1,2)+1 + ji2=(jpp+1)/2 + sea1=pifpartone(x1,qt,-1,je1,ji1) + g1= pifpartone(x1,qt, 0,je1,ji1) + uv1= pifpartone(x1,qt, 1,je1,ji1) + dv1= pifpartone(x1,qt, 2,je1,ji1) + sea2=pifpartone(x2,qt,-1,je2,ji2) + g2= pifpartone(x2,qt, 0,je2,ji2) + uv2= pifpartone(x2,qt, 1,je2,ji2) + dv2= pifpartone(x2,qt, 2,je2,ji2) + else + sea1=pifpartone(x1,qt,-1,je1,1)+pifpartone(x1,qt,-1,je1,2) + g1= pifpartone(x1,qt, 0,je1,1)+pifpartone(x1,qt, 0,je1,2) + uv1= pifpartone(x1,qt, 1,je1,1)+pifpartone(x1,qt, 1,je1,2) + dv1= pifpartone(x1,qt, 2,je1,1)+pifpartone(x1,qt, 2,je1,2) + sea2=pifpartone(x2,qt,-1,je2,1)+pifpartone(x2,qt,-1,je2,2) + g2= pifpartone(x2,qt, 0,je2,1)+pifpartone(x2,qt, 0,je2,2) + uv2= pifpartone(x2,qt, 1,je2,1)+pifpartone(x2,qt, 1,je2,2) + dv2= pifpartone(x2,qt, 2,je2,1)+pifpartone(x2,qt, 2,je2,2) + endif + + ffsigj= ffborn(s,t, g1*g2 !gg + + * ,(uv1+dv1+2.*naflav*sea1)*g2+g1*(uv2+dv2+2.*naflav*sea2) !gq + + * ,(uv1+sea1)*(uv2+sea2) !qq + * +(dv1+sea1)*(dv2+sea2)+sea1*sea2*(naflav-1)*2. + + * ,(uv1+sea1)*sea2+(uv2+sea2)*sea1 !qa + * +(dv1+sea1)*sea2+(dv2+sea2)*sea1+sea1*sea2*(naflav-2)*2. + + * ,dv1*uv2+dv2*uv1+(uv2+dv2)*sea1*(naflav-1)*2. !qqp + * +(uv1+dv1)*sea2*(naflav-1)*2. + * +sea1*sea2*naflav*(naflav-1)*4. + + *) + end + +c----------------------------------------------------------------------- + function ffsig(t,qt,x1,x2) !former psjy +c----------------------------------------------------------------------- + include 'epos.incsem' + include 'epos.inc' + + s=engy**2*x1*x2 + + g1= pifpartone(x1,qt, 0,2,1)+pifpartone(x1,qt, 0,2,2) + uv1= pifpartone(x1,qt, 1,2,1)+pifpartone(x1,qt, 1,2,2) + dv1= pifpartone(x1,qt, 2,2,1)+pifpartone(x1,qt, 2,2,2) + sea1=pifpartone(x1,qt,-1,2,1)+pifpartone(x1,qt,-1,2,2) + g2= pifpartone(x2,qt, 0,2,1)+pifpartone(x2,qt, 0,2,2) + uv2= pifpartone(x2,qt, 1,2,1)+pifpartone(x2,qt, 1,2,2) + dv2= pifpartone(x2,qt, 2,2,1)+pifpartone(x2,qt, 2,2,2) + sea2=pifpartone(x2,qt,-1,2,1)+pifpartone(x2,qt,-1,2,2) + + ffsig= ffborn(s,t, g1*g2 !gg + + * ,(uv1+dv1+2.*naflav*sea1)*g2+g1*(uv2+dv2+2.*naflav*sea2) !gq + + * ,(uv1+sea1)*(uv2+sea2) !qq + * +(dv1+sea1)*(dv2+sea2)+sea1*sea2*(naflav-1)*2. + + * ,(uv1+sea1)*sea2+(uv2+sea2)*sea1 !qa + * +(dv1+sea1)*sea2+(dv2+sea2)*sea1+sea1*sea2*(naflav-2)*2. + + * ,dv1*uv2+dv2*uv1+(uv2+dv2)*sea1*(naflav-1)*2. !qqp + * +(uv1+dv1)*sea2*(naflav-1)*2. + * +sea1*sea2*naflav*(naflav-1)*4. + + *) + end + +c------------------------------------------------------------------------ + function ffborn(s,t,gg,gq,qq,qa,qqp) +c------------------------------------------------------------------------ + + ffborn= + *( psbori(s,t,0,0,1)+psbori(s,s-t,0,0,1) + * +psbori(s,t,0,0,2)+psbori(s,s-t,0,0,2)) /2. *gg !gg + + *+(psbori(s,t,0,1,1)+psbori(s,s-t,0,1,1)) *gq !gq + + *+(psbori(s,t,1,1,1)+psbori(s,s-t,1,1,1))/2. *qq !qq + + *+(psbori(s,t,1,-1,1)+psbori(s,s-t,1,-1,1)+psbori(s,t,1,-1,2)+ + * psbori(s,s-t,1,-1,2)+psbori(s,t,1,-1,3)+psbori(s,s-t,1,-1,3)) !qa + * *qa + + *+(psbori(s,t,1,2,1)+psbori(s,s-t,1,2,1)) *qqp !qq' + + end + +c----------------------------------------------------------------------- + function pifpartone(xx,qq,j,je,ji) ! pol interpolation of partone +c----------------------------------------------------------------------- + include 'epos.incsem' + include 'epos.inc' + common/tabfptn/kxxmax,kqqmax,fptn(20,20,-1:2,0:2,2) + real wi(3),wj(3) + common /cpifpartone/npifpartone + data npifpartone /0/ + npifpartone=npifpartone+1 + if(npifpartone.eq.1)call MakeFpartonTable + + qqmax=engy**2/4. + xxmin=0.01/engy + xxmax=1 + + xxk=1.+log(xx/xxmin)/log(xxmax/xxmin)*(kxxmax-1) + qqk=1.+log(qq/q2min)/log(qqmax/q2min)*(kqqmax-1) + kxx=int(xxk) + kqq=int(qqk) + if(kxx.lt.1)kxx=1 + if(kqq.lt.1)kqq=1 + if(kxx.gt.(kxxmax-2))kxx=kxxmax-2 + if(kqq.gt.(kqqmax-2))kqq=kqqmax-2 + + wi(2)=xxk-kxx + wi(3)=wi(2)*(wi(2)-1.)*.5 + wi(1)=1.-wi(2)+wi(3) + wi(2)=wi(2)-2.*wi(3) + + wj(2)=qqk-kqq + wj(3)=wj(2)*(wj(2)-1.)*.5 + wj(1)=1.-wj(2)+wj(3) + wj(2)=wj(2)-2.*wj(3) + pifpartone=0 + do kx=1,3 + do kq=1,3 + pifpartone=pifpartone+fptn(kxx+kx-1,kqq+kq-1,j,je,ji) + * *wi(kx)*wj(kq) + enddo + enddo + end + +c----------------------------------------------------------------------- + subroutine MakeFpartonTable +c----------------------------------------------------------------------- + include 'epos.incsem' + include 'epos.inc' + common/tabfptn/kxxmax,kqqmax,fptn(20,20,-1:2,0:2,2) + write (*,'(a,$)')'(Fparton table' + kxxmax=10 + kqqmax=10 + qqmax=engy**2/4. + xxmin=0.01/engy + xxmax=1 + do ji=1,2 + do je=0,2 + write(*,'(a,$)')'.' + do j=-1,2 + do kxx=1,kxxmax + xx=xxmin*(xxmax/xxmin)**((kxx-1.)/(kxxmax-1.)) + do kqq=1,kqqmax + qq=q2min*(qqmax/q2min)**((kqq-1.)/(kqqmax-1.)) + fptn(kxx,kqq,j,je,ji)= fpartone(xx,qq,j,je,ji) + enddo + enddo + enddo + enddo + enddo + write (*,'(a,$)')'done)' + end + +c------------------------------------------------------------------------ + function fpartone(xx,qq,j,je,ji) !former pspdf0 (sha) +c----------------------------------------------------------------------- +c +c parton distribution function for proton ( actually x*f(x) !!!!!!! ) +c +c xx = light cone momentum fraction +c qq = virtuality scale +c j = parton type +c -1 ... sea (distribution function per flavor) +c 0 ... g +c 1 ... u +c 2 ... d +c je = emission type +c 0 ... no emissions +c 1 ... emissions +c 2 ... all +c ji = initial parton type +c 1 ... sea (q et g) +c 2 ... val +c----------------------------------------------------------------------- + double precision z,xmin,xm,zx,psuds + common/ar3/ x1(7),a1(7) + include 'epos.inc' + include 'epos.incsem' + + fpartone=0 + if(je.eq.1)goto888 + +c ...... f_0 * sudakov......... + + if(j.eq.0.and.ji.eq.1)then + fpartone=fzeroGlu(xx,2,1) !hadron class 2, projectile side + elseif((j.eq.1.or.j.eq.2).and.ji.eq.2)then + fpartone=psdfh4(xx,q2min,0.,2,j) + elseif(j.eq.-1.and.ji.eq.1)then + fpartone=fzeroSea(xx,2,1) + endif + fpartone=fpartone*sngl(psuds(qq,j)/psuds(q2min,j)) + if(je.eq.0)goto999 + +c......... integral f_0 E_qcd............ + + 888 continue + xmin=dble(xx)/(1.d0-dble(q2ini/qq)) + if(xmin.lt.1.d0)then + dpd1=0. + dpd2=0. + xm=max(xmin,0.3d0) + + !numerical integration xm -> 1 + + do i=1,7 + do m=1,2 + zx=1.d0-(1.d0-xm)*(.5d0+(dble(m)-1.5d0)*dble(x1(i)))**.25d0 + z=xx/zx + + gl=fzeroGlu(sngl(zx),2,1) + uv=psdfh4(sngl(zx),q2min,0.,2,1) + dv=psdfh4(sngl(zx),q2min,0.,2,2) + sea=fzeroSea(sngl(zx),2,1) + + fz=0 + if(j.eq.0)then + if(ji.eq.1) + * fz=gl *psevi(q2min,qq,z,1,1) + * +sea*psevi(q2min,qq,z,2,1) !ccccc + if(ji.eq.2) + * fz=(uv+dv)*psevi(q2min,qq,z,2,1) + elseif(j.eq.1.and.ji.eq.2)then + fz=psevi(q2min,qq,z,3,2)*uv + elseif(j.eq.2.and.ji.eq.2)then + fz=psevi(q2min,qq,z,3,2)*dv + elseif(j.eq.-1)then + akns=psevi(q2min,qq,z,3,2) !nonsinglet contribution + aks=(psevi(q2min,qq,z,2,2)-akns) !singlet contribution + if(ji.eq.1) + * fz=psevi(q2min,qq,z,1,2)*gl + * +sea*aks+sea*akns !ccccc + if(ji.eq.2) + * fz=(uv+dv)*aks + endif + dpd1=dpd1+a1(i)*fz/sngl(zx)**2/sngl(1.d0-zx)**3 + enddo + enddo + dpd1=dpd1*sngl(1.d0-xm)**4/8.*xx + + !numerical integration xmin -> xm + + if(xm.gt.xmin)then + do i=1,7 + do m=1,2 + zx=xx+(xm-xx) + & *((xmin-xx)/(xm-xx))**(.5d0-(dble(m)-1.5d0)*dble(x1(i))) + z=xx/zx + + gl=fzeroGlu(sngl(zx),2,1) + uv=psdfh4(sngl(zx),q2min,0.,2,1) + dv=psdfh4(sngl(zx),q2min,0.,2,2) + sea=fzeroSea(sngl(zx),2,1) + + fz=0 + if(j.eq.0)then + if(ji.eq.1) + * fz=gl *psevi(q2min,qq,z,1,1) + * +sea*psevi(q2min,qq,z,2,1) !ccccc + if(ji.eq.2) + * fz=(uv+dv)*psevi(q2min,qq,z,2,1) + elseif(j.eq.1.and.ji.eq.2)then + fz=psevi(q2min,qq,z,3,2)*uv + elseif(j.eq.2.and.ji.eq.2)then + fz=psevi(q2min,qq,z,3,2)*dv + elseif(j.eq.-1)then + akns=psevi(q2min,qq,z,3,2) !nonsinglet contribution + aks=(psevi(q2min,qq,z,2,2)-akns) !singlet contribution + if(ji.eq.1) + * fz=psevi(q2min,qq,z,1,2)*gl + * +sea*aks+sea*akns !ccccc + if(ji.eq.2) + * fz=(uv+dv)*aks + endif + dpd2=dpd2+a1(i)*fz*sngl((1.d0-xx/zx)/zx) + enddo + enddo + dpd2=dpd2*sngl(log((xm-xx)/(xmin-xx))*.5d0*xx) + endif + fpartone=fpartone+dpd2+dpd1 + endif + + 999 continue + if(j.lt.0)fpartone=fpartone/naflav/2. + return + end + +c------------------------------------------------------------------------ + function fparton(xx,qq,j) !former pspdf0 (sha) +c----------------------------------------------------------------------- +c +c parton distribution function for proton ( actually x*f(x) !!!!!!! ) +c +c xx = light cone momentum fraction +c qq = virtuality scale +c j = parton type +c -1 ... sea (dsistribution fuction per flavor) +c 0 ... g +c 1 ... u +c 2 ... d +c +c----------------------------------------------------------------------- +c (see pages 105 - 107 of our report) +c +c fparton(xx) = xx * f(xx) !!!!! +c +c f_j(xx,qq) = \sum_k \int(xx<x<1) dx/x f0_k(x) Eqcd_k_j(xx/x,qq) +c +c f0_k = fzeroGlu or fzeroSea +c +c Eqcd=E~qcd+delta*sudakov, E~qcd: at least one emission +c +c----------------------------------------------------------------------- + double precision z,xmin,xm,zx,psuds + common/ar3/ x1(7),a1(7) + include 'epos.inc' + include 'epos.incsem' + +c ...... f_0 * sudakov......... + + if(j.eq.0)then + fparton=fzeroGlu(xx,2,1) + elseif(j.eq.1.or.j.eq.2)then + fparton=psdfh4(xx,q2min,0.,2,j) + else + fparton=fzeroSea(xx,2,1) + endif + fparton=fparton*sngl(psuds(qq,j)/psuds(q2min,j)) + +c......... integral f_0 E_qcd............ + + xmin=xx/(1.d0-dble(q2ini/qq)) + if(xmin.lt.1.d0)then + dpd1=0. + dpd2=0. + xm=max(xmin,.3d0) + + !numerical integration xm -> 1 + + do i=1,7 + do m=1,2 + zx=1.d0-(1.d0-xm)*(.5d0+(dble(m)-1.5d0)*dble(x1(i)))**.25d0 + z=xx/zx + + gl=fzeroGlu(sngl(zx),2,1) + uv=psdfh4(sngl(zx),q2min,0.,2,1) + dv=psdfh4(sngl(zx),q2min,0.,2,2) + sea=fzeroSea(sngl(zx),2,1) + + if(j.eq.0)then + fz=psevi(q2min,qq,z,1,1)*gl + * +(uv+dv+sea)*psevi(q2min,qq,z,2,1) + elseif(j.eq.1)then + fz=psevi(q2min,qq,z,3,2)*uv + elseif(j.eq.2)then + fz=psevi(q2min,qq,z,3,2)*dv + else + akns=psevi(q2min,qq,z,3,2) !nonsinglet contribution + aks=(psevi(q2min,qq,z,2,2)-akns) !singlet contribution + fz=(psevi(q2min,qq,z,1,2)*gl+(uv+dv+sea)*aks+sea*akns) + endif + dpd1=dpd1+a1(i)*fz/sngl(zx)**2/sngl(1.d0-zx)**3 + enddo + enddo + dpd1=dpd1*sngl((1.d0-xm)**4/8.*xx) + + !numerical integration xmin -> xm + + if(xm.gt.xmin)then + do i=1,7 + do m=1,2 + zx=xx+(xm-xx)*((xmin-xx)/(xm-xx)) + * **(.5d0-(dble(m)-1.5)*dble(x1(i))) + z=xx/zx + + gl=fzeroGlu(sngl(zx),2,1) + uv=psdfh4(sngl(zx),q2min,0.,2,1) + dv=psdfh4(sngl(zx),q2min,0.,2,2) + sea=fzeroSea(sngl(zx),2,1) + + if(j.eq.0)then + fz=psevi(q2min,qq,z,1,1)*gl+(uv+dv+sea)* + * psevi(q2min,qq,z,2,1) + elseif(j.eq.1)then + fz=psevi(q2min,qq,z,3,2)*uv + elseif(j.eq.2)then + fz=psevi(q2min,qq,z,3,2)*dv + else + akns=psevi(q2min,qq,z,3,2) !nonsinglet contribution + aks=(psevi(q2min,qq,z,2,2)-akns) !singlet contribution + fz=(psevi(q2min,qq,z,1,2)*gl+(uv+dv+sea)*aks+sea*akns) + endif + dpd2=dpd2+a1(i)*fz*sngl((1.d0-xx/zx)/zx) + enddo + enddo + dpd2=dpd2*sngl(log((xm-xx)/(xmin-xx))*.5d0*xx) + endif + fparton=fparton+dpd2+dpd1 + endif + if(j.lt.0)fparton=fparton/naflav/2. + return + end + +c------------------------------------------------------------------------ + function fzeroGlu(z,k,ipt) +c----------------------------------------------------------------------- +c +c x*f(x) +c +c f = F & EsoftGluon &=convolution +c +c F(x) = alpff(k)*x**betff(ipt)*(1-x)**alplea(k) +c +c EsoftGluon(x) = x**(-1-dels) * EsoftGluonTil(x) +c +c z - light cone x +c k - hadron class +c ipt - 1=proj 2=targ +c----------------------------------------------------------------------- + double precision xpmin,xp + include 'epos.inc' + common /ar3/ x1(7),a1(7) + include 'epos.incsem' + + fzeroGlu=0. + xpmin=z + xpmin=xpmin**(1+betff(ipt)+dels) + do i=1,7 + do m=1,2 + xp=(.5*(1.+xpmin+(2*m-3)*x1(i)*(1.-xpmin)))**(1./ + * (1+betff(ipt)+dels)) + zz=z/xp + fzeroGlu=fzeroGlu+a1(i)*(1.-xp)**alplea(k)*EsoftGluonTil(zz) + enddo + enddo + fzeroGlu=fzeroGlu*.5*(1.-xpmin)/(1+betff(ipt)+dels) + + fzeroGlu=fzeroGlu *alpff(k) *z**(-dels) + + end + +c------------------------------------------------------------------------ + function fzeroSea(z,k,ipt) +c----------------------------------------------------------------------- +c +c x*f(x) +c +c f = F & EsoftQuark &=convolution +c +c F(x) = alpff(k)*x**betff(ipt)*(1-x)**alplea(k) +c +c EsoftQuark(x) = x**(-1-dels) * EsoftQuarkTil(x) +c +c z - light cone x of the quark, +c k - hadron class +c----------------------------------------------------------------------- + double precision xpmin,xp + common /ar3/ x1(7),a1(7) + include 'epos.inc' + include 'epos.incsem' + + fzeroSea=0. + xpmin=z + xpmin=xpmin**(1+betff(ipt)+dels) + do i=1,7 + do m=1,2 + xp=(.5*(1.+xpmin+(2*m-3)*x1(i)*(1.-xpmin)))**(1./ + * (1+betff(ipt)+dels)) + zz=z/xp + fzeroSea=fzeroSea+a1(i)*(1.-xp)**alplea(k)*EsoftQuarkTil(zz) + enddo + enddo + fzeroSea=fzeroSea*.5*(1.-xpmin)/(1+betff(ipt)+dels) + + fzeroSea=fzeroSea *alpff(k) *z**(-dels) + + end + +c------------------------------------------------------------------------ + function EsoftGluonTil(zz) +c----------------------------------------------------------------------- +c EsoftGluon = zz^(-1-dels) * EsoftGluonTil +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + EsoftGluonTil=gamsoft*(1-glusea)*(1.-zz)**betpom + end + +c------------------------------------------------------------------------ + function EsoftQuarkTil(zz) +c----------------------------------------------------------------------- +c EsoftQuark = zz^(-1-dels) * EsoftQuarkTil +c----------------------------------------------------------------------- + double precision zmin,z + common /ar3/ x1(7),a1(7) + include 'epos.inc' + include 'epos.incsem' + + EsoftQuarkTil=0. + zmin=zz + zmin=zmin**(1.+dels) + do i=1,7 + do m=1,2 + z=(.5d0*(1.+zmin+(2*m-3)*x1(i)*(1.d0-zmin))) + * **(1.d0/(1.d0+dels)) + EsoftQuarkTil=EsoftQuarkTil+a1(i)*max(1.d-5,(1.d0-zz/z))**betpom + * *(z**2+(1.-z)**2) + enddo + enddo + EsoftQuarkTil=EsoftQuarkTil*1.5*(1.d0-zmin)/(1.+dels) + !1.5=naflav/2 at Q0 + EsoftQuarkTil=gamsoft*glusea*EsoftQuarkTil + + end + +c------------------------------------------------------------------------ + function EsoftQZero(zz) ! former psftilf +c----------------------------------------------------------------------- +c +c EsoftQuark = EsoftQZero * wsplit * z^(-1-dels) * gamsoft +c +c zz - ratio of the quark and pomeron light cone x (zz=x_G/x_P) +c integration over quark to gluon light cone momentum ratio (z=x/x_G): +c +c EsoftQZero = int(dz) z^dels * (1-zz/z)^betpom * P_qG(z) +c +c----------------------------------------------------------------------- + double precision zmin,z + common /ar3/ x1(7),a1(7) + include 'epos.incsem' + + EsoftQZero=0. + zmin=zz + zmin=zmin**(1.+dels) + do i=1,7 + do m=1,2 + z=(.5d0*(1.+zmin+(2*m-3)*x1(i)*(1.d0-zmin))) + * **(1.d0/(1.d0+dels)) + EsoftQZero=EsoftQZero+a1(i)*max(1.d-5,(1.d0-zz/z))**betpom + * *(z**2+(1.-z)**2) + enddo + enddo + EsoftQZero=EsoftQZero*1.5*(1.d0-zmin)/(1.+dels) !1.5=naflav/2 at Q0 + return + end + +c------------------------------------------------------------------------ + function ffsigi(qq,y0) !former psjx1 (sto) +c------------------------------------------------------------------------ +c +c dsigma/dpt_jet = \int dy \int dx1 ffsig(x1,x2(x1)) +c +c x1=xplus, x2=xminus +c x2=x2(x1) due to u+t+s=0 +c ( s=x1*x2*spp, t/spp=-x1*xt*exp(-y)/2, u/spp=-x2*xt*exp(y)/2 ) +c +c qq = pt**2, xt=2.*sqrt(qq/s) +c rapidity range: 0 to y0 +c +c ffsig = function ffsig(t,qq,x1,x2) +c +c----------------------------------------------------------------------- + include 'epos.incsem' + include 'epos.inc' + double precision xx1,xx2,xt,ymax,ymin,y,xmin,xmax + ig=3 + ig1=3 + s=engy**2 + ffsigi=0. + if(s.le.4.*qq)return + if(qq.lt.q2min)return + xt=2d0*sqrt(dble(qq)/dble(s)) + ymax=min(dble(y0),log(1d0/xt+sqrt((1d0/xt-1d0)*(1d0/xt+1d0)))) + ymin=-ymax !final result must be divided by 2 + do i=1,ig + do m=1,2 + y=.5d0*(ymax+ymin+(ymin-ymax)*dble((2*m-3)*tgss(ig,i))) + !for xx1-integration, use variable x=xx1-xt*exp(y)/2.,with xmin<x<xmax + xmin=xt**2/2.d0/(2.d0-xt*exp(-y)) !condition x2<1 + xmax=1.d0-xt*exp(y)/2.d0 !condition x1<1 + fx=0. + do i1=1,ig1 + do m1=1,2 + xx1=xt*exp(y)/2.d0+xmin*(xmax/xmin)**dble(.5 + & +tgss(ig1,i1)*(m1-1.5)) + xx2=xt*exp(-y)*xx1/(2.d0*xx1-xt*exp(y)) + z=sngl(xx1*xx2) + sh=z*s + aa=1.-4.*qq/sh + aa=max(1e-10,aa) + t=sh/2.*(1.-sqrt(aa)) !formula in parton-parton cms + ft=ffsig(t,qq,sngl(xx1),sngl(xx2)) + fx=fx+wgss(ig1,i1)*ft/sh**2 + enddo + enddo + fx=fx*0.5*sngl(log(xmax/xmin)) !dx/x=0.5*log(xmax/xmin)dt (gauss) + ffsigi=ffsigi+wgss(ig,i)*fx + enddo + enddo + ffsigi=ffsigi*0.5*sngl(ymax-ymin) !dy=0.5*(ymax-ymin)dt (gauss) + * *2*pi*(2*pi*pssalf(qq/qcdlam))**2 !alpha = 2*pi*pssalf + * *2*sqrt(qq) !d2pt=2*pi*pt*dpt + * /2 ! y interval 2 * Delta_y + * /2 ! condition t < sqrt(s)/2, + ! since t > sqrt(s)/2 is automatically included, + ! see psbori + return + end + +c------------------------------------------------------------------------ + function psbori(s,t,j,l,n) +c----------------------------------------------------------------------- +c contribution to the born cross-section: +c +c dsigmaBorn/d2pt/dy = s/pi * delta(s+t+u) * 2*pi*alpha**2 /s**2 *psbori +c +c s - c.m. energy squared for the born scattering, +c t - invariant variable for the born scattering |(p1-p3)**2|, +c j - parton type at current end of the ladder (0 - g, 1,-1,2,... - q) +c l - parton type at opposite end of the ladder (0 - g, 1,-1,2,... - q) +c n - subprocess number +c----------------------------------------------------------------------- + include 'epos.incsem' + + psbori=0. + u=s-t + if(u.le.0.d0)return + + if(iabs(j).ne.4)then !light quarks and gluons + if(n.eq.1)then + if(j.eq.0.and.l.eq.0)then !gg->gg + psbori=(3.-t*u/s**2+s*u/t**2+s*t/u**2)*4.5 + elseif(j*l.eq.0)then !gq->gq + psbori=(s**2+u**2)/t**2+(s/u+u/s)/2.25 + elseif(j.eq.l)then !qq->qq + psbori=((s**2+u**2)/t**2+(s**2+t**2)/u**2)/2.25 + * -s**2/t/u/3.375 + elseif(j.eq.-l)then !qq~->qq~ + psbori=((s**2+u**2)/t**2+(u**2+t**2)/s**2)/2.25 + * +u**2/t/s/3.375 + else !qq'->qq' + psbori=(s**2+u**2)/t**2/2.25 + endif + elseif(n.eq.2)then + if(j.eq.0.and.l.eq.0)then !gg->qq~ + psbori=.5*(t/u+u/t)-1.125*(t*t+u*u)/s**2 + elseif(j.eq.-l)then !qq~->q'q'~ + psbori=(t*t+u*u)/s**2/1.125 + else + psbori=0. + endif + elseif(n.eq.3)then + if(j.ne.0.and.j.eq.-l)then !qq~->gg + psbori=32./27.*(t/u+u/t)-(t*t+u*u)/s**2/.375 + else + psbori=0. + endif + +c............ n=4 for photon product processes, make e_q**2 =2/9., +c the average value of charge squared for all types of quarks. + elseif(n.eq.4) then + if(j.ne.0.and.j.eq.-l)then !qq~->g+gamma + psbori=16*factgam*(u/t+t/u)/81. + elseif (j*l.eq.0.and.j+l.ne.0) then !q(q~)g->q(q~)+gamma + psbori=2*factgam*(u/s+s/u)/27. + else + psbori=0. + endif +ctp090305 temporary to avoid hard gamma which produce fragmentation problem in psahot + psbori=0. !???????????? + elseif(n.eq.5) then + if(j.ne.0.and.j.eq.-l)then !qq~->gamma+gamma + psbori=4*factgam*(t/u+u/t)/81. + else + psbori=0. + endif +ctp090305 temporary to avoid hard gamma which produce fragmentation problem in psahot + psbori=0. !???????????? + endif + + elseif(n.eq.1)then !c-quark + + if(l.eq.0)then !cg->cg + xm=qcmass**2/s/u + psbori=(s**2+u**2)/t**2+(s/u+u/s)/2.25 + * -4.*qcmass**2/t+xm*(xm*t**2-t)/.5625+4.*qcmass**2*xm + else !cq->cq + psbori=(s**2+u**2)/t**2/2.25-qcmass**2/t/1.125 + endif + + else + + psbori=0. + + endif + return + end + +c----------------------------------------------------------------------- + double precision function om51p(sy,xh,yp,b,iqq) +c----------------------------------------------------------------------- +c om5p - chi~(x,y) +c xh - fraction of the energy squared s for the pomeron; +c yp - rapidity for the pomeron; +c b - impact parameter between the pomeron ends; +c iqq =-1 - 0+1+2+3+4, +c iqq = 0 - soft pomeron, +c iqq = 1 - gg, +c iqq = 2 - qg, +c iqq = 3 - gq, +c iqq = 4 - qq, +c iqq = 5 - soft(int)|b, +c iqq = 6 - gg(int)|b, +c iqq = 7 - soft(proj)|b, +c iqq = 8 - gg(proj)|b, +c iqq = 9 - qg(proj)|b, +c iqq = 10 - total fro-uncut integrated, +c iqq = 11 - total uncut integrated, +c iqq = 12 - soft(int), +c iqq = 13 - gg(int), +c iqq = 14 - <b^2*soft(int)>, +c iqq = 15 - <b^2*gg(int)>, +c iqq = 16 - soft(proj-int), +c iqq = 17 - gg(proj-int), +c iqq = 18 - qg(proj-int), +c iqq = 19 - <b^2*soft(proj)>, +c iqq = 20 - <b^2*gg(proj)>, +c iqq = 21 - <b^2*qg(proj)> +c----------------------------------------------------------------------- + double precision xh,yp!,coefom1,coefom2 + common /psar7/ delx,alam3p,gam3p + common /psar37/ coefom1,coefom2 + include 'epos.inc' + include 'epos.incsem' + + xp=dsqrt(xh)*exp(yp) + if(xh.ne.0.d0)then + xm=xh/xp + else + xm=0. + endif + rp=r2had(iclpro)+r2had(icltar)+slopom*log(max(1.,sy)) + zb=exp(-b**2/(4.*.0389*rp)) + rh=r2had(iclpro)+r2had(icltar) + + if(iqq.eq.0)then !soft +c rp=r2hads(iclpro)+r2hads(icltar)+slopoms*log(max(1.,sy)) + zb=exp(-b**2/(4.*.0389*rp)) + om51p=chad(iclpro)*chad(icltar)*gamhads(iclpro) + * *gamhads(icltar)*sy**dels*(xp*xm)**(-alppar)*zb/rp + elseif(iqq.le.4)then !gg,qg,gq,qq + om51p=psvin(sy,xp,xm,zb,iqq) + elseif(iqq.eq.5)then !soft(int)|b +c rh=alam3p+slopoms*log(max(1.,sy)) + om51p=sy**dels*zb**(rp/rh)/rh + elseif(iqq.eq.6)then !gg(int)|b + om51p=psvin(sy,xp,xm,zb,14) + elseif(iqq.eq.7)then !soft(proj)b +c rh=r2hads(iclpro)+.5*alam3p+slopoms*log(max(1.,sy)) + om51p=chad(iclpro)*gamhads(iclpro)*sy**dels + * *xp**(-alppar)*zb**(rp/rh)/rh + elseif(iqq.eq.8)then !gg(proj)b + om51p=psvin(sy,xp,xm,zb,16) + elseif(iqq.eq.9)then !qg(proj)b + om51p=psvin(sy,xp,xm,zb,18) + elseif(iqq.eq.10)then !total fro-uncut integrated + om51p=0.d0 + return + elseif(iqq.eq.11)then !total uncut integrated + om51p=psvin(sy,xp,xm,zb,9) +c om51p=om51p+dble(coefom1)/2.d0*om51p**2+dble(coefom2)/6.d0*om51p**3 !!!!!!!!!! +c if(om51p.gt.100.d0)om51p=100.d0 + elseif(iqq.eq.12)then !soft(int) + om51p=sy**dels*4.*.0389 + elseif(iqq.eq.13)then !gg(int) + om51p=psvin(sy,xp,xm,zb,5) + elseif(iqq.eq.14)then !<b^2*soft(int)> +c rh=alam3p+slopoms*log(max(1.,sy)) + om51p=sy**dels*rh*(4.*.0389)**2 + elseif(iqq.eq.15)then !<b^2*gg(int)> + om51p=psvin(sy,xp,xm,zb,15) + elseif(iqq.eq.16)then !soft(proj-int) + om51p=chad(iclpro)*gamhads(iclpro)*sy**dels + * *xp**(-alppar)*4.*.0389 + elseif(iqq.eq.17)then !gg(proj-int) + om51p=psvin(sy,xp,xm,zb,6) + elseif(iqq.eq.18)then !qg(proj-int) + om51p=psvin(sy,xp,xm,zb,7) + elseif(iqq.eq.19)then !<b^2*soft(proj)> +c rh=r2hads(iclpro)+.5*alam3p+slopoms*log(max(1.,sy)) + om51p=chad(iclpro)*gamhads(iclpro)*sy**dels + * *xp**(-alppar)*rh*(4.*.0389)**2 + elseif(iqq.eq.20)then !<b^2*gg(proj)> + om51p=psvin(sy,xp,xm,zb,17) + elseif(iqq.eq.21)then !<b^2*qg(proj)> + om51p=psvin(sy,xp,xm,zb,19) + else + om51p=0. + call utstop("Unknown iqq in om51p !&") + endif + + return + end + +cc----------------------------------------------------------------------- +c double precision function om2p(xh,yp,xprem0,xmrem0,b,iqq) +cc----------------------------------------------------------------------- +cc om2p - chi~(x,y) for cut pomeron +cc xh - fraction of the energy squared s for the pomeron; +cc yp - rapidity for the pomeron; +cc xprem - x+ for the projectile remnant; +cc xmrem - x- for the target remnant; +cc b - impact parameter between the pomeron ends; +cc iqq = 0 - total, +cc iqq = 1 - 1-cut, +cc iqq = 2 - Y+, +cc iqq = -2 - Y-, +cc iqq = 3 - 1-cut(soft), +cc iqq = 4 - 1+(gg), +cc iqq = 5 - 1+(qg), +cc iqq = 6 - 1+(gq), +cc iqq = 7 - 1+(difr) +cc iqq = -7 - 1-(difr) +cc----------------------------------------------------------------------- +c double precision xh,yp,xprem0,xmrem0 +c include 'epos.inc' +c include 'epos.incsem' +c +c om2p=0.d0 +c sy=xh*engy**2 +c xprem=sngl(xprem0) +c xmrem=sngl(xmrem0) +c xp=dsqrt(xh)*dexp(yp) +c if(xh.ne.0.d0)then +c xm=xh/xp +c else +c xm=0. +c endif +c rp=r2had(iclpro)+r2had(icltar)+slopom*log(max(1.,sy)) +c zb=exp(-b**2/(4.*.0389*rp)) +c +c if(iqq.eq.0)then +c om2p=psvy(xp,xprem,xm,xmrem,b,2) +c * +psvy(xp,xprem,xm,xmrem,b,-2) +c * +psvy(xp,xprem,xm,xmrem,b,3) +c * +psvy(xp,xprem,xm,xmrem,b,-3) +c * +psvy(xp,xprem,xm,xmrem,b,9) +c * +psvy(xp,xprem,xm,xmrem,b,-9) +c * +psvx(xp,xprem,xm,xmrem,b,1) +c * +psvx(xp,xprem,xm,xmrem,b,2) +c * +psvx(xp,xprem,xm,xmrem,b,-2) +c * +psvx(xp,xprem,xm,xmrem,b,6) +c * +psvx(xp,xprem,xm,xmrem,b,-6) +c om2p=om2p+(chad(iclpro)*chad(icltar)*gamhad(iclpro) +c * *gamhad(icltar)*sy**dels*(xp*xm)**(-alppar)*zb/rp +c * +psvin(sy,xp,xm,zb,1)+psvin(sy,xp,xm,zb,2) +c * +psvin(sy,xp,xm,zb,3)+psvin(sy,xp,xm,zb,4)) +c elseif(iqq.eq.1)then +c om2p=psvy(xp,xprem,xm,xmrem,b,2)+psvy(xp,xprem,xm,xmrem,b,-2) +c * +psvx(xp,xprem,xm,xmrem,b,1) +c elseif(iqq.eq.2)then +c om2p=psvy(xp,xprem,xm,xmrem,b,3) +c * +psvx(xp,xprem,xm,xmrem,b,2) +c elseif(iqq.eq.-2)then +c om2p=psvy(xp,xprem,xm,xmrem,b,-3) +c * +psvx(xp,xprem,xm,xmrem,b,-2) +c elseif(iqq.eq.3)then +c om2p=psvy(xp,xprem,xm,xmrem,b,4)+psvy(xp,xprem,xm,xmrem,b,-4) +c * +psvx(xp,xprem,xm,xmrem,b,3) +c elseif(iqq.eq.4)then +c om2p=psvy(xp,xprem,xm,xmrem,b,5)+psvy(xp,xprem,xm,xmrem,b,7) +c * +psvy(xp,xprem,xm,xmrem,b,-5)+psvy(xp,xprem,xm,xmrem,b,-7) +c * +psvx(xp,xprem,xm,xmrem,b,4)+psvx(xp,xprem,xm,xmrem,b,-4) +c elseif(iqq.eq.5)then +c om2p=psvy(xp,xprem,xm,xmrem,b,6)+psvy(xp,xprem,xm,xmrem,b,-8) +c * +psvx(xp,xprem,xm,xmrem,b,5) +c elseif(iqq.eq.6)then +c om2p=psvy(xp,xprem,xm,xmrem,b,-6)+psvy(xp,xprem,xm,xmrem,b,8) +c * +psvx(xp,xprem,xm,xmrem,b,-5) +c elseif(iqq.eq.7)then +c om2p=psvy(xp,xprem,xm,xmrem,b,9) +c * +psvx(xp,xprem,xm,xmrem,b,6) +c elseif(iqq.eq.-7)then +c om2p=psvy(xp,xprem,xm,xmrem,b,-9) +c * +psvx(xp,xprem,xm,xmrem,b,-6) +c else +c stop'om2p-wrong iqq!!!' +c endif +c return +c end +c +cc----------------------------------------------------------------------- +c double precision function om3p(xh,yp,xleg,xprem,xmrem,xlrem +c *,b1,b2,b12,iqq) +cc----------------------------------------------------------------------- +cc om3p - chi~(x,y) for cut pomeron (nuclear effects) +cc xh - fraction of the energy squared s for the pomeron; +cc yp - rapidity for the pomeron; +cc xleg - x for the pomeron leg; +cc xprem - x+ for the projectile remnant; +cc xmrem - x- for the target remnant; +cc xlrem - x for the leg remnant; +cc b1 - impact parameter between the pomeron ends; +cc b2 - impact parameter for the second pomeron end; +cc iqq = 1 - uncut+, +cc iqq = 2 - cut+, +cc iqq = 3 - scr+, +cc iqq = 4 - diffr+, +cc iqq = 5 - uncut-, +cc iqq = 6 - cut-, +cc iqq = 7 - scr-, +cc iqq = 8 - diff- +cc iqq = 9 - uncut-h+, +cc iqq = 10 - uncut-h-, +cc iqq = 11 - uncut-YY+, +cc iqq = 12 - uncut-YY-, +cc----------------------------------------------------------------------- +c double precision xh,yp,xleg,xprem,xmrem,xlrem +c +c om3p=0.d0 +c return !!!!!!!!!!!!!!! +cc if(iqq.ne.1.and.iqq.ne.5.and.iqq.ne.9.and.iqq.ne.10 +cc *.and.iqq.ne.11.and.iqq.ne.12)return +c +cc$$$ xp=dsqrt(xh)*exp(yp) +cc$$$ if(xh.ne.0.d0)then +cc$$$ xm=xh/xp +cc$$$ else +cc$$$ xm=0.d0 +cc$$$ endif +cc$$$ +cc$$$ return +c end +c +cc----------------------------------------------------------------------- +c double precision function om4p(xx1,xx2,xx3,xx4 +c *,b12,b13,b14,b23,b24,b34,iqq) +cc----------------------------------------------------------------------- +cc om4p - chi for 2-leg contributions +cc xx_i - x+- for pomeron ends; +cc b_ij - impact parameter diff. between pomeron ends; +cc iqq = 1 - uncut-H, +cc iqq = 2 - uncut-YY+, +cc iqq = 3 - uncut-YY- +cc----------------------------------------------------------------------- +c double precision xx1,xx2xx3,xx4 +c om4p=0.d0 +c return +c end +c +cc------------------------------------------------------------------------ +c function omi5pp(sy,xpp,xpm,z,iqq) !former psfsh1 +cc----------------------------------------------------------------------- +cc omi5pp - integrated semihard interaction eikonal +cc sy - energy squared for the hard interaction, +cc z - impact parameter factor, z=exp(-b**2/rp), +cc iqq - type of the hard interaction: +cc 0 - soft, 1 - gg, 2 - qg, 3 - gq +cc----------------------------------------------------------------------- +c common /ar3/ x1(7),a1(7) +c common /ar9/ x9(3),a9(3) +c include 'epos.inc' +c include 'epos.incsem' +c fsy(zsy)=zsy**dels !*(1.-1./zsy)**betpom +c +c omi5pp=0. +c if(iclpro.eq.4.and.iqq.eq.2.or.icltar.eq.4.and.iqq.eq.3)then +c spmin=4.*q2min+2.*qcmass**2 +c elseif(iqq.ne.0)then +c spmin=4.*q2min +c else +c spmin=0. +c endif +c if(sy.le.spmin)return +c +c rp=r2had(iclpro)+r2had(icltar)+slopom*log(max(1.,sy)) +c alpq=(alppar+1.)/2. +c if(iqq.eq.3)then +c iclt=iclpro +c iclp=icltar +c else +c iclp=iclpro +c iclt=icltar +c endif +c +c if(iqq.eq.0)then +c xpmax=(1.-spmin/sy)**(1.+alplea(iclp)) +c do i=1,3 +c do m=1,2 +c xp=1.-(xpmax*(.5+x9(i)*(m-1.5)))**(1./(1.+alplea(iclp))) +c xmmax=(1.-spmin/sy/xp)**(1.+alplea(iclt)) +c do i1=1,3 +c do m1=1,2 +c xm=1.-(xmmax*(.5+x9(i1)*(m1-1.5)))**(1./(1.+alplea(iclt))) +c +c sy1=sy*xp*xm +c rh=r2had(iclpro)+r2had(icltar)+slopom*log(max(1.,sy1)) +c omi5pp=omi5pp+a9(i)*a9(i1)*fsy(sy1)*xmmax*z**(rp/rh)/rh +c * *(xp*xm)**(-alppar) +c enddo +c enddo +c enddo +c enddo +c omi5pp=omi5pp*xpmax/(1.+alplea(iclp))/(1.+alplea(iclt)) +c * *chad(iclpro)*chad(icltar)*gamhad(iclpro)*gamhad(icltar) +c * *(xpp*xpm)**(1.-alppar)/4. +c return +c else +c +c xmin=(spmin/sy)**(delh-dels) +c do i=1,3 +c do m=1,2 +c zh=(.5*(1.+xmin-(2*m-3)*x9(i)*(1.-xmin)))**(1./(delh-dels)) +c if(iclpro.eq.4.and.iqq.eq.2.or.icltar.eq.4.and.iqq.eq.3)then +c call psjti0(zh*sy,sgq,sgqb,4,0) +c call psjti0(zh*sy,sqq,sqqb,4,1) +c else +c call psjti0(zh*sy,sgg,sggb,0,0) +c call psjti0(zh*sy,sgq,sgqb,0,1) +c call psjti0(zh*sy,sqq,sqqb,1,1) +c call psjti0(zh*sy,sqaq,sqaqb,-1,1) +c call psjti0(zh*sy,sqqp,sqqpb,1,2) +c sqq=(sqq+sqaq+2.*(naflav-1)*sqqp)/naflav/2. +c endif +c +c if(iqq.eq.1)then +c stg=0. +c do i1=1,3 +c do m1=1,2 +c xx=.5+x9(i1)*(m1-1.5) +c xp=zh**xx +c xm=zh/xp +c +c xp1max=(1.-xp)**(1.+alplea(iclp)) +c xm1max=(1.-xm)**(1.+alplea(iclt)) +c do i2=1,3 +c do m2=1,2 +c xp1=1.-(xp1max*(.5+x9(i2)*(m2-1.5))) +c * **(1./(1.+alplea(iclp))) +c do i3=1,3 +c do m3=1,2 +c xm1=1.-(xm1max*(.5+x9(i3)*(m3-1.5))) +c * **(1./(1.+alplea(iclt))) +c if(xp1.lt.xp.or.xm1.lt.xm)write (*,*)'xp1,xm1,xp,xm' +c * ,xp1,xm1,xp,xm +c +c rh=r2had(iclpro)+r2had(icltar)+slopom +c * *log(xp1*xm1/xp/xm) +c glu1=(1.-xp/xp1)**betpom*(1.-glusea) +c sea1=EsoftQZero(xp/xp1)*glusea +c glu2=(1.-xm/xm1)**betpom*(1.-glusea) +c sea2=EsoftQZero(xm/xm1)*glusea +c stg=stg+a9(i1)*a9(i2)*a9(i3)*(glu1*glu2*sgg +c * +(glu1*sea2+sea1*glu2)*sgq+sea1*sea2*sqq) +c * *xp1max*xm1max*(xp1*xm1)**(dels-alppar) +c * *z**(rp/rh)/rh +c enddo +c enddo +c enddo +c enddo +c enddo +c enddo +c omi5pp=omi5pp-a9(i)*log(zh)*stg/zh**delh +c +c else +c stq=0. +c xpmin=zh**(dels+.5) +c do i1=1,3 +c do m1=1,2 +c xp=(.5*(1.+xpmin-(2*m1-3)*x9(i1)*(1.-xpmin))) +c * **(1./(dels+.5)) +c xm=zh/xp +c if(xp*xpp.lt..99999)then +c uv1=psdfh4(xp*xpp,q2min,0.,iclp,1) +c dv1=psdfh4(xp*xpp,q2min,0.,iclp,2) +c xm1max=(1.-xm)**(1.+alplea(iclt)) +c do i2=1,3 +c do m2=1,2 +c xm1=1.-(xm1max*(.5+x9(i2)*(m2-1.5))) +c * **(1./(1.+alplea(iclt))) +c +c rh=r2had(iclpro)+r2had(icltar)+slopom*log(xm1/xm) +c glu2=(1.-xm/xm1)**betpom*(1.-glusea) +c sea2=EsoftQZero(xm/xm1)*glusea +c stq=stq+a9(i1)*a9(i2)*(glu2*sgq+sea2*sqq)*(uv1+dv1) +c * *z**(rp/rh)/rh*xm1max*xm1**(dels-alppar)/sqrt(xp) +c * *((1.-xp)/(1.-xp*xpp))**(1.-alpq+alplea(iclp)) +c enddo +c enddo +c endif +c enddo +c enddo +c stq=stq*(1.-xpmin) +c omi5pp=omi5pp+a9(i)*stq/zh**delh +c endif +c enddo +c enddo +c endif +c +c omi5pp=omi5pp*(1.-xmin)/(delh-dels) +c if(iqq.eq.1)then +c omi5pp=omi5pp*chad(iclp)*chad(iclt)*gamhad(iclp) +c * *gamhad(iclt)*ffrr**2*(xpp*xpm)**(1.-alppar) +c * /(1.+alplea(iclp))/(1.+alplea(iclt))*pi/8.*factk +c else +c omi5pp=omi5pp*chad(iclp)*chad(iclt)*ffrr*gamhad(iclt) +c * *xpp**(1.-alpq)*xpm**(1.-alppar)/(.5+dels) +c * /(1.+alplea(iclt))/16.*factk +c endif +c return +c end +c +c------------------------------------------------------------------------ + function om52pi(sy,xpp,xpm,iqq,je1,je2) !modified om51pp +c----------------------------------------------------------------------- +c sy - energy squared for the hard interaction +c +c iqq = 0 - sea-sea, +c iqq = 1 - val-sea, +c iqq = 2 - sea-val, +c iqq = 3 - val-val, +c +c je = emission type +c 0 ... no emissions +c 1 ... emissions +c else ... all +c +c already b-averaged (\int d2b /sigine*10) +c----------------------------------------------------------------------- + common /ar3/ x1(7),a1(7) + common /psar7/ delx,alam3p,gam3p + include 'epos.inc' + include 'epos.incsem' + if(iqq.lt.0.or.iqq.gt.3)stop'om52pi: unvalid iqq' + + om52pi=0. + + ef1=0 + ef2=0 + ef3=0 + ef4=0 + if( je1.ge.1 .and. je2.ge.1) ef1=1 + if( je1.ge.1 .and.(je2.eq.0.or.je2.eq.2))ef2=1 + if((je1.eq.0.or.je1.eq.2).and. je2.ge.1) ef3=1 + if((je1.eq.0.or.je1.eq.2).and.(je2.eq.0.or.je2.eq.2))ef4=1 + + spmin=4.*q2min + if(sy.le.spmin)goto999 + + if(iqq.eq.1)then + iclv=iclpro +ctp060829 icls=icltar + elseif(iqq.eq.2)then +ctp060829 icls=iclpro + iclv=icltar + endif + + delss=dels + if(iqq.eq.3)delss=-0.5 + xmin=spmin/sy + xmin=xmin**(delh-delss) + alpq=(alppar+1.)/2. + +c numerical integration over zh + do i=1,7 + do m=1,2 + zh=(.5*(1.+xmin-(2*m-3)*x1(i)*(1.-xmin)))**(1./(delh-delss)) + sgg= ef1 *pijet(2,q2min,q2min,zh*sy,0,0) + * + (ef2+ef3)*pijet(1,q2min,q2min,zh*sy,0,0) + * + ef4 *pijet(0,q2min,q2min,zh*sy,0,0) + sgq= ef1 *pijet(2,q2min,q2min,zh*sy,0,1) + * + (ef2+ef3)*pijet(1,q2min,q2min,zh*sy,0,1) + * + ef4 *pijet(0,q2min,q2min,zh*sy,0,1) + sqq= ef1 *pijet(2,q2min,q2min,zh*sy,1,1) + * + (ef2+ef3)*pijet(1,q2min,q2min,zh*sy,1,1) + * + ef4 *pijet(0,q2min,q2min,zh*sy,1,1) + sqaq= ef1 *pijet(2,q2min,q2min,zh*sy,-1,1) + * + (ef2+ef3)*pijet(1,q2min,q2min,zh*sy,-1,1) + * + ef4 *pijet(0,q2min,q2min,zh*sy,-1,1) + sqqp= ef1 *pijet(2,q2min,q2min,zh*sy,1,2) + * + (ef2+ef3)*pijet(1,q2min,q2min,zh*sy,1,2) + * + ef4 *pijet(0,q2min,q2min,zh*sy,1,2) + sqqi=sqq + sqq=(sqq+sqaq+2.*(naflav-1)*sqqp)/naflav/2. + if(iqq.eq.0)then + stg=0. + do i1=1,7 + do m1=1,2 + xx=.5+x1(i1)*(m1-1.5) + xp=zh**xx + xm=zh/xp + glu1=EsoftGluonTil(xp) + sea1=EsoftQuarkTil(xp) + glu2=EsoftGluonTil(xm) + sea2=EsoftQuarkTil(xm) + dstg= glu1*glu2*sgg + * +(glu1*sea2+sea1*glu2)*sgq !ccccc + * +sea1*sea2*sqq !ccccc + stg=stg+a1(i1)*dstg + enddo + enddo + om52pi=om52pi-a1(i)*log(zh)*stg/zh**delh + elseif(iqq.eq.3)then + stq=0. !int^1_(sqrt(z)) dx_p / x_p / sqrt(1-x_p) =int^(tmax)_(0) dt + tmax=sqrt(1.-sqrt(zh)) !t=ln((1+sqrt(1-x_p))/(1-sqrt(1-x_p))) + tmax=log((1.+tmax)/(1.-tmax)) + if(tmax.gt.1.e-20)then + do i1=1,7 + do m1=1,2 + t=tmax*(.5+x1(i1)*(m1-1.5)) + z01=((1.d0-exp(-1.d0*t))/(1.d0+exp(-1.d0*t)))**2 + xp=1.-z01 + xm=zh/xp + if(xp*xpp.le..9999.and.xm*xpm.le..9999 + * .or.xm*xpp.le..9999.and.xp*xpm.le..9999)then + stq=stq+a1(i1) + * *(psharg(xp*xpp,xm*xpm,sqqi,sqqp,sqaq) + * +psharg(xm*xpp,xp*xpm,sqqi,sqqp,sqaq)) + * *max(1e-20,1.-xp)**(.5-alpq) + * *max(1e-20,1.-xm)**(-alpq) + * *xp**delss*xm**delss + * *xpp**alppar/gamhad(iclpro) ! Eval + * *xpm**alppar/gamhad(icltar) ! Eval + endif + enddo + enddo + stq=stq*tmax + endif + om52pi=om52pi+a1(i)*stq/zh**delh + elseif(iqq.eq.1.or.iqq.eq.2)then + stq=0. + tmax=acos(sqrt(zh)) + do i1=1,7 + do m1=1,2 + t=tmax*(.5+x1(i1)*(m1-1.5)) + xp=cos(t)**2 + xm=zh/xp + if(xp*xpp.lt..99999)then + uv1=psdfh4(xp*xpp,q2min,0.,iclv,1) ! Eval + dv1=psdfh4(xp*xpp,q2min,0.,iclv,2) ! Eval + glu2=EsoftGluonTil(xm) + sea2=EsoftQuarkTil(xm) + dstq=0 + if(xp.ne.1.) + * dstq=(glu2*sgq+sea2*sqq)*(uv1+dv1) + * *(1.-xp*xpp)**(-1.+alpq-alplea(iclv)) ! Eval + * *xp**(delss-.5)*(1.-xp)**(-alpq+.5) ! Eval *sqrt(1-x)/sqrt(x) + * *xpp**alppar/gamhad(iclv) ! Eval + stq=stq+a1(i1)*dstq + endif + enddo + enddo + stq=stq*tmax + om52pi=om52pi+a1(i)*stq/zh**delh + else + stop'om52pi: unvalid iqq (2). ' + endif + enddo + enddo + + om52pi=om52pi*(1.-xmin)/(delh-delss) + + if(iqq.eq.0)then + om52pi=om52pi/4 + elseif(iqq.eq.3)then + om52pi=om52pi/4 + * * utgam1(2.+alplea(iclpro)-alpq) ! Eval + * /utgam1(1.+alplea(iclpro))/utgam1(1.-alpq) ! Eval + * * utgam1(2.+alplea(icltar)-alpq) ! Eval + * /utgam1(1.+alplea(icltar))/utgam1(1.-alpq) ! Eval + * /xpp**alpq/xpm**alpq ! Eval + elseif(iqq.le.2)then + om52pi=om52pi/2 + * *utgam1(2.+alplea(iclv)-alpq)/utgam1(1.+alplea(iclv)) ! Eval + * /utgam1(1.-alpq) ! Eval + * /xpp**alpq ! Eval + endif + + 999 continue + om52pi=om52pi*factk * .0390 /sigine*10 /2. + end + +c------------------------------------------------------------------------ + function psharg(zh1,zh2,sqq,sqqp,sqaq) +c----------------------------------------------------------------------- + include 'epos.incsem' + include 'epos.inc' + + alpq=(alppar+1.)/2. + if(zh1.le..9999.and.zh2.le..9999)then + uv1=psdfh4(zh1,q2min,0.,iclpro,1) + dv1=psdfh4(zh1,q2min,0.,iclpro,2) + uv2=psdfh4(zh2,q2min,0.,icltar,1) + dv2=psdfh4(zh2,q2min,0.,icltar,2) + if(iclpro.eq.2.and.icltar.eq.2)then !proton + fff=sqq*(uv1*uv2+dv1*dv2)+sqqp*(uv1*dv2+dv1*uv2) + elseif(iclpro.eq.1.or.icltar.eq.1)then !pion + fff=sqq*uv1*uv2+sqaq*dv1*dv2+sqqp*(uv1*dv2+dv1*uv2) + elseif(iclpro.eq.3.or.icltar.eq.3)then !kaon + fff=sqq*uv1*uv2+sqqp*(uv1*dv2+dv1*uv2+dv1*dv2) + elseif(iclpro.eq.4.or.icltar.eq.4)then !J/psi + fff=sqq*uv1*(uv2+dv2) + else + fff=0. + call utstop("Projectile not know in psharg !&") + endif + psharg=fff + * *(1.-zh1)**(-1.+alpq-alplea(iclpro)) + * *(1.-zh2)**(-1.+alpq-alplea(icltar)) + else + psharg=0. + endif + return + end + +c------------------------------------------------------------------------ + function om51pp(sy,xpp,z,iqq) !former psfsh +c----------------------------------------------------------------------- +c om51pp - semihard interaction eikonal +c sy - energy squared for the hard interaction, +c z - impact parameter factor, z=exp(-b**2/rp), +c iqq - type of the hard interaction: +c 0 - gg, 1 - qg, 2 - gq, 3 - gg(int), 4 - gg(proj), 5 - qg(proj), +c 6 - gg(int)|b=0, 7 - <b^2*gg(int)>, 8 - gg(proj)|b=0, +c 9 - <b^2*gg(proj)>, 10 - qg(proj)|b=0, 11 - <b^2*qg(proj)> +c----------------------------------------------------------------------- + common /ar3/ x1(7),a1(7) + common /psar7/ delx,alam3p,gam3p + include 'epos.inc' + include 'epos.incsem' + + om51pp=0. + if(iqq.eq.0.or.iqq.eq.3.or.iqq.eq.4 + *.or.iqq.eq.6.or.iqq.eq.7.or.iqq.eq.8.or.iqq.eq.9 + *.or.iclpro.ne.4.and.(iqq.eq.1.or.iqq.eq.5 + *.or.iqq.eq.10.or.iqq.eq.11) + *.or.icltar.ne.4.and.iqq.eq.2)then + spmin=4.*q2min + else + spmin=4.*q2min+2.*qcmass**2 + endif + if(sy.le.spmin)goto999 + + icls=iclpro + if(iqq.eq.1.or.iqq.eq.5.or.iqq.eq.10.or.iqq.eq.11)then + iclv=iclpro + icls=icltar + elseif(iqq.eq.2)then + icls=iclpro + iclv=icltar + endif + + xmin=spmin/sy + xmin=xmin**(delh-dels) + rp=r2had(iclpro)+r2had(icltar)+slopom*log(max(1.,sy)) + alpq=(alppar+1.)/2. + +c numerical integration over zh + do i=1,7 + do m=1,2 + zh=(.5*(1.+xmin-(2*m-3)*x1(i)*(1.-xmin)))**(1./ + * (delh-dels)) + if(iqq.eq.0.or.iqq.eq.3.or.iqq.eq.4 + * .or.iqq.eq.6.or.iqq.eq.7.or.iqq.eq.8.or.iqq.eq.9 + * .or.iclpro.ne.4.and.(iqq.eq.1.or.iqq.eq.5 + * .or.iqq.eq.10.or.iqq.eq.11) + * .or.icltar.ne.4.and.iqq.eq.2)then + call psjti0(zh*sy,sgg,sggb,0,0) !inclusive (sj) and born (sjb) + call psjti0(zh*sy,sgq,sgqb,0,1) + call psjti0(zh*sy,sqq,sqqb,1,1) + call psjti0(zh*sy,sqaq,sqaqb,-1,1) + call psjti0(zh*sy,sqqp,sqqpb,1,2) + sqq=(sqq+sqaq+2.*(naflav-1)*sqqp)/naflav/2. +c...........test....... +c tgg= psjet(q2min,q2min,q2min,zh*sy,0,0,0) +c * +2*psjet1(q2min,q2min,q2min,zh*sy,0,0,0) +c * + psborn(q2min,q2min,q2min,zh*sy,0,0,0,1) +c tgq= psjet(q2min,q2min,q2min,zh*sy,0,1,0) +c * +2*psjet1(q2min,q2min,q2min,zh*sy,0,1,0) +c * + psborn(q2min,q2min,q2min,zh*sy,0,1,0,1) +c tqq= psjet(q2min,q2min,q2min,zh*sy,1,1,0) +c * +2*psjet1(q2min,q2min,q2min,zh*sy,1,1,0) +c * + psborn(q2min,q2min,q2min,zh*sy,1,1,0,1) +c tqa= psjet(q2min,q2min,q2min,zh*sy,-1,1,0) +c * +2*psjet1(q2min,q2min,q2min,zh*sy,-1,1,0) +c * + psborn(q2min,q2min,q2min,zh*sy,-1,1,0,1) +c tqqp= psjet(q2min,q2min,q2min,zh*sy,1,2,0) +c * +2*psjet1(q2min,q2min,q2min,zh*sy,1,2,0) +c * + psborn(q2min,q2min,q2min,zh*sy,1,2,0,1) +c write(6,'(f12.2,3x,2f7.3,2(3x,2f7.3))') +c * zh*sy,tgg,sgg, tgq,sgq, tqqp,sqqp +c....................... + else + call psjti0(zh*sy,sgq,sgqb,4,0) + call psjti0(zh*sy,sqq,sqqb,4,1) + endif + + if(iqq.eq.0.or.iqq.eq.3.or.iqq.eq.4 + * .or.iqq.eq.6.or.iqq.eq.7.or.iqq.eq.8.or.iqq.eq.9)then + stg=0. + do i1=1,7 + do m1=1,2 + xx=.5+x1(i1)*(m1-1.5) + xp=zh**xx + xm=zh/xp + glu1=(1.-xp)**betpom*(1.-glusea) + sea1=EsoftQZero(xp)*glusea + glu2=(1.-xm)**betpom*(1.-glusea) + sea2=EsoftQZero(xm)*glusea + rh=0. + if(iqq.eq.0)then + rh=r2had(iclpro)+r2had(icltar)-slopom*log(zh) + elseif(iqq.eq.3.or.iqq.eq.4)then + rh=1. + elseif(iqq.eq.6.or.iqq.eq.7)then + rh=alam3p-slopom*log(zh) + elseif(iqq.eq.8.or.iqq.eq.9)then + rh=r2had(iclpro)+.5*alam3p-slopom*log(zh) + endif + dstg=(glu1*glu2*sgg+ + * (glu1*sea2+sea1*glu2)*sgq+sea1*sea2*sqq) + * *z**(rp/rh)/rh + if(iqq.eq.7.or.iqq.eq.9)dstg=dstg*rh**2 + stg=stg+a1(i1)*dstg + enddo + enddo + om51pp=om51pp-a1(i)*log(zh)*stg/zh**delh + else + stq=0. + tmax=acos(sqrt(zh)) + do i1=1,7 + do m1=1,2 + t=tmax*(.5+x1(i1)*(m1-1.5)) + xp=cos(t)**2 + xm=zh/xp + if(xp*xpp.lt..99999)then + uv1=psdfh4(xp*xpp,q2min,0.,iclv,1) + dv1=psdfh4(xp*xpp,q2min,0.,iclv,2) + glu2=(1.-xm)**betpom*(1.-glusea) + sea2=EsoftQZero(xm)*glusea + rh=0. + if(iqq.le.2)then + rh=r2had(iclpro)+r2had(icltar)-slopom*log(xm) + elseif(iqq.eq.5)then + rh=1. + elseif(iqq.le.10.or.iqq.le.11)then + rh=r2had(iclpro)+.5*alam3p-slopom*log(xm) + endif + dstq=0 + if(xp.ne.1.) + * dstq=(glu2*sgq+sea2*sqq)*(uv1+dv1) + * *z**(rp/rh)/rh + * *(1.-xp*xpp)**(-1.+alpq-alplea(iclv)) + * *xp**(dels-.5)*(1.-xp)**(-alpq+.5) + if(iqq.eq.11)dstq=dstq*rh**2 + stq=stq+a1(i1)*dstq + endif + enddo + enddo + stq=stq*tmax + om51pp=om51pp+a1(i)*stq/zh**delh + endif + enddo + enddo + + om51pp=om51pp*(1.-xmin)/(delh-dels)/sy**delh/2. + if(iqq.eq.0)then + om51pp=om51pp*chad(iclpro)*chad(icltar)*gamhad(iclpro) + * *gamhad(icltar)*ffrr**2*pi + elseif(iqq.eq.3)then + om51pp=om51pp*ffrr**2*pi*4.*.0389 + elseif(iqq.eq.6)then + om51pp=om51pp*ffrr**2*pi + elseif(iqq.eq.7)then + om51pp=om51pp*ffrr**2*pi*(4.*.0389)**2 + elseif(iqq.eq.4.or.iqq.eq.8.or.iqq.eq.9)then + om51pp=om51pp*ffrr**2*pi*chad(iclpro)*gamhad(iclpro) + if(iqq.eq.4)om51pp=om51pp*4.*.0389 + if(iqq.eq.9)om51pp=om51pp*(4.*.0389)**2 + elseif(iqq.le.2)then + om51pp=om51pp*chad(iclpro)*chad(icltar)*ffrr*gamhad(icls) + * *utgam1(2.+alplea(iclv)-alpq)/utgam1(1.+alplea(iclv)) + * /utgam1(1.-alpq)/2./xpp**alpq + elseif(iqq.eq.5.or.iqq.eq.10.or.iqq.eq.11)then + om51pp=om51pp*chad(iclv)*ffrr + * *utgam1(2.+alplea(iclv)-alpq)/utgam1(1.+alplea(iclv)) + * /utgam1(1.-alpq)/2./xpp**alpq + if(iqq.eq.5)om51pp=om51pp*4.*.0389 + if(iqq.eq.11)om51pp=om51pp*(4.*.0389)**2 + endif + 999 continue + end + +c------------------------------------------------------------------------------- + subroutine epocrossc(niter,gtot,gprod,gabs,gcoh,gqel,gdd) +c------------------------------------------------------------------------------- +c epocrossc - nucleus-nucleus (nucleus-hydrogen) interaction cross sections +c by calculation will real nuclear profiles and eikonal (simplified simulations) +c gtot - total cross section +c gprod - production cross section (all diffraction included) +c gabs - cut Pomerons cross section (no diffraction at all) +c gdd - proj (ionudi=2) or proj or targ (ionudi=0/3) excited diffraction +c cross section +c gcoh - coherent (elastic with respect to the projectile) cross section +c (non excited diff proj if ionudi=2, non excited proj+targ if ionudi=0/3) +c +c Be careful : this function is not symmetric for gdd and gqel (only projectile +c diffraction) in case of ionudi=2. +c (target diffraction is not treated explicitely and contributes to +c gprod, gdd, gcoh and gtot). +c +c WARNING : results are sure only in case of ionudi=1 (no substraction from +c diffractive part) in particular for AA with A > 10 (nuclear diff +c not well described). For pA seems to be OK with ionudi 2 and 3. +c +c code from QGSJET programs by S.Ostapchenko +c------------------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + common /cncl/xproj(mamx),yproj(mamx),zproj(mamx) + * ,xtarg(mamx),ytarg(mamx),ztarg(mamx) + common/geom/rmproj,rmtarg,bmax,bkmx + dimension wabs(28),wdd(28),wcoh(28),wprod(28),wqel(28) + & ,b0(28),ai(28) + common /ar3/ x1(7),a1(7) + double precision xgabs,xgdd,xgprod,xgcoh,xgqel + + call utpri('epocrs',ish,ishini,2) + if(ish.ge.2)write(ifch,201)niter,bmax + kollini=koll !koll modified + do i=1,7 + b0(15-i)=bmax*sqrt((1.+x1(i))/2.) + b0(i)=bmax*sqrt((1.-x1(i))/2.) + ai(i)=a1(i)*bmax**2*pi*5.05 !factor change cs + ai(15-i)=ai(i) + enddo + if(maproj.gt.1.or.matarg.gt.1)then + difn=max(difnuc(maproj),difnuc(matarg)) + else + difn=1. + endif + do i=1,7 + tp=(1.+x1(i))/2. + tm=(1.-x1(i))/2. + b0(14+i)=bmax-log(tp)*difn + b0(29-i)=bmax-log(tm)*difn + ai(14+i)=a1(i)*b0(14+i)/tp*10.*difn*pi + ai(29-i)=a1(i)*b0(29-i)/tm*10.*difn*pi + enddo + do i=1,28 + wabs(i)=0. + wdd(i)=0. + wprod(i)=0. + wcoh(i)=0. + wqel(i)=0. + enddo + do nc=1,niter + if(maproj.eq.1)then + xproj(1)=0. + yproj(1)=0. + zproj(1)=0. + else + call conxyz('p',mamx,xproj,yproj,zproj,ypjtl-yhaha) + endif + if(matarg.eq.1)then + xtarg(1)=0. + ytarg(1)=0. + ztarg(1)=0. + else + call conxyz('t',mamx,xtarg,ytarg,ztarg,yhaha) + endif + + do i=1,28 + call epogcr(b0(i),xgabs,xgdd,xgprod,xgcoh,xgqel) + wabs(i)=wabs(i)+sngl(xgabs) + wdd(i)=wdd(i)+sngl(xgdd) + wprod(i)=wprod(i)+sngl(xgprod) + wcoh(i)=wcoh(i)+sngl(xgcoh) + wqel(i)=wqel(i)+sngl(xgqel) + enddo + enddo + + gabs=0. + gdd=0. + gcoh=0. + gprod=0. + gqel=0. + do i=1,28 + wabs(i)=wabs(i)/niter + wdd(i)=wdd(i)/niter + wcoh(i)=wcoh(i)/niter + wprod(i)=wprod(i)/niter + wqel(i)=wqel(i)/niter + gabs=gabs+ai(i)*wabs(i) + gdd=gdd+ai(i)*wdd(i) + gcoh=gcoh+ai(i)*wcoh(i) + gqel=gqel+ai(i)*wqel(i) + gprod=gprod+ai(i)*wprod(i) + enddo + + + gtot=gprod+gcoh !total=all cut (with diff) + all uncut + if(ish.ge.2)write (ifch,202)gtot,gprod,gabs,gdd,gcoh,gqel + +201 format(2x,'epocrossc - A-B interaction cross sections,' + *,' N of iter.:',i5,' bmax:',f5.2) +202 format(2x,'epocrossc: gtot=',e10.3,2x,'gprod=',e10.3,2x + *,'gabs=',e10.3/4x,'gdd=',e10.3,2x,'gcoh=',e10.3,'gqel=',e10.3) + + + koll=kollini + call utprix('epocrs',ish,ishini,2) + + return + end + +c------------------------------------------------------------------------------- + subroutine epogcr(b,gabs,gdd,gprod,gcoh,gqel) +c------------------------------------------------------------------------------- +c epogcr - integrands (b-profiles) for nucleus-nucleus cross sections +c b - impact parameter +c code from QGSJET programs by S.Ostapchenko +c------------------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + include 'epos.incpar' + common /cncl/xproj(mamx),yproj(mamx),zproj(mamx) + * ,xtarg(mamx),ytarg(mamx),ztarg(mamx) + common/geom/rmproj,rmtarg,bmax,bkmx + common/scrangle/ phik3(kollmx),thetak3(kollmx) + double precision vin,gabs,gdd,gprod,gcoh,fdd,gqel,fdt,vdt,vcu + + if(ish.ge.9)write (ifch,201)b + gprod=1d0 + gabs=1d0 + gdd=1d0 + fdd=1d0 + fdt=1d0 + bx=0 + by=0 + + if(maproj.eq.1.and.matarg.eq.1)then + if(b.gt.bkmx)then + koll=0 + else + koll=1 + bk(1)=b + iproj(1)=1 + itarg(1)=1 + lproj(1)=1 + ltarg(1)=1 + lproj3(1)=1 + ltarg3(1)=1 + kproj3(1,1)=1 + ktarg3(1,1)=1 + kproj(1,1)=1 + ktarg(1,1)=1 + endif + else + bx=b + by=0. + koll=0 + do i=1,maproj + lproj(i)=0 + lproj3(i)=0 + enddo + do j=1,matarg + ltarg(j)=0 + ltarg3(j)=0 + enddo + do 12 i=1,maproj + do 11 j=1,matarg + bij=sqrt((xproj(i)+bx-xtarg(j))**2+(yproj(i)+by-ytarg(j))**2) + if(bij.gt.bkmx)goto 11 + + koll=koll+1 + if(koll.gt.kollmx)call utstop('epogcr: kollmx too small&') + bk(koll)=bij + bkx(koll)=xproj(i)+bx-xtarg(j) + bky(koll)=yproj(i)+by-ytarg(j) + iproj(koll)=i + itarg(koll)=j + lproj(i)=lproj(i)+1 + ltarg(j)=ltarg(j)+1 + kproj(i,lproj(i))=koll + ktarg(j,ltarg(j))=koll + if(iscreen.ne.0.and.bij.le.bkmxndif)then + if(zbrmax.gt.0..and.bij.gt.zbcut+zbrmax*rangen())goto 11 + lproj3(i)=lproj3(i)+1 + ltarg3(j)=ltarg3(j)+1 + kproj3(i,lproj3(i))=koll + ktarg3(j,ltarg3(j))=koll +c define angle for anti-shadowing + if(abs(bky(koll)).gt.1.e-6)then + if(abs(bkx(koll)).gt.1.e-6)then + phik3(koll)=atan(bky(koll)/bkx(koll)) + else + phik3(koll)=sign(0.5*pi,bky(koll)) + endif + elseif(bkx(koll).lt.0.)then + phik3(koll)=pi + endif + if(bk(koll).gt.0.)then + thetak3(koll)=atan(bglaubx/bk(koll)) + else + thetak3(koll)=0.5*pi + endif + endif + + 11 continue + 12 continue + endif + if(koll.eq.0)then + gabs=0d0 + gdd=0d0 + gprod=0d0 + gcoh=0d0 + gqel=0d0 + goto 1000 + endif + if(iscreen.ne.0)call CalcScrPair(b) + + irea=-1 + call GfunParK(irea) + if(ionudi.eq.0 + & .and.(maproj.ne.1.or.matarg.ne.1).and.nglevt.eq.0)then + gabs=0d0 + gdd=0d0 + gprod=0d0 + gcoh=0d0 + gqel=0d0 + goto 1000 + endif + call integom1(irea) + + do n=1,maproj + call epov(n,vin,vcu,vdt) + gprod=gprod*vin + gabs=gabs*vcu + fdd=fdd*(1.-rexdif(iclpro)) + & **(1.+rexres(iclpro)*float(lproj(n)-1)) + fdt=fdt*vdt + enddo + gprod=min(gprod,1.d0) + gcoh=1d0-2d0*sqrt(gprod)+gprod + gprod=1d0-gprod + gabs=max(0d0,1d0-gabs) !cut (no diffraction) + gdd=max(0d0,gprod-gabs) !diffractive part + gqel=0d0 + if(ionudi.eq.2.and.maproj+matarg.gt.2)then + gqel=fdd*gdd !quasielastic = diffractive without excited proj. + if(iLHC.eq.1)gqel=gqel-fdd*fdt*gdd !DPE counted as inelastic + gdd=gdd-gqel !only excited projectile diffraction + elseif(iLHC.ne.1)then + gqel=fdd*fdt*gdd !quasielastic = diffractive without excited proj. or targ + gdd=gdd-gqel !inelastic part due to excited diffraction + endif + 1000 continue + if(ish.ge.9)write (ifch,202)gabs,gdd,gprod,gcoh,gqel,fdd,fdt + +201 format(2x,'epogcr-integrands for nucleus-nucleus cross sections,' + *,' b=',e10.3) +202 format(2x,'epogcr: gabs=',e10.3,2x,'gdd=',e10.3,2x,'gprod=',e10.3 + *,2x,'gcoh=',e10.3,2x,'gqel=',e10.3,2x,'fdd=',e10.3,' fdt=',e10.3) + return + end + +c============================================================================= + subroutine epov(n,vin,vcu,vdt) +c epov - eikonal factors for nucleus-nucleus interaction +c (used for cross-section calculation) +c n - projectile nucleon indice +c vin - all uncut pomerons +c vcu - all uncut non diff pomerons +c vdt - non diffractive excitation factor for target +c code from QGSJET programs by S.Ostapchenko +c---------------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + common /cncl/xproj(mamx),yproj(mamx),zproj(mamx) + * ,xtarg(mamx),ytarg(mamx),ztarg(mamx) + double precision vvv2,vvv1,dv,vin,vcu,vdt,PhiExpoK,PhiExpoK2 + + if(ish.ge.9)write (ifch,201)xproj(n),yproj(n) + + vin=0.d0 + vcu=0.d0 + vvv1=1.d0 + vvv2=1.d0 + dv=1.d0 + do m=1,lproj(n) + k=kproj(n,m) + vvv2=vvv2*max(0.d0,PhiExpoK2(k,1.d0,1.d0)) + vvv1=vvv1*max(0.d0,PhiExpoK(k,1.d0,1.d0)) + dv=dv*(1.-rexdif(icltar)) + & **(1.+rexres(icltar)*float(ltarg(m)-1)) + enddo + vcu=vvv2 + vin=vvv1 !exp(-2 * chi) + vdt=dv + + if(ish.ge.9)write (ifch,202)vin,vcu,vdt + if(ish.ge.9)write (ifch,203) + +201 format(2x,'epov - eikonal factor: nucleon coordinates x=', + *e10.3,2x,'y=',e10.3) +202 format(2x,'vin=',e10.3,2x,'vcu=',e10.3,2x,'vdt=',e10.3) +203 format(2x,'epov - end') + return + end + +c------------------------------------------------------------------------ + subroutine psfz(iqq,gz2,b) +c----------------------------------------------------------------------- +c hadron-nucleus cross sections calculation +c b - impact parameter squared +C iqq - 1 = elastic cross section +C 2 = inelastic cross section +c----------------------------------------------------------------------- + double precision PhiExpo + include 'epos.inc' + include 'epos.incems' + include 'epos.incpar' + common /ar3/ x1(7),a1(7) + external pttcs,pprcs + + gz2=0. + e1=exp(-1.) + if(iomega.eq.2)then !no dif + rs=r2had(iclpro)+r2had(icltar)+slopom*log(engy**2) + else + rs=r2had(iclpro)+r2had(icltar)+max(slopom,slopoms)*log(engy**2) + & +gwidth*(r2had(iclpro)+r2had(icltar)) + & +bmxdif(iclpro,icltar)/4./0.0389 + endif + rpom=4.*.0389*rs + kollini=koll !koll modified in zzfz + koll=1 + if(iscreen.ne.0.and.(maproj.gt.1.or.matarg.gt.1))then + call zzfz(zzp,zzt,kollth,b) + koll=kollth + else + zzp=0. + zzt=0. + endif + + do i1=1,7 + do m=1,2 + z=.5+x1(i1)*(m-1.5) + zv1=exp(-z) + zv2=(e1*z) + b1=sqrt(-rpom*log(zv1)) + b2=sqrt(-rpom*log(zv2)) + + if(maproj.eq.1.and.matarg.eq.1)then + cg1=1. + cg2=1. + elseif(matarg.eq.1)then + cg1=ptrot(pprcs,b,b1) + cg2=ptrot(pprcs,b,b2) + else + cg1=ptrot(pttcs,b,b1) + cg2=ptrot(pttcs,b,b2) + endif + + vv21=sngl(Phiexpo(zzp,zzt,1.,1.d0,1.d0,engy**2,b1)) + vv22=sngl(Phiexpo(zzp,zzt,1.,1.d0,1.d0,engy**2,b2)) + if(iqq.ne.1)then + gz2=gz2+a1(i1)*(cg1*(1.-vv21)+cg2*(1.-vv22)/z) + else + vv11=sngl(Phiexpo(zzp,zzt,0.5,1.d0,1.d0,engy**2,b1)) + vv12=sngl(Phiexpo(zzp,zzt,0.5,1.d0,1.d0,engy**2,b2)) + gz2=gz2+a1(i1)*(cg1*(vv21-2.*vv11+1.) + & +cg2*(vv22-2.*vv12+1.)/z) + endif + enddo + enddo + gz2=gz2*rpom*0.5 + + koll=kollini + + return + end + +c------------------------------------------------------------------------ + subroutine zzfz(zzp,zzt,kollth,b) +c----------------------------------------------------------------------- +c hadron-nucleus cross sections calculation +c b - impact parameter squared +C xsfct - 0.5 = total cross section +C 1.0 = inelastic cross section +c----------------------------------------------------------------------- + common /psar50/ zznuc,b2xnuc + include 'epos.inc' + include 'epos.incems' + include 'epos.incpar' + common /ar3/ x1(7),a1(7) + external pttcs,pprcs,pttzz,pprzz + + zzp=0. + zzt=0. + kollth=1 + if(iscreen.eq.0.or.(maproj.eq.1.and.matarg.eq.1))return + + rs=r2had(iclpro)+r2had(icltar)+slopom*log(engy**2) + rpom=4.*.0389*rs + bgl2=2.*rpom*epscrp + zzpp=epscrw*fscra(engy/egyscr) +c caculate the radius where Z is saturated at epscrx to define the bases +c of nuclear shadowing + satrad=0. + if(zzpp.gt.0.)satrad=-bgl2*log(epscrx/zzpp) + bglx=zbrads*sqrt(max(0.1,satrad)) + fzbrmax=1. + if(zbrmax.gt.0)fzbrmax=zbrmax + fzbcut=1. + if(zbcut.gt.0)fzbcut=zbcut*bglx + fzbrads=1. + if(bglx.gt.0)fzbrads=bglx + fnuc=1.2*fzbcut/fzbrads + b2xnuc=bgl2+4.*fzbrmax*sqrt(float(maproj*matarg))*fnuc + + + e1=exp(-1.) + + colp=0. + colt=0. + do i1=1,7 + do m=1,2 + z=.5+x1(i1)*(m-1.5) + zv1=exp(-z) + zv2=(e1*z) + b1=sqrt(-rpom*log(zv1)) + b2=sqrt(-rpom*log(zv2)) + + + if(maproj.gt.1)then + cg1=ptrot(pprcs,b,b1) + cg2=ptrot(pprcs,b,b2) + colnuc=a1(i1)*(cg1+cg2/z) + colp=colp+colnuc + rho=0.05 + zznuc=epscrw*fscro(engy/egyscr,rho) + zp1=ptrot(pprzz,b,b1) + zp2=ptrot(pprzz,b,b2) + zzp=zzp+a1(i1)*(zp1+zp2/z) + endif + if(matarg.gt.1)then + cg1=ptrot(pttcs,b,b1) + cg2=ptrot(pttcs,b,b2) + colnuc=a1(i1)*(cg1+cg2/z) + colt=colt+colnuc + rho=0.05 + zznuc=epscrw*fscro(engy/egyscr,rho) + zt1=ptrot(pttzz,b,b1) + zt2=ptrot(pttzz,b,b2) + zzt=zzt+a1(i1)*(zt1+zt2/z) + endif + + enddo + enddo + colp=sqrt(colp) + colt=sqrt(colt) + if(colp.gt.1.)then + kollth=nint(max(1.,colp)) + colp=fnuc*log(colp) + zzp=sqrt(zzp) + zzp=0.01*zzp*colp*bgl2 +c saturation + zzp=min(zzp,colp*epscrx) + else + zzp=0. + endif + if(colt.gt.1.)then + kollth=nint(max(1.,kollth+colt)) + colt=fnuc*log(colt) + zzt=sqrt(zzt) + zzt=0.01*zzt*colt*bgl2 +c saturation + zzt=min(zzt,colt*epscrx) + else + zzt=0. + endif +c zzp=zzp*2. !correction to have formula=MC +c zzt=zzt*2. + +c print *,'ici',b,zzp,zzt,kollth,b2xnuc + + return + end + + +c------------------------------------------------------------------------ + function ptgau(func,bm,ipt,iqq) +c----------------------------------------------------------------------- +c impact parameter integration for impact parameters <bm - +c for nucleus-nucleus and hadron-nucleus cross-sections calculation +c ipt=1 : projectile, ipt=2 : target +c iqq=1 : elastic xsection, iqq=2 : inelastic cross section +c----------------------------------------------------------------------- + include 'epos.inc' + common /ar3/ x1(7),a1(7) + external func + + ptgau=0. + do i=1,7 + do m=1,2 + b=bm*sqrt(.5+x1(i)*(m-1.5)) + ptgau=ptgau+func(b,ipt,iqq)*a1(i) + enddo + enddo + ptgau=ptgau*bm**2*pi*.5 + return + end + +c------------------------------------------------------------------------ + function ptgau1(bm,ipt,iqq) +c----------------------------------------------------------------------- +c impact parameter integration for impact parameters >bm - +c for hadron-nucleus cross-sections calculation +c ipt=1 : projectile, ipt=2 : target +c iqq=1 : elastic xsection, iqq=2 : inelastic cross section +c----------------------------------------------------------------------- + include 'epos.inc' + common /ar5/ x5(2),a5(2) + + ptgau1=0. + if(ipt.eq.1)then + difn=difnuc(maproj) + else + difn=difnuc(matarg) + endif + do i=1,2 + b=bm+x5(i)*difn + ptgau1=ptgau1+ptfau(b,ipt,iqq)*a5(i)*exp(x5(i))*b*2.*pi*difn + enddo + return + end +c------------------------------------------------------------------------ + function ptgau2(bm,iqq) +c----------------------------------------------------------------------- +c impact parameter integration for impact parameters >bm - +c for nucleus-nucleus cross-sections calculation +c iqq=1 : elastic xsection, iqq=2 : inelastic cross section +c----------------------------------------------------------------------- + include 'epos.inc' + common /ar5/ x5(2),a5(2) + + ptgau2=0. + difn=difnuc(maproj)+difnuc(matarg) + do i=1,2 + b=bm+x5(i)*difn + ptgau2=ptgau2+ptfauAA(b,iqq)*a5(i)*exp(x5(i))*b*2.*pi*difn + enddo + return + end + + +c------------------------------------------------------------------------ + function ptfau(b,ipt,iqq) +c----------------------------------------------------------------------- +c ptfau - integrands for hadron-nucleus cross-sections calculation +c ipt=1 : projectile, ipt=2 : target +c iqq=1 : elastic xsection, iqq=2 : inelastic cross section +c----------------------------------------------------------------------- + include 'epos.inc' + common /psar35/ anorm,anormp + + call psfz(iqq,gz2,b) + + if(ipt.eq.1)then + ptfau=1.-max(0.,(1.-anormp*gz2))**maproj + else + ptfau=1.-max(0.,(1.-anorm*gz2))**matarg + endif + + return + end + +c------------------------------------------------------------------------ + function ptfauAA(b,iqq) +c----------------------------------------------------------------------- +c ptfau - integrands for hadron-nucleus cross-sections calculation +c iqq=1 : elastic xsection, iqq=2 : inelastic cross section +c----------------------------------------------------------------------- + include 'epos.inc' + common /ar3/ x1(7),a1(7) + common /psar35/ anorm,anormp + external pprcs + + ptfauAA=0. + e1=exp(-1.) + rs=r2had(iclpro)+r2had(icltar)+max(slopom,slopoms)*log(engy**2) + & +gwidth*(r2had(iclpro)+r2had(icltar)) + & +bmxdif(iclpro,icltar)/4./0.0389 + rpom=4.*.0389*rs + do i1=1,7 + do m=1,2 + z=.5+x1(i1)*(m-1.5) + zv1=exp(-z) + zv2=(e1*z) + b1=sqrt(-rpom*log(zv1)) + b2=sqrt(-rpom*log(zv2)) + call psfz(iqq,gz21,b1) + call psfz(iqq,gz22,b2) + ptfau1=max(0.,(1.-anorm*gz21))**matarg + ptfau2=max(0.,(1.-anorm*gz22))**matarg + cg1=ptrot(pprcs,b,b1) + cg2=ptrot(pprcs,b,b2) + ptfauAA=ptfauAA+a1(i1)*(cg1*(1.-ptfau1)+cg2*(1.-ptfau2)/z) + enddo + enddo + ptfauAA=ptfauAA*rpom/2. + ptfauAA=1.-max(0.,(1.-anormp*ptfauAA))**maproj + + return + end + +c------------------------------------------------------------------------ + function ptrot(func,s,b) +c----------------------------------------------------------------------- +c convolution of nuclear profile functions (axial angle integration) +c----------------------------------------------------------------------- + common /ar8/ x2(4),a2 + external func + + ptrot=0. + do i=1,4 + sb1=b**2+s**2-2.*b*s*(2.*x2(i)-1.) + sb2=b**2+s**2-2.*b*s*(1.-2.*x2(i)) + ptrot=ptrot+(func(sb1)+func(sb2)) + enddo + ptrot=ptrot*a2 + return + end + +c------------------------------------------------------------------------ + function pttcs(b0) +c----------------------------------------------------------------------- +c ptt - nuclear profile function value at imp param squared b*difnuc**2 +c----------------------------------------------------------------------- + include 'epos.inc' + common /psar34/ rrr,rrrm + common /ar5/ x5(2),a5(2) + common /ar9/ x9(3),a9(3) + + b=b0/difnuc(matarg)**2 + pttcs=0. + zm=rrrm**2-b + if(zm.gt.4.*b)then + zm=sqrt(zm) + else + zm=2.*sqrt(b) + endif + + do i=1,3 + z1=zm*(1.+x9(i))*0.5 + z2=zm*(1.-x9(i))*0.5 + quq=sqrt(b+z1**2)-rrr + if (quq.lt.85.)pttcs=pttcs+a9(i)/(1.+exp(quq)) + quq=sqrt(b+z2**2)-rrr + if (quq.lt.85.)pttcs=pttcs+a9(i)/(1.+exp(quq)) + enddo + pttcs=pttcs*zm*0.5 + + dt=0. + do i=1,2 + z1=x5(i)+zm + quq=sqrt(b+z1**2)-rrr-x5(i) + if (quq.lt.85.)dt=dt+a5(i)/(exp(-x5(i))+exp(quq)) + enddo + + pttcs=pttcs+dt + return + end + + +c------------------------------------------------------------------------ + function pttzz(b0) +c----------------------------------------------------------------------- +c ptt - nuclear Z function value at imp param squared b*difnuc**2 +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incpar' + common /psar34/ rrr,rrrm + common /psar50/ zznuc,b2xnuc + common /ar5/ x5(2),a5(2) + common /ar9/ x9(3),a9(3) + + pttzz=0. + b=b0/difnuc(matarg)**2 +c absb=max(1.e-9,sqrt(b0)-zbcut) + absb=max(1.e-9,sqrt(b0)) + bsq=absb*absb + zm=rrrm**2-b + if(zm.gt.4.*b)then + zm=sqrt(zm) + else + zm=2.*sqrt(b) + endif + + do i=1,3 + z1=zm*(1.+x9(i))*0.5 + z2=zm*(1.-x9(i))*0.5 + quq=sqrt(b+z1**2)-rrr + if (quq.lt.85.)pttzz=pttzz+a9(i)/(1.+exp(quq)) + quq=sqrt(b+z2**2)-rrr + if (quq.lt.85.)pttzz=pttzz+a9(i)/(1.+exp(quq)) + enddo + pttzz=pttzz*zm*0.5 + + dt=0. + do i=1,2 + z1=x5(i)+zm + quq=sqrt(b+z1**2)-rrr-x5(i) + if (quq.lt.85.)dt=dt+a5(i)/(exp(-x5(i))+exp(quq)) + enddo + + pttzz=max(0.,(pttzz+dt)-1.)*zznuc*exp(-bsq/2./b2xnuc) + + return + end + +c------------------------------------------------------------------------ + function pprcs(b0) +c----------------------------------------------------------------------- +c ppr - nuclear profile function value at imp param squared b*difnuc**2 +c----------------------------------------------------------------------- + include 'epos.inc' + common /psar41/ rrrp,rrrmp + common /ar5/ x5(2),a5(2) + common /ar9/ x9(3),a9(3) + + b=b0/difnuc(maproj)**2 + pprcs=0. + zm=rrrmp**2-b + if(zm.gt.4.*b)then + zm=sqrt(zm) + else + zm=2.*sqrt(b) + endif + + do i=1,3 + z1=zm*(1.+x9(i))*0.5 + z2=zm*(1.-x9(i))*0.5 + quq=sqrt(b+z1**2)-rrrp + if (quq.lt.85.)pprcs=pprcs+a9(i)/(1.+exp(quq)) + quq=sqrt(b+z2**2)-rrrp + if (quq.lt.85.)pprcs=pprcs+a9(i)/(1.+exp(quq)) + enddo + pprcs=pprcs*zm*0.5 + + dt=0. + do i=1,2 + z1=x5(i)+zm + quq=sqrt(b+z1**2)-rrrp-x5(i) + if (quq.lt.85.)dt=dt+a5(i)/(exp(-x5(i))+exp(quq)) + enddo + + pprcs=pprcs+dt + return + end + +c------------------------------------------------------------------------ + function pprzz(b0) +c----------------------------------------------------------------------- +c ppr - Z nuclear function value at imp param squared b*difnuc**2 +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incpar' + common /psar41/ rrrp,rrrmp + common /psar50/ zznuc,b2xnuc + common /ar5/ x5(2),a5(2) + common /ar9/ x9(3),a9(3) + + pprzz=0. + b=b0/difnuc(maproj)**2 +c absb=max(1.e-9,sqrt(b0)-zbcut) + absb=max(1.e-9,sqrt(b0)) + bsq=absb*absb + zm=rrrmp**2-b + if(zm.gt.4.*b)then + zm=sqrt(zm) + else + zm=2.*sqrt(b) + endif + + do i=1,3 + z1=zm*(1.+x9(i))*0.5 + z2=zm*(1.-x9(i))*0.5 + quq=sqrt(b+z1**2)-rrrp + if (quq.lt.85.)pprzz=pprzz+a9(i)/(1.+exp(quq)) + quq=sqrt(b+z2**2)-rrrp + if (quq.lt.85.)pprzz=pprzz+a9(i)/(1.+exp(quq)) + enddo + pprzz=pprzz*zm*0.5 + + dt=0. + do i=1,2 + z1=x5(i)+zm + quq=sqrt(b+z1**2)-rrrp-x5(i) + if (quq.lt.85.)dt=dt+a5(i)/(exp(-x5(i))+exp(quq)) + enddo + + pprzz=max(0.,(pprzz+dt)-1.)*zznuc*exp(-bsq/2./b2xnuc) + + return + end + +c------------------------------------------------------------------------------ + function pscrse(ek,mapr,matg,iqq) +c------------------------------------------------------------------------------ +c hadron-nucleus (hadron-proton) and nucl-nucl particle production cross section +c ek - lab kinetic energy for the interaction +c maproj - projec mass number +c matarg - target mass number +c iqq=1 - ela cross section +c >2 - ine cross section (2 used for cut (changing iomega), 3 uses table, +c 4 used for ine without table) +c------------------------------------------------------------------------------ + dimension wk(3),wa(3),wb(3) + include 'epos.inc' + common /psar33/ asect(7,4,8),asectn(7,8,8) + common /psar34/ rrr,rrrm + common /psar35/ anorm,anormp + common /psar41/ rrrp,rrrmp + external ptfau,ptfauAA + + pscrse=0. + call idmass(1120,amt1) + call idmass(1220,amt2) + amtar=0.5*(amt1+amt2) + if(matg.eq.1)amtar=amt1 + if(mapr.eq.1)then + call idmass(idproj,ampro) + else + ampro=amtar + endif + egy=ek+ampro +c p=sqrt(max(0.,egy**2-ampro**2)) + egy=sqrt( 2*egy*amtar+amtar**2+ampro**2 ) + + if(isetcs.le.1.or.iqq.ne.3)then + maprojsave=maproj + matargsave=matarg + engysave=engy + maproj=mapr + matarg=matg + engy=egy + if(matg.eq.1.and.mapr.eq.1)then + if(iqq.eq.1)then !sig ela + call psfz(1,gz2,0.) + else !sig ine + call psfz(2,gz2,0.) + endif + gin=gz2*pi*10. + elseif(mapr.eq.1)then + rad=radnuc(matg) + bm=rad+2. + rrr=rad/difnuc(matg) + rrrm=rrr+log(9.) + anorm=1.5/pi/rrr**3/(1.+(pi/rrr)**2)/difnuc(matg)**2 + if(iqq.ne.1)then + gin=(ptgau(ptfau,bm,2,2)+ptgau1(bm,2,2))*10. !sig ine + else + gin=(ptgau(ptfau,bm,2,1)+ptgau1(bm,2,1))*10. !sig ela + endif + elseif(matg.eq.1)then + rad=radnuc(mapr) + bm=rad+2. + rrrp=rad/difnuc(mapr) + rrrmp=rrrp+log(9.) + anormp=1.5/pi/rrrp**3/(1.+(pi/rrrp)**2)/difnuc(mapr)**2 + if(iqq.ne.1)then + gin=(ptgau(ptfau,bm,1,2)+ptgau1(bm,1,2))*10. !sig ine + else + gin=(ptgau(ptfau,bm,1,1)+ptgau1(bm,1,1))*10. !sig ela + endif + else + rad=radnuc(matg)+1. + radp=radnuc(mapr)+1. + bm=rad+radp+2. + rrr=rad/difnuc(matg) + rrrm=rrr+log(9.) + rrrp=radp/difnuc(mapr) + rrrmp=rrrp+log(9.) + anorm=1.5/pi/rrr**3/(1.+(pi/rrr)**2)/difnuc(matg)**2 + anormp=1.5/pi/rrrp**3/(1.+(pi/rrrp)**2)/difnuc(mapr)**2 + if(iqq.ne.1)then + gin=(ptgau(ptfauAA,bm,2,2)+ptgau2(bm,2))*10. !sig ine + else + gin=(ptgau(ptfauAA,bm,2,1)+ptgau2(bm,1))*10. !sig ela + endif + endif + pscrse=gin + maproj=maprojsave + matarg=matargsave + engy=engysave + else + ye=log10(max(1.,egy/1.5))+1. + je=min(5,int(ye)) + + wk(2)=ye-je + wk(3)=wk(2)*(wk(2)-1.)*.5 + wk(1)=1.-wk(2)+wk(3) + wk(2)=wk(2)-2.*wk(3) + + ya=matg + ya=log(ya)/.69315+1. + ja=min(int(ya),6) + wa(2)=ya-ja + wa(3)=wa(2)*(wa(2)-1.)*.5 + wa(1)=1.-wa(2)+wa(3) + wa(2)=wa(2)-2.*wa(3) + + if(mapr.eq.1)then + + do i=1,3 + do m=1,3 + pscrse=pscrse+asect(je+i-1,iclpro,ja+m-1)*wk(i)*wa(m) + enddo + enddo + + else + + yb=mapr + yb=log(yb)/.69315+1. + jb=min(int(yb),6) + wb(2)=yb-jb + wb(3)=wb(2)*(wb(2)-1.)*.5 + wb(1)=1.-wb(2)+wb(3) + wb(2)=wb(2)-2.*wb(3) + + do i=1,3 + do m=1,3 + do n=1,3 + pscrse=pscrse+asectn(je+i-1,jb+n-1,ja+m-1)*wk(i)*wa(m)*wb(n) + enddo + enddo + enddo + + endif + + pscrse=exp(pscrse) + endif + return + end + +c------------------------------------------------------------------------------ + function eposcrse(ek,mapro,matar,id) +c------------------------------------------------------------------------------ +c inelastic cross section of epos +c (id=0 corresponds to air) +c ek - kinetic energy for the interaction +c maproj - projec mass number (1<maproj<64) +c matarg - target mass number (1<matarg<64) +c------------------------------------------------------------------------------ + include 'epos.inc' + + eposcrse=0. + if(id.eq.0)then + do k=1,3 + mt=int(airanxs(k)) + eposcrse=eposcrse+airwnxs(k)*pscrse(ek,mapro,mt,3) + enddo + else + eposcrse=pscrse(ek,mapro,matar,3) + endif + + return + end + +c------------------------------------------------------------------------------ + function eposinecrse(ek,mapro,matar,id) +c------------------------------------------------------------------------------ +c inelastic cross section of epos not using tabulated xs +c (id=0 corresponds to air) +c ek - kinetic energy for the interaction +c maproj - projec mass number (1<maproj<64) +c matarg - target mass number (1<matarg<64) +c------------------------------------------------------------------------------ + include 'epos.inc' + + eposinecrse=0. + if(id.eq.0)then + do k=1,3 + mt=int(airanxs(k)) + eposinecrse=eposinecrse+airwnxs(k)*pscrse(ek,mapro,mt,4) + enddo + else + eposinecrse=pscrse(ek,mapro,matar,4) + endif + + return + end + +c------------------------------------------------------------------------------ + function eposelacrse(ek,mapro,matar,id) +c------------------------------------------------------------------------------ +c elastic cross section of epos +c (id=0 corresponds to air) +c ek - kinetic energy for the interaction +c maproj - projec mass number (1<maproj<64) +c matarg - target mass number (1<matarg<64) +c------------------------------------------------------------------------------ + include 'epos.inc' + + eposelacrse=0. + if(id.eq.0)then + do k=1,3 + mt=int(airanxs(k)) + eposelacrse=eposelacrse+airwnxs(k)*pscrse(ek,mapro,mt,1) + enddo + else + eposelacrse=pscrse(ek,mapro,matar,1) + endif + + return + end + + +c------------------------------------------------------------------------------ + function eposcutcrse(ek,mapro,matar,id) +c------------------------------------------------------------------------------ +c total cross section of epos +c (id=0 corresponds to air) +c ek - kinetic energy for the interaction +c maproj - projec mass number (1<maproj<64) +c matarg - target mass number (1<matarg<64) +c------------------------------------------------------------------------------ + include 'epos.inc' + + eposcutcrse=0. + iomegasave=iomega + iomega=2 + if(id.eq.0)then + do k=1,3 + mt=int(airanxs(k)) + eposcutcrse=eposcutcrse+airwnxs(k)*pscrse(ek,mapro,mt,2) + enddo + else + eposcutcrse=pscrse(ek,mapro,matar,2) + endif + iomega=iomegasave + + return + end + +c------------------------------------------------------------------------------ + subroutine crseaaEpos(sigt,sigi,sigc,sige) +c------------------------------------------------------------------------------ +c nucleus-nucleus (hadron) cross section of epos from simplified (realistic) +c simulations +c (id=0 corresponds to air) +c sigt = sig tot +c sigi = sig inelastic (cut + projectile diffraction) +c sigc = sig cut +c sige = sig elastic (includes target diffraction) +c------------------------------------------------------------------------------ + include 'epos.inc' + niter=20000 + if(idtarg.eq.0)then + sigt=0. + sigc=0. + sigi=0. + sige=0. + sigd=0. + sigql=0. + do k=1,3 + matarg=int(airanxs(k)) + call epocrossc(niter,xsigt,xsigi,xsigc,xsige,xsigql,xsigd) + sigt=sigt+airwnxs(k)*xsigt + sigi=sigi+airwnxs(k)*xsigi + sigc=sigc+airwnxs(k)*xsigc + sige=sige+airwnxs(k)*xsige + sigd=sigd+airwnxs(k)*xsigd + sigql=sigql+airwnxs(k)*xsigql + enddo + else + call epocrossc(niter,sigt,sigi,sigc,sige,sigql,sigd) + endif + if(ionudi.ne.1)then + sige=sige+sigql !add non-excited diffractive projectile to elastic + sigi=sigi-sigql !do not count non-excited diffractive projectile in inelastic + if(maproj+matarg.gt.2)then + sigc=sigc+sigd*0.95 !for absorbtion cross section remove 5% of the + !excited projectile diffractive cross section + !which "looks like" non excited (approximation) + endif + endif + end + + +cc------------------------------------------------------------------------ +c function pshard1(sy,xpp,xpm,z) +cc----------------------------------------------------------------------- +cc pshard - qq-pomeron eikonal +cc sy - energy squared for the pomeron, +cc xpp - lc+ for the pomeron, +cc xpm - lc- for the pomeron +cc----------------------------------------------------------------------- +c common /ar3/ x1(7),a1(7) +c common /ar9/ x9(3),a9(3) +c include 'epos.inc' +c include 'epos.incsem' +c +c pshard1=0. +c if(iclpro.ne.4.and.icltar.ne.4)then +c spmin=4.*q2min +c else +c spmin=4.*q2min+2.*qcmass**2 +c endif +c if(sy.le.spmin)return +c +c rp=r2had(iclpro)+r2had(icltar)+slopom*log(max(1.,sy)) +c alpq=(alppar+1.)/2. +c xmin=spmin/sy !min hard pomeron mass share +c xminl=xmin**(delh+.5) +c +c do i=1,3 +c do m=1,2 +c zh=(.5*(1.+xminl-(2*m-3)*x9(i)*(1.-xminl)))**(1./(delh+.5)) +c if(iclpro.ne.4.and.icltar.ne.4)then +c call psjti0(zh*sy,sqq,sqqb,1,1) +c call psjti0(zh*sy,sqqp,sqqpb,1,2) +c call psjti0(zh*sy,sqaq,sqaqb,-1,1) +c else +c call psjti0(zh*sy,sqq,sqqb,4,1) +c sqq=0. +c sqaq=0. +c endif +c +c stq=0. +c do i1=1,3 +c do m1=1,2 +c xx=.5+x9(i1)*(m1-1.5) +c xp=zh**xx +c xm=zh/xp +c if(xp*xpp.le..9999.and.xm*xpm.le..9999.or. +c * xm*xpp.le..9999.and.xp*xpm.le..9999)then +c stq=stq+a9(i1)*psharf(xp*xpp,xm*xpm,sqq,sqqp,sqaq) +c * *(1.-xp)**(1.+alplea(iclpro)-alpq) +c * *(1.-xm)**(1.+alplea(icltar)-alpq) +c endif +c enddo +c enddo +c pshard1=pshard1-a9(i)*stq/zh**(delh+0.5)*log(zh) +c enddo +c enddo +c pshard1=pshard1*(1.-xminl)/(delh+.5)/4.*factk +c **chad(iclpro)*chad(icltar)*(xpp*xpm)**(1.-alpq) +c **z**(rp/(r2had(iclpro)+r2had(icltar))) +c */(8.*pi*(r2had(iclpro)+r2had(icltar))) +c return +c end +c +c------------------------------------------------------------------------ + function pshard(sy,xpp,xpm) +c----------------------------------------------------------------------- +c pshard - qq-pomeron eikonal +c sy - energy squared for the pomeron, +c xpp - lc+ for the pomeron, +c xpm - lc- for the pomeron +c----------------------------------------------------------------------- + double precision z01 + common /ar3/ x1(7),a1(7) + include 'epos.inc' + include 'epos.incsem' + + pshard=0. + if(iclpro.ne.4.and.icltar.ne.4)then + spmin=4.*q2min + else + spmin=4.*q2min+2.*qcmass**2 + endif + if(sy.le.spmin)return + + alpq=(alppar+1.)/2. + xmin=spmin/sy !min hard pomeron mass share + xminl=xmin**(delh+.5) + + do i=1,7 + do m=1,2 + zh=(.5*(1.+xminl-(2*m-3)*x1(i)*(1.-xminl)))**(1./(delh+.5)) + if(iclpro.ne.4.and.icltar.ne.4)then + call psjti0(zh*sy,sqq,sqqb,1,1) + call psjti0(zh*sy,sqqp,sqqpb,1,2) + call psjti0(zh*sy,sqaq,sqaqb,-1,1) + else + call psjti0(zh*sy,sqq,sqqb,4,1) + sqqp=0. + sqaq=0. + endif + + stq=0. !int^1_(sqrt(z)) dx_p / x_p / sqrt(1-x_p) =int^(tmax)_(0) dt + tmax=sqrt(1.-sqrt(zh)) !t=ln((1+sqrt(1-x_p))/(1-sqrt(1-x_p))) + tmax=log((1.+tmax)/(1.-tmax)) + if(tmax.gt.1.e-20)then + do i1=1,7 + do m1=1,2 + t=tmax*(.5+x1(i1)*(m1-1.5)) + z01=((1.d0-exp(-1.d0*t))/(1.d0+exp(-1.d0*t)))**2 + xp=1.-z01 + xm=zh/xp + if(xp*xpp.le..9999.and.xm*xpm.le..9999.or. + * xm*xpp.le..9999.and.xp*xpm.le..9999)then + stq=stq+a1(i1)*(psharf(xp*xpp,xm*xpm,sqq,sqqp,sqaq)+ + * psharf(xm*xpp,xp*xpm,sqq,sqqp,sqaq)) + * *z01**(.5-alpq)/(1.-xm)**alpq + endif + enddo + enddo + stq=stq*tmax + endif + pshard=pshard+a1(i)*stq/zh**(delh+0.5) + enddo + enddo + pshard=pshard*(1.-xminl)/(delh+.5)/4.* + *utgam1(2.+alplea(iclpro)-alpq)/utgam1(1.+alplea(iclpro))/ + *utgam1(1.-alpq)* + *utgam1(2.+alplea(icltar)-alpq)/utgam1(1.+alplea(icltar))/ + *utgam1(1.-alpq)* + *chad(iclpro)*chad(icltar)/(8.*pi*(r2had(iclpro)+r2had(icltar)))* + *(xpp*xpm)**(-alpq)/sy**delh + return + end + +c------------------------------------------------------------------------ + function psharf(zh1,zh2,sqq,sqqp,sqaq) +c----------------------------------------------------------------------- + include 'epos.incsem' + include 'epos.inc' + + alpq=(alppar+1.)/2. + if(zh1.le..9999.and.zh2.le..9999)then + uv1=psdfh4(zh1,q2min,0.,iclpro,1) + dv1=psdfh4(zh1,q2min,0.,iclpro,2) + uv2=psdfh4(zh2,q2min,0.,icltar,1) + dv2=psdfh4(zh2,q2min,0.,icltar,2) + if(iclpro.eq.2.and.icltar.eq.2)then !proton + fff=sqq*(uv1*uv2+dv1*dv2)+sqqp*(uv1*dv2+dv1*uv2) + elseif(iclpro.eq.1.or.icltar.eq.1)then !pion + fff=sqq*uv1*uv2+sqaq*dv1*dv2+sqqp*(uv1*dv2+dv1*uv2) + elseif(iclpro.eq.3.or.icltar.eq.3)then !kaon + fff=sqq*uv1*uv2+sqqp*(uv1*dv2+dv1*uv2+dv1*dv2) + elseif(iclpro.eq.4.or.icltar.eq.4)then !J/psi + fff=sqq*uv1*(uv2+dv2) + else + fff=0. + call utstop("Projectile not know in psharg !&") + endif + psharf=fff*(1.-zh1)**(-1.+alpq-alplea(iclpro))* + * (1.-zh2)**(-1.+alpq-alplea(icltar)) + else + psharf=0. + endif + return + end + +c------------------------------------------------------------------------ + function psvin(sy,xpp,xpm,z,iqq) +c----------------------------------------------------------------------- +c psvin - contributions to the interaction eikonal +c sy - energy squared for the hard interaction, +c xpp - lc+ for the sh pomeron, +c xpm - lc- for the sh pomeron, +c z - impact parameter factor, z=exp(-b**2/4*rp), +c iqq = 1 - gg, +c iqq = 2 - qg, +c iqq = 3 - gq, +c iqq = 4 - qq, +c iqq = 5 - gg(int), +c iqq = 6 - gg(proj), +c iqq = 7 - qg(proj), +c iqq = 9 - total uncut-integrated, +c iqq = 10 - total cut, +c iqq = 14 - gg(int)|b=0, +c iqq = 15 - <b^2*gg(int)>, +c iqq = 16 - gg(proj)|b=0, +c iqq = 17 - <b^2*gg(proj)>, +c iqq = 18 - qg(proj)|b=0, +c iqq = 19 - <b^2*qg(proj)> +c----------------------------------------------------------------------- + dimension wk(3),wi(3),wj(3),wz(3),fa(3) + common /psar2/ edmax,epmax + common /psar4/ fhgg(11,10,8),fhqg(11,10,80) + *,fhgq(11,10,80),fhqq(11,10,80),fhgg0(11,10),fhgg1(11,10,4) + *,fhqg1(11,10,40),fhgg01(11),fhgg02(11),fhgg11(11,4) + *,fhgg12(11,4),fhqg11(11,10,4),fhqg12(11,10,4) + *,ftoint(11,14,2,2,3) + common /psar7/ delx,alam3p,gam3p + include 'epos.inc' + include 'epos.incsem' + + if(iqq.eq.3)then + xp=xpm + xm=xpp + iclp=icltar + iclt=iclpro + else + xp=xpp + xm=xpm + iclp=iclpro + iclt=icltar + endif + rp=r2had(iclpro)+r2had(icltar)+slopom*log(max(1.,sy)) + + psvin=0. + if(iqq.eq.1.or.iqq.eq.5.or.iqq.eq.6.or.iqq.eq.14 + *.or.iqq.eq.15.or.iqq.eq.16.or.iqq.eq.17 + *.or.iclpro.ne.4.and.(iqq.eq.2.or.iqq.eq.7 + *.or.iqq.eq.18.or.iqq.eq.19) + *.or.icltar.ne.4.and.iqq.eq.3 + *.or.iclpro.ne.4.and.icltar.ne.4)then + spmin=4.*q2min + else + spmin=4.*q2min+2.*qcmass**2 + endif + if(sy.le.spmin.and.(iqq.le.7.or.iqq.gt.13))return + + if(iqq.le.7.or.iqq.gt.13)then + yl=log(sy/spmin)/log(epmax/2./spmin)*10.+1 + k=int(yl) + if(k.gt.9)k=9 + wk(2)=yl-k + wk(3)=wk(2)*(wk(2)-1.)*.5 + wk(1)=1.-wk(2)+wk(3) + wk(2)=wk(2)-2.*wk(3) + + if(iqq.ne.4)then !---------------- not 4 ------------------ + + if(iqq.eq.5)then + if(k.eq.1)then + psvin=max(0.,exp(fhgg01(k+1))*wk(2) + * +exp(fhgg01(k+2))*wk(3)) + else + psvin=exp(fhgg01(k)*wk(1)+fhgg01(k+1)*wk(2) + * +fhgg01(k+2)*wk(3)) + endif + psvin=psvin*factk*sy**delh + return + + elseif(iqq.eq.15)then + if(k.eq.1)then + psvin=max(0.,exp(fhgg02(k+1))*wk(2) + * +exp(fhgg02(k+2))*wk(3)) + else + psvin=exp(fhgg02(k)*wk(1)+fhgg02(k+1)*wk(2) + * +fhgg02(k+2)*wk(3)) + endif + psvin=psvin*factk*sy**delh + return + + elseif(iqq.eq.6)then + if(k.eq.1)then + psvin=max(0.,exp(fhgg11(k+1,iclpro))*wk(2) + * +exp(fhgg11(k+2,iclpro))*wk(3)) + else + psvin=exp(fhgg11(k,iclpro)*wk(1)+fhgg11(k+1,iclpro)*wk(2) + * +fhgg11(k+2,iclpro)*wk(3)) + endif + psvin=psvin*factk*sy**delh*xp**(-alppar) + return + + elseif(iqq.eq.17)then + if(k.eq.1)then + psvin=max(0.,exp(fhgg12(k+1,iclpro))*wk(2) + * +exp(fhgg12(k+2,iclpro))*wk(3)) + else + psvin=exp(fhgg12(k,iclpro)*wk(1)+fhgg12(k+1,iclpro)*wk(2) + * +fhgg12(k+2,iclpro)*wk(3)) + endif + psvin=psvin*factk*sy**delh*xp**(-alppar) + return + + elseif(iqq.eq.7.or.iqq.eq.19)then + if(xp.lt..2)then + xl=log(10.*xp)/log(2.)+5. + else + xl=5.*xp+5. + endif + i=int(xl) + if(i.lt.1)i=1 + if(i.eq.5)i=4 + if(i.gt.8)i=8 + wi(2)=xl-i + wi(3)=wi(2)*(wi(2)-1.)*.5 + wi(1)=1.-wi(2)+wi(3) + wi(2)=wi(2)-2.*wi(3) + do k1=1,3 + fa(k1)=0. + do i1=1,3 + k2=k+k1-1 + fhhh=0. + if(iqq.eq.7)then + fhhh=fhqg11(k2,i+i1-1,iclpro) + elseif(iqq.eq.19)then + fhhh=fhqg12(k2,i+i1-1,iclpro) + endif + fa(k1)=fa(k1)+fhhh*wi(i1) + enddo + enddo + if(k.eq.1)then + psvin=max(0.,exp(fa(2))*wk(2)+exp(fa(3))*wk(3)) + else + psvin=exp(fa(1)*wk(1)+fa(2)*wk(2)+fa(3)*wk(3)) + endif + psvin=psvin*factk*sy**delh + return + endif + + jz=int(10.*z) + if(jz.gt.8)jz=8 + if(jz.lt.1)jz=1 + wz(2)=10.*z-jz + wz(3)=wz(2)*(wz(2)-1.)*.5 + wz(1)=1.-wz(2)+wz(3) + wz(2)=wz(2)-2.*wz(3) + + if(iqq.eq.14)then + do k1=1,3 + k2=k+k1-1 + fa(k1)=fhgg0(k2,jz)*wz(1)+fhgg0(k2,jz+1) + * *wz(2)+fhgg0(k2,jz+2)*wz(3) + enddo + if(k.eq.1)then + psvin=max(0.,exp(fa(2))*wk(2)+exp(fa(3))*wk(3)) + else + psvin=exp(fa(1)*wk(1)+fa(2)*wk(2)+fa(3)*wk(3)) + endif + psvin=psvin*z*factk*sy**delh + + elseif(iqq.eq.16)then + do k1=1,3 + k2=k+k1-1 + fa(k1)=fhgg1(k2,jz,iclpro)*wz(1)+fhgg1(k2,jz+1,iclpro) + * *wz(2)+fhgg1(k2,jz+2,iclpro)*wz(3) + enddo + if(k.eq.1)then + psvin=max(0.,exp(fa(2))*wk(2)+exp(fa(3))*wk(3)) + else + psvin=exp(fa(1)*wk(1)+fa(2)*wk(2)+fa(3)*wk(3)) + endif + psvin=psvin*z*factk*sy**delh*xp**(-alppar) + + elseif(iqq.eq.18)then + if(xp.lt..2)then + xl=log(10.*xp)/log(2.)+5. + else + xl=5.*xp+5. + endif + i=int(xl) + if(i.lt.1)i=1 + if(i.eq.5)i=4 + if(i.gt.8)i=8 + wi(2)=xl-i + wi(3)=wi(2)*(wi(2)-1.)*.5 + wi(1)=1.-wi(2)+wi(3) + wi(2)=wi(2)-2.*wi(3) + do k1=1,3 + fa(k1)=0. + do i1=1,3 + do l1=1,3 + k2=k+k1-1 + l2=jz+l1-1+10*(iclpro-1) + fhhh=fhqg1(k2,i+i1-1,l2) + fa(k1)=fa(k1)+fhhh*wi(i1)*wz(l1) + enddo + enddo + enddo + if(k.eq.1)then + psvin=max(0.,exp(fa(2))*wk(2)+exp(fa(3))*wk(3)) + else + psvin=exp(fa(1)*wk(1)+fa(2)*wk(2)+fa(3)*wk(3)) + endif + psvin=psvin*z*factk*sy**delh + + elseif(iqq.eq.1)then !1111111111111111111111111111111111 + + do k1=1,3 + k2=k+k1-1 + iclpt=iclpro+4*(icltar-1) + fa(k1)=fhgg(k2,jz,iclpt)*wz(1)+fhgg(k2,jz+1,iclpt) + * *wz(2)+fhgg(k2,jz+2,iclpt)*wz(3) + enddo + if(k.eq.1)then + psvin=max(0.,exp(fa(2))*wk(2)+exp(fa(3))*wk(3)) + else + psvin=exp(fa(1)*wk(1)+fa(2)*wk(2)+fa(3)*wk(3)) + endif + psvin=psvin*z*factk*sy**delh*(xp*xm)**(-alppar) + + else ! 2222222222222222222222 3333333333333333333333 .... + + if(xp.lt..2)then + xl=log(10.*xp)/log(2.)+5. + else + xl=5.*xp+5. + endif + i=int(xl) + if(i.lt.1)i=1 + if(i.eq.5)i=4 + if(i.gt.8)i=8 + wi(2)=xl-i + wi(3)=wi(2)*(wi(2)-1.)*.5 + wi(1)=1.-wi(2)+wi(3) + wi(2)=wi(2)-2.*wi(3) + do k1=1,3 + fa(k1)=0. + do i1=1,3 + do l1=1,3 + k2=k+k1-1 + fhhh=0. + if(iqq.eq.2)then + l2=jz+l1-1+10*(iclpro+4*(icltar-1)-1) + fhhh=fhqg(k2,i+i1-1,l2) + elseif(iqq.eq.3)then + l2=jz+l1-1+10*(iclpro+4*(icltar-1)-1) + fhhh=fhgq(k2,i+i1-1,l2) + endif + fa(k1)=fa(k1)+fhhh*wi(i1)*wz(l1) + enddo + enddo + enddo + if(k.eq.1)then + psvin=max(0.,exp(fa(2))*wk(2)+exp(fa(3))*wk(3)) + else + psvin=exp(fa(1)*wk(1)+fa(2)*wk(2)+fa(3)*wk(3)) + endif + psvin=psvin*xm**(-alppar)*z*factk*sy**delh + endif + + else ! ------------- 4444444444444444444 ----------------------- + + if(xp.lt..2)then + xl1=log(10.*xp)/log(2.)+5. + else + xl1=5.*xp+5. + endif + i=max(1,int(xl1)) + if(i.eq.5)i=4 + i=min(8,i) + wi(2)=xl1-i + wi(3)=wi(2)*(wi(2)-1.)*.5 + wi(1)=1.-wi(2)+wi(3) + wi(2)=wi(2)-2.*wi(3) + + if(xm.lt..2)then + xl2=log(10.*xm)/log(2.)+5. + else + xl2=5.*xm+5. + endif + j=max(1,int(xl2)) + if(j.eq.5)j=4 + j=min(8,j) + wj(2)=xl2-j + wj(3)=wj(2)*(wj(2)-1.)*.5 + wj(1)=1.-wj(2)+wj(3) + wj(2)=wj(2)-2.*wj(3) + + do k1=1,3 + fa(k1)=0. + do i1=1,3 + do j1=1,3 + k2=k+k1-1 + j2=j+j1-1+10*(iclp+4*(iclt-1)-1) + fa(k1)=fa(k1)+fhqq(k2,i+i1-1,j2)*wi(i1)*wj(j1) + enddo + enddo + enddo + if(k.eq.1)then + psvin=max(0.,exp(fa(2))*wk(2)+exp(fa(3))*wk(3)) + else + psvin=exp(fa(1)*wk(1)+fa(2)*wk(2)+fa(3)*wk(3)) + endif + psvin=psvin*z**(rp/(r2had(iclpro)+r2had(icltar)))* + * factk*sy**delh + + endif !-------------------------------------------- + + return + endif + + yl=log(sy)/log(1.e8)*10.+1 + k=max(1,int(yl)) + k=min(k,9) !?????????????9 + wk(2)=yl-k + wk(3)=wk(2)*(wk(2)-1.)*.5 + wk(1)=1.-wk(2)+wk(3) + wk(2)=wk(2)-2.*wk(3) + + if(z.gt..1)then + zz=10.*z+4 + else + zz=50.*z + endif + jz=min(12,int(zz)) + if(jz.eq.0)jz=1 + if(jz.eq.4)jz=3 + wz(2)=zz-jz + wz(3)=wz(2)*(wz(2)-1.)*.5 + wz(1)=1.-wz(2)+wz(3) + wz(2)=wz(2)-2.*wz(3) + + if(iqq.eq.9)then + do k1=1,3 + do l1=1,3 + k2=k+k1-1 + l2=jz+l1-1 + psvin=psvin+ftoint(k2,l2,icdp,icdt,iclp)*wk(k1)*wz(l1) + enddo + enddo + psvin=exp(psvin)*z + + endif + return + end + +c------------------------------------------------------------------------ + function psbint(q1,q2,qqcut,ss,m1,l1,jdis) +c----------------------------------------------------------------------- +c psbint - born cross-section interpolation +c q1 - virtuality cutoff at current end of the ladder; +c q2 - virtuality cutoff at opposite end of the ladder; +c qqcut - p_t cutoff for the born process; +c s - total c.m. energy squared for the scattering, +c m1 - parton type at current end of the ladder (0 - g, 1,-1,2,... - q) +c l1 - parton type at opposite end of the ladder (0 - g, 1,-1,2,... - q) +c----------------------------------------------------------------------- + dimension wi(3),wk(3) + common /psar2/ edmax,epmax + common /psar21/ csbor(20,160,2) + include 'epos.incsem' + double precision psuds + + psbint=0. + if(jdis.eq.0)then + qq=max(q1,q2) + else + qq=max(q1/4.,q2) + endif + qq=max(qq,qqcut) + if(iabs(m1).ne.4)then + q2mass=0. + if(m1.ne.0.and.m1.eq.l1)then + m=2 + l=2 + elseif(m1.ne.0.and.m1.eq.-l1)then + m=3 + l=1 + elseif(m1.ne.0.and.l1.ne.0.and.m1.ne.l1)then + m=3 + l=2 + else + m=min(1,iabs(m1))+1 + l=min(1,iabs(l1))+1 + endif + else + q2mass=qcmass**2 + m=4 + l=min(1,iabs(l1))+1 + endif + s=ss-q2mass + spmin=4.*q2min+q2mass + s2min=4.*qq+q2mass + if(s.le.s2min)return + + p1=s/(1.+q2mass/s) + if(p1.gt.4.*qq)then + tmin=2.*qq/(1.+sqrt(1.-4.*qq/p1)) + else + tmin=2.*qq + endif + qmax=p1/4. + tmax=p1/2. + + ml=20*(m-1)+80*(l-1) + qli=log(qq/q2min)/log(qmax/q2min)*19.+1. + sl=log(s/spmin)/log(epmax/2./spmin)*19.+1. + k=int(sl) + i=int(qli) + if(k.lt.1)k=1 + if(i.lt.1)i=1 + if(k.gt.18)k=18 + if(i.gt.18)i=18 + + wi(2)=qli-i + wi(3)=wi(2)*(wi(2)-1.)*.5 + wi(1)=1.-wi(2)+wi(3) + wi(2)=wi(2)-2.*wi(3) + + wk(2)=sl-k + wk(3)=wk(2)*(wk(2)-1.)*.5 + wk(1)=1.-wk(2)+wk(3) + wk(2)=wk(2)-2.*wk(3) + + do i1=1,3 + do k1=1,3 + psbint=psbint+csbor(i+i1-1,k+k1+ml-1,jdis+1) + * *wi(i1)*wk(k1) + enddo + enddo + psbint=exp(psbint)*(1./tmin-1./tmax) + if(jdis.eq.0.and.qq.gt.q1)then + psbint=psbint*sngl(psuds(qq,m1)/psuds(q1,m1)) + elseif(jdis.eq.1.and.4.*qq.gt.q1)then + psbint=psbint*sngl(psuds(4.*qq,m1)/psuds(q1,m1)) + endif + if(qq.gt.q2)psbint=psbint*sngl(psuds(qq,l1)/psuds(q2,l1)) + return + end + +c----------------------------------------------------------------------- + function psborn(q1,q2,qqcut,s,j,l,jdis,md) +c----------------------------------------------------------------------- +c +c hard 2->2 parton scattering born cross-section +c including sudakov on both sides +c +c q1 - virtuality cutoff at current end of the ladder; +c q2 - virtuality cutoff at opposite end of the ladder; +c qqcut - p_t cutoff for the born process; +c s - c.m. energy squared for the scattering; +c j - parton type at current end of the ladder (0 - g, 1,2 etc. - q); +c l - parton type at opposite end of the ladder (0 - g, 1,2 etc. - q). +c----------------------------------------------------------------------- + common /ar3/ x1(7),a1(7) + double precision sud0,psbornd,psuds + include 'epos.inc' + include 'epos.incsem' + + psborn=0 + + if(jdis.eq.0)then + qq=max(q1,q2) + else + qq=max(q1/4.,q2) + endif + qq=max(qq,qqcut) +c if(j.ne.3)then !kkkkkkkkkk charm is 3 ??? + if(j.ne.4)then + j1=j + q2mass=0. + else + j1=4 + q2mass=qcmass**2 + endif + p1=s/(1.+q2mass/s) + if(p1.gt.4.*qq)then + tmin=2.*qq/(1.+sqrt(1.-4.*qq/p1)) + else + tmin=2.*qq +! return !tmin=2.*qq !kkkkkkk !????????????? tp why not ? + endif + tmax=p1/2. + sud0=psuds(q1,j1)*psuds(q2,l) + + psbornd=0.d0 + do i=1,7 + do m=1,2 + t=2.*tmin/(1.+tmin/tmax-x1(i)*(2*m-3) + & *(1.-tmin/tmax)) + qt=t*(1.-t/p1) + if(qt.lt..999*qq.and.ish.ge.1)write(ifch,*)'psborn:qt,qq,q1,q2' + & ,qq,qt,q1,q2 + + if(jdis.eq.0)then + scale=qt + else + scale=qt*4. + endif + if(j1.eq.0.and.l.eq.0)then + fb=ffborn(s,t, 1. , 0. , 0. , 0. , 0. ) !gg + elseif(j1*l.eq.0)then + fb=ffborn(s,t, 0. , 1. , 0. , 0. , 0.) !qg + elseif(j1.eq.l)then + fb=ffborn(s,t, 0. , 0. , 1. , 0. , 0.) !qq + elseif(j1.eq.-l)then + fb=ffborn(s,t, 0. , 0. , 0. , 1. , 0.) !qq + else + fb=ffborn(s,t, 0. , 0. , 0. , 0. , 1.) !qq + endif + fb=fb*pssalf(qt/qcdlam)**2 + psbornd=psbornd+dble(a1(i)*fb)*dble(t)**2 + & *psuds(scale,j1)*psuds(qt,l) + enddo + enddo + psbornd=psbornd*dble(2.*pi**3)/dble(s)**2/sud0*2 + * /2 !CS for parton pair + if(md.eq.1)psbornd=psbornd*(1./tmin-1./tmax) + psborn=sngl(psbornd) + return + end + +c------------------------------------------------------------------------ + function psdgh(s,qq,long) +c----------------------------------------------------------------------- +c psdgh +c s - energy squared for the interaction (hadron-hadron), +c----------------------------------------------------------------------- + common/ar3/ x1(7),a1(7) + common /cnsta/ pi,pii,hquer,prom,piom,ainfin + include 'epos.incsem' + double precision psuds + + xd=qq/s + if(long.eq.0)then + psdgh=(psdfh4(xd,q2min,0.,2,1)/2.25+psdfh4(xd,q2min,0.,2,2)/9. + * +psdfh4(xd,q2min,0.,2,3)/9.+ + * 2.*(psdfh4(xd,q2min,0.,2,-1)+psdfh4(xd,q2min,0.,2,-2)+ + * psdfh4(xd,q2min,0.,2,-3))/4.5) + * *sngl(psuds(qq,1)/psuds(q2min,1))*4.*pi**2*alfe/qq + else + psdgh=0. + endif + + dgh=0. + if(long.eq.0)then + s2min=qq/(1.-q2ini/qq) + else + s2min=4.*max(q2min,qcmass**2)+qq + s2min=s2min/(1.-4.*q2ini/(s2min-qq)) + endif + xmin=s2min/s + + if(xmin.lt.1.)then + do i=1,7 !numerical integration over z1 + do m=1,2 + if(long.eq.0)then + z1=qq/s+(xmin-qq/s)*((1.-qq/s)/(xmin-qq/s)) + * **(.5+(m-1.5)*x1(i)) + else + z1=.5*(1.+xmin+(2*m-3)*x1(i)*(1.-xmin)) + endif + call psdint(z1*s,qq,sds,sdn,sdb,sdt,sdr,1,long) + call psdint(z1*s,qq,sdsg,sdng,sdbg,sdtg,sdrg,0,long) + tu=psdfh4(z1,q2min,0.,2,1) + td=psdfh4(z1,q2min,0.,2,2) + ts=psdfh4(z1,q2min,0.,2,3) + tg=psdfh4(z1,q2min,0.,2,0) + tsea=2.*(psdfh4(z1,q2min,0.,2,-1)+psdfh4(z1,q2min,0.,2,-2) + * +psdfh4(z1,q2min,0.,2,-3)) + gy=sdn*(tu/2.25+td/9.+ts/9.+tsea/4.5)+sdtg*tg/4.5 + * +sdt*(tu+td+ts+tsea)/4.5 + dgh=dgh+a1(i)*gy*(1.-qq/s/z1) + enddo + enddo + dgh=dgh*log((1.-qq/s)/(xmin-qq/s))*.5 + endif + psdgh=psdgh+dgh + return + end + +c------------------------------------------------------------------------ + function psdh(s,qq,iclpro0,long) +c----------------------------------------------------------------------- +c pshard - hard quark-quark interaction cross-section +c s - energy squared for the interaction (hadron-hadron), +c iclpro0 - type of the primary hadron (nucleon) +c----------------------------------------------------------------------- + common /ar3/ x1(7),a1(7) + include 'epos.incsem' + include 'epos.inc' + double precision psuds + + xd=qq/s + qqs=q2min + if(long.eq.0.and.(idisco.eq.0.or.idisco.eq.1))then + psdh=(psdfh4(xd,qqs,0.,iclpro0,1)/2.25+ + * psdfh4(xd,qqs,0.,iclpro0,2)/9.) + * *sngl(psuds(qq,1)/psuds(qqs,1)) + * *4.*pi**2*alfe/qq + else + psdh=0. + endif + + dh=0. + if(long.eq.0)then + s2min=qq/(1.-q2ini/qq) + else + s2min=4.*max(q2min,qcmass**2)+qq + s2min=s2min/(1.-4.*q2ini/(s2min-qq)) + endif + xmin=s2min/s + if(xmin.lt.1.)then + do i=1,7 !numerical integration over z1 + do m=1,2 + if(long.eq.0)then + z1=qq/s+(xmin-qq/s)*((1.-qq/s)/(xmin-qq/s)) + * **(.5+(m-1.5)*x1(i)) + else + z1=.5*(1.+xmin+(2*m-3)*x1(i)*(1.-xmin)) + endif + call psdint(z1*s,qq,sds,sdn,sdb,sdt,sdr,1,long) + tu=psdfh4(z1,qqs,0.,iclpro0,1) + td=psdfh4(z1,qqs,0.,iclpro0,2) + gy=sdt*(tu+td)/4.5+sdn*(tu/2.25+td/9.) + if(long.eq.0)then + gy=gy*(1.-qq/s/z1) + else + gy=gy/z1 + endif + dh=dh+a1(i)*gy + enddo + enddo + if(long.eq.0)then + dh=dh*log((1.-qq/s)/(xmin-qq/s))*.5 + else + dh=dh*(1.-xmin)*.5 + endif + endif + psdh=psdh+dh + return + end + +c------------------------------------------------------------------------ + function psdsh(s,qq,iclpro0,dqsh,long) +c----------------------------------------------------------------------- +c psdsh - semihard interaction eikonal +c s - energy squared for the interaction (hadron-hadron), +c iclpro0 - hadron class, +c z - impact parameter factor, z=exp(-b**2/rp), +c iqq - type of the hard interaction (0 - gg, 1 - qg, 2 - gq) +c----------------------------------------------------------------------- + common /ar3/ x1(7),a1(7) + include 'epos.inc' + include 'epos.incsem' + double precision psuds + + xd=qq/s + if(long.eq.0.and.(idisco.eq.0.or.idisco.eq.1))then + dqsh=fzeroSeaZZ(xd,iclpro0)/xd**dels + * *ffrr*4.*pi*gamhad(iclpro0)/ + * 4.5*sngl(psuds(qq,1)/psuds(q2min,1)) + * *4.*pi**2*alfe/qq + else + dqsh=0. + endif + + if(long.eq.0)then + s2min=qq/(1.-q2ini/qq) + else + s2min=qq+4.*max(q2min,qcmass**2) + endif + xmin=s2min/s + xmin=xmin**(delh-dels) + dsh=0. + if(xmin.lt.1.)then +c numerical integration over z1 + do i=1,7 + do m=1,2 + z1=(.5*(1.+xmin-(2*m-3)*x1(i)*(1.-xmin)))**(1./ + * (delh-dels)) + call psdint(z1*s,qq,sdsg,sdng,sdbg,sdtg,sdrg,0,long) + call psdint(z1*s,qq,sdsq,sdnq,sdbq,sdtq,sdrq,1,long) + dsh=dsh+a1(i)/z1**delh*(sdtg*fzeroGluZZ(z1,iclpro0) + * +(sdtq+sdnq)*fzeroSeaZZ(z1,iclpro0)) + enddo + enddo + dsh=dsh*(1.-xmin)/(delh-dels)/2. + endif + psdsh=dqsh+dsh*ffrr*4.*pi*gamhad(iclpro0)/4.5 !*ccorr(1,1,iclpro0) + return + end + +cc------------------------------------------------------------------------ +c function psdsh1(s,qq,iclpro0,dqsh,long) +cc----------------------------------------------------------------------- +cc psdsh - semihard interaction eikonal +cc s - energy squared for the interaction (hadron-hadron), +cc iclpro0 - hadron class, +cc z - impact parameter factor, z=exp(-b**2/rp), +cc iqq - type of the hard interaction (0 - gg, 1 - qg, 2 - gq) +cc----------------------------------------------------------------------- +c common /ar3/ x1(7),a1(7) +c include 'epos.inc' +c include 'epos.incsem' +cc double precision psuds +c +c psdsh1=0. !only for plotting in psaevp : not use any more +c +cc$$$ xd=qq/s +cc$$$ write(ifch,*)'Psdsh1 for xd,qq',xd,qq +cc$$$ if(long.eq.0.and.(idisco.eq.0.or.idisco.eq.1))then +cc$$$ dqsh=psftist(xd)/4.5*sngl(psuds(qq,1)/psuds(q2min,1)) +cc$$$ * *4.*pi**2*alfe/qq +cc$$$ else +cc$$$ dqsh=0. +cc$$$ endif +cc$$$ +cc$$$ if(long.eq.0)then +cc$$$ s2min=qq/(1.-q2ini/qq) +cc$$$ else +cc$$$ s2min=qq+4.*max(q2min,qcmass**2) +cc$$$ endif +cc$$$ xmin=s2min/s +cc$$$ xmin=xmin**(delh-dels) +cc$$$ dsh=0. +cc$$$ if(xmin.lt.1.)then +cc$$$c numerical integration over z1 +cc$$$ do i=1,7 +cc$$$ do m=1,2 +cc$$$ z1=(.5*(1.+xmin-(2*m-3)*x1(i)*(1.-xmin)))**(1./ +cc$$$ * (delh-dels)) +cc$$$ call psdint(z1*s,qq,sdsg,sdng,sdbg,sdtg,sdrg,0,long) +cc$$$ call psdint(z1*s,qq,sdsq,sdnq,sdbq,sdtq,sdrq,1,long) +cc$$$ dsh=dsh+a1(i)/z1**delh*(sdtg*psftigt(z1) +cc$$$ * +(sdtq+sdnq)*psftist(z1))*z1**dels +cc$$$ enddo +cc$$$ enddo +cc$$$ dsh=dsh*(1.-xmin)/(delh-dels)/2. +cc$$$ endif +cc$$$ psdsh1=dqsh+dsh/4.5 +c return +c end +c + +c------------------------------------------------------------------------ + function psev0(q1,qq,xx,j) +c----------------------------------------------------------------------- + double precision xx,psuds,psev00 + common /ar3/ x1(7),a1(7) + include 'epos.incsem' + + psev0=0. + psev00=0.d0 + do i=1,7 + do m=1,2 + if(j.eq.1)then !g->q + qi=2.*q1/(1.+q1/qq+(1.-q1/qq)*(2.*m-3.)*x1(i)) + psev00=psev00+a1(i)*qi*psuds(qi,0)/psuds(qi,1) + * /log(qi*(1.d0-xx)/qcdlam) + else !q->g + qi=(.5*(q1+qq+(q1-qq)*(2.*m-3.)*x1(i))) + psev00=psev00+a1(i)/qi/psuds(qi,0)*psuds(qi,1) + * /log(qi*(1.d0-xx)/qcdlam) + endif + enddo + enddo + + if(j.eq.1)then + psev00=psev00*(1.d0/q1-1.d0/qq)*psuds(qq,1)/psuds(qq,0)/2.d0 + else + psev00=psev00*(qq-q1)*psuds(qq,0)/psuds(qq,1)/2.d0 + endif + psev00=psev00/log(log(qq*(1.d0-xx)/qcdlam) + & /log(q1*(1.d0-xx)/qcdlam)) + psev0=sngl(psev00) + return + end + +c------------------------------------------------------------------------ + function psev(q1,qq,xx,j,l,n) +c------------------------------------------------------------------------ + double precision xx,zmax,zmax1,zmin,zmin1,z,psuds,fk,fq + &,fz1,fz2 + common /ar3/ x1(7),a1(7) + include 'epos.incsem' + + zmax=1.d0-q2ini/qq + zmin=xx/zmax + qmax=qq + fz1=0.d0 + fz2=0.d0 + + if(zmin.lt.zmax)then + if(zmin.lt..1d0)then + zmax1=min(.1d0,zmax) + do i=1,7 + do m=1,2 + if(n.eq.2)then + z=xx+(zmin-xx)*((zmax1-xx)/(zmin-xx))**(.5+(m-1.5)*x1(i)) + elseif(j.eq.1)then + z=zmin*(zmax1/zmin)**(.5+(m-1.5)*x1(i)) + else + z=(.5d0*(zmax1+zmin+(zmax1-zmin)*(2*m-3)*x1(i))) + endif + qmin=max(q2ini/(1.d0-xx/z),q2ini/(1.d0-z)) + qmin=max(qmin,q1) + + do k=1,2 + fq=0.d0 + do i1=1,7 + do m1=1,2 + if(n.eq.2)then + qi=qmin*(qmax/qmin)**(.5+x1(i1)*(m1-1.5)) + else + qi=(.5*(qmax+qmin+(qmax-qmin)*(2.*m1-3.)*x1(i1))) + endif + + if(j.eq.3.and.k.eq.1)then + fk=0.d0 + else + if(n.eq.2)then + fk=dble(psevi0(q1,qi,xx/z,min(2,j),k)) + else + fk=dble(psevi(q1,qi,xx/z,j,k)/qi) + endif + endif + qt=qi*(1.d0-z) + fq=fq+a1(i1)*fk/psuds(qi,l-1)*pssalf(qt/qcdlam) + enddo + enddo + if(n.eq.2)then + fq=fq*log(qmax/qmin)*(1.d0-xx/z) + elseif(j.eq.1)then + fq=fq*(qmax-qmin) + else + fq=fq*(qmax-qmin)/z + endif + fz1=fz1+a1(i)*fq*psfap(z,k-1,l-1) + enddo + enddo + enddo + if(n.eq.2)then + fz1=fz1*log((zmax1-xx)/(zmin-xx))/4. + elseif(j.eq.1)then + fz1=fz1*log(zmax1/zmin)/4. + else + fz1=fz1*(zmax1-zmin)/4. + endif + endif + + if(zmax.gt..1d0)then + zmin1=max(.1d0,zmin) + do i=1,7 + do m=1,2 + z=1.d0-(1.d0-zmax)*((1.d0-zmin1)/(1.d0-zmax))** + * (.5+x1(i)*(m-1.5)) + qmin=max(q2ini/(1.d0-z),q2ini/(1.d0-xx/z)) + qmin=max(qmin,q1) + + do k=1,2 + fq=0. + do i1=1,7 + do m1=1,2 + if(n.eq.2)then + qi=qmin*(qmax/qmin)**(.5+x1(i1)*(m1-1.5)) + else + qi=(.5*(qmax+qmin+(qmax-qmin)*(2.*m1-3.)*x1(i1))) + endif + + if(j.eq.3.and.k.eq.1)then + fk=0.d0 + else + if(n.eq.2)then + fk=dble(psevi0(q1,qi,xx/z,min(2,j),k)) + else + fk=dble(psevi(q1,qi,xx/z,j,k)/qi) + endif + endif + qt=qi*(1.d0-z) + fq=fq+a1(i1)*fk/psuds(qi,l-1)*pssalf(qt/qcdlam) + enddo + enddo + if(n.eq.2)then + fq=fq*log(qmax/qmin) + else + fq=fq*(qmax-qmin) + endif + fz2=fz2+a1(i)*fq*psfap(z,k-1,l-1)*(1.d0/z-1.d0) + enddo + enddo + enddo + fz2=fz2*log((1.d0-zmin1)/(1.d0-zmax))/4. + endif + endif + psev=sngl((fz1+fz2)*psuds(qq,l-1)) + return + end + +c------------------------------------------------------------------------ + function psevi0(q1,qq,xx,m,l) +c------------------------------------------------------------------------ + double precision xx,xmax,psuds + dimension wi(3),wj(3),wk(3) + common /psar2/ edmax,epmax + common /psar31/ evk0(21,21,54) + include 'epos.inc' + include 'epos.incsem' + + xmax=1.d0-2.d0*q2ini/epmax + qmin=max(1.d0*q2min,q2ini/(1.d0-xx)) + qm1=max(q1,qmin) + if(qq.gt..5001*epmax.and.ish.ge.1)then + write(ifch,*)'0-extrap.:q1,qq,epmax,xx,m,l:',q1,qq,epmax,xx,m,l +c stop + endif + if(xx.ge.xmax.or.qq.le.1.000*qm1)then + psevi0=0. +c write (*,*)'xx,xmax,qq,qm1,qmin,q1',xx,xmax,qq,qm1,qmin,q1 + return + endif + + if(m.eq.l)then + psevi0=1. + else + if(xx.lt..1d0)then + yx=log(10.d0*xx)+13. + k=int(yx) + if(k.gt.11)k=11 + if(k.lt.1)k=1 + elseif(xx.lt..9d0)then + yx=10.*xx+12. + k=int(yx) + if(k.gt.19)k=19 + else + yx=log(10.d0*(1.d0-xx))/log(10.d0*(1.d0-xmax))*6.+21 + k=int(yx) + if(k.gt.25)k=25 + endif + wk(2)=yx-k + wk(3)=wk(2)*(wk(2)-1.)*.5 + wk(1)=1.-wk(2)+wk(3) + wk(2)=wk(2)-2.*wk(3) + + qli=log(qq/qmin)/log(.5*epmax/qmin)*20.+1. + qlj=log(qm1/qmin)/log(qq/qmin)*20.+1. + i=int(qli) + if(i.gt.19)i=19 + if(i.lt.1)i=1 + wi(2)=qli-i + wi(3)=wi(2)*(wi(2)-1.)*.5 + wi(1)=1.-wi(2)+wi(3) + wi(2)=wi(2)-2.*wi(3) + + j=int(qlj) + if(j.lt.1)j=1 + if(j.gt.19)j=19 + wj(2)=qlj-j + wj(3)=wj(2)*(wj(2)-1.)*.5 + wj(1)=1.-wj(2)+wj(3) + wj(2)=wj(2)-2.*wj(3) + + psevi0=0. + do i1=1,3 + do j1=1,3 + do k1=1,3 + psevi0=psevi0+evk0(i+i1-1,j+j1-1,k+k1-1+27*(m-1)) + * *wi(i1)*wj(j1)*wk(k1) + enddo + enddo + enddo + psevi0=exp(psevi0) + endif + psevi0=psevi0*psfap(xx,m-1,l-1)*log(log(qq*(1.d0-xx)/qcdlam) + */log(qm1*(1.d0-xx)/qcdlam))*sngl(psuds(qq,m-1)/psuds(q1,m-1))/4.5 + return + end + +c------------------------------------------------------------------------ + function psevi(q1,qq,xx,m,l) +c------------------------------------------------------------------------ +c m l: 1 1 ... gluon -> gluon +c 2 1 ... quark -> gluon +c 1 2 ... gluon -> quark +c 3 2 ... quark -> quark non singlet +c 2 2 ... quark -> quark all +c singlet = all - non singlet +c----------------------------------------------------------------------- + double precision xx,xmax,psuds + dimension wi(3),wj(3),wk(3) + common /psar2/ edmax,epmax + common /psar32/ evk(21,21,135) + include 'epos.inc' + include 'epos.incsem' + + psevi=0. + xmax=1.d0-2.d0*q2ini/epmax + if(qq.gt..5001*epmax.and.ish.ge.1)then + write(ifch,*)'1-extrap.:q1,qq,epmax,xx,m,l:',q1,qq,epmax,xx,m,l +c stop + endif + qmin=max(1.d0*q2min,q2ini/(1.d0-xx)) + qm1=max(q1,qmin) + if(xx.ge.xmax.or.qq.le.1.0001*qm1)then + return + endif + qmin1=max(1.d0*qmin,q2ini/(1.d0-dsqrt(xx))) + if(qq.le.1.0001*qmin1)then + psevi=psevi0(q1,qq,xx,min(m,2),l) + return + endif + + if(xx.lt..1d0)then + yx=log(10.d0*xx)+13. + k=int(yx) + if(k.gt.11)k=11 + if(k.lt.1)k=1 + elseif(xx.lt..9d0)then + yx=10.*xx+12. + k=int(yx) + if(k.gt.19)k=19 + else + yx=log(10.d0*(1.d0-xx))/log(10.d0*(1.d0-xmax))*6.+21 + k=int(yx) + if(k.gt.25)k=25 + endif + wk(2)=yx-k + wk(3)=wk(2)*(wk(2)-1.)*.5 + wk(1)=1.-wk(2)+wk(3) + wk(2)=wk(2)-2.*wk(3) + + qli=log(qq/qmin)/log(.5*epmax/qmin)*20.+1. + qlj=log(qm1/qmin)/log(qq/qmin)*20.+1. + i=int(qli) + if(i.lt.1)i=1 + if(i.gt.19)i=19 + wi(2)=qli-i + wi(3)=wi(2)*(wi(2)-1.)*.5 + wi(1)=1.-wi(2)+wi(3) + wi(2)=wi(2)-2.*wi(3) + + j=int(qlj) + if(j.lt.1)j=1 + if(j.gt.19)j=19 + wj(2)=qlj-j + wj(3)=wj(2)*(wj(2)-1.)*.5 + wj(1)=1.-wj(2)+wj(3) + wj(2)=wj(2)-2.*wj(3) + + do i1=1,3 + do j1=1,3 + do k1=1,3 + if(m.eq.3)then + k2=k+k1-1+108 + else + k2=k+k1-1+27*(m-1)+54*(l-1) + endif + psevi=psevi+evk(i+i1-1,j+j1-1,k2) + * *wi(i1)*wj(j1)*wk(k1) + enddo + enddo + enddo + psevi=exp(psevi)*psfap(xx,m-1,l-1)*log(log(qq*(1.d0-xx)/qcdlam) + */log(qm1*(1.d0-xx)/qcdlam))/4.5 + if(q1.lt.qm1)psevi=psevi*sngl(psuds(qm1,m-1)/psuds(q1,m-1)) + return + end + +c------------------------------------------------------------------------ + function psjci(q1,s,l1) +c----------------------------------------------------------------------- +c psjci - inclusive ordered ladder cross-section interpolation for c-quark +c q1 - virtuality cutoff at current end of the ladder +c s - total c.m. energy squared for the ladder, +c l1 - parton type at current end of the ladder (0-g, 1,2,etc.-q) +c----------------------------------------------------------------------- + dimension wi(3),wk(3) + common /psar2/ edmax,epmax + common /psar23/ cschar(20,20,2) + include 'epos.incsem' + + psjci=0. + q2mass=qcmass**2 + spmin=4.*q2min+q2mass + qq=q1 + s2min=4.*qq+q2mass + if(s.le.s2min)return + + smins=s2min/(1.-q2ini/q1) +c if(s.le.smins)goto 1 + if(s.le.smins.or.qq.le.q2min)goto 1 !??????? ctp070618 + + p1=s/(1.+q2mass/s) + if(p1.gt.4.*qq)then + tmin=2.*qq/(1.+sqrt(1.-4.*qq/p1)) + else + tmin=2.*qq + endif + tmax=p1/2. + qmax=p1/4. + + l=min(1,iabs(l1))+1 + qli=log(qq/q2min)/log(qmax/q2min)*19.+1. + sl=log(s/spmin)/log(epmax/2./spmin)*19.+1. + k=int(sl) + i=int(qli) + if(i.lt.1)i=1 + if(k.gt.18)k=18 + if(i.gt.18)i=18 + + wi(2)=qli-i + wi(3)=wi(2)*(wi(2)-1.)*.5 + wi(1)=1.-wi(2)+wi(3) + wi(2)=wi(2)-2.*wi(3) + + wk(2)=sl-k + wk(3)=wk(2)*(wk(2)-1.)*.5 + wk(1)=1.-wk(2)+wk(3) + wk(2)=wk(2)-2.*wk(3) + + do i1=1,3 + do k1=1,3 + psjci=psjci+cschar(i+i1-1,k+k1-1,l)*wi(i1)*wk(k1) + enddo + enddo + psjci=exp(psjci)*(1./tmin-1./tmax) + return +1 psjci=psbint(q2min,q1,0.,s,4,l1,0) + return + end + +c----------------------------------------------------------------------- + function psjct(s,l) +c----------------------------------------------------------------------- +c psjct - unordered ladder cross-section for c-quark +c s - c.m. energy squared for the scattering; +c l - parton type at opposite end of the ladder (0 - g, 1,2 etc. - q). +c----------------------------------------------------------------------- + double precision xx,zmax,qmax,qmin,qi,zmin,fsj,z,s2,sj + common /ar3/ x1(7),a1(7) + include 'epos.inc' + include 'epos.incsem' + + psjct=0. + q2mass=qcmass**2 + zmax=dble(s)/(dble(s)+dble(5.*q2mass)) + qmax=zmax**2*dble(q2mass)/(1.d0-zmax) + qmin=dble(q2min) + + if(qmax.lt.qmin.and.ish.ge.1)write(ifch,*)'psjct:qmin,qmax' + * ,qmin,qmax + do i=1,7 + do m=1,2 + qi=2.d0*qmin/(1.d0+qmin/qmax+dble((2*m-3)*x1(i)) + * *(1.d0-qmin/qmax)) + zmax=(2.d0/(1.d0+dsqrt(1.d0+4.d0*dble(q2mass)/qi)))**delh + zmin=(5.d0*qi/dble(s))**delh + + fsj=0.d0 + if(zmax.lt.zmin.and.ish.ge.1)write(ifch,*)'psjct:zmin,zmax' + * ,zmin,zmax + do i1=1,7 + do m1=1,2 + z=(.5d0*(zmax+zmin+dble((2*m1-3)*x1(i1)) + * *(zmax-zmin)))**(1./delh) + s2=z*dble(s)-qi + xx=z + sj=dble(psjti(sngl(qi),q2min,sngl(s2),0,l,0)*psfap(xx,1,0))*z + fsj=fsj+dble(a1(i1))*sj*dble(pssalf(sngl(qi)/qcdlam))/z**delh + enddo + enddo + fsj=fsj*(zmax-zmin) + psjct=psjct+a1(i)*sngl(fsj*qi) + enddo + enddo + psjct=psjct*sngl(1./qmin-1./qmax)/delh/4. + return + end + +c------------------------------------------------------------------------ + function psjet1(q1,q2,qqcut,s,j,l,jdis) +c----------------------------------------------------------------------- +c psjet1 - ordered parton ladder cross-section +c q1 - virtuality cutoff at current end of the ladder; +c q2 - virtuality cutoff at opposite end of the ladder; +c qqcut - p_t cutoff for the born process; +c s - c.m. energy squared for the scattering; +c j - parton type at current end of the ladder (0 - g, 1,2 etc. - q); +c l - parton type at opposite end of the ladder (0 - g, 1,2 etc. - q). +c----------------------------------------------------------------------- + double precision xx,z,qq,xmax,xmin,s2min,smin,p1,q2ms,q2inis,xmin1 + *,sh,qtmin,t,xmax1,fx1,fx2,psuds + common /ar3/ x1(7),a1(7) + common /ar9/ x9(3),a9(3) + include 'epos.inc' + include 'epos.incsem' + + psjet1=0. + if(jdis.eq.0)then + qq=dble(max(q1,q2)) + elseif(jdis.eq.1)then + qq=dble(max(q1/4.,q2)) + else + qq=dble(max(q1,q2/4.)) + endif + qq=max(qq,dble(qqcut)) + if(l.ne.3)then + q2mass=0. + else + q2mass=qcmass**2 + endif + s2min=dble(q2mass)+4.d0*qq + if(jdis.eq.0.or.jdis.eq.2)then + smin=s2min/(1.d0-dble(q2ini)/qq) + else + smin=s2min/(1.d0-dble(q2ini)/qq/4.d0) + endif + if(dble(s).le.smin)return + + q2ms=dble(q2mass)/dble(s) + q2inis=dble(q2ini)/dble(s) + p1=dble(s)/(1.d0+q2ms) + + + if(jdis.eq.0.or.jdis.eq.2)then + xmax=.5d0*(1.d0+q2ms)+dsqrt(.25d0*(1.d0-q2ms)**2-4.d0*q2inis) + else + xmax=.5d0*(1.+q2ms)+dsqrt(.25d0*(1.-q2ms)**2-q2inis) + endif + xmin=max(1.d0+q2ms-xmax,s2min/dble(s)) + if(xmin.ge.xmax.and.ish.ge.1)then + write(ifch,*)'jti1,xmin,xmax',xmin,xmax +c return + endif + + fx1=0.d0 + fx2=0.d0 + if(xmax.gt..8d0)then + xmin1=max(xmin,.8d0) + do i=1,3 + do m=1,2 + z=1.d0-(1.d0-xmax)*((1.d0-xmin1)/(1.d0-xmax))** + * (.5d0+dble(x9(i)*(m-1.5))) + sh=z*dble(s) + xx=z + p1=sh/(1.d0+dble(q2mass)/sh) + + if(jdis.eq.0.or.jdis.eq.2)then + qtmin=max(qq,dble(q2ini)/(1.d0-z)) + else + qtmin=max(qq,dble(q2ini)/(1.d0-z)/4.d0) + endif + tmin=2.d0*dble(qtmin)/(1.d0+dsqrt(1.d0-4.d0*dble(qtmin)/p1)) + tmax=p1/2.d0 + + ft=0. + if(tmin.ge.tmax.and.ish.ge.1)write(ifch,*)'psjet1:tmin,tmax' + * ,tmin,tmax + do i1=1,3 + do m1=1,2 + t=2.d0*tmin/(1.d0+tmin/tmax-dble(x9(i1)*(2*m1-3)) + & *(1.d0-tmin/tmax)) + qt=sngl(t*(1.d0-t/p1)) +c if(qt.lt.qtmin)write (*,*)'psjet1:qt,qq',qt,qq + + if(jdis.eq.0)then + scale1=qt + scale2=qt + elseif(jdis.eq.1)then + scale1=qt*4. + scale2=qt + elseif(jdis.eq.2)then + scale1=qt + scale2=qt*4. + endif + fb=0. + do n=1,3 + fb=fb+psjetj(q1,scale1,sngl(t),xx,sngl(sh),j,l,n) + enddo + ft=ft+a9(i1)*fb*pssalf(qt/qcdlam)**2*sngl(t**2 + * *psuds(scale2,l)) + enddo + enddo + fx1=fx1+dble(a9(i)*ft)*(1.d0/tmin-1.d0/tmax)/sh**2*(1.d0-z) + enddo + enddo + fx1=fx1*dlog((1.d0-xmin1)/(1.d0-xmax)) + endif + + if(xmin.lt..8d0)then + xmax1=min(xmax,.8d0)**(-delh) + xmin1=xmin**(-delh) + do i=1,3 + do m=1,2 + z=(.5d0*(xmax1+xmin1+(xmin1-xmax1)*dble((2*m-3)*x9(i)))) + * **(-1./delh) + sh=z*dble(s) + xx=z + p1=sh/(1.d0+dble(q2mass)/sh) + + if(jdis.eq.0.or.jdis.eq.2)then + qtmin=max(qq,dble(q2ini)/(1.d0-z)) + else + qtmin=max(qq,dble(q2ini)/(1.d0-z)/4.d0) + endif + tmin=2.d0*dble(qtmin)/(1.d0+dsqrt(1.d0-4.d0*dble(qtmin)/p1)) + tmax=p1/2.d0 + + ft=0. + if(tmin.ge.tmax.and.ish.ge.1)write(ifch,*)'psjet1:tmin,tmax' + & ,tmin,tmax + do i1=1,3 + do m1=1,2 + t=2.d0*tmin/(1.d0+tmin/tmax-dble(x9(i1)*(2*m1-3)) + & *(1.d0-tmin/tmax)) + qt=sngl(t*(1.d0-t/p1)) + if(qt.lt.sngl(qtmin).and.ish.ge.1)write(ifch,*)'psjet1:qt,qq' + & ,qt,qq + + if(jdis.eq.0)then + scale1=qt + scale2=qt + elseif(jdis.eq.1)then + scale1=qt*4. + scale2=qt + elseif(jdis.eq.2)then + scale1=qt + scale2=qt*4. + endif + fb=0. + do n=1,3 + fb=fb+psjetj(q1,scale1,sngl(t),xx,sngl(sh),j,l,n) + enddo + ft=ft+a9(i1)*fb*pssalf(qt/qcdlam)**2*sngl(t**2 + * *psuds(scale2,l)) + enddo + enddo + fx2=fx2+dble(a9(i)*ft)*(1.d0/tmin-1.d0/tmax)/sh**2*z**(1.+delh) + enddo + enddo + fx2=fx2*(xmin1-xmax1)/dble(delh) + endif + psjet1=sngl((fx1+fx2)/psuds(q2,l))*pi**3*2 + * /2 !CS for parton pair + return + end + +c----------------------------------------------------------------------- + function psjet(q1,q2,qqcut,s,j,l,jdis) +c----------------------------------------------------------------------- +c parton ladder cross-section +c with at least one emission on each side +c +c q1 - virtuality cutoff at current end of the ladder; +c q2 - virtuality cutoff at opposite end of the ladder; +c qqcut - p_t cutoff for the born process; +c s - c.m. energy squared for the scattering; +c j - parton type at current end of the ladder (0 - g, 1,2 etc. - q); +c l - parton type at opposite end of the ladder (0 - g, 1,2 etc. - q). +c----------------------------------------------------------------------- + double precision xx1,xx2,qq,s2min,xmin,xmax,xmin1,xmax1,t,tmin + *,tmax,sh,z,qtmin,ft,fx1,fx2 + common /ar3/ x1(7),a1(7) + common /ar9/ x9(3),a9(3) + include 'epos.inc' + include 'epos.incsem' + common/ccctest/iiitest + iiitest=0 + + psjet=0. + if(jdis.eq.0)then + qq=dble(max(q1,q2)) + else + qq=dble(max(q1/4.,q2)) + endif + qq=max(qq,dble(qqcut)) + s2min=4.d0*qq + if(dble(s).le.s2min/(1.d0-dble(q2ini)/qq)**2)return !kkkkkkk + + phi=acos(1.-54.*q2ini/s)/3. + zmax=(1.+2.*cos(phi))**2/9. !kkkkkkk + zmin=(1.-cos(phi)+sqrt(3.d0)*sin(phi))/3. !kkkkkkk + zmin=max(zmin**2,sngl(s2min/dble(s))) + if(zmin.gt.zmax.and.ish.ge.1)write(ifch,*)'psjet:zmin,zmax' + * ,zmin,zmax + zmin=zmin**(-delh) + zmax=zmax**(-delh) + do i=1,3 + do m=1,2 + z=dble(.5*(zmax+zmin+(zmin-zmax)*(2*m-3)*x9(i)))**(-1./delh) + xmin=dsqrt(z) + sh=z*dble(s) + + qtmin=max(qq,dble(q2ini)/(1.d0-dsqrt(z))) + tmin=max(0.d0,1.d0-4.d0*qtmin/sh) + tmin=2.d0*qtmin/(1.d0+dsqrt(tmin)) !kkkkkkk + tmax=sh/2.d0 + + ft=0.d0 +c if(tmin.gt.tmax)write (*,*)'psjet:tmin,tmax',tmin,tmax + do i1=1,3 + do m1=1,2 + t=2.d0*tmin/(1.d0+tmin/tmax-dble(x9(i1)*(2*m1-3)) + & *(1.d0-tmin/tmax)) + qt=t*(1.d0-t/sh) +c if(qt.lt.qtmin)write (*,*)'psjet:qt,qq',qt,qq + xmax=1.d0-q2ini/qt + xmin=max(dsqrt(z),z/xmax) !xm>xp !!! + if(xmin.gt.xmax.and.ish.ge.1)write(ifch,*)'psjet:xmin,xmax' + * ,xmin,xmax + fx1=0.d0 + fx2=0.d0 + if(xmax.gt..8d0)then + xmin1=max(xmin,.8d0) + do i2=1,3 + do m2=1,2 + xx1=1.d0-(1.d0-xmax)*((1.d0-xmin1)/(1.d0-xmax))** + * dble(.5+x9(i2)*(m2-1.5)) + xx2=z/xx1 + + fb=0. + fb=fb+psjeti(q1,q2,qt,sngl(t),xx1,xx2,sngl(sh) + * ,j,l,jdis) + * +psjeti(q1,q2,qt,sngl(t),xx2,xx1,sngl(sh) + * ,j,l,jdis) + fx1=fx1+dble(a9(i2)*fb)*(1.d0/xx1-1.d0) + * *pssalf(qt/qcdlam)**2 + enddo + enddo + fx1=fx1*dlog((1.d0-xmin1)/(1.d0-xmax)) + endif + if(xmin.lt..8d0)then + xmax1=min(xmax,.8d0) + do i2=1,3 + do m2=1,2 + xx1=xmin*(xmax1/xmin)**dble(.5+x9(i2)*(m2-1.5)) + xx2=z/xx1 + + fb=0. + fb=fb+psjeti(q1,q2,qt,sngl(t),xx1,xx2,sngl(sh) + * ,j,l,jdis) + * +psjeti(q1,q2,qt,sngl(t),xx2,xx1,sngl(sh) + * ,j,l,jdis) + fx2=fx2+dble(a9(i2))*fb*pssalf(qt/qcdlam)**2 + enddo + enddo + fx2=fx2*dlog(xmax1/xmin) + endif + ft=ft+dble(a9(i1))*(fx1+fx2)*t**2 + enddo + enddo + ft=ft*(1.d0/tmin-1.d0/tmax) + psjet=psjet+a9(i)*sngl(ft*z**(1.+delh)/sh**2) + enddo + enddo + psjet=psjet*(zmin-zmax)/delh*pi**3 + * /2. !CS for parton pair + return + end + +c----------------------------------------------------------------------- + function pijet(ii,qi,qq,sk,m1,l1) !polynomial interpol of jet CS +c----------------------------------------------------------------------- +c ii ..... type of CS (2 = bothside, 1 = oneside, 0 = no emission, Born) +c qi ..... virtuality cutoff at current end of the ladder +c qq ..... virtuality cutoff of Born +c sk ..... energy squared for the scattering +c m1,l1 .. parton types +c----------------------------------------------------------------------- + include 'epos.incsem' + common/psar2/edmax,epmax + common/tabcsjet/ksmax,iqmax,jqmax,csjet(0:2,2,20,20,20,3,2) + real wi(3),wj(3),wk(3) + common/cpijet/npijet + data npijet/0/ + npijet=npijet+1 + if(npijet.eq.1)call MakeCSTable + + if(m1.ne.0.and.m1.eq.l1)then + m=2 + l=2 + elseif(m1.ne.0.and.m1.eq.-l1)then + m=3 + l=1 + elseif(m1.ne.0.and.l1.ne.0.and.m1.ne.l1)then + m=3 + l=2 + else + m=min(1,iabs(m1))+1 + l=min(1,iabs(l1))+1 + endif + + qqmin=min(qi,qq) + qmax=sk/4. + spmin=4.*q2min + spmed=spmin*(epmax/2./spmin)**(1./(ksmax-1.)) + if(sk.le.spmed)then + kk=2 + spmax=spmed + else + kk=1 + spmax=epmax/2. + endif + + qli=1.+log(qi/q2min)/log(qmax/q2min)*(iqmax-1) + qlj=1.+log(qq/qqmin)/log(qmax/qqmin)*(jqmax-1) + sl= 1.+log(sk/spmin)/log(spmax/spmin)*(ksmax-1) + k=int(sl) + i=int(qli) + j=int(qlj) + if(k.lt.1)k=1 + if(j.lt.1)j=1 + if(i.lt.1)i=1 + if(k.gt.(ksmax-2))k=ksmax-2 + if(i.gt.(iqmax-2))i=iqmax-2 + if(j.gt.(jqmax-2))j=jqmax-2 + + wi(2)=qli-i + wi(3)=wi(2)*(wi(2)-1.)*.5 + wi(1)=1.-wi(2)+wi(3) + wi(2)=wi(2)-2.*wi(3) + + wj(2)=qlj-j + wj(3)=wj(2)*(wj(2)-1.)*.5 + wj(1)=1.-wj(2)+wj(3) + wj(2)=wj(2)-2.*wj(3) + + wk(2)=sl-k + wk(3)=wk(2)*(wk(2)-1.)*.5 + wk(1)=1.-wk(2)+wk(3) + wk(2)=wk(2)-2.*wk(3) + + pijet=0 + do i1=1,3 + do j1=1,3 + do k1=1,3 + pijet=pijet+csjet(ii,kk,k+k1-1,i+i1-1,j+j1-1,m,l) + * *wi(i1)*wj(j1)*wk(k1) + enddo + enddo + enddo + ! if(ii.eq.2)print*,' ' + ! write(*,'(i2,f6.0,i2,3x,3(2f5.2,2x),f5.2)') + !* ii,sk,k,(wk(kk1),csjet(ii,kk,k+kk1-1,1,1,m,l),kk1=1,3) ,pijet + end + +c----------------------------------------------------------------------- + subroutine MakeCSTable !tabulates psjet +c----------------------------------------------------------------------- +c last two indices of table: parton types +c 1 1 ... gg +c 1 2 ... gq +c 2 1 ... qg +c 2 2 ... qq +c 3 1 ... qa +c 3 2 ... qq' +c----------------------------------------------------------------------- + include 'epos.incsem' + common/psar2/edmax,epmax + common/tabcsjet/ksmax,iqmax,jqmax,csjet(0:2,2,20,20,20,3,2) + write (*,'(a,$)')'(CS table' + ksmax=10 + iqmax=3 + jqmax=3 + spmin=4.*q2min + do kk=1,2 + if(kk.eq.1)then + spmax=epmax/2. + else !if(kk.eq.2) + spmax=spmin*(epmax/2./spmin)**(1./(ksmax-1.)) + endif + do m=1,3 !parton type at upper end of the ladder + write (*,'(a,$)')'.' + do l=1,2 !parton type at lower end of the ladder + m1=m-1 + l1=l-1 + if(m.eq.3.and.l.eq.1)l1=-m1 + do k=1,ksmax + sk=spmin*(spmax/spmin)**((k-1.)/(ksmax-1.)) + qmax=sk/4. + do i=1,iqmax + qi=q2min*(qmax/q2min)**((i-1.)/(iqmax-1.)) + do j=1,jqmax + qq=qi*(qmax/qi)**((j-1.)/(jqmax-1.)) + !write(*,'(i3,4f8.3,2i4,$)')j, qi,q2min,qq,sk,m1,l1 + csjet(2,kk,k,i,j,m,l)= psjet(qi,q2min,qq,sk,m1,l1,0) + csjet(1,kk,k,i,j,m,l)=psjet1(qi,q2min,qq,sk,m1,l1,0) + csjet(0,kk,k,i,j,m,l)=psborn(qi,q2min,qq,sk,m1,l1,0,1) + ! if(i.eq.1.and.j.eq.1.and.m.eq.1.and.l.eq.1) + ! *write(*,'(2f8.2,f13.2,2i3,3x,i3,3f8.3)') + ! * qi,qq,sk,m1,l1,k,csjet(2,kk,k,i,j,m,l) + ! * ,csjet(1,kk,k,i,j,m,l),csjet(0,kk,k,i,j,m,l) + enddo + enddo + enddo + enddo + enddo + enddo + write (*,'(a,$)')'done)' + end + +c----------------------------------------------------------------------- + function psjeti(q1,q2,qt,t,xx1,xx2,s,j,l,jdis) +c----------------------------------------------------------------------- +c +c E~qcd_ji * E~qcd_lk * B_ik +c +c B_ik = psbori = contribution to Born xsection: +c dsigmaBorn/d2pt/dy +c = s/pi * delta(s+t+u) * 2*pi*alpha**2 /s**2 * B_ik +c +c E~qcd: at least one emission +c +c q1 - virtuality cutoff at current end of the ladder +c q2 - virtuality cutoff at opposite end of the ladder +c xx1 - feinman x for the first parton for the born process +c xx2 - feinman x for the second parton for the born process +c s - c.m. energy squared for the born scattering +c t - invariant variable for the scattering |(p1-p3)**2|, +c j - parton type at current end of the ladder (0 - g, 1,-1,2,... - q) +c l - parton type at opposite end of the ladder (0 - g, 1,-1,2,... - q) +c----------------------------------------------------------------------- +c reminder +c psevi: 1 1 ... gluon -> gluon +c 2 1 ... quark -> gluon +c 1 2 ... gluon -> quark +c 3 2 ... quark -> quark non singlet +c 2 2 ... quark -> quark all +c singlet = all - non singlet +c----------------------------------------------------------------------- + double precision xx1,xx2 + include 'epos.incsem' + common/ccctest/iiitest + + if(jdis.eq.0)then + scale=qt + else + scale=qt*4. + endif + if(j.eq.0.and.l.eq.0)then ! gluon-gluon ---> + akg1=psevi(q1,scale,xx1,1,1) !gluon contribution + akg2=psevi(q2,qt,xx2,1,1) !gluon contribution + aks1=psevi(q1,scale,xx1,1,2)/naflav/2. !singlet contribution per quark + aks2=psevi(q2,qt,xx2,1,2)/naflav/2. !singlet contribution per quark + psjeti=ffborn(s,t,akg1*akg2 + * ,(akg1*aks2+aks1*akg2)*naflav*2. !ccccc + * ,aks1*aks2*naflav*2. + * ,aks1*aks2*naflav*2. + * ,aks1*aks2*naflav*2.*(naflav-1)*2. + *) + elseif(j.eq.0)then ! gluon-quark ---> + akg1=psevi(q1,scale,xx1,1,1) !gluon contribution + akg2=psevi(q2,qt,xx2,2,1) !gluon contribution + aks1=psevi(q1,scale,xx1,1,2)/naflav/2. !singlet contribution + akns2=psevi(q2,qt,xx2,3,2) !nonsinglet contribution + aks2=(psevi(q2,qt,xx2,2,2)-akns2)/naflav/2. !singlet contribution + psjeti=ffborn(s,t,akg1*akg2 + * ,(akg1*(akns2+aks2*naflav*2.)+aks1*akg2*naflav*2.) + * ,aks1*(akns2+aks2*naflav*2.) + * ,aks1*(akns2+aks2*naflav*2.) + * ,aks1*(akns2+aks2*naflav*2.)*(naflav-1)*2.) + elseif(l.eq.0)then ! quark-gluon ---> + akg1=psevi(q1,scale,xx1,2,1) !gluon contribution + akg2=psevi(q2,qt,xx2,1,1) !gluon contribution + akns1=psevi(q1,scale,xx1,3,2) !nonsinglet contribution + aks1=(psevi(q1,scale,xx1,2,2)-akns1)/naflav/2. !singlet contribution + aks2=psevi(q2,qt,xx2,1,2)/naflav/2. !singlet contribution + psjeti=ffborn(s,t,akg1*akg2 + * ,(akg2*(akns1+aks1*naflav*2.)+aks2*akg1*naflav*2.) + * ,aks2*(akns1+aks1*naflav*2.) + * ,aks2*(akns1+aks1*naflav*2.) + * ,aks2*(akns1+aks1*naflav*2.)*(naflav-1)*2.) + else ! quark-quark ---> + akg1=psevi(q1,scale,xx1,2,1) !gluon contribution + akg2=psevi(q2,qt,xx2,2,1) !gluon contribution + akns1=psevi(q1,scale,xx1,3,2) !nonsinglet contribution + aks1=(psevi(q1,scale,xx1,2,2)-akns1)/naflav/2.!singlet contribution + akns2=psevi(q2,qt,xx2,3,2) !nonsinglet contribution + aks2=(psevi(q2,qt,xx2,2,2)-akns2)/naflav/2.!singlet contribution + + if(j.eq.l)then + psjeti=ffborn(s,t,akg1*akg2 + * ,(akg2*(akns1+aks1*naflav*2.)+akg1*(akns2+aks2*naflav*2.)) + * ,((akns1+aks1)*(akns2+aks2)+aks1*aks2*(2.*naflav-1.)) + * ,(akns1*aks2+akns2*aks1+aks1*aks2*naflav*2.) + * ,(akns1*aks2+akns2*aks1+aks1*aks2*naflav*2.)*(naflav-1)*2.) + elseif(j.eq.-l)then + psjeti=ffborn(s,t,akg1*akg2 + * ,(akg2*(akns1+aks1*naflav*2.)+akg1*(akns2+aks2*naflav*2.)) + * ,(akns1*aks2+akns2*aks1+aks1*aks2*naflav*2.) + * ,((akns1+aks1)*(akns2+aks2)+aks1*aks2*(2.*naflav-1.)) + * ,(akns1*aks2+akns2*aks1+aks1*aks2*naflav*2.)*(naflav-1)*2.) + else !j.ne.l,-l + psjeti=ffborn(s,t,akg1*akg2 + * ,(akg2*(akns1+aks1*naflav*2.)+akg1*(akns2+aks2*naflav*2.)) + * ,(akns1*aks2+akns2*aks1+aks1*aks2*naflav*2.) + * ,(akns1*aks2+akns2*aks1+aks1*aks2*naflav*2.) + * ,(akns1*akns2+akns1*aks2*(naflav-1)*2. + * +akns2*aks1*(naflav-1)*2.+aks1*aks2*naflav*2.*(naflav-1)*2.)) + endif + endif + return + end + +c----------------------------------------------------------------------- + function psjetj(q1,scale,t,xx,s,j,l,n) +c----------------------------------------------------------------------- +c psjetj - integrand for the ordered ladder cross-section +c q1 - virtuality cutoff at current end of the ladder, +c scale - born process scale, +c t - invariant variable for the scattering |(p1-p3)**2|, +c xx - feinman x for the first parton for the born process +c s - c.m. energy squared for the born scattering, +c j - parton type at current end of the ladder (0 - g, 1,-1,2,... - q) +c l - parton type at opposite end of the ladder (0 - g, 1,-1,2,... - q) +c n - subprocess number +c----------------------------------------------------------------------- + double precision xx + include 'epos.incsem' + + m=min(1,iabs(j))+1 + if(l.ne.3)then + if(l.eq.0)then + psjetj=psevi(q1,scale,xx,m,1)*(psbori(s,t,0,0,n)+ !gg + * psbori(s,s-t,0,0,n))/2. + * +psevi(q1,scale,xx,m,2)*(psbori(s,t,1,0,n)+ !qg + * psbori(s,s-t,1,0,n)) + elseif(j.eq.0)then + aks=psevi(q1,scale,xx,1,2)/naflav/2. !singlet contribution per quark + psjetj=psevi(q1,scale,xx,1,1)*(psbori(s,t,0,1,n)+ !gq + * psbori(s,s-t,0,1,n)) + * +aks*(psbori(s,t,1,1,n)+psbori(s,s-t,1,1,n))/2. !qq + * +aks*(psbori(s,t,-1,1,n)+psbori(s,s-t,-1,1,n)) !qq~ + * +aks*(psbori(s,t,1,2,n)+psbori(s,s-t,1,2,n))*(naflav-1)*2. !qq' + else + akg=psevi(q1,scale,xx,2,1) !gluon contribution + akns=psevi(q1,scale,xx,3,2) !nonsinglet contribution + aks=(psevi(q1,scale,xx,2,2)-akns)/naflav/2. !singlet contribution + if(j.eq.l)then + psjetj=akg*(psbori(s,t,0,1,n)+psbori(s,s-t,0,1,n)) !gq + * +(akns+aks)*(psbori(s,t,1,1,n)+psbori(s,s-t,1,1,n))/2. !qq + * +aks*(psbori(s,t,-1,1,n)+psbori(s,s-t,-1,1,n)) !qq~ + * +aks*(psbori(s,t,1,2,n)+psbori(s,s-t,1,2,n))*(naflav-1)*2. !qq' + elseif(j.eq.-l)then + psjetj=akg*(psbori(s,t,0,1,n)+psbori(s,s-t,0,1,n)) !gq + * +aks*(psbori(s,t,1,1,n)+psbori(s,s-t,1,1,n))/2. !qq + * +(akns+aks)*(psbori(s,t,-1,1,n)+psbori(s,s-t,-1,1,n)) !qq~ + * +aks*(psbori(s,t,1,2,n)+psbori(s,s-t,1,2,n))*(naflav-1)*2.!qq' + else + psjetj=akg*(psbori(s,t,0,1,n)+psbori(s,s-t,0,1,n)) !gq + * +aks*(psbori(s,t,1,1,n)+psbori(s,s-t,1,1,n))/2. !qq + * +aks*(psbori(s,t,-1,1,n)+psbori(s,s-t,-1,1,n)) !qq~ + * +(akns+aks*(naflav-1)*2.)* + * (psbori(s,t,1,2,n)+psbori(s,s-t,1,2,n)) !qq' + endif + endif + elseif(n.eq.1)then + p1=s/(1.+qcmass**2/s) + psjetj=psevi(q1,scale,xx,m,1)*(psbori(s,t,4,0,n)+ !cg + * psbori(s,p1-t,4,0,n)) + * +psevi(q1,scale,xx,m,2)*(psbori(s,t,4,1,n)+ !cq + * psbori(s,p1-t,4,1,n)) + else + psjetj=0. + endif + return + end + +c------------------------------------------------------------------------ + function psjti(q1,qqcut,s,m1,l1,jdis) +c----------------------------------------------------------------------- +c psjti - inclusive hard cross-section interpolation - for any ordering +c in the ladder +c q1 - virtuality cutoff at current end of the ladder +c qqcut - p_t cutoff for the born process; +c s - total c.m. energy squared for the ladder +c m1 - parton type at current end of the ladder (0-g, 1,2,etc.-q) +c l1 - parton type at opposite end of the ladder (0-g, 1,2,etc.-q) +c----------------------------------------------------------------------- + dimension wi(3),wj(3),wk(3) + common /psar2/ edmax,epmax + common /psar19/ cstot(20,20,240) + include 'epos.incsem' + + psjti=0. +c jdis1=jdis + if(jdis.eq.0)then + qqmin=q1 + qmax=s/4. + else + qqmin=max(q2min,q1/4.) + qmax=s + endif + qq=max(qqmin,qqcut) + spmin=4.*q2min + s2min=4.*qq + if(s.le.s2min)return + + if(jdis.eq.0)then + smins=s2min/(1.-q2ini/qq) + else + smins=s2min/(1.-q2ini/qq/4.) + endif + if(s.le.smins)goto 1 + + if(s.gt.4.*qq)then + tmin=2.*qq/(1.+sqrt(1.-4.*qq/s)) + else + tmin=2.*qq + endif + tmax=s/2. + + if(m1.ne.0.and.m1.eq.l1)then + m=2 + l=2 + elseif(m1.ne.0.and.m1.eq.-l1)then + m=3 + l=1 + elseif(m1.ne.0.and.l1.ne.0.and.m1.ne.l1)then + m=3 + l=2 + else + m=min(1,iabs(m1))+1 + l=min(1,iabs(l1))+1 + endif + + ml=20*(m-1)+60*(l-1)+120*jdis + qli=log(q1/q2min)/log(qmax/q2min)*19.+1. + qlj=log(qq/qqmin)/log(s/4./qqmin)*19.+1. + sl=log(s/spmin)/log(epmax/2./spmin)*19.+1. + k=int(sl) + i=int(qli) + j=int(qlj) + if(j.lt.1)j=1 + if(i.lt.1)i=1 + if(k.gt.18)k=18 + if(i.gt.18)i=18 + if(j.gt.18)j=18 + + wi(2)=qli-i + wi(3)=wi(2)*(wi(2)-1.)*.5 + wi(1)=1.-wi(2)+wi(3) + wi(2)=wi(2)-2.*wi(3) + + wj(2)=qlj-j + wj(3)=wj(2)*(wj(2)-1.)*.5 + wj(1)=1.-wj(2)+wj(3) + wj(2)=wj(2)-2.*wj(3) + + wk(2)=sl-k + wk(3)=wk(2)*(wk(2)-1.)*.5 + wk(1)=1.-wk(2)+wk(3) + wk(2)=wk(2)-2.*wk(3) + + do i1=1,3 + do j1=1,3 + do k1=1,3 + psjti=psjti+cstot(i+i1-1,j+j1-1,k+k1+ml-1) + * *wi(i1)*wj(j1)*wk(k1) + enddo + enddo + enddo + psjti=exp(psjti)*(1./tmin-1./tmax) + return +1 continue + psjti=psbint(q1,q2min,qqcut,s,m1,l1,jdis) + return + end + +c------------------------------------------------------------------------ + subroutine psjti0(ss,sj,sjb,m1,l1) +c----------------------------------------------------------------------- +c psjti0 - inclusive hard cross-section interpolation - +c for minimal virtuality cutoff in the ladder +c s - total c.m. energy squared for the ladder, +c sj - inclusive jet cross-section, +c sjb - born cross-section, +c m1 - parton type at current end of the ladder (0-g, 1,2,etc.-q) +c l1 - parton type at opposite end of the ladder (0-g, 1,2,etc.-q) +c----------------------------------------------------------------------- + dimension wk(3) + common /psar2/ edmax,epmax + common /psar22/ cstotzero(20,4,2),csborzer(20,4,2) + include 'epos.incsem' + + sj=0. + sjb=0. + if(iabs(m1).ne.4)then + q2mass=0. + if(m1.ne.0.and.m1.eq.l1)then + m=2 + l=2 + elseif(m1.ne.0.and.m1.eq.-l1)then + m=3 + l=1 + elseif(m1.ne.0.and.l1.ne.0.and.m1.ne.l1)then + m=3 + l=2 + else + m=min(1,iabs(m1))+1 + l=min(1,iabs(l1))+1 + endif + else + q2mass=qcmass**2 + m=4 + l=min(1,iabs(l1))+1 + endif + s=ss-q2mass + qq=q2min + spmin=4.*qq+q2mass + if(s.le.spmin)return + + p1=s/(1.+q2mass/s) + if(p1.gt.4.*qq)then + tmin=2.*qq/(1.+sqrt(1.-4.*qq/p1)) + else + tmin=2.*qq + endif + tmax=.5*p1 + + sl=log(s/spmin)/log(epmax/2./spmin)*19.+1. + k=int(sl) + if(k.gt.18)k=18 + wk(2)=sl-k + wk(3)=wk(2)*(wk(2)-1.)*.5 + wk(1)=1.-wk(2)+wk(3) + wk(2)=wk(2)-2.*wk(3) + + do k1=1,3 + sj=sj+cstotzero(k+k1-1,m,l)*wk(k1) + sjb=sjb+csborzer(k+k1-1,m,l)*wk(k1) + enddo + + sjb=exp(sjb)*(1./tmin-1./tmax) + sj=max(sjb,exp(sj)*(1./tmin-1./tmax)) + return + end + +c------------------------------------------------------------------------ + function psjti1(q1,q2,qqcut,s,m1,l1,jdis) +c----------------------------------------------------------------------- +c psjti1 - inclusive hard cross-section interpolation - for strict order +c in the ladder +c q1 - virtuality cutoff at current end of the ladder +c q2 - virtuality cutoff at opposite end of the ladder +c qqcut - p_t cutoff for the born process; +c s - total c.m. energy squared for the ladder, +c m1 - parton type at current end of the ladder (0-g, 1,2,etc.-q) +c l1 - parton type at opposite end of the ladder (0-g, 1,2,etc.-q) +c----------------------------------------------------------------------- + dimension wi(3),wj(3),wk(3) + common /psar2/ edmax,epmax + common /psar20/ csord(20,20,240) + include 'epos.incsem' + double precision psuds + + psjti1=0. + if(jdis.eq.0)then + qqmin=max(q1,q2) + else + qqmin=max(q1,q2/4.) + endif + qq=max(qqmin,qqcut) + spmin=4.*q2min + s2min=4.*qq + if(s.le.s2min)return + + smins=s2min/(1.-q2ini/qq) + if(s.le.smins)goto 1 + + if(s.gt.4.*qq)then + tmin=2.*qq/(1.+sqrt(1.-4.*qq/s)) + else + tmin=2.*qq + endif + tmax=s/2. + + if(m1.ne.0.and.m1.eq.l1)then + m=2 + l=2 + elseif(m1.ne.0.and.m1.eq.-l1)then + m=3 + l=1 + elseif(m1.ne.0.and.l1.ne.0.and.m1.ne.l1)then + m=3 + l=2 + else + m=min(1,iabs(m1))+1 + l=min(1,iabs(l1))+1 + endif + + ml=20*(m-1)+60*(l-1)+120*jdis + qli=log(q1/q2min)/log(s/4./q2min)*19.+1. + qlj=log(qq/qqmin)/log(s/4./qqmin)*19.+1. + sl=log(s/spmin)/log(epmax/2./spmin)*19.+1. + k=int(sl) + i=int(qli) + j=int(qlj) + if(j.lt.1)j=1 + if(i.lt.1)i=1 + if(k.gt.18)k=18 + if(i.gt.18)i=18 + if(j.gt.18)j=18 + + wi(2)=qli-i + wi(3)=wi(2)*(wi(2)-1.)*.5 + wi(1)=1.-wi(2)+wi(3) + wi(2)=wi(2)-2.*wi(3) + + wj(2)=qlj-j + wj(3)=wj(2)*(wj(2)-1.)*.5 + wj(1)=1.-wj(2)+wj(3) + wj(2)=wj(2)-2.*wj(3) + + wk(2)=sl-k + wk(3)=wk(2)*(wk(2)-1.)*.5 + wk(1)=1.-wk(2)+wk(3) + wk(2)=wk(2)-2.*wk(3) + + do i1=1,3 + do j1=1,3 + do k1=1,3 + k2=k+k1+ml-1 + psjti1=psjti1+csord(i+i1-1,j+j1-1,k2) + * *wi(i1)*wj(j1)*wk(k1) + enddo + enddo + enddo + psjti1=exp(psjti1)*(1./tmin-1./tmax) + + if(jdis.eq.0.and.qq.gt.q2)then + psjti1=psjti1*sngl(psuds(qq,l1)/psuds(q2,l1)) + elseif(jdis.eq.1.and.4.*qq.gt.q2)then + psjti1=psjti1*sngl(psuds(4.*qq,l1)/psuds(q2,l1)) + endif + return +1 continue + if(jdis.eq.0)then + psjti1=psbint(q1,q2,qqcut,s,m1,l1,0) + else + psjti1=psbint(q2,q1,qqcut,s,l1,m1,1) + endif + return + end + +c------------------------------------------------------------------------ + function pspdfg(xx,qqs,qq,iclpro0,j) +c----------------------------------------------------------------------- +c pspdf - parton distribution function +c qq - virtuality scale +c qqs - initial virtuality for the input distributions +c iclpro0 - hadron class +c j - parton type +c----------------------------------------------------------------------- + double precision z + common/ar3/ x1(7),a1(7) + include 'epos.incsem' + double precision psuds + + pspdfg=psdfh4(xx,qqs,0.,iclpro0,j) + if(j.gt.0)pspdfg=pspdfg+psdfh4(xx,qqs,0.,iclpro0,-j) !+sea contr. + pspdfg=pspdfg*sngl(psuds(qq,j)/psuds(qqs,j)) + + xmin=xx/(1.-q2ini/qq) + if(xmin.ge.1.)return + + dpd1=0. + dpd2=0. + xm=max(xmin,.3) + do i=1,7 !numerical integration over zx + do m=1,2 + zx=1.-(1.-xm)*(.5+(m-1.5)*x1(i))**.25 + z=xx/zx + + if(j.eq.0)then + aks=psevi(qqs,qq,z,2,1) !quark contribution + akg=psevi(qqs,qq,z,1,1) !gluon contribution + akns=0. + else + akg=psevi(qqs,qq,z,1,2)/naflav/2. !gluon contribution + akns=psevi(qqs,qq,z,3,2) !nonsinglet contribution + aks=(psevi(qqs,qq,z,2,2)-akns)/naflav/2. !quark contribution + endif + + fz=akg*psdfh4(zx,qqs,0.,iclpro0,0) + * +akns*psdfh4(zx,qqs,0.,iclpro0,j) + * +aks*(psdfh4(zx,qqs,0.,iclpro0,1)+ + * 2.*psdfh4(zx,qqs,0.,iclpro0,-1) + * +psdfh4(zx,qqs,0.,iclpro0,2)+2.*psdfh4(zx,qqs,0.,iclpro0,-2) + * +2.*psdfh4(zx,qqs,0.,iclpro0,-3)) + if(j.gt.0)fz=fz+akns*psdfh4(zx,qqs,0.,iclpro0,-j) + + dpd1=dpd1+a1(i)*fz/zx**2/(1.-zx)**3 + enddo + enddo + dpd1=dpd1*(1.-xm)**4/8.*xx + + if(xm.gt.xmin)then + do i=1,7 !numerical integration + do m=1,2 + zx=xx+(xm-xx)*((xmin-xx)/(xm-xx))**(.5-(m-1.5)*x1(i)) + z=xx/zx + + if(j.eq.0)then + aks=psevi(qqs,qq,z,2,1) !quark contribution + akg=psevi(qqs,qq,z,1,1) !gluon contribution + akns=0. + else + akg=psevi(qqs,qq,z,1,2)/naflav/2. !gluon contribution + akns=psevi(qqs,qq,z,3,2) !nonsinglet contribution + aks=(psevi(qqs,qq,z,2,2)-akns)/naflav/2. !quark contribution + endif + + fz=akg*psdfh4(zx,qqs,0.,iclpro0,0) + * +akns*psdfh4(zx,qqs,0.,iclpro0,j) + * +aks*(psdfh4(zx,qqs,0.,iclpro0,1) + * +2.*psdfh4(zx,qqs,0.,iclpro0,-1) + * +psdfh4(zx,qqs,0.,iclpro0,2)+2.*psdfh4(zx,qqs,0.,iclpro0,-2) + * +2.*psdfh4(zx,qqs,0.,iclpro0,-3)) + if(j.gt.0)fz=fz+akns*psdfh4(zx,qqs,0.,iclpro0,-j) + + dpd2=dpd2+a1(i)*fz*(1.-xx/zx)/zx + enddo + enddo + dpd2=dpd2*log((xm-xx)/(xmin-xx))*.5*xx + endif + pspdfg=pspdfg+dpd2+dpd1 + return + end + +c----------------------------------------------------------------------- + subroutine psaevp +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + qq=xpar1 + jmod=nint(xpar2) + iologb=1 + + if(jmod.eq.0)then !??????????????ttttttt + write(*,*)"no more triple Pomeron, xpar2=0 in psaevp not accepted" + write(*,*)"use xpar2=1 instead" + jmod=1 + endif + + do i=1,nrbins + if(iologb.eq.0)then + xx=xminim+(xmaxim-xminim)*(i-.5)/nrbins + else + xx=xminim*(xmaxim/xminim)**((i-.5)/nrbins) + endif + ar(i,1)=xx + ar(i,2)=0. + if(jmod.eq.0)then !evolution+matrix element +3P (ours) + ww=qq/xx + ar(i,3)=(psdh(ww,qq,2,0)+psdh(ww,qq,2,1) +c * +psdsh1(ww,qq,2,dqsh,0)+psdsh1(ww,qq,2,dqsh,1) + * )/(4.*pi**2*alfe)*qq + elseif(jmod.eq.1)then !evolution+matrix element (ours) + ww=qq/xx + ar(i,3)=(psdh(ww,qq,2,0)+psdh(ww,qq,2,1)+ + * psdsh(ww,qq,2,dqsh,0)+psdsh(ww,qq,2,dqsh,1) + * )/(4.*pi**2*alfe)*qq + elseif(jmod.eq.2)then !just evolution (grv) + ar(i,3)=(pspdfg(xx,q2min,qq,2,1)/2.25+ + * pspdfg(xx,q2min,qq,2,2)/9.+ + * pspdfg(xx,q2min,qq,2,-1)*2./3.6+ + * pspdfg(xx,q2min,qq,2,-3)*2./9.) + if(naflav.eq.4)ar(i,3)=ar(i,3)+pspdfg(xx,q2min,qq,2,-4) + * *2./2.25 + elseif(jmod.eq.3)then !grv + ar(i,3)=(psdfh4(xx,qq,0.,2,1)+2.*psdfh4(xx,qq,0.,2,-1))/2.25 + * +(psdfh4(xx,qq,0.,2,2)+2.*psdfh4(xx,qq,0.,2,-2))/9. + * +2.*psdfh4(xx,qq,0.,2,-3)/9. ! + elseif(jmod.eq.4)then !just evolution (ours) + ar(i,3)=(fparton(xx,qq,1)/2.25+fparton(xx,qq,2)/9.+ + * fparton(xx,qq,-1)*6./4.5) !uv+dv+6*sea + if(naflav.eq.4)ar(i,3)=ar(i,3)+fparton(xx,qq,-4)*2./2.25 + elseif(jmod.eq.5)then !grv+res + ww=qq/xx + ar(i,3)=(psdgh(ww,qq,0)+psdgh(ww,qq,1) + * )/(4.*pi**2*alfe)*qq + endif + ar(i,4)=0. + enddo + return + end + +c------------------------------------------------------------------------ + subroutine pscs(c,s) +c----------------------------------------------------------------------- +c pscs - cos (c) and sin (s) generation for uniformly distributed angle +c----------------------------------------------------------------------- +1 s1=2.*rangen()-1. + s2=2.*rangen()-1. + s3=s1*s1+s2*s2 + if(s3.gt.1.)goto 1 + s3=sqrt(s3) + c=s1/s3 + s=s2/s3 + return + end + +c------------------------------------------------------------------------ + subroutine psdefrot(ep,s0x,c0x,s0,c0) +c----------------------------------------------------------------------- +c psdefrot - determination of the parameters the spacial rotation to the +c system for 4-vector ep +c s0, c0 - sin and cos for the zx-rotation; +c s0x, c0x - sin and cos for the xy-rotation +c----------------------------------------------------------------------- + dimension ep(4) + +c transverse momentum square for the current parton (ep) + pt2=ep(3)**2+ep(4)**2 + if(pt2.ne.0.)then + pt=sqrt(pt2) +c system rotation to get pt=0 - euler angles are determined (c0x = cos t +c s0x = sin theta, c0 = cos phi, s0 = sin phi) + c0x=ep(3)/pt + s0x=ep(4)/pt +c total momentum for the gluon + pl=sqrt(pt2+ep(2)**2) + s0=pt/pl + c0=ep(2)/pl + else + c0x=1. + s0x=0. + pl=abs(ep(2)) + s0=0. + c0=ep(2)/pl + endif + + ep(2)=pl + ep(3)=0. + ep(4)=0. + return + end + +c------------------------------------------------------------------------ + subroutine psdeftr(s,ep,ey) +c----------------------------------------------------------------------- +c psdeftr - determination of the parameters for the lorentz transform to +c rest frame system for 4-vector ep of mass squared s +c----------------------------------------------------------------------- + dimension ey(3) + double precision ep(4) + + do i=1,3 + if(ep(i+1).eq.0.d0)then + ey(i)=1. + else + wp=ep(1)+ep(i+1) + wm=ep(1)-ep(i+1) + if(wp.gt.1.e-8.and.wm/wp.lt.1.e-8)then + ww=s + do l=1,3 + if(l.ne.i)ww=ww+ep(l+1)**2 + enddo + wm=ww/wp + elseif(wm.gt.1.e-8.and.wp/wm.lt.1.e-8)then + ww=s + do l=1,3 + if(l.ne.i)ww=ww+ep(l+1)**2 + enddo + wp=ww/wm + endif + ey(i)=sqrt(wm/wp) + ep(1)=wp*ey(i) + ep(i+1)=0. + endif + enddo + ep(1)=dsqrt(dble(s)) + return + end + +c------------------------------------------------------------------------ + function psdfh4(xxx,qqs,qq,icq,iq) +c------------------------------------------------------------------------ +c psdfh4 - GRV structure functions +c------------------------------------------------------------------------ + common /psar8/ stmass ,amhadr(8),qcmass + common /psar36/ alvc + + psdfh4=0. +! if(x.gt..99999)return + x=min(xxx,0.99999) !warning ! but necessary for idraflx + + if(icq.eq.2)then + if(qqs.le.0.232**2)return + sq=log(log(qqs/.232**2)/log(.23/.232**2)) + if(sq.le.0.)return + if(iq.eq.0)then !gluon + alg=.524 + betg=1.088 + aag=1.742-.93*sq + bbg=-.399*sq**2 + ag=7.486-2.185*sq + bg=16.69-22.74*sq+5.779*sq*sq + cg=-25.59+29.71*sq-7.296*sq*sq + dg=2.792+2.215*sq+.422*sq*sq-.104*sq*sq*sq + eg=.807+2.005*sq + eeg=3.841+.361*sq + psdfh4=(1.-x)**dg*(x**aag*(ag+bg*x+cg*x**2)*log(1./x)**bbg + * +sq**alg*exp(-eg+sqrt(eeg*sq**betg*log(1./x)))) + elseif(iq.eq.1.or.iq.eq.2)then !u_v or d_v + aau=.59-.024*sq + bbu=.131+.063*sq + auu=2.284+.802*sq+.055*sq*sq + au=-.449-.138*sq-.076*sq*sq + bu=.213+2.669*sq-.728*sq*sq + cu=8.854-9.135*sq+1.979*sq*sq + du=2.997+.753*sq-.076*sq*sq + uv=auu*x**aau*(1.-x)**du* + * (1.+au*x**bbu+bu*x+cu*x**1.5) + + aad=.376 + bbd=.486+.062*sq + add=.371+.083*sq+.039*sq*sq + ad=-.509+3.31*sq-1.248*sq*sq + bd=12.41-10.52*sq+2.267*sq*sq + ccd=6.373-6.208*sq+1.418*sq*sq + dd=3.691+.799*sq-.071*sq*sq + dv=add*x**aad*(1.-x)**dd* + * (1.+ad*x**bbd+bd*x+ccd*x**1.5) + + if(iq.eq.1)then !u_v + psdfh4=uv + elseif(iq.eq.2)then !d_v + psdfh4=dv + endif + elseif(iq.eq.-3)then !s_sea + als=.914 + bets=.577 + aas=1.798-.596*sq + as=-5.548+3.669*sqrt(sq)-.616*sq + bs=18.92-16.73*sqrt(sq)+5.168*sq + ds=6.379-.35*sq+.142*sq*sq + es=3.981+1.638*sq + ees=6.402 + psdfh4=(1.-x)**ds*sq**als/log(1./x)**aas*(1.+as*sqrt(x) + * +bs*x)*exp(-es+sqrt(ees*sq**bets*log(1./x))) + elseif(iabs(iq).lt.3)then !u_sea or d_sea + aadel=.409-.005*sq + bbdel=.799+.071*sq + addel=.082+.014*sq+.008*sq*sq + adel=-38.07+36.13*sq-.656*sq*sq + bdel=90.31-74.15*sq+7.645*sq*sq + ccdel=0. + ddel=7.486+1.217*sq-.159*sq*sq + delv=addel*x**aadel*(1.-x)**ddel* + * (1.+adel*x**bbdel+bdel*x+ccdel*x**1.5) + + alud=1.451 + betud=.271 + aaud=.41-.232*sq + bbud=.534-.457*sq + aud=.89-.14*sq + bud=-.981 + cud=.32+.683*sq + dud=4.752+1.164*sq+.286*sq*sq + eud=4.119+1.713*sq + eeud=.682+2.978*sq + udsea=(1.-x)**dud*(x**aaud*(aud+bud*x+cud*x**2) + * *log(1./x)**bbud+sq**alud*exp(-eud+sqrt(eeud*sq**betud* + * log(1./x)))) + + if(iq.eq.-1)then !u_sea + psdfh4=(udsea-delv)/2. + elseif(iq.eq.-2)then !d_sea + psdfh4=(udsea+delv)/2. + endif + else + psdfh4=0. + endif + elseif(icq.eq.1.or.icq.eq.3)then + if(qqs.le.0.204**2)return + sq=log(log(qqs/.204**2)/log(.26/.204**2)) + if(sq.le.0.)return + if(iq.eq.1.or.iq.eq.2)then + aapi=.517-.02*sq + api=-.037-.578*sq + bpi=.241+.251*sq + dpi=.383+.624*sq + anorm=1.212+.498*sq+.009*sq**2 + psdfh4=.5*anorm*x**aapi*(1.-x)**dpi* + * (1.+api*sqrt(x)+bpi*x) + elseif(iq.eq.0)then + alfpi=.504 + betpi=.226 + aapi=2.251-1.339*sqrt(sq) + api=2.668-1.265*sq+.156*sq**2 + bbpi=0. + bpi=-1.839+.386*sq + cpi=-1.014+.92*sq-.101*sq**2 + dpi=-.077+1.466*sq + epi=1.245+1.833*sq + eppi=.51+3.844*sq + psdfh4=(1.-x)**dpi*(x**aapi*(api+bpi*sqrt(x)+cpi*x)* + * log(1./x)**bbpi+sq**alfpi* + * exp(-epi+sqrt(eppi*sq**betpi*log(1./x)))) + elseif(iq.eq.-3)then + alfpi=.823 + betpi=.65 + aapi=1.036-.709*sq + api=-1.245+.713*sq + bpi=5.58-1.281*sq + dpi=2.746-.191*sq + epi=5.101+1.294*sq + eppi=4.854-.437*sq + psdfh4=sq**alfpi/log(1./x)**aapi*(1.-x)**dpi* + * (1.+api*sqrt(x)+bpi*x)* + * exp(-epi+sqrt(eppi*sq**betpi*log(1./x))) + elseif(iabs(iq).lt.3)then + alfpi=1.147 + betpi=1.241 + aapi=.309-.134*sqrt(sq) + api=.219-.054*sq + bbpi=.893-.264*sqrt(sq) + bpi=-.593+.24*sq + cpi=1.1-.452*sq + dpi=3.526+.491*sq + epi=4.521+1.583*sq + eppi=3.102 + psdfh4=(1.-x)**dpi*(x**aapi*(api+bpi*sqrt(x)+cpi*x)* + * log(1./x)**bbpi+sq**alfpi* + * exp(-epi+sqrt(eppi*sq**betpi*log(1./x)))) + else + psdfh4=0. + endif + elseif(icq.eq.0)then + if(qqs.le.0.204**2)return + sq=log(log(qqs/.204**2)/log(.26/.204**2)) + if(sq.le.0.)return + if(iq.eq.0)then + alfpi=.504 + betpi=.226 + aapi=2.251-1.339*sqrt(sq) + api=2.668-1.265*sq+.156*sq**2 + bbpi=0. + bpi=-1.839+.386*sq + cpi=-1.014+.92*sq-.101*sq**2 + dpi=-.077+1.466*sq + epi=1.245+1.833*sq + eppi=.51+3.844*sq + psdfh4=(1.-x)**dpi*(x**aapi*(api+bpi*sqrt(x)+cpi*x)* + * log(1./x)**bbpi+sq**alfpi* + * exp(-epi+sqrt(eppi*sq**betpi*log(1./x)))) + * *.543 + else + alfpi=.823 + betpi=.65 + aapi=1.036-.709*sq + api=-1.245+.713*sq + bpi=5.58-1.281*sq + dpi=2.746-.191*sq + epi=5.101+1.294*sq + eppi=4.854-.437*sq + str=sq**alfpi/log(1./x)**aapi*(1.-x)**dpi* + * (1.+api*sqrt(x)+bpi*x)* + * exp(-epi+sqrt(eppi*sq**betpi*log(1./x))) + if(iq.eq.3)then + psdfh4=str*.543*2. + else + aapi=.517-.02*sq + api=-.037-.578*sq + bpi=.241+.251*sq + dpi=.383+.624*sq + anorm=1.212+.498*sq+.009*sq**2 + val=.5*anorm*x**aapi*(1.-x)**dpi* + * (1.+api*sqrt(x)+bpi*x) + + alfpi=1.147 + betpi=1.241 + aapi=.309-.134*sqrt(sq) + api=.219-.054*sq + bbpi=.893-.264*sqrt(sq) + bpi=-.593+.24*sq + cpi=1.1-.452*sq + dpi=3.526+.491*sq + epi=4.521+1.583*sq + eppi=3.102 + sea=(1.-x)**dpi*(x**aapi*(api+bpi*sqrt(x)+cpi*x)* + * log(1./x)**bbpi+sq**alfpi* + * exp(-epi+sqrt(eppi*sq**betpi*log(1./x)))) + if(iq.eq.1)then + psdfh4=(.836*(val+2.*sea)-.587*str) + elseif(iq.eq.2)then + psdfh4=(.25*(val+2.*sea)+.587*str) + else + psdfh4=0. + endif + endif + endif + psdfh4=psdfh4/(1.+qq/.59)**2 + + elseif(icq.eq.4)then + if(qqs.le.qcmass**2)return + sq=log(log(qqs/qcmass**2)/log(.23/qcmass**2)) + if(sq.le.0.)return + if(iq.eq.2)then + psdfh4=x**3*(1.-x)**alvc*(alvc+3.)*(alvc+2.)*(alvc+1.) + else + aapi=.517-.02*sq + api=-.037-.578*sq + bpi=.241+.251*sq + dpi=.383+.624*sq + anorm=1.212+.498*sq+.009*sq**2 + psdfh4=.5*anorm*x**aapi*(1.-x)**dpi* + * (1.+api*sqrt(x)+bpi*x) + endif + else + psdfh4=0. + endif + return + end + + +c------------------------------------------------------------------------ + function psfap(x,j,l) +c----------------------------------------------------------------------- +c psfap - altarelli-parisi function (multiplied by x) +c x - light cone momentum share value, +c j - type of the parent parton (0-g;1,2,etc.-q) +c l - type of the daughter parton (0-g;1,2,etc.-q) +c----------------------------------------------------------------------- + double precision x + include 'epos.incsem' + + if(j.eq.0)then + if(l.eq.0)then + psfap=((1.d0-x)/x+x/(1.d0-x)+x*(1.d0-x))*6.d0 + else + psfap=(x**2+(1.d0-x)**2)*naflav + endif + else + if(l.eq.0)then + psfap=(1.d0+(1.d0-x)**2)/x/.75d0 + else + psfap=(x**2+1.d0)/(1.d0-x)/.75d0 + endif + endif + return + end + +cc------------------------------------------------------------------------ +c function psgen(a1,a2) +cc----------------------------------------------------------------------- +cc psgen - x-values generation according to distribution +cc x1^(-a1) x2^(-0.5) +cc----------------------------------------------------------------------- +c common/lept1/engy,elepti,elepto,angmue,icinpu +c +c aa=max(a1,a2) +c1 continue +c if(aa.lt.1.)then +c x1=.5*rangen()**(1./(1.-aa)) +c elseif(aa.eq.1.)then +c x1=.5/engy**rangen() +c else +c x1=.5*(1.+rangen()*(engy**(aa-1.)-1.))**(1./(1.-aa)) +c endif +c if(x1.lt.1.e-7.or.x1.gt..999999)then +c goto 1 +c endif +c if(rangen().lt..5)then +c gb=x1**(aa-a1)*.5**aa/(1.-x1)**a2 +c else +c x1=1.-x1 +c gb=(1.-x1)**(aa-a2)*.5**aa/x1**a1 +c endif +c if(rangen().gt.gb)goto 1 +c psgen=x1 +c return +c end +c +c------------------------------------------------------------------------ + function psidd(icc) +c----------------------------------------------------------------------- +c psidd - kink type decoder +c----------------------------------------------------------------------- + if(icc.eq.0)then !g + psidd=9 + elseif(iabs(icc).le.2)then !u,u~,d,d~ + psidd=icc + elseif(iabs(icc).eq.4)then !s,s~ + psidd=icc/4*3 + elseif(iabs(icc).gt.10)then !c,c~ etc. + psidd=icc/10 + elseif(icc.eq.3)then !ud + psidd=1200 + elseif(icc.eq.-3)then !u~d~ + psidd=-1200 + elseif(icc.eq.6)then !uu + psidd=1100 + elseif(icc.eq.-6)then !u~u~ + psidd=-1100 + elseif(icc.eq.7)then !dd + psidd=2200 + elseif(icc.eq.-7)then !d~d~ + psidd=-2200 + else + psidd=0. + write (*,*)'psidd?????????',icc + endif + return + end + +cc------------------------------------------------------------------------ +c function pslam(s,a,b) +cc----------------------------------------------------------------------- +cc kinematical function for two particle decay - maximal pt-value +cc a - first particle mass squared, +cc b - second particle mass squared, +cc s - two particle invariant mass squared +cc----------------------------------------------------------------------- +c pslam=.25/s*(s+a-b)**2-a +c return +c end +c +c------------------------------------------------------------------------ + function psjvrg1(qt,s,y0) +c----------------------------------------------------------------------- + common /ar3/ x1(7),a1(7) + common /cnsta/ pi,pii,hquer,prom,piom,ainfin + include 'epos.incsem' + double precision xt,ymin,ymax,y,xmin,xmax,xx1,xx2 + + psjvrg1=0. + if(s.le.4.*qt)return + + xt=2.d0*sqrt(dble(qt)/dble(s)) + ymax=min(dble(y0),log(1d0/xt+sqrt((1d0/xt-1d0)*(1d0/xt+1d0)))) + ymin=-ymax + + do i=1,7 + do m=1,2 + y=.5d0*(ymax+ymin+(ymin-ymax)*dble((2*m-3)*x1(i))) + xmin=xt**2/2.d0/(2.d0-xt*exp(-y)) + xmax=1.d0-xt*exp(y)/2.d0 + + fx=0. + do i1=1,7 + do m1=1,2 + xx1=xt*exp(y)/2d0+xmin*(xmax/xmin)**dble(.5+x1(i1)*(m1-1.5)) + xx2=xt*exp(-y)*xx1/(2.d0*xx1-xt*exp(y)) + z=sngl(xx1*xx2) + sh=z*s + t=sngl(dble(sh)/2d0*(1d0 + & -sqrt(max(0d0,1d0-4d0*dble(qt)/dble(sh))))) + ft=psjvrx(t,qt,sngl(xx1),sngl(xx2),sh) + fx=fx+a1(i1)*ft/sh**2 + enddo + enddo + fx=fx*sngl(log(xmax/xmin)) + psjvrg1=psjvrg1+a1(i)*fx + enddo + enddo + psjvrg1=psjvrg1*sngl(ymax-ymin)*pi**3 + **pssalf(qt/qcdlam)**2*sqrt(qt) + return + end + +c----------------------------------------------------------------------- + function psjvrx(t,qt,xx1,xx2,s) +c----------------------------------------------------------------------- + include 'epos.incsem' + + g1=psdfh4(xx1,qt,0.,2,0) + ub1=psdfh4(xx1,qt,0.,2,-1) + u1=psdfh4(xx1,qt,0.,2,1)+ub1 + db1=psdfh4(xx1,qt,0.,2,-2) + d1=psdfh4(xx1,qt,0.,2,2)+db1 + sb1=psdfh4(xx1,qt,0.,2,-3) + s1=sb1 + g2=psdfh4(xx2,qt,0.,2,0) + ub2=psdfh4(xx2,qt,0.,2,-1) + u2=psdfh4(xx2,qt,0.,2,1)+ub2 + db2=psdfh4(xx2,qt,0.,2,-2) + d2=psdfh4(xx2,qt,0.,2,2)+db2 + sb2=psdfh4(xx2,qt,0.,2,-3) + s2=sb2 + + psjvrx=g1*g2*(psbori(s,t,0,0,1)+psbori(s,s-t,0,0,1) + *+psbori(s,t,0,0,2)+psbori(s,s-t,0,0,2))/2. + *+(psbori(s,t,0,1,1)+psbori(s,s-t,0,1,1))* + *(g2*(u1+ub1+d1+db1+s1+sb1)+g1*(u2+ub2+d2+db2+s2+sb2)) + *+(psbori(s,t,1,1,1)+psbori(s,s-t,1,1,1))/2.* + *(u1*u2+ub1*ub2+d1*d2+db1*db2+s1*s2+sb1*sb2) + *+(psbori(s,t,1,-1,1)+psbori(s,s-t,1,-1,1)+psbori(s,t,1,-1,2)+ + *psbori(s,s-t,1,-1,2)+psbori(s,t,1,-1,3)+psbori(s,s-t,1,-1,3))* + *(u1*ub2+ub1*u2+d1*db2+db1*d2+s1*sb2+sb1*s2) + *+(psbori(s,t,1,2,1)+psbori(s,s-t,1,2,1))* + *((u1+ub1)*(d2+db2+s2+sb2)+(u2+ub2)*(d1+db1+s1+sb1)+ + *(d1+db1)*(u2+ub2+s2+sb2)+(d2+db2)*(u1+ub1+s1+sb1)+ + *(s1+sb1)*(u2+ub2+d2+db2)+(s2+sb2)*(u1+ub1+d1+db1)) + return + end + +c------------------------------------------------------------------------ + function psjwo1(qt,s,y0) +c----------------------------------------------------------------------- + common /ar3/ x1(7),a1(7) + common /cnsta/ pi,pii,hquer,prom,piom,ainfin + double precision xt,ymax,ymin,y,xmin,xmax,xx1,xx2 + include 'epos.incsem' + + psjwo1=0. + if(s.le.4.*qt)return + + xt=2.d0*sqrt(dble(qt)/dble(s)) + ymax=min(dble(y0),log(1d0/xt+sqrt((1d0/xt-1d0)*(1d0/xt+1d0)))) + ymin=-ymax + + do i=1,7 + do m=1,2 + y=.5d0*(ymax+ymin+(ymin-ymax)*dble(2*m-3)*dble(x1(i))) + xmin=xt**2/2.d0/(2.d0-xt*exp(-y)) + xmax=1.d0-xt*exp(y)/2.d0 + + fx=0. + do i1=1,7 + do m1=1,2 + xx1=xt*exp(y)/2.d0+xmin*(xmax/xmin)**dble(.5+x1(i1)*(m1-1.5)) + xx2=xt*exp(-y)/(2.d0-xt*exp(y)/xx1) + z=sngl(xx1*xx2) + sh=z*s + t=sngl(dble(sh)/2d0*(1d0-sqrt(1d0-4d0*dble(qt)/dble(sh)))) + ft=psjwox(t,qt,sngl(xx1),sngl(xx2),sh) + fx=fx+a1(i1)*ft/sh**2 + enddo + enddo + fx=fx*log(xmax/xmin) + psjwo1=psjwo1+a1(i)*fx + enddo + enddo + psjwo1=psjwo1*sngl(ymax-ymin)*pi**3 + **pssalf(qt/qcdlam)**2*sqrt(qt) + return + end + +c----------------------------------------------------------------------- + function psjwox(t,qt,xx1,xx2,s) +c----------------------------------------------------------------------- + double precision x,scale,upv1,dnv1,sea1,str1,chm1,gl1, + *upv2,dnv2,sea2,str2,chm2,gl2 + scale=sqrt(qt) + x=xx1 + call strdo1(x,scale,upv1,dnv1,sea1,str1,chm1,gl1) + x=xx2 + call strdo1(x,scale,upv2,dnv2,sea2,str2,chm2,gl2) + + psjwox=gl1*gl2*(psbori(s,t,0,0,1)+psbori(s,s-t,0,0,1) + *+psbori(s,t,0,0,2)+psbori(s,s-t,0,0,2)+psbori(s,t,0,0,3) + *+psbori(s,s-t,0,0,3))/2. + *+(psbori(s,t,0,1,1)+psbori(s,s-t,0,1,1) + *+psbori(s,t,0,1,2)+psbori(s,s-t,0,1,2)+psbori(s,t,0,1,3) + *+psbori(s,s-t,0,1,3))*(gl2*(upv1+dnv1+4.*sea1+2.*str1+2.*chm1)+ + *gl1*(upv2+dnv2+4.*sea2+2.*str2+2.*chm2)) + *+(psbori(s,t,1,1,1)+psbori(s,s-t,1,1,1) + *+psbori(s,t,1,1,2)+psbori(s,s-t,1,1,2)+psbori(s,t,1,1,3)+ + *psbori(s,s-t,1,1,3))/2.* + *((upv1+sea1)*(upv2+sea2)+(dnv1+sea1)*(dnv2+sea2)+2.*sea1*sea2 + *+2.*str1*str2+2.*chm1*chm2) + *+(psbori(s,t,1,-1,1)+psbori(s,s-t,1,-1,1)+psbori(s,t,1,-1,2)+ + *psbori(s,s-t,1,-1,2)+psbori(s,t,1,-1,3)+psbori(s,s-t,1,-1,3))* + *((upv1+sea1)*sea2+sea1*(upv2+sea2)+(dnv1+sea1)*sea2+ + *sea1*(dnv2+sea2)+2.*str1*str2+2.*chm1*chm2) + *+(psbori(s,t,1,2,1) + *+psbori(s,s-t,1,2,1)+psbori(s,t,1,2,2)+psbori(s,s-t,1,2,2) + *+psbori(s,t,1,2,3)+psbori(s,s-t,1,2,3))* + *(upv1*dnv2+upv2*dnv1+(upv1+dnv1)*(2.*sea2+2.*str2+2.*chm2)+ + *(upv2+dnv2)*(2.*sea1+2.*str1+2.*chm1)+ + *4.*sea1*(2.*sea2+2.*str2+2.*chm2)+2.*str1*(4.*sea2+2.*chm2)+ + *2.*chm1*(4.*sea2+2.*str2)) + return + end + +c------------------------------------------------------------------------ + subroutine pslcsh(wp1,wm1,wp2,wm2,samqt,amqpt) +c----------------------------------------------------------------------- +c pslcsh - sh pomeron lc momentum sharing between two strings +c------------------------------------------------------------------------ + double precision amqt(4),yqm(4),yqm1(4),xlp(4),xlm(4),am23,sx,y2 + *,wp1,wp2,wm1,wm2,s,sq,psutz,yqmax,y,amjp,amjm,y1,s12,s34,x34,amqpt + dimension samqt(4) + include 'epos.inc' + + s=wp1*wm1 + sq=dsqrt(s) + do i=1,4 + amqt(i)=dble(samqt(i)) + yqm(i)=dlog(sq/amqt(i)*psutz(s,amqt(i)**2,(amqpt-amqt(i))**2)) + enddo + yqmax=max(yqm(1),yqm(2)) + +1 y=yqmax*dble(rangen()) + j=int(1.5+rangen()) + if(y.gt.yqm(j))goto 1 + + amjp=amqt(j)*dexp(y) + amjm=amqt(j)*dexp(-y) + do i=3,4 + am23=amqt(3-j)+amqt(7-i) + sx=(am23+amjp)*(am23+amjm) + yqm1(i)=dlog(sq/amqt(i)*psutz(s,amqt(i)**2,sx)) + enddo + yqmax1=max(yqm1(3),yqm1(4)) + if(dble(rangen()).gt.yqmax1/max(yqm(3),yqm(4)))goto 1 + + y1=yqmax1*dble(rangen()) + j1=int(3.5+rangen()) + if(y1.gt.yqm1(j1))goto 1 + + amjp1=amqt(j1)*exp(y1) + amjm1=amqt(j1)*exp(-y1) + s12=(amqt(3-j)+amjp)*(amqt(3-j)+amjm) + s34=(amqt(7-j1)+amjp1)*(amqt(7-j1)+amjm1) + y2=dlog(sq/(amqt(3-j)+amjp)*psutz(s,s12,s34)) + + xlp(j)=amqt(j)/sq*dexp(y+y2) + xlm(j)=amqt(j)/sq*dexp(-y-y2) + xlp(3-j)=amqt(3-j)/sq*dexp(y2) + xlm(3-j)=amqt(3-j)/sq*dexp(-y2) + x34=1.-xlm(1)-xlm(2) + xlm(7-j1)=x34/(1.+amjp1/amqt(7-j1)) + xlm(j1)=x34-xlm(7-j1) +c write (*,*)'xlc',xlp(1),xlp(2),xlm(3),xlm(4) + if(dble(rangen()).gt.(xlp(1)*xlp(2)*xlm(3)*xlm(4))**(-alpqua)* + *(xlp(j)*(1.d0-xlp(j))*xlm(j1)*(1.d0-xlm(j1))))goto 1 + + wp2=xlp(2)*wp1 + wp1=xlp(1)*wp1 + wm2=xlm(4)*wm1 + wm1=xlm(3)*wm1 +c write (*,*)'wp1,wm1,wp2,wm2',wp1,wm1,wp2,wm2 + return + end + +c------------------------------------------------------------------------ + function psnorm(ep) +c----------------------------------------------------------------------- +c 4-vector squared calculation +c----------------------------------------------------------------------- + double precision sm2,ep(4) + sm2=ep(1)**2 + do i=1,3 + sm2=sm2-ep(i+1)**2 + enddo + psnorm=sm2 + return + end + +c------------------------------------------------------------------------ + subroutine psrotat(ep,s0x,c0x,s0,c0) +c----------------------------------------------------------------------- +c psrotat - spacial rotation to the lab. system for 4-vector ep +c s0, c0 - sin and cos for the zx-rotation; +c s0x, c0x - sin and cos for the xy-rotation +c----------------------------------------------------------------------- + dimension ep(4),ep1(3) + + ep1(3)=ep(4) + ep1(2)=ep(2)*s0+ep(3)*c0 + ep1(1)=ep(2)*c0-ep(3)*s0 + + ep(2)=ep1(1) + ep(4)=ep1(2)*s0x+ep1(3)*c0x + ep(3)=ep1(2)*c0x-ep1(3)*s0x + return + end + +cc------------------------------------------------------------------------ +c subroutine psrotat1(ep,s0x,c0x,s0,c0) +cc----------------------------------------------------------------------- +cc psrotat - spacial rotation to the lab. system for 4-vector ep +cc s0, c0 - sin and cos for the zx-rotation; +cc s0x, c0x - sin and cos for the xy-rotation +cc----------------------------------------------------------------------- +c dimension ep(4),ep1(3) +c +c ep1(1)=ep(2) +c ep1(3)=-ep(3)*s0x+ep(4)*c0x +c ep1(2)=ep(3)*c0x+ep(4)*s0x +c +c ep(4)=ep1(3) +c ep(3)=-ep1(1)*s0+ep1(2)*c0 +c ep(2)=ep1(1)*c0+ep1(2)*s0 +c return +c end +c +c----------------------------------------------------------------------- + function pssalf(qq) +c----------------------------------------------------------------------- +c pssalf - effective qcd coupling (alpha_s/2/pi) +c----------------------------------------------------------------------- + include "epos.incsem" + pssalf=2./(11.-naflav/1.5)/log(qq) + return + end + +c------------------------------------------------------------------------ + subroutine pstrans(ep,ey,jj) +c----------------------------------------------------------------------- +c pstrans - lorentz boosts according to the parameters ey ( determining +c shift along the z,x,y-axis respectively (ey(1),ey(2),ey(3))) +c jj=1 - inverse transformation to the lab. system; +c jj=-1 - direct transformation +c----------------------------------------------------------------------- + dimension ey(3),ep(4) + + if(jj.eq.1)then +c lorentz transform to lab. system according to 1/ey(i) parameters + do i=1,3 + if(ey(4-i).ne.1.)then + wp=(ep(1)+ep(5-i))/ey(4-i) + wm=(ep(1)-ep(5-i))*ey(4-i) + ep(1)=.5*(wp+wm) + ep(5-i)=.5*(wp-wm) + endif + enddo + else +c lorentz transform to lab. system according to ey(i) parameters + do i=1,3 + if(ey(i).ne.1.)then + wp=(ep(1)+ep(i+1))*ey(i) + wm=(ep(1)-ep(i+1))/ey(i) + ep(1)=.5*(wp+wm) + ep(i+1)=.5*(wp-wm) + endif + enddo + endif + return + end + +c------------------------------------------------------------------------ + double precision function psuds(q,m) +c----------------------------------------------------------------------- +c psuds - spacelike sudakov formfactor +c q - maximal value of the effective momentum, +c m - type of parton (0 - g, 1,2, etc. - q) +c----------------------------------------------------------------------- + dimension wi(3) + common /psar15/ sudx(40,2) + include 'epos.incsem' + double precision dps,qlm,ffacs,qlm0,qlmi + + j=min(iabs(m),1)+1 + + if(q.gt.q2ini)then + qli=log(q/q2min)*2.+1. + i=int(qli) + if(i.lt.1)i=1 + if(i.gt.38)i=38 + wi(2)=qli-i + wi(3)=wi(2)*(wi(2)-1.)*.5 + wi(1)=1.-wi(2)+wi(3) + wi(2)=wi(2)-2.*wi(3) + dps=0.d0 + do i1=1,3 + dps=dps+dble(sudx(i+i1-1,j)*wi(i1)) + enddo + + qlm0=dble(log(q2ini/qcdlam)) + qlm=dble(log(q/qcdlam)) + qlmi=qlm-qlm0 !=log(q/q2ini) + psuds=(qlm*log(qlm/qlm0)-qlmi) + + ffacs=(11.d0-dble(naflav)/1.5d0)/12.d0 + if(j.eq.1)then + psuds=(psuds-ffacs*log(qlm/qlm0) + * +dps*(1.d0-dble(q2ini/q)))/ffacs + else + psuds=(psuds-log(qlm/qlm0)*.75d0 + * +dps*(1.d0-dble(q2ini/q)))*4.d0/9.d0/ffacs + endif + psuds=exp(-psuds) + else + psuds=1.d0 + endif + return + end + +c------------------------------------------------------------------------ + function psudx(q,j) +c----------------------------------------------------------------------- +c psudx - part of the bspacelike sudakov formfactor +c q - maximal value of the effective momentum, +c j - type of parton (1 - g, 2 - q) +c----------------------------------------------------------------------- + common /ar3/ x1(7),a1(7) + include 'epos.incsem' + + psudx=0. + + do i=1,7 + do m=1,2 + qt=.5*(q2ini+q-x1(i)*(2.*m-3.)*(q2ini-q)) + if(j.eq.1)then + zm=1.-qt/q + dps=((11.-naflav/1.5)/12.-zm**2*(1.-naflav/12.)+ + * (zm**3/3.-zm**4/4.)*(1.-naflav/3.))*q/qt + else + dps=(1.-qt/q/4.) + endif + psudx=psudx+a1(i)*dps/log(qt/qcdlam) + enddo + enddo + psudx=psudx*.5 + return + end + +c------------------------------------------------------------------------ + double precision function psutz(s,a,b) +c----------------------------------------------------------------------- +c psutz - kinematical function for two particle decay - light cone momen +c share for the particle of mass squared a, +c b - partner's mass squared, +c s - two particle invariant mass +c----------------------------------------------------------------------- + double precision a1,b1,s1,x,dx,s,a,b + a1=dsqrt(a) + b1=dsqrt(b) + s1=dsqrt(s) + x=(1.d0+(a1-b1)*(a1+b1)/s)/2.d0 + dx=(x-a1/s1)*(x+a1/s1) +c x=.5*(1.+(a-b)/s) +c dx=(x*x-a/s) + if(dx.gt.0.d0)then + x=x+dsqrt(dx) + else + x=a1/s1 + endif + psutz=min(0.999999999d0,x) + return + end + +c------------------------------------------------------------------------ + block data ptdata +c----------------------------------------------------------------------- +c constants for numerical integration (gaussian weights) +c----------------------------------------------------------------------- + common /ar3/ x1(7),a1(7) + common /ar4/ x4(2),a4(2) + common /ar5/ x5(2),a5(2) + common /ar8/ x2(4),a2 + common /ar9/ x9(3),a9(3) + + data x1/.9862838,.9284349,.8272013,.6872929,.5152486, + *.3191124,.1080549/ + data a1/.03511946,.08015809,.1215186,.1572032, + *.1855384,.2051985,.2152639/ + data x2/.00960736,.0842652,.222215,.402455/ + data a2/.392699/ + data x4/ 0.339981,0.861136/ + data a4/ 0.652145,0.347855/ + data x5/.585786,3.41421/ + data a5/.853553,.146447/ + data x9/.93247,.661209,.238619/ + data a9/.171324,.360762,.467914/ + end + +c------------------------------------------------------------------------ + subroutine strdo1(x,scale,upv,dnv,sea,str,chm,gl) +c------------------------------------------------------------------------ +c :::::::::::: duke owens set 1 :::::::::::::::::::::::::::: +c------------------------------------------------------------------------ + implicit double precision(a-h,o-z) + double precision + + f(5),a(6,5),b1(3,6,5) + data q0,ql1/2.d0,.2d0/ + data b1/3.d0,0.d0,0.d0,.419d0,.004383d0,-.007412d0, + &3.46d0,.72432d0,-.065998d0,4.4d0,-4.8644d0,1.3274d0, + &6*0.d0,1.d0, + &0.d0,0.d0,.763d0,-.23696d0,.025836d0,4.d0,.62664d0,-.019163d0, + &0.d0,-.42068d0,.032809d0,6*0.d0,1.265d0,-1.1323d0,.29268d0, + &0.d0,-.37162d0,-.028977d0,8.05d0,1.5877d0,-.15291d0, + &0.d0,6.3059d0,-.27342d0,0.d0,-10.543d0,-3.1674d0, + &0.d0,14.698d0,9.798d0,0.d0,.13479d0,-.074693d0, + &-.0355d0,-.22237d0,-.057685d0,6.3494d0,3.2649d0,-.90945d0, + &0.d0,-3.0331d0,1.5042d0,0.d0,17.431d0,-11.255d0, + &0.d0,-17.861d0,15.571d0,1.564d0,-1.7112d0,.63751d0, + &0.d0,-.94892d0,.32505d0,6.d0,1.4345d0,-1.0485d0, + &9.d0,-7.1858d0,.25494d0,0.d0,-16.457d0,10.947d0, + &0.d0,15.261d0,-10.085d0/ + wn=1.d0 + s= log( log( max(q0,scale)/ql1)/ log(q0/ql1)) + do 10 i=1,5 + do 10 j=1,6 + 10 a(j,i)=b1(1,j,i)+s*(b1(2,j,i)+s*b1(3,j,i)) + do 40 i=1,5 + 40 f(i)=a(1,i)*x**a(2,i)*(wn-x)**a(3,i)*(wn+x* + & (a(4,i)+x*(a(5,i)+x*a(6,i)))) + do 50 i=1,2 + aa=wn+a(2,i)+a(3,i) + 50 f(i)=f(i)*utgam2(aa)/((wn+a(2,i)*a(4,i)/aa) + &*utgam2(a(2,i))*utgam2(wn+a(3,i))) + upv=f(1)-f(2) + dnv=f(2) + sea=f(3)/6.d0 + str=sea + chm=f(4) + gl =f(5) + return + end + + + +c------------------------------------------------------------------------ + function fzeroGluZZ(z,k) ! former psftild +c----------------------------------------------------------------------- +c +c fzeroGluZZComplete = fzeroGluZZ * z^(-1-dels) * gamsoft * gamhad +c +c A = 8*pi*s0*gampar*gamtilde +c integration over semihard pomeron light cone momentum share xp==u +c +c fzeroGluZZ = (1-glusea) * engy^epszero +c * int(du) u^(epszero-alppar+dels) (1-u)^alplea * (1-z/u)**betpom +c +c z - light cone x of the gluon, +c k - hadron class +c----------------------------------------------------------------------- + double precision xpmin,xp + include 'epos.inc' + common /ar3/ x1(7),a1(7) + include 'epos.incsem' + + fzeroGluZZ=0. + xpmin=z + xpmin=xpmin**(1.-alppar+dels+epszero) + do i=1,7 + do m=1,2 + xp=(.5*(1.+xpmin+(2*m-3)*x1(i)*(1.-xpmin)))**(1./ + * (1.-alppar+dels+epszero)) + fzeroGluZZ=fzeroGluZZ+a1(i)*(1.-xp)**alplea(k)*(1.-z/xp)**betpom + enddo + enddo + fzeroGluZZ= + * fzeroGluZZ*.5*(1.-xpmin)/(1.-alppar+dels+epszero) + * *(1.-glusea) *engy**epszero + return + end + +c------------------------------------------------------------------------ + function fzeroSeaZZ(z,k) ! former psftile +c----------------------------------------------------------------------- +c +c fzeroSeaZZComplete = fzeroSeaZZ * z^(-1-dels) * gamsoft * gamhad +c +c gamsoft = 8*pi*s0*gampar*gamtilde +c integration over semihard pomeron light cone momentum share xp==u +c +c fzeroSeaZZ = glusea * engy^epszero +c * int(du) u^(epszero-alppar+dels) (1-u)^alplea * EsoftQZero(z/u) +c +c z - light cone x of the quark, +c k - hadron class +c----------------------------------------------------------------------- + double precision xpmin,xp + common /ar3/ x1(7),a1(7) + include 'epos.inc' + include 'epos.incsem' + + fzeroSeaZZ=0. + xpmin=z + xpmin=xpmin**(1.-alppar+dels+epszero) + do i=1,7 + do m=1,2 + xp=(.5*(1.+xpmin+(2*m-3)*x1(i)*(1.-xpmin)))**(1./ + * (1.-alppar+dels+epszero)) + zz=z/xp + fzeroSeaZZ=fzeroSeaZZ+a1(i)*(1.-xp)**alplea(k)*EsoftQZero(zz) + enddo + enddo + fzeroSeaZZ=fzeroSeaZZ*.5*(1.-xpmin)/(1.-alppar+dels+epszero) + * *glusea *engy**epszero + return + end + + +c######################################################################## +c######################################################################## + subroutine psaini +c######################################################################## +c######################################################################## + +c----------------------------------------------------------------------- +c common initialization procedure +c if isetcs = 0, alpD, betD, etc ... in inirj are not used and xkappa=1 +c if isetcs = 1, alpD, betD, etc ... in inirj are not used but xkappa.ne.1 +c if isetcs = 2, alpD, betD, xkappa, etc ... in inirj are used and +c cross section from calculation in inics are read. +c if epos.inics doesn't exist, it produces only the calculated part of it. +c if isetcs = 3, alpD, betD, xkappa, etc ... in inirj are used and +c cross section from simulation in inics are read. +c if epos.inics doesn't exist, it produces the calculated AND the +c simulated part of it both for ionudi=1 and 3. Only the values for +c ionudi=1 (elastic for diffraction counted in xs) are always correct. +c AA xs with ionudi=3 do not always correspond to MC simulations. +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incpar' + include 'epos.incsem' + include 'epos.incems' + logical lcalc!,lcalc2 +c double precision om5p,xh,yh,v3pom(4),om2p + dimension gamhad0(nclha),r2had0(nclha),chad0(nclha) + *,alplea0(nclha),asect11(7,4,8),asect13(7,4,8),asect21(7,4,8) + *,asect23(7,4,8),asect31(7,8,8),asect33(7,8,8) + *,asect41(7,8,8),asect43(7,8,8)!,cgam(idxD) + common /psar2/ edmax,epmax + common /psar4/ fhgg(11,10,8),fhqg(11,10,80) + *,fhgq(11,10,80),fhqq(11,10,80),fhgg0(11,10),fhgg1(11,10,4) + *,fhqg1(11,10,40),fhgg01(11),fhgg02(11),fhgg11(11,4) + *,fhgg12(11,4),fhqg11(11,10,4),fhqg12(11,10,4) + *,ftoint(11,14,2,2,3) + common /psar7/ delx,alam3p,gam3p + common /psar9/ alpr + common /psar15/ sudx(40,2) + common /psar19/ cstot(20,20,240) + common /psar20/ csord(20,20,240) + common /psar21/ csbor(20,160,2) + common /psar22/ cstotzero(20,4,2),csborzer(20,4,2) + common /psar23/ cschar(20,20,2) + common /psar25/ csdsi(21,21,104) + common /psar27/ csds(21,26,4),csdt(21,26,2),csdr(21,26,2) + common /psar33/ asect(7,4,8),asectn(7,8,8) + common /psar34/ rrr,rrrm + common /psar35/ anorm,anormp + common /psar41/ rrrp,rrrmp + common /psar36/ alvc + common /psar37/ coefom1,coefom2 + common /psar38/ vfro(11,14,3,2) + common /psar39/ vnorm(11,14,3,2,2) +c$$$ common /psar40/ coefxu1(idxD,nclha,10) +c$$$ *,coefxu2(idxD,idxD,nclha,10),coefxc2(idxD,idxD,nclha,10) + common/producetab/ producetables !used to link with CRMC + logical producetables + common /ar3/ x1(7),a1(7) + common /testj/ ajeth(4),ajete(5),ajet0(7) + parameter(nbkbin=40) + common /kfitd/ xkappafit(nclegy,nclha,nclha,nbkbin),xkappa,bkbin + common/geom/rmproj,rmtarg,bmax,bkmx + character textini*38 + external ptfau,ptfauAA + + + call utpri('psaini',ish,ishini,4) + +c for fragmentation +c ----------------- +c number of flavors in fragmentation not less than active flavor in hard string + nrflav=min(max(nrflav,naflav),nflavems) + pmqu2=pmqu**2 + difud=pmqd**2-pmqu2 + difus=pmqs**2-pmqu2 + difuuu=(pmqq+pmqu+pmqu)**2-pmqu2 + difuud=(pudd*pmqq+pmqd+pmqu)**2-pmqu2 + difuus=(puds*pmqq+pmqs+pmqu)**2-pmqu2 + difudd=(pudd*pudd*pmqq+pmqd+pmqd)**2-pmqu2 + difuds=(pudd*puds*pmqq+pmqs+pmqd)**2-pmqu2 + difuss=(puds*puds*pmqq+pmqs+pmqs)**2-pmqu2 + if(nrflav.gt.3)then + difuc=pmqc**2-pmqu2 + difuuc=(pudc*pmqq+pmqc+pmqu)**2-pmqu2 + difudc=(pudd*pudc*pmqq+pmqc+pmqd)**2-pmqu2 + difusc=(puds*pudc*pmqq+pmqc+pmqs)**2-pmqu2 + difucc=(pudc*pudc*pmqq+pmqc+pmqs)**2-pmqu2 + else + difuc=0. + difuuc=0. + difudc=0. + difusc=0. + difucc=0. + rstrac(1)=0. + rstrac(2)=0. + rstrac(3)=0. + rstrac(4)=0. + endif + + if(iappl.ne.6)then + + do i=1,4 + ajeth(i)=0. + enddo + do i=1,5 + ajete(i)=0. + ajet0(i)=0. + enddo + ajet0(6)=0. + ajet0(7)=0. + + + if(isetcs.le.1)then !for Kfit + bkbin=0.3 + else + bkbin=0.1 + endif + xkappa=1. + + edmax=edmaxi !1.e12 defined in epos-bas + epmax=epmaxi !1.e12 defined in epos-bas + +c fix enhanced diagrams at minimum energy = 2.5 + delx=1.5 !sqrt(egymin*egymin/exp(1.)) +c arbitrary value for alam3p (not good if too small (infinite loop in rsh)) + alam3p=0.5*(r2had(1)+r2had(2)+r2had(3)) !0.6 + gam3p=.1 + + + +c interface to 'bas' +c ---------------- + + dels=alppom-1. + alpqua=(alppar+1.)/2. + if(abs(alpqua).lt.1.e-6)call utstop('alpar should not be -1 !&') + alpr=-2.+alpqua !x-exponent for remnant mass + + +c omega coeffs +c ---------------- + coefom0=utgam1(1.+dels-alppar)*utgam1(1.+alplea(iclpro)) + */utgam1(2.+alplea(iclpro)+dels-alppar) + **utgam1(1.+dels-alppar)*utgam1(1.+alplea(icltar)) + */utgam1(2.+alplea(icltar)+dels-alppar) + coefom1=1.-utgam1(1.+dels-alppar)**2*utgam1(1.+alplea(iclpro)) + */utgam1(1.+alplea(iclpro)+2.*(1.+dels-alppar)) + **utgam1(1.+dels-alppar)**2*utgam1(1.+alplea(icltar)) + */utgam1(1.+alplea(icltar)+2.*(1.+dels-alppar))/coefom0**2 + coefom2=3.*coefom1-1. + *+utgam1(1.+dels-alppar)**3*utgam1(1.+alplea(iclpro)) + */utgam1(1.+alplea(iclpro)+3.*(1.+dels-alppar)) + **utgam1(1.+dels-alppar)**3*utgam1(1.+alplea(icltar)) + */utgam1(1.+alplea(icltar)+3.*(1.+dels-alppar))/coefom0**3 + if(ish.ge.4)write(ifch,*)'coefom',coefom0,coefom1,coefom2,delx + +c soft pomeron: abbreviations +c--------------------------------------- + if(iappl.eq.1.or.iappl.eq.8.or.iappl.eq.9)then + + +c--------------------------------------- +c auxiliary constants: +c--------------------------------------- + stmass=.05 !string mass cutoff + +c--------------------------------------- +c parton density normalization + sq=log(log(q2min/.232**2)/log(.23/.232**2)) + du=2.997+.753*sq-.076*sq*sq + qnorm=0. + do i=1,7 + do m=1,2 + xx=.5+x1(i)*(m-1.5) + xxq=1.-xx**(1./(1.+du)) + qnorm=qnorm+a1(i)*(psdfh4(xxq,q2min,0.,2,1)+ + * psdfh4(xxq,q2min,0.,2,2))/(1.-xxq)**du + enddo + enddo + qnorm=qnorm*.5/(1.+du) + qnormp=qnorm +ckkkkk----------------------------- +c ffrr=(1.-qnorm)/4./pi/gamhad(2) +c * *utgam1(2.+betpom-dels)/utgam1(1.-dels) +c * /utgam1(1.+betpom)/utgam1(1.+alplea(2))/ +c * utgam1(2.-alppar)*utgam1(3.+alplea(2)-alppar) +c ffrr=(1.-qnorm)/4./pi/gamhad(2) +c * *utgam1(2.+betpom-dels)/utgam1(1.-dels) +c * /utgam1(1.+betpom) +c write(6,*)'===========',ffrr + ffrr=gamtil + * /utgam1(1.+alplea(2))/ + * utgam1(2.-alppar)*utgam1(3.+alplea(2)-alppar) + gamsoft=ffrr*4.*pi +ckkkkkkk------------------------------- + if(ish.ge.4)write (ifch,*)'rr,qnorm',ffrr,qnorm + + + sq=log(log(q2min/.232**2)/log(.25/.232**2)) + dpi=.367+.563*sq + qnorm=0. + do i=1,7 + do m=1,2 + xx=.5+x1(i)*(m-1.5) + xxq=1.-xx**(1./(1.+dpi)) + qnorm=qnorm+a1(i)*(psdfh4(xxq,q2min,0.,1,1)+ + * psdfh4(xxq,q2min,0.,1,2))/(1.-xxq)**dpi + enddo + enddo + qnorm=qnorm*.5/(1.+dpi) + cftmp=1./(1.-qnormp)*(1.-qnorm) + * *utgam1(alplea(2)+1.)/utgam1(alplea(2)+3.-alppar) + * /utgam1(alplea(1)+1.)*utgam1(alplea(1)+3.-alppar) + gamhad(1)=gamhad(2)*cftmp + if(gamhadsi(1).lt.0.)then + gamhads(1)=gamhad(1) + else + gamhads(1)=gamhad(1)*gamhadsi(1) + endif + gamhad(1)=gamhads(1) + if(ish.ge.4) + * write (ifch,*)'gamhad(1),gamhads(1)',gamhad(1),gamhads(1) + + if(gamhadsi(2).lt.0.)then + gamhads(2)=gamhad(2) + else + gamhads(2)=gamhad(2)*gamhadsi(2) + endif + gamhad(2)=gamhads(2) + if(ish.ge.4) + * write (ifch,*)'gamhad(2),gamhads(2)',gamhad(2),gamhads(2) + + qnorm=0. + do i=1,7 + do m=1,2 + xx=.5+x1(i)*(m-1.5) + xxq=1.-xx**(1./(1.+dpi)) + qnorm=qnorm+a1(i)*(psdfh4(xxq,q2min,0.,1,1)+ + * psdfh4(xxq,q2min,0.,1,2))/(1.-xxq)**dpi + enddo + enddo + qnorm=qnorm*.5/(1.+dpi) + cftmp=1./(1.-qnormp)*(1.-qnorm) + * *utgam1(alplea(2)+1.)/utgam1(alplea(2)+3.-alppar) + * /utgam1(alplea(3)+1.)*utgam1(alplea(3)+3.-alppar) + gamhad(3)=gamhad(2)*cftmp + if(gamhadsi(3).lt.0.)then + gamhads(3)=gamhad(3) + else + gamhads(3)=gamhad(3)*gamhadsi(3) + endif + gamhad(3)=gamhads(3) + if(ish.ge.4) + * write (ifch,*)'gamhad(3),gamhads(3)',gamhad(3),gamhads(3) + + quamas=.35 + gamhad(4)=gamhad(1)*(quamas/qcmass)**2 + if(gamhadsi(4).lt.0.)then + gamhads(4)=gamhad(4) + else + gamhads(4)=gamhad(4)*gamhadsi(4) + endif + gamhad(4)=gamhads(4) + if(ish.ge.4) + * write (ifch,*)'gamhad(4),gamhads(4)',gamhad(4),gamhads(4) + gnorm=0. + do i=1,7 + do m=1,2 + xx=.5+x1(i)*(m-1.5) + xxg=xx**(1./(1.-dels)) + gnorm=gnorm+a1(i)*(fzeroGluZZ(xxg,4)+fzeroSeaZZ(xxg,4)) + enddo + enddo + gnorm=gnorm/(1.-dels)*2.*pi*gamhad(4)*ffrr + alvc=6./(1.-gnorm)-4. + if(ish.ge.4) write (ifch,*)'rr,qnorm,gnorm,alvc', + * ffrr,qnorm,gnorm,alvc + +c write (*,*)'rr-c,qnorm,gnorm,alvc',ffrr,qnorm,gnorm,alvc + endif + +c----------------------------------------------- +c tabulation of inclusive jet cross sections +c-------------------------------------------------- + + do i=1,40 + qi=q2min*exp(.5*(i-1)) + sudx(i,1)=psudx(qi,1) + sudx(i,2)=psudx(qi,2) + enddo + if(ish.ge.4)write(ifch,*)'bare cross sections ...' + + call psaevc + +ccc call MakeCSTable + + inquire(file=fnii(1:nfnii),exist=lcalc) + if(lcalc)then + if(inicnt.eq.1)then + write(ifmt,'(3a)')'read from ',fnii(1:nfnii),' ...' + open(1,file=fnii(1:nfnii),status='old') + read (1,*)qcdlam0,q2min0,q2ini0,naflav0,epmax0,pt2cut0 + if(qcdlam0.ne.qcdlam)write(ifmt,'(a)')'initl: wrong qcdlam' + if(q2min0 .ne.q2min )write(ifmt,'(a)')'initl: wrong q2min' + if(q2ini0 .ne.q2ini )write(ifmt,'(a)')'initl: wrong q2ini' + if(naflav0.ne.naflav)write(ifmt,'(a)')'initl: wrong naflav' + if(epmax0 .ne.epmax )write(ifmt,'(a)')'initl: wrong epmax' + if(pt2cut0 .ne.pt2cut )write(ifmt,'(a)')'initl: wrong pt2cut' + if(qcdlam0.ne.qcdlam.or.q2min0 .ne.q2min .or.q2ini0 .ne.q2ini + * .or.naflav0.ne.naflav.or.epmax0 .ne.epmax.or. pt2cut.ne.pt2cut0) + * then + write(ifmt,'(//a//)')' initl has to be reinitialized!!!' + stop + endif + read (1,*)csbor,csord,cstot,cstotzero,csborzer + close(1) + endif + + goto 1 + + elseif(.not.producetables)then + write(ifmt,*) "Missing epos.initl file !" + write(ifmt,*) "Please correct the defined path ", + &"or force production ..." + stop + + endif + + write(ifmt,'(a)')'initl does not exist -> calculate tables ...' + + write (*,*)'Born xsection csbor' + spmin=4.*q2min + spminc=4.*q2min+qcmass**2 + do m=1,4 !parton type at upper end of the ladder (1...4 - g,u,d,c) + do k=1,20 + if(m.ne.4)then + sk=spmin*(epmax/2./spmin)**((k-1)/19.) + p1=sk + else + sk=spminc*(epmax/2./spminc)**((k-1)/19.) + p1=sk/(1.+qcmass**2/sk) + endif + qmax=p1/4. + do i=1,20 + qq=q2min*(qmax/q2min)**((i-1)/19.) + do l=1,2 !parton type at lower end of the ladder + k1=k+20*(m-1)+80*(l-1) + m1=m-1 + if(m.eq.3.and.l.eq.1)then !dd~ + l1=-m1 + else !du + l1=l-1 + endif !born cr.-sect. + csbor(i,k1,1)=log(max(1.e-30,psborn(qq,qq,qq,sk,m1,l1,0,0))) + if(m.ne.4)then + csbor(i,k1,2)=log(max(1.e-30,psborn(4.*qq,qq,qq,sk,m1,l1,1,0))) + endif + enddo + enddo + enddo + enddo + + write (*,*)'ordered jet xsection csord' + do m=1,4 !parton type at upper end of the ladder + do k=1,20 + write (*,*)' m=',m,'/4 k=',k,'/20' + if(m.ne.4)then + sk=spmin*(epmax/2./spmin)**((k-1)/19.) !c.m. energy squared for the hard + p1=sk + else + sk=spminc*(epmax/2./spminc)**((k-1)/19.) + p1=sk/(1.+qcmass**2/sk) + endif + qmax=p1/4. + tmax=p1/2. + do i=1,20 !cross-sections initialization + qi=q2min*(qmax/q2min)**((i-1)/19.) + do j=1,20 + qq=qi*(qmax/qi)**((j-1)/19.) + if(p1.gt.4.*qq)then + tmin=2.*qq/(1.+sqrt(1.-4.*qq/p1)) + else + tmin=2.*qq + endif + do l=1,2 !parton type at lower end of the ladder + m1=m-1 + if(m.eq.3.and.l.eq.1)then + l1=-m1 + else + l1=l-1 + endif + if(m.ne.4)then + k1=k+20*(m-1)+60*(l-1) + if(k.eq.1.or.i.eq.20.or.j.eq.20)then + csord(i,j,k1)=log(max(1.e-30,psborn(qi,qq,qq,sk,m1,l1,0,0))) + csord(i,j,k1+120)= + * log(max(1.e-30,psborn(4.*qq,qi,qq,sk,l1,m1,1,0))) + else + csord(i,j,k1)=log(psjet1(qi,qq,qq,sk,m1,l1,0) + * /(1./tmin-1./tmax)+psborn(qi,qq,qq,sk,m1,l1,0,0)) + csord(i,j,k1+120)=log(psjet1(qi,4.*qq,qq,sk,m1,l1,2) + * /(1./tmin-1./tmax)+psborn(4.*qq,qi,qq,sk,l1,m1,1,0)) + + endif + elseif(j.eq.1)then + if(k.eq.1.or.i.eq.20)then + cschar(i,k,l)=log(max(1.e-30,psborn(q2min,qi,qq,sk,m1,l1,0,0))) + else + cschar(i,k,l)=log(psjet1(qi,q2min,qq,sk,l1,m1,0) + * /(1./tmin-1./tmax)+psborn(q2min,qi,qq,sk,m1,l1,0,0)) + endif + endif + enddo + enddo + enddo + enddo + enddo + + write (ifmt,*)'tests:' + write (ifmt,'(a,a)')' n-1 sk qi qj qq ' + * ,' born born-i ord ord-i ' + do k=1,7 + sk=spmin*(epmax/2./spmin)**((k-1)/19.) + if(k.ge.5)sk=spmin*1.5**(k-4) + do n=1,2 + if(n.eq.1)then + qmax1=sk/4. + qmax2=sk/4. + else !if(n.eq.2)then + qmax1=sk/4. + qmax2=sk + endif + do i=1,3 + qi=q2min*(qmax1/q2min)**((i-1)/3.) + do j=1,3 + qj=q2min*(qmax2/q2min)**((j-1)/3.) + qqmax=sk/4. + if(n.eq.1)then + qqmin=max(qi,qj) + else + qqmin=max(qi,qj/4.) + endif + do lq=1,3 + qq=qqmin*(qqmax/qqmin)**((lq-1)/3.) + if(sk.gt.4.*qq)then + tmin=2.*qq/(1.+sqrt(1.-4.*qq/sk)) + else + tmin=2.*qq + endif + tmax=sk/2. + do m=1,1 !parton type at upper end of the ladder (1 + do l=1,1 !parton type at lower end of the ladder (1 + m1=m-1 + if(m.eq.3.and.l.eq.1)then + l1=-m1 + else + l1=l-1 + endif + a=psborn(qj,qi,qq,sk,l1,m1,n-1,0)*(1./tmin-1./tmax) + b=psbint(qj,qi,qq,sk,l1,m1,n-1) + c=psjet1(qi,qj,qq,sk,m1,l1,2*(n-1)) + * +psborn(qj,qi,qq,sk,l1,m1,n-1,0)*(1./tmin-1./tmax) + d=psjti1(qi,qj,qq,sk,m1,l1,n-1) + write (ifmt,'(i3,4f9.1,3x,4f9.4)')n-1,sk,qi,qj,qq,a,b,c,d + enddo + enddo + enddo + enddo + enddo + enddo + enddo + + write (*,*)'jet xsection cstot' + do k=1,20 + write (*,*)'k=',k,'/20' + sk=spmin*(epmax/2./spmin)**((k-1)/19.) !c.m. energy squared for the hard + qmax=sk/4. + tmax=sk/2. + do i=1,20 !cross-sections initialization + do n=1,2 + if(n.eq.1)then + qi=q2min*(qmax/q2min)**((i-1)/19.) + else + qi=q2min*(4.*qmax/q2min)**((i-1)/19.) + endif + do j=1,20 + if(n.eq.1)then + qq=qi*(qmax/qi)**((j-1)/19.) + else + qq=max(q2min,qi/4.)*(qmax/max(q2min,qi/4.))** + * ((j-1)/19.) + endif + if(sk.gt.4.*qq)then + tmin=2.*qq/(1.+sqrt(1.-4.*qq/sk)) + else + tmin=2.*qq + endif + do m=1,3 !parton type at upper end of the ladder (1 + do l=1,2 !parton type at lower end of the ladder (1 + m1=m-1 + if(m.eq.3.and.l.eq.1)then + l1=-m1 + else + l1=l-1 + endif + k1=k+20*(m-1)+60*(l-1)+120*(n-1) + if(k.eq.1.or.i.eq.20.or.j.eq.20)then + cstot(i,j,k1)=log(max(1.e-30,psborn(qi,q2min,qq,sk,m1,l1,n-1,0))) + else + if(n.eq.1)then + cstot(i,j,k1)=log((psjet(qi,q2min,qq,sk,m1,l1,0)+ + * psjti1(qi,q2min,qq,sk,m1,l1,0)+ + * psjti1(q2min,qi,qq,sk,l1,m1,0) + * -psbint(qi,q2min,qq,sk,m1,l1,0))/(1./tmin-1./tmax)) + else + cstot(i,j,k1)=log((psjet(qi,q2min,qq,sk,m1,l1,1)+ + * psjet1(qi,q2min,qq,sk,m1,l1,1)+ + * psjti1(q2min,qi,qq,sk,l1,m1,1))/(1./tmin-1./tmax)) + endif + endif + enddo + enddo + enddo + enddo + enddo + enddo + +c total and born hard cross-sections logarithms for minimal cutoff +c (q2min), interpolated in the psjti0 procedure + spmin=4.*q2min + spminc=4.*q2min+qcmass**2 + do m=1,4 + do l=1,2 + m1=m-1 + if(m.eq.3.and.l.eq.1)then + l1=-m1 + else + l1=l-1 + endif + do k=1,20 + if(m.ne.4)then + sk=spmin*(epmax/2./spmin)**((k-1)/19.) !c.m. energy squared for the hard + p1=sk + qq=q2min + else + sk=spminc*(epmax/2./spminc)**((k-1)/19.) + p1=sk/(1.+qcmass**2/sk) + qq=q2min + endif + if(p1.gt.4.*qq)then + tmin=2.*qq/(1.+sqrt(1.-4.*qq/p1)) + else + tmin=2.*qq + endif + tmax=p1/2. + + k1=k+20*(m-1)+80*(l-1) + csborzer(k,m,l) + * =log(max(1.e-30,psborn(q2min,q2min,qq,sk,m1,l1,0,0))) + if(k.eq.1)then + cstotzero(k,m,l)=csborzer(k,m,l) + elseif(m.ne.4)then + cstotzero(k,m,l)=log(psjti(q2min,qq,sk,m1,l1,0)/ + * (1./tmin-1./tmax)) + else + smins=2.5*q2min*(1.+sqrt(1.+4.*qcmass**2/q2min)) + if(sk.le.smins)then + cstotzero(k,m,l)=log(psjci(q2min,sk,l1)/(1./tmin-1./tmax)) + else + cstotzero(k,m,l)=log((psjci(q2min,sk,l1)+psjct(sk,l1)) + * /(1./tmin-1./tmax)) + endif + endif + enddo + enddo + enddo + + write(ifmt,'(a)')'write to initl ...' + open(1,file=fnii(1:nfnii),status='unknown') + write (1,*)qcdlam,q2min,q2ini,naflav,epmax,pt2cut + write (1,*)csbor,csord,cstot,cstotzero,csborzer,cschar + close(1) + +1 continue + + if(iappl.ne.8)goto 3 + if(ish.ge.3)write(ifch,*)'dis cross sections ...' + inquire(file=fnid(1:nfnid),exist=lcalc) + if(lcalc)then + if(inicnt.eq.1)then + write(ifmt,'(3a)')'read from ',fnid(1:nfnid),' ...' + open(1,file=fnid(1:nfnid),status='old') + read (1,*)qcdlam0,q2min0,q2ini0,naflav0,epmax0,edmax0 + if(qcdlam0.ne.qcdlam)write(ifmt,'(a)')'inidi: wrong qcdlam' + if(q2min0 .ne.q2min )write(ifmt,'(a)')'inidi: wrong q2min' + if(q2ini0 .ne.q2ini )write(ifmt,'(a)')'inidi: wrong q2ini' + if(naflav0.ne.naflav)write(ifmt,'(a)')'inidi: wrong naflav' + if(epmax0 .ne.epmax )write(ifmt,'(a)')'inidi: wrong epmax' + if(edmax0 .ne.edmax )write(ifmt,'(a)')'inidi: wrong edmax' + if(qcdlam0.ne.qcdlam.or.q2min0 .ne.q2min.or.q2ini0 .ne.q2ini + * .or.naflav0.ne.naflav.or.epmax0 .ne.epmax + * .or.edmax0 .ne.edmax)then + write(ifmt,'(//a//)')' inidi has to be reinitialized!!!' + stop + endif + read (1,*)csdsi,csds,csdt,csdr + close(1) + endif + goto 3 + + elseif(.not.producetables)then + write(ifmt,*) "Missing epos.inidi file !" + write(ifmt,*) "Please correct the defined path ", + &"or force production ..." + stop + + endif + + write(ifmt,'(a)')'inidi does not exist -> calculate tables ...' + do j=1,21 + qq=q2min*exp(.5*(j-1)) !photon virtuality + + do m=1,2 !parton type at the end of the ladder + q2mass=qcmass**2 + s2min=4.*max(q2mass,q2min)+qq + if(m.eq.2)s2min=s2min/(1.-4.*q2ini/(s2min-qq)) + do k=1,26 + write (*,*)'sin,j,m,k',j,m,k + sk=s2min*(edmax/s2min)**(.04*(k-1)) !c.m. energy squared + if(k.eq.26)sk=1.01*sk + qmin=q2min + if(m.eq.1)then + qmax=(sk-qq)/4. + else + qmax=(sk-qq+sqrt((sk-qq)**2-16.*sk*q2ini))/8. + endif + + do i=1,21 !cross-sections calculation + qi=qmin*(qmax/qmin)**((i-1)/20.) + tmax=.5*sk + qtq=4.*max(q2mass,qi)/(sk-qq) + if(qtq.lt.1.)then + tmin=.5*sk*qtq/(1.+sqrt(1.-qtq)) + else + tmin=.5*sk + endif + + do ilong=1,2 + k1=k+26*(m-1)+52*(ilong-1) + if(m.eq.1)then + if(tmax.gt.1.01*tmin)then + sij=psds(qi,qq,sk,m-1,ilong-1) + if(sij.lt.0.)write (*,*)'qi,qq,sk,m,long,sij', + * qi,qq,sk,m,ilong,sij + csdsi(i,j,k1)=log(max(0.,sij)/(1./tmin-1./tmax) + * +psdbor(qi,qq,sk,ilong-1)) + else + csdsi(i,j,k1)= + * log(max(1.e-25,psdbor(qi,qq,sk,ilong-1))) + endif + else + csdsi(i,j,k1)=psds(qi,qq,sk,m-1,ilong-1) + endif + enddo + enddo + enddo + enddo + enddo + + do j=1,21 + qq=q2min*exp(.5*(j-1)) !photon virtuality + s2min=max(4.*qq,16.*q2min) !pt2dis=qq + do m=1,2 + do k=1,26 + do ilong=1,2 + k1=k+26*(m-1)+52*(ilong-1) + csds(j,k,m+2*(ilong-1))=csdsi(1,j,k1) + enddo + + sk=(s2min+qq)*(edmax/(s2min+qq))**(.04*(k-1)) + csdt(j,k,m)=psdres(qq,sk,s2min,m-1) + csdr(j,k,m)=psdrga(qq,sk-qq,s2min,m-1) + enddo + enddo + enddo + + write(ifmt,'(a)')'write to inidi ...' + + write(ifmt,'(a)')'write to inidi ...' + open(1,file=fnid(1:nfnid),status='unknown') + write (1,*)qcdlam,q2min,q2ini,naflav,epmax,edmax + write (1,*)csdsi,csds,csdt,csdr + close(1) +3 continue + +c--------------------------------------- +c tabulation of semihard eikonals +c--------------------------------------- + +!!!!!!!!! if(iappl.eq.1)then + + if(ish.ge.4)write(ifch,*)'semihard eikonals ...' +5 continue + inquire(file=fnrj,exist=lcalc) + if(lcalc)then + if(inicnt.eq.1)then + write(ifmt,'(3a)')'read from ',fnrj(1:nfnrj),' ...' + open(1,file=fnrj(1:nfnrj),status='old') + read (1,*)alpqua0,alplea0,alppom0,slopom0, + * gamhad0,r2had0,chad0, + * qcdlam0,q2min0,q2ini0,betpom0,glusea0,naflav0, + * factk0,pt2cut0,gamtil0 + if(alpqua0.ne.alpqua)write(ifmt,'(a,2f8.4)') + * 'inirj: wrong alpqua',alpqua0,alpqua + if(alppom0.ne.alppom)write(ifmt,'(a,2f8.4)') + * 'inirj: wrong alppom',alppom0,alppom + if(slopom0.ne.slopom)write(ifmt,'(a,2f8.4)') + * 'inirj: wrong slopom',slopom0,slopom + iii=2 + if(gamhad0(iii).ne.gamhad(iii))write(ifmt,'(a,i1,a,2f8.4)') + * 'inirj: wrong gamhad(',iii,')',gamhad0(iii),gamhad(iii) + do iii=1,3 + if(r2had0(iii) .ne.r2had(iii) )write(ifmt,'(a,i1,a,2f8.4)') + * 'inirj: wrong r2had(',iii,')',r2had0(iii),r2had(iii) + if(chad0(iii) .ne.chad(iii) )write(ifmt,'(a,i1,a,2f8.4)') + * 'inirj: wrong chad(',iii,')',chad0(iii),chad(iii) + if(alplea0(iii).ne.alplea0(iii))write(ifmt,'(a,i1,a,2f8.4)') + * 'inirj: wrong alplea(',iii,')',alplea0(iii),alplea(iii) + enddo + if(qcdlam0.ne.qcdlam)write(ifmt,'(a,2f8.4)') + * 'inirj: wrong qcdlam',qcdlam0,qcdlam + if(q2min0 .ne.q2min )write(ifmt,'(a,2f8.4)') + * 'inirj: wrong q2min',q2min0,q2min + if(q2ini0 .ne.q2ini )write(ifmt,'(a,2f8.4)') + * 'inirj: wrong q2ini',q2ini0,q2ini + if(betpom0.ne.betpom)write(ifmt,'(a,2f8.4)') + * 'inirj: wrong betpom',betpom0,betpom + if(glusea0.ne.glusea)write(ifmt,'(a,2f8.4)') + * 'inirj: wrong glusea',glusea0,glusea + if(naflav0.ne.naflav)write(ifmt,'(a,2f8.4)') + * 'inirj: wrong naflav',naflav0,naflav + if(factk0 .ne.factk )write(ifmt,'(a,2f8.4)') + * 'inirj: wrong factk', factk0,factk + if(pt2cut0 .ne.pt2cut )write(ifmt,'(a,2f8.4)') + * 'inirj: wrong pt2cut', pt2cut0,pt2cut + if(gamtil0 .ne.gamtil )write(ifmt,'(a,2f8.4)') + * 'inirj: wrong gamtil', gamtil0,gamtil + if(alpqua0.ne.alpqua.or.alppom0.ne.alppom + * .or.slopom0.ne.slopom.or.gamhad0(2).ne.gamhad(2) + * .or.r2had0(1).ne.r2had(1).or.r2had0(2).ne.r2had(2) + * .or.r2had0(3).ne.r2had(3) + * .or.chad0(1).ne.chad(1).or.chad0(2).ne.chad(2) + * .or.chad0(3).ne.chad(3) + * .or.alplea0(1).ne.alplea(1).or.alplea0(2).ne.alplea(2) + * .or.alplea0(3).ne.alplea(3) + * .or.qcdlam0.ne.qcdlam.or.q2min0 .ne.q2min + * .or.q2ini0 .ne.q2ini.or.gamtil0.ne.gamtil + * .or.betpom0.ne.betpom.or.glusea0.ne.glusea.or.naflav0.ne.naflav + * .or.factk0 .ne.factk .or.pt2cut0.ne.pt2cut)then + write(ifmt,'(//a//)')' inirj has to be reinitialized!!!!' + stop + endif + + read(1,*)fhgg,fhqg,fhgq,fhqq,fhgg0,fhgg1,fhqg1 + * ,fhgg01,fhgg02,fhgg11,fhgg12,fhqg11,fhqg12 + * ,ftoint,vfro,vnorm,coefxu1,coefxu2,coefxc2 + read(1,*)bkbin0,iclpro10,iclpro20,icltar10,icltar20,iclegy10 + * ,iclegy20,egylow0,egymax0,iomega0,egyscr0,epscrw0,epscrp0 + if(isetcs.gt.1)then + textini=' ' + if(iclpro10.ne.iclpro1)write(textini,'(a,2i8)') + * 'inirj: wrong iclpro1 ',iclpro10,iclpro1 + if(iclpro20.ne.iclpro2)write(textini,'(a,2i8)') + * 'inirj: wrong iclpro2 ',iclpro20,iclpro2 + if(icltar10.ne.icltar1)write(textini,'(a,2i8)') + * 'inirj: wrong icltar1 ',icltar10,icltar1 + if(icltar20.ne.icltar2)write(textini,'(a,2i8)') + * 'inirj: wrong icltar2 ',icltar20,icltar2 + if(iclegy10.ne.iclegy1)write(textini,'(a,2i8)') + * 'inirj: wrong iclegy1 ',iclegy10,iclegy1 + if(iclegy20.ne.iclegy2)write(textini,'(a,2i8)') + * 'inirj: wrong iclegy2 ',iclegy20,iclegy2 + if(iomega0.ne.iomega)write(textini,'(a,2i8)') + * 'inirj: wrong iomega ',iomega0,iomega + if(egylow0.ne.egylow)write(textini,'(a,2f8.4)') + * 'inirj: wrong egylow ',egylow0,egylow + if(egymax0.ne.egymax)write(textini,'(a,2f8.4)') + * 'inirj: wrong egymax ',egymax0,egymax + if(epscrw0.ne.epscrw)write(textini,'(a,2f8.4)') + * 'inirj: wrong epscrw ',epscrw0,epscrw + if(epscrp0.ne.epscrp)write(textini,'(a,2f8.4)') + * 'inirj: wrong epscrp ',epscrp0,epscrp + if(bkbin0.ne.bkbin)write(textini,'(a,2f8.4)') + * 'inirj: wrong bkbin',bkbin0,bkbin + if(textini.ne.' ')then + write(ifmt,'(//10x,a//10x,a//)')textini, + * 'inirj has to be reinitialized!!!!' + stop + endif + do iiipro=iclpro1,iclpro2 + do iiitar=icltar1,icltar2 + do iiiegy=iclegy1,iclegy2 + do iiib=1,nbkbin + read(1,*)xkappafit(iiiegy,iiipro,iiitar,iiib) + enddo + xkappafit(iiiegy,iiipro,iiitar,nbkbin)=1. + do iiib=2,nbkbin-1 + if(xkappafit(iiiegy,iiipro,iiitar,iiib).lt.1.)then + xkappafit(iiiegy,iiipro,iiitar,iiib)=max(1.,0.5* + * (xkappafit(iiiegy,iiipro,iiitar,iiib-1) + * +xkappafit(iiiegy,iiipro,iiitar,iiib+1))) + endif + enddo + do iiidf=idxD0,idxD + read(1,*)alpDs(iiidf,iiiegy,iiipro,iiitar), + * alpDps(iiidf,iiiegy,iiipro,iiitar), + * alpDpps(iiidf,iiiegy,iiipro,iiitar), + * betDs(iiidf,iiiegy,iiipro,iiitar), + * betDps(iiidf,iiiegy,iiipro,iiitar), + * betDpps(iiidf,iiiegy,iiipro,iiitar), + * gamDs(iiidf,iiiegy,iiipro,iiitar), + * delDs(iiidf,iiiegy,iiipro,iiitar) + enddo + enddo + enddo + enddo + endif + + close(1) + + endif + + + goto 4 + + elseif(.not.producetables)then + write(ifmt,*) "Missing epos.inirj file !" + write(ifmt,*) "Please correct the defined path ", + &"or force production ..." + stop + + endif + + write(ifmt,'(a)')'inirj does not exist -> calculate tables ...' + + engysave=engy + maprojsave=maproj + matargsave=matarg + iclpros=iclpro + icltars=icltar + spmin=4.*q2min + spminc=4.*q2min+2.*qcmass**2 + icltar=2 + + write(ifmt,'(a)')' tabulate om5 ...' + + do iy=1,11 + sy=spmin*(epmax/2./spmin)**((iy-1)/10.) + syc=spminc*(epmax/2./spminc)**((iy-1)/10.) + iclpro=2 + icltar=2 + if(iy.eq.1)then + fhgg01(iy)=-80. + fhgg02(iy)=-80. + else + fhgg01(iy)=log(om51pp(sy,1.,1.,3)) + fhgg02(iy)=log(om51pp(sy,1.,1.,7)) + endif + + do iclpro=iclpro1,iclpro2 + if(iy.eq.1)then + fhgg11(iy,iclpro)=-80. + fhgg12(iy,iclpro)=-80. + else + fhgg11(iy,iclpro)=log(om51pp(sy,1.,1.,4)) + fhgg12(iy,iclpro)=log(om51pp(sy,1.,1.,9)) + endif + do ix=1,10 + if(ix.le.5)then + xp=.1*2.**(ix-5) + else + xp=.2*(ix-5) + endif + if(iy.eq.1)then + fhqg11(iy,ix,iclpro)=-80. + fhqg12(iy,ix,iclpro)=-80. + elseif(iclpro.eq.4)then + fhqg11(iy,ix,iclpro)=log(om51pp(syc,1.,1.,5)) + fhqg12(iy,ix,iclpro)=log(om51pp(syc,1.,1.,11)) + else + fhqg11(iy,ix,iclpro)=log(om51pp(sy,xp,1.,5)) + fhqg12(iy,ix,iclpro)=log(om51pp(sy,xp,1.,11)) + endif + enddo + enddo + + do iz=1,10 + z=.1*iz + + iclpro=2 + icltar=2 + if(iy.eq.1)then + fhgg0(iy,iz)=-80. + else + fhgg0(iy,iz)=log(om51pp(sy,1.,z,6)/z) + endif + + do iclpro=iclpro1,iclpro2 + if(iy.eq.1)then + fhgg1(iy,iz,iclpro)=-80. + else + fhgg1(iy,iz,iclpro)=log(om51pp(sy,1.,z,8)/z) + endif + + do ix=1,10 + if(ix.le.5)then + xp=.1*2.**(ix-5) + else + xp=.2*(ix-5) + endif + if(iy.eq.1)then + fhqg1(iy,ix,iz+10*(iclpro-1))=-80. + elseif(iclpro.eq.4)then + fhqg1(iy,ix,iz+10*(iclpro-1))=log(om51pp(syc,xp,z,10)/z) + else + fhqg1(iy,ix,iz+10*(iclpro-1))=log(om51pp(sy,xp,z,10)/z) + endif + enddo + enddo + enddo + enddo + + do iclpro=iclpro1,iclpro2 !hadron type (1 - pion, 2 - nucleon, 3 - kaon, 4 - charm) + do icltar=icltar1,icltar2 !hadron type (2 - nucleon) + do iy=1,11 + sy=spmin*(epmax/2./spmin)**((iy-1)/10.) + syc=spminc*(epmax/2./spminc)**((iy-1)/10.) + do iz=1,10 + z=.1*iz + if(iy.eq.1)then + fhgg(iy,iz,iclpro+4*(icltar-1))=-80. + else + fhgg(iy,iz,iclpro+4*(icltar-1))=log(om51pp(sy,1.,z,0)/z) + endif + + do ix=1,10 + if(ix.le.5)then + xp=.1*2.**(ix-5) + else + xp=.2*(ix-5) + endif + if(iy.eq.1)then + fhqg(iy,ix,iz+10*(iclpro+4*(icltar-1)-1))=-80. + fhgq(iy,ix,iz+10*(iclpro+4*(icltar-1)-1))=-80. + else + if(iclpro.ne.4)then + syx=sy + else + syx=syc + endif + fhqg(iy,ix,iz+10*(iclpro+4*(icltar-1)-1))= + * log(om51pp(syx,xp,z,1)/z) + if(icltar.ne.4)then + syx=sy + else + syx=syc + endif + fhgq(iy,ix,iz+10*(iclpro+4*(icltar-1)-1))= + * log(om51pp(syx,xp,z,2)/z) + endif + enddo + enddo + + do ix1=1,10 + if(ix1.le.5)then + xpph=.1*2.**(ix1-5) + else + xpph=.2*(ix1-5) + endif + do ix2=1,10 + if(ix2.le.5)then + xmm=.1*2.**(ix2-5) + else + xmm=.2*(ix2-5) + endif + + if(iy.eq.1)then + fhqq(iy,ix1,ix2+10*(iclpro+4*(icltar-1)-1))=-80. + else + if(iclpro.ne.4.and.icltar.ne.4)then + syx=sy + else + syx=syc + endif + fhqq(iy,ix1,ix2+10*(iclpro+4*(icltar-1)-1))= + * log(pshard(syx,xpph,xmm)) + endif + enddo + enddo + enddo + enddo + + enddo + + if(isetcs.gt.1)then + + + write(ifmt,'(a)')' tabulate fit parameters ...' + + engysave=engy + do iclpro=iclpro1,iclpro2 !hadron type (1 - pion, 2 - nucleon, 3 - kaon, 4 - charm) + do icltar=icltar1,icltar2 !hadron type (2 - nucleon) + do iclegy=iclegy2,iclegy1,-1 + call param + enddo + do iiclegy=iclegy2,iclegy1,-1 + engy=egyfac**(iiclegy-1)*egylow + call paramini(0) + call Kfit(iiclegy) + enddo + enddo + enddo + engy=engysave + + endif + + write(ifmt,'(a)')' write to inirj ...' + open(1,file=fnrj,status='unknown') + write (1,*)alpqua,alplea,alppom,slopom,gamhad,r2had,chad, + *qcdlam,q2min,q2ini,betpom,glusea,naflav,factk,pt2cut,gamtil + write (1,*)fhgg,fhqg,fhgq,fhqq,fhgg0,fhgg1,fhqg1 + *,fhgg01,fhgg02,fhgg11,fhgg12,fhqg11,fhqg12 + *,ftoint,vfro,vnorm,coefxu1,coefxu2,coefxc2 + write(1,*)bkbin,iclpro1,iclpro2,icltar1,icltar2,iclegy1,iclegy2 + *,egylow,egymax,iomega,egyscr,epscrw,epscrp + do iiipro=iclpro1,iclpro2 + do iiitar=icltar1,icltar2 + do iiiegy=iclegy1,iclegy2 + do iiib=1,nbkbin + write(1,*)xkappafit(iiiegy,iiipro,iiitar,iiib) + enddo + do iiidf=idxD0,idxD + write(1,*)alpDs(iiidf,iiiegy,iiipro,iiitar), + * alpDps(iiidf,iiiegy,iiipro,iiitar), + * alpDpps(iiidf,iiiegy,iiipro,iiitar), + * betDs(iiidf,iiiegy,iiipro,iiitar), + * betDps(iiidf,iiiegy,iiipro,iiitar), + * betDpps(iiidf,iiiegy,iiipro,iiitar), + * gamDs(iiidf,iiiegy,iiipro,iiitar), + * delDs(iiidf,iiiegy,iiipro,iiitar) + enddo + enddo + enddo + enddo + + close(1) + + engy=engysave + maproj=maprojsave + matarg=matargsave + iclpro=iclpros + icltar=icltars + inicnt=1 + goto 5 + +4 continue + +c-------------------------------------- +c inelastic cross sections +c--------------------------------------- + + if(isetcs.ge.2)then !-------------------- + + if(ish.ge.4)write(ifch,*)'cross sections ...' + 6 continue + inquire(file=fncs,exist=lcalc) + if(lcalc)then + if(inicnt.eq.1)then + write(ifmt,'(3a)')'read from ',fncs(1:nfncs),' ...' + open(1,file=fncs(1:nfncs),status='old') + read (1,*)alpqua0,alplea0,alppom0,slopom0, + * gamhad0,r2had0,chad0, + * qcdlam0,q2min0,q2ini0,betpom0,glusea0,naflav0, + * factk0,pt2cut0 + if(alpqua0.ne.alpqua)write(ifmt,'(a,2f8.4)') + * 'inics: wrong alpqua',alpqua0,alpqua + if(alppom0.ne.alppom)write(ifmt,'(a,2f8.4)') + * 'inics: wrong alppom',alppom0,alppom + if(slopom0.ne.slopom)write(ifmt,'(a,2f8.4)') + * 'inics: wrong slopom',slopom0,slopom + iii=2 + if(gamhad0(iii).ne.gamhad(iii))write(ifmt,'(a,i1,a,2f8.4)') + * 'inics: wrong gamhad(',iii,')',gamhad0(iii),gamhad(iii) + do iii=1,3 + if(r2had0(iii) .ne.r2had(iii) )write(ifmt,'(a,i1,a,2f8.4)') + * 'inics: wrong r2had(',iii,')',r2had0(iii),r2had(iii) + if(chad0(iii) .ne.chad(iii) )write(ifmt,'(a,i1,a,2f8.4)') + * 'inics: wrong chad(',iii,')',chad0(iii),chad(iii) + if(alplea0(iii).ne.alplea0(iii))write(ifmt,'(a,i1,a,2f8.4)') + * 'inics: wrong alplea(',iii,')',alplea0(iii),alplea(iii) + enddo + if(qcdlam0.ne.qcdlam)write(ifmt,'(a,2f8.4)') + * 'inics: wrong qcdlam',qcdlam0,qcdlam + if(q2min0 .ne.q2min )write(ifmt,'(a,2f8.4)') + * 'inics: wrong q2min',q2min0,q2min + if(q2ini0 .ne.q2ini )write(ifmt,'(a,2f8.4)') + * 'inics: wrong q2ini',q2ini0,q2ini + if(betpom0.ne.betpom)write(ifmt,'(a,2f8.4)') + * 'inics: wrong betpom',betpom0,betpom + if(glusea0.ne.glusea)write(ifmt,'(a,2f8.4)') + * 'inics: wrong glusea',glusea0,glusea + if(naflav0.ne.naflav)write(ifmt,'(a,2f8.4)') + * 'inics: wrong naflav',naflav0,naflav + if(factk0 .ne.factk )write(ifmt,'(a,2f8.4)') + * 'inics: wrong factk', factk0,factk + if(pt2cut0 .ne.pt2cut )write(ifmt,'(a,2f8.4)') + * 'inics: wrong pt2cut', pt2cut0,pt2cut + if(alpqua0.ne.alpqua.or.alppom0.ne.alppom + * .or.slopom0.ne.slopom.or.gamhad0(2).ne.gamhad(2) + * .or.r2had0(1).ne.r2had(1).or.r2had0(2).ne.r2had(2) + * .or.r2had0(3).ne.r2had(3) + * .or.chad0(1).ne.chad(1).or.chad0(2).ne.chad(2) + * .or.chad0(3).ne.chad(3) + * .or.alplea0(1).ne.alplea(1).or.alplea0(2).ne.alplea(2) + * .or.alplea0(3).ne.alplea(3) + * .or.qcdlam0.ne.qcdlam.or.q2min0 .ne.q2min + * .or.q2ini0 .ne.q2ini + * .or.betpom0.ne.betpom.or.glusea0.ne.glusea.or.naflav0.ne.naflav + * .or.factk0 .ne.factk .or.pt2cut0.ne.pt2cut)then + write(ifmt,'(//a//)')' inics has to be reinitialized!!!!' + stop + endif + + read(1,*)isetcs0,iclpro10,iclpro20,icltar10,icltar20,iclegy10 + * ,iclegy20,egylow0,egymax0,iomega0,egyscr0,epscrw0,epscrp0 + + if(iclpro10.ne.iclpro1)write(ifmt,'(a,2i2)') + * 'inics: wrong iclpro1',iclpro10,iclpro1 + if(iclpro20.ne.iclpro2)write(ifmt,'(a,2i2)') + * 'inics: wrong iclpro2',iclpro20,iclpro2 + if(icltar10.ne.icltar1)write(ifmt,'(a,2i2)') + * 'inics: wrong icltar1',icltar10,icltar1 + if(icltar20.ne.icltar2)write(ifmt,'(a,2i2)') + * 'inics: wrong icltar2',icltar20,icltar2 + if(iclegy10.ne.iclegy1)write(ifmt,'(a,2i4)') + * 'inics: wrong iclegy1',iclegy10,iclegy1 + if(iclegy20.ne.iclegy2)write(ifmt,'(a,2i4)') + * 'inics: wrong iclegy2',iclegy20,iclegy2 + if(iomega0.ne.iomega)write(textini,'(a,2i8)') + * 'inics: wrong iomega ',iomega0,iomega + if(egylow0.ne.egylow)write(ifmt,'(a,2f8.4)') + * 'inics: wrong egylow',egylow0,egylow + if(egymax0.ne.egymax)write(ifmt,'(a,2f12.4)') + * 'inics: wrong egymax',egymax0,egymax + if(egyscr0.ne.egyscr)write(ifmt,'(a,2f8.4)') + * 'inics: wrong egyscr ',egyscr0,egyscr + if(epscrw0.ne.epscrw)write(ifmt,'(a,2f8.4)') + * 'inics: wrong epscrw',epscrw0,epscrw + if(epscrp0.ne.epscrp)write(ifmt,'(a,2f8.4)') + * 'inics: wrong epscrp',epscrp0,epscrp + if(isetcs0.lt.isetcs)write(ifmt,'(a,2f8.4)') + * 'inics: wrong isetcs',isetcs0,isetcs + if(iclpro10.ne.iclpro1.or.iclpro20.ne.iclpro2 + * .or.icltar10.ne.icltar1.or.icltar20.ne.icltar2 + * .or.iclegy10.ne.iclegy1.or.iclegy20.ne.iclegy2 + * .or.egylow0.ne.egylow.or.egymax0.ne.egymax + * .or.egyscr0.ne.egyscr.or.epscrw0.ne.epscrw.or.isetcs0.lt.isetcs + * .or.epscrp0.ne.epscrp)then + write(ifmt,'(//a//)')' inics has to be reinitialized!!!!' + stop + endif + if(isetcs.eq.2)then + if(ionudi.eq.1)then + read (1,*)asect,asect13,asect21,asect23,asectn + * ,asect33,asect41,asect43 + else !ionudi=3 + read (1,*)asect11,asect,asect21,asect23,asect31 + * ,asectn,asect41,asect43 + endif + elseif(isetcs.eq.3)then + if(ionudi.eq.1)then + read (1,*)asect11,asect13,asect,asect23,asect31 + * ,asect33,asectn,asect43 + else !ionudi=3 + read (1,*)asect11,asect13,asect21,asect,asect31 + * ,asect33,asect41,asectn + endif + else + write(ifmt,'(//a//)')' Wrong isetcs in psaini !!!!' + endif + + close(1) + + endif + + + goto 7 + + + elseif(.not.producetables)then + write(ifmt,*) "Missing epos.inics file !" + write(ifmt,*) "Please correct the defined path ", + &"or force production ..." + stop + + endif + + ifradesave=ifrade + iremnsave=iremn + idprojsave=idproj + idprojinsave=idprojin + idtargsave=idtarg + idtarginsave=idtargin + laprojsave=laproj + latargsave=latarg + maprojsave=maproj + matargsave=matarg + icltarsave=icltar + iclprosave=iclpro + engysave=engy + pnllsave=pnll + elabsave=elab + ecmssave=ecms + iclegysave=iclegy + nrevtsave=nrevt + neventsave=nevent + ntevtsave=ntevt + isetcssave=isetcs + noebinsave=noebin + isigmasave=isigma + bminimsave=bminim + bmaximsave=bmaxim + bimevtsave=bimevt + bkmxndifsave=bkmxndif +c fctrmxsave=fctrmx + ionudisave=ionudi + + + isetcs=2 + isigma=1 + noebin=1 + idtarg=1120 + idtargin=1120 + bminim=0. + bmaxim=10000. + ifrade=0 !to save time, no fragmentation + iremn=0 !to save time, simple remnants + ionudi=3 !to have both ionudi=1 and 3 in tables + + write(ifmt,'(a)')'inics does not exist -> calculate tables ...' + +c initialize random numbers + if(seedj.ne.0d0)then + call ranfini(seedj,iseqsim,2) + else + stop 'seedi = 0 ... Please define it !' + endif + call aseed(2) + + laproj=-1 + maproj=1 + icltar=2 + do iclpro=1,4 + if(iclpro.lt.iclpro1.or.iclpro.gt.iclpro2)then + do ie=1,7 + do iia=1,8 + asect11(ie,iclpro,iia)=0. + asect21(ie,iclpro,iia)=0. + asect13(ie,iclpro,iia)=0. + asect23(ie,iclpro,iia)=0. + enddo + enddo + else + do ie=1,7 + engy=1.5*10.**(ie-1) + call paramini(0) + bkmxndif=conbmxndif() + if(ish.ge.1) + & write(ifch,*)' calcul. ',ie,' (',iclpro,')',engy + write(ifmt,*)' calcul. ',ie,' (',iclpro,')',engy + + sigine=0. + do iia=1,8 + matarg=2**(iia-1) + if(matarg.eq.1)then !hadron-proton interaction +c ine=cut+diff + call psfz(2,gz2,0.) + gin=gz2*pi*10. +c cut + iomegasave=iomega + iomega=2 + call psfz(2,gz2,0.) + iomega=iomegasave + gcut=gz2*pi*10. +c diff + difpart=gin-gcut +c non excited projectile and target + gqela=(1.-rexdif(iclpro))*(1.-rexdif(icltar))*difpart + gin3=max(1.,gin-gqela) + else + call conini + rad=radnuc(matarg) + bm=rad+2. + rrr=rad/difnuc(matarg) + rrrm=rrr+log(9.) + anorm=1.5/pi/rrr**3/(1.+(pi/rrr)**2)/difnuc(matarg)**2 +c gela=(ptgau(ptfau,bm,2,1)+ptgau1(bm,2,1))*10. !sig_ela +c in=cut+diff + gcut=(ptgau(ptfau,bm,2,2)+ptgau1(bm,2,2))*10. !sig_in + gin=gcut +c cut + iomegasave=iomega + iomega=2 + gcut=(ptgau(ptfau,bm,2,2)+ptgau1(bm,2,2))*10. !sig_cut + iomega=iomegasave +c diff + difpart=gin-gcut +c non excited projectile + gqela=(1.-rexdif(iclpro)) + & **(1.+rexres(iclpro)*float(matarg-1)**0.3) +c non excited target + gqela=gqela*(1.-rexdif(icltar)) + gqela=gqela*difpart + gin3=max(1.,gin-gqela) + endif + if(ish.ge.1)write (ifch,226)matarg,gin,gin3 +226 format(2x,'psaini: hadron-nucleus (',i3,') cross sections:'/ + * 4x,'gin,gin3=',2e10.3) + write(ifmt,*)' matarg,gin,gin3:',matarg,gin,gin3 + asect11(ie,iclpro,iia)=log(gin) + asect13(ie,iclpro,iia)=log(gin3) + enddo + enddo + + if(isetcssave.ge.3)then + + if(iclpro.eq.1)then + idprojin=120 + elseif(iclpro.eq.2)then + idprojin=1120 + elseif(iclpro.eq.3)then + idprojin=130 + endif + do ie=1,7 + engy=1.5*10.**(ie-1) + if(engy.le.egymin)engy=egymin + if(engy.ge.egymax)engy=egymax + write(ifmt,*)' simul. ',ie,' (',iclpro,')',engy + if(ish.ge.1) + & write(ifch,*)' simul. ',ie,' (',iclpro,')',engy + do iia=1,8 + matarg=2**(iia-1) + latarg=min(1,matarg/2) +c fctrmx=max(ftcrmxsave,float(matarg)) !to get stable pA and AA cross section, this number has to be large for large A + ntevt=0 + nrevt=0 + pnll=-1. + elab=-1. + ecms=-1. + ekin=-1. + call conini + call ainit + nevent=50000 + if(iia.gt.40)nevent=nevent/10 +c if(matarg.eq.1)nevent=1 + call epocrossc(nevent,sigt,sigi,sigc,sige,sigql,sigd) +c do not count non-excited diffractive projectile in inelastic + sigi3=sigi-sigql + if(ish.ge.1)write (ifch,228)matarg,sigi,sigi3 + 228 format(2x,'simul.: hadron-nucleus (',i3,') cross sections:'/ + * 4x,'gin,gin3=',2e10.3) + write(ifmt,*)' matarg,sigi,sigi3 :',matarg,sigi,sigi3 + asect21(ie,iclpro,iia)=log(sigi) + asect23(ie,iclpro,iia)=log(sigi3) +c do n=1,nevent +c ntry=0 +c 222 ntevt=ntevt+1 +c iret=0 +c ntry=ntry+1 +c bimevt=-1. +c if(ntry.lt.10000)then +cc if random sign for projectile, set it here +c idproj=idprojin*(1-2*int(rangen()+0.5d0)) +c call emsaaa(iret) +c if(iret.gt.0)goto 222 +c else +c ntevt=ntry +c endif +c enddo +c a=pi*bmax**2 +c if(a.gt.0..and.ntevt.gt.0.)then +c xs=anintine/float(ntevt)*a*10. +c write(ifmt,*)' matarg,nevent,ntevt,bmax,xs :' +c . ,matarg,anintine,ntevt,bmax,xs +c write(ifch,*)' matarg,nevent,ntevt,bmax,xs :' +c . ,matarg,anintine,ntevt,bmax,xs +c asect2(ie,iclpro,iia)=log(xs) +c else +c write(ifmt,*)' Problem ? ',iclpro,matarg,bmax,ntevt +c asect2(ie,iclpro,iia)=0. +c endif + enddo + enddo + else + do ie=1,7 + do iia=1,8 + asect21(ie,iclpro,iia)=0. + asect23(ie,iclpro,iia)=0. + enddo + enddo + endif + endif + enddo + + idprojin=1120 + iclpro=2 + icltar=2 + do ie=1,7 + engy=1.5*10.**(ie-1) + call paramini(0) + bkmxndif=conbmxndif() + if(ish.ge.1) + & write(ifch,*)' calcul. AB ',ie,engy + write(ifmt,*)' calcul. AB ',ie,engy + + do iia=1,8 + maproj=2**(iia-1) + laproj=max(1,maproj/2) + do iib=1,8 + matarg=2**(iib-1) + latarg=max(1,matarg/2) + sigine=0. + if(matarg.eq.1.and.maproj.eq.1)then !proton-proton interaction +c ine=cut+diff + call psfz(2,gz2,0.) + gin=gz2*pi*10. +c cut + iomegasave=iomega + iomega=2 + call psfz(2,gz2,0.) + iomega=iomegasave + gcut=gz2*pi*10. +c diff + difpart=gin-gcut +c non excited projectile and target + gqela=(1.-rexdif(iclpro))*(1.-rexdif(icltar))*difpart + gin3=max(1.,gin-gqela) + else + call conini + if(maproj.eq.1)then + rad=radnuc(matarg) + bm=rad+2. + rrr=rad/difnuc(matarg) + rrrm=rrr+log(9.) + anorm=1.5/pi/rrr**3/(1.+(pi/rrr)**2)/difnuc(matarg)**2 +c gela=(ptgau(ptfau,bm,2,1)+ptgau1(bm,2,1))*10. !sig_ela +c in=cut+diff + gcut=(ptgau(ptfau,bm,2,2)+ptgau1(bm,2,2))*10. !sig_in + gin=gcut +c cut + iomegasave=iomega + iomega=2 + gcut=(ptgau(ptfau,bm,2,2)+ptgau1(bm,2,2))*10. !sig_cut + iomega=iomegasave +c diff + difpart=gin-gcut +c non excited projectile + gqela=(1.-rexdif(iclpro)) + & **(1.+rexres(iclpro)*float(matarg-1)**0.3) +c non excited target + gqela=gqela*(1.-rexdif(icltar))**(1.+float(matarg)**0.3) + gqela=gqela*difpart + gin3=max(1.,gin-gqela) + elseif(matarg.eq.1)then + radp=radnuc(maproj) + bm=radp+2. + rrrp=radp/difnuc(maproj) + rrrmp=rrrp+log(9.) + anormp=1.5/pi/rrrp**3/(1.+(pi/rrrp)**2)/difnuc(maproj)**2 +c gtot=(ptgau(ptfau,bm,1,1)+ptgau1(bm,1,1))*10. !sig_in +c in=cut+diff + gcut=(ptgau(ptfau,bm,1,2)+ptgau1(bm,1,2))*10. !sig_in + gin=gcut !in=cut+diff +c cut + iomegasave=iomega + iomega=2 + gcut=(ptgau(ptfau,bm,1,2)+ptgau1(bm,1,2))*10. !sig_cut + iomega=iomegasave +c diff + difpart=gin-gcut +c non excited projectile + gqela=(1.-rexdif(iclpro))**(1.+float(maproj)**0.3) +c non excited target + gqela=gqela*(1.-rexdif(icltar)) + & **(1.+rexres(icltar)*float(maproj-1)**0.3) + gqela=gqela*difpart + gin3=max(1.,gin-gqela) + else + rad=radnuc(matarg)+1. + radp=radnuc(maproj)+1. + bm=rad+radp+2. + rrr=rad/difnuc(matarg) + rrrm=rrr+log(9.) + rrrp=radp/difnuc(maproj) + rrrmp=rrrp+log(9.) + anorm=1.5/pi/rrr**3/(1.+(pi/rrr)**2)/difnuc(matarg)**2 + anormp=1.5/pi/rrrp**3/(1.+(pi/rrrp)**2)/difnuc(maproj)**2 +c ine=cut+diff +c gtot=(ptgau(ptfauAA,bm,2,1)+ptgau2(bm,1))*10. + gcut=(ptgau(ptfauAA,bm,2,2)+ptgau2(bm,2))*10. +c gin=gtot + gin=gcut +c cut + iomegasave=iomega + iomega=2 + gcut=(ptgau(ptfauAA,bm,2,2)+ptgau2(bm,2))*10. !sig_cut + iomega=iomegasave +c diff + difpart=gin-gcut +c non excited projectile + gqelap=(1.-rexdif(iclpro)) + & **(1.+rexres(iclpro)*float(matarg-1)**0.3) + gqelap=gqelap**(1.+float(maproj)**0.3) +c non excited target + gqelat=(1.-rexdif(icltar)) + & **(1.+rexres(icltar)*float(maproj-1)**0.3) + gqelat=gqelat**(1.+float(maproj)**0.3) + gqela=gqelap*gqelat*difpart + gin3=gin-gqela + endif + endif + if(ish.ge.1)write (ifch,227)maproj,matarg,gin,gin3 + 227 format(2x,'psaini: nucleus-nucleus (',i3,'-',i3 + * ,') cross sections:',/,4x,'gin,gin3=',2e10.3) + write(ifmt,*)' maproj,matarg,gin,gin3 :' + * ,maproj,matarg,gin,gin3 + asect31(ie,iia,iib)=log(gin) + asect33(ie,iia,iib)=log(gin3) + + enddo + enddo + enddo + + if(isetcssave.ge.3)then + + do ie=1,7 + engy=1.5*10.**(ie-1) + if(engy.le.egymin)engy=egymin + if(engy.ge.egymax)engy=egymax + write(ifmt,*)' AB xs ',ie,engy + if(ish.ge.1) + & write(ifch,*)' AB xs ',ie,engy + do iia=1,8 + maproj=2**(iia-1) + laproj=max(1,maproj/2) + do iib=1,8 + matarg=2**(iib-1) + latarg=max(1,matarg/2) +c fctrmx=max(ftcrmxsave,float(max(maproj,matarg))) !to get stable pA and AA cross section, this number has to be large for large A + ntevt=0 + nrevt=0 + pnll=-1. + elab=-1. + ecms=-1. + ekin=-1. + call conini + call ainit + nevent=10000 + if(iia.gt.40)nevent=nevent/5 + if(iib.gt.40)nevent=nevent/5 +c if(maproj+matarg.eq.2)nevent=1 + call epocrossc(nevent,sigt,sigi,sigc,sige,sigql,sigd) +c do not count non-excited diffractive projectile in inelastic + sigi3=sigi-sigql + if(ish.ge.1)write (ifch,229)maproj,matarg,sigi,sigi3 + 229 format(2x,'simul.: nucleus-nucleus (',i3,'-',i3 + * ,') cross sections:',/,4x,'gin,gin3=',2e10.3) + write(ifmt,*)' maproj,matarg,sigi,sigi3 :',maproj,matarg + & ,sigi,sigi3 + asect41(ie,iia,iib)=log(sigi) + asect43(ie,iia,iib)=log(sigi3) + +c do n=1,nevent +c ntry=0 +c 223 ntevt=ntevt+1 +c iret=0 +c ntry=ntry+1 +c bimevt=-1. +c if(ntry.lt.10000)then +c call emsaaa(iret) +c if(iret.gt.0)goto 223 +c else +c ntevt=ntry +c endif +c enddo +c a=pi*bmax**2 +c if(a.gt.0..and.ntevt.gt.0.)then +c xs=anintine/float(ntevt)*a*10. +c write(ifmt,*)' maproj,matarg,nevent,ntevt,bmax,xs :' +c & ,maproj,matarg,anintine,ntevt,bmax,xs +c write(ifch,*)' maproj,matarg,nevent,ntevt,bmax,xs :' +c & ,maproj,matarg,anintine,ntevt,bmax,xs +c asect4(ie,iia,iib)=log(xs) +c else +c write(ifmt,*)' Problem ? ',maproj,matarg,bmax,ntevt +c asect4(ie,iia,iib)=0. +c endif + enddo + enddo + enddo + else + do ie=1,7 + do iia=1,8 + do iib=1,8 + asect41(ie,iia,iib)=0. + asect43(ie,iia,iib)=0. + enddo + enddo + enddo + endif + + ifrade=ifradesave + iremn=iremnsave + idproj=idprojsave + idprojin=idprojinsave + idtarg=idtargsave + idtargin=idtarginsave + laproj=laprojsave + latarg=latargsave + maproj=maprojsave + matarg=matargsave + icltar=icltarsave + iclpro=iclprosave + engy=engysave + pnll=pnllsave + elab=elabsave + ecms=ecmssave + iclegy=iclegysave + nrevt=nrevtsave + nevent=neventsave + ntevt=ntevtsave + isetcs=isetcssave + noebin=noebinsave + isigma=isigmasave + bminim=bminimsave + bmaxim=bmaximsave + bimevt=bimevtsave + bkmxndif=bkmxndifsave + ionudi=ionudisave +c fctrmx=fctrmxsave + inicnt=1 + + write(ifmt,'(a)')'write to inics ...' + open(1,file=fncs,status='unknown') + write (1,*)alpqua,alplea,alppom,slopom,gamhad,r2had,chad, + *qcdlam,q2min,q2ini,betpom,glusea,naflav,factk,pt2cut + write(1,*)isetcs,iclpro1,iclpro2,icltar1,icltar2,iclegy1,iclegy2 + *,egylow,egymax,iomega,egyscr,epscrw,epscrp + write (1,*)asect11,asect13,asect21,asect23 + * ,asect31,asect33,asect41,asect43 + + close(1) + + + goto 6 + + 7 continue + + endif !----------isetcs.ge.2----------- + + endif + + call utprix('psaini',ish,ishini,4) + + return + end + +cc----------------------------------------------------------------------- +c function fjetxx(jpp,je1,je2) +cc----------------------------------------------------------------------- +cc almost exactly psjet, just with Eqcd replaced by fparton +cc for testing +cc gives indeed the same result as jetx +cc so the integration seems correct +cc----------------------------------------------------------------------- +c double precision xx1,xx2,s2min,xmin,xmax,xmin1,xmax1,t,tmin +c *,tmax,sh,z,qtmin,ft,fx1,fx2 +c common /ar3/ x1(7),a1(7) +c common /ar9/ x9(3),a9(3) +c include 'epos.inc' +c include 'epos.incsem' +c +c fjetxx=0. +c s=engy*engy +c s2min=4.d0*q2min +c +c zmin=s2min/dble(s) +c zmax=1 +c +c zmin=zmin**(-delh) +c zmax=zmax**(-delh) +c do i=1,3 +c do m=1,2 +c z=dble(.5*(zmax+zmin+(zmin-zmax)*(2*m-3)*x9(i)))**(-1./delh) +c xmin=dsqrt(z) +c sh=z*dble(s) +c qtmin=max(dble(q2min),dble(q2ini)/(1.d0-dsqrt(z))) +c tmin=max(0.d0,1.d0-4.d0*qtmin/sh) +c tmin=2.d0*qtmin/(1.d0+dsqrt(tmin)) +c tmax=sh/2.d0 +c ft=0.d0 +c do i1=1,3 +c do m1=1,2 +c t=2.d0*tmin/(1.d0+tmin/tmax-dble(x9(i1)*(2*m1-3)) +c & *(1.d0-tmin/tmax)) +c qt=t*(1.d0-t/sh) +c xmax=1.d0-q2ini/qt +c xmin=max(dsqrt(z),z/xmax) !xm<xp !!! +c if(xmin.gt.xmax.and.ish.ge.1)write(ifmt,*)'fjetxx:xmin,xmax' +c * ,xmin,xmax +c fx1=0.d0 +c fx2=0.d0 +c if(xmax.gt..8d0)then +c xmin1=max(xmin,.8d0) +c do i2=1,3 +c do m2=1,2 +c xx1=1.d0-(1.d0-xmax)*((1.d0-xmin1)/(1.d0-xmax))** +c * dble(.5+x9(i2)*(m2-1.5)) +c xx2=z/xx1 +c fb=ffsigj(sngl(t),qt,sngl(xx1),sngl(xx2),jpp,je1,je2) +c * +ffsigj(sngl(t),qt,sngl(xx2),sngl(xx1),jpp,je1,je2) +c fx1=fx1+dble(a9(i2)*fb)*(1.d0/xx1-1.d0) +c * *pssalf(qt/qcdlam)**2 +c enddo +c enddo +c fx1=fx1*dlog((1.d0-xmin1)/(1.d0-xmax)) +c endif +c if(xmin.lt..8d0)then +c xmax1=min(xmax,.8d0) +c do i2=1,3 +c do m2=1,2 +c xx1=xmin*(xmax1/xmin)**dble(.5+x9(i2)*(m2-1.5)) +c xx2=z/xx1 +c +c fb=0. +c fb=fb +c * +ffsigj(sngl(t),qt,sngl(xx1),sngl(xx2),jpp,je1,je2) +c * +ffsigj(sngl(t),qt,sngl(xx2),sngl(xx1),jpp,je1,je2) +c fx2=fx2+dble(a9(i2))*fb*pssalf(qt/qcdlam)**2 +c enddo +c enddo +c fx2=fx2*dlog(xmax1/xmin) +c endif +c ft=ft+dble(a9(i1))*(fx1+fx2)*t**2 +c enddo +c enddo +c ft=ft*(1.d0/tmin-1.d0/tmax) +c fjetxx=fjetxx+a9(i)*sngl(ft*z**(1.+delh)/sh**2) +c * /z ! ffsig = xp f xm f sigma +c enddo +c enddo +c fjetxx=fjetxx*(zmin-zmax)/delh*pi**3 +c ! * /2. !??????????????? kkkkkkkkk +c return +c end +c +c diff --git a/modules/epos/epos-tim-lhc.f b/modules/epos/epos-tim-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..0e65d1145d03379ecd30b0586d18655a96fbcf2c --- /dev/null +++ b/modules/epos/epos-tim-lhc.f @@ -0,0 +1,686 @@ +c--------------------------------------------------------------------- + subroutine timann +c--------------------------------------------------------------------- +c electron-positron +c--------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + common/nfla/nfla + parameter (ntim=1000) + common/cprt/pprt(5,ntim),q2prt(ntim),idaprt(2,ntim),idprt(ntim) + &,iorprt(ntim),jorprt(ntim),nprtj + integer jcp(6,2),jcm(6,2) + dimension p1(5),jorprt2(ntim),ng(ntim) + + call utpri('timann',ish,ishini,5) + egyevt=engy + qsqevt=engy**2 + + 123 nprtj=1 + en=engy + q20=0. + nptl=0 + nptl=nptl+1 !electron + pptl(1,nptl)=0. + pptl(2,nptl)=0. + pptl(3,nptl)=sqrt(en**2/4-2.61121e-7) + pptl(4,nptl)=en/2. + pptl(5,nptl)=0.000511 + idptl(nptl)=12 + istptl(nptl)=1 + + nptl=nptl+1 !positron + pptl(1,nptl)=0. + pptl(2,nptl)=0. + pptl(3,nptl)=-sqrt(en**2/4-2.61121e-7) + pptl(4,nptl)=en/2. + pptl(5,nptl)=0.000511 + idptl(nptl)=-12 + istptl(nptl)=1 + + nptl=nptl+1 !virtual gamma + pptl(1,nptl)=0. + pptl(2,nptl)=0. + pptl(3,nptl)=0. + pptl(4,nptl)=en + pptl(5,nptl)=en + idptl(nptl)=10 + iorptl(nptl)=nptl-2 + jorptl(nptl)=nptl-1 + istptl(nptl)=1 + + pprt(1,nprtj)=0. + pprt(2,nprtj)=0. + pprt(3,nprtj)=0. + pprt(4,nprtj)=en + pprt(5,nprtj)=en + idaprt(1,nprtj)=2 + idaprt(2,nprtj)=3 + if(q20.gt.0.)then + pprt(5,nprtj)=sqrt(q20) + else + pprt(5,nprtj)=en + endif + nfla=0 + do i=1,naflav + call idmass(i,am) + if (2.*am.lt.en) nfla=i + enddo + if(itflav.eq.0)then + s=engy**2 + dlz=2.4 + amz=91.1885 + al=1./real(137.035989d0) + gf=1.16639e-5 + ak=sqrt(2.)*gf*amz**2/(16*pi*al) + chi1=ak*s*(s-amz**2)/((s-amz**2)**2+dlz**2*amz**2) + chi2=ak**2*s**2/((s-amz**2)**2+dlz**2*amz**2) + qe=-1. + ve=0.25-2.*qe*0.232 + ae=-0.5 + qf=2./3. + vf=sign(.5,qf)-2.*qf*0.232 + af=sign(.5,qf) + dsmax1= + $ 2.*(qf**2-2.*qf*ve*vf*chi1 + $ +(ae**2+ve**2)*(af**2+vf**2)*chi2) + $ + abs(-4*qf*ae*af*chi1+8*ae*ve*af*vf*chi2) + + qf=-1./3. + vf=sign(.5,qf)-2.*qf*0.232 + af=sign(.5,qf) + dsmax2= + $ 2.*(qf**2-2.*qf*ve*vf*chi1 + $ +(ae**2+ve**2)*(af**2+vf**2)*chi2) + $ + abs(-4*qf*ae*af*chi1+8*ae*ve*af*vf*chi2) + + 100 iq1=1+INT(nfla*rangen()) + call idchrg(iq1,qf) + ct=-1.+2.*rangen() + vf=sign(.5,qf)-2.*qf*0.232 + af=sign(.5,qf) + dsigma= + $ (1.+ct**2)*(qf**2-2.*qf*ve*vf*chi1 + $ +(ae**2+ve**2)*(af**2+vf**2)*chi2) + $ + ct*(-4*qf*ae*af*chi1+8*ae*ve*af*vf*chi2) + if(rangen().gt.dsigma/max(dsmax1,dsmax2)) goto 100 + else + iq1=itflav + endif + if(rangen().lt.0.5)iq1=-iq1 + + + nprtj=nprtj+1 + idprt(nprtj)=iq1 + pprt(4,nprtj)=en/2. + pprt(5,nprtj)=en + iorprt(nprtj)=1 + jorprt(nprtj)=iq1 + q2prt(nprtj)=en**2 + + nprtj=nprtj+1 + idprt(nprtj)=-iq1 + pprt(4,nprtj)=en/2. + pprt(5,nprtj)=en + iorprt(nprtj)=1 + jorprt(nprtj)=-iq1 + q2prt(nprtj)=en**2 + + call timsho(2,3) + + jorprt2(1)=0 !!color-connection, no origin!! + jt=1 + if(idprt(idaprt(1,1)).lt.0)jt=2 + do i=1,nprtj + ng(i)=0 + if(idaprt(1,i).ne.0) then + js=jt + if(idprt(i).lt.0.and. + & ((idprt(idaprt(2,i)).eq.9.and.jt.eq.1).or. + & (idprt(idaprt(1,i)).eq.9.and.jt.eq.2)))then + js=3-jt + elseif(idprt(i).gt.0.and.idprt(i).ne.9.and. + & ((idprt(idaprt(2,i)).eq.9.and.jt.eq.2).or. + & (idprt(idaprt(1,i)).eq.9.and.jt.eq.1)))then + js=3-jt + elseif(idprt(i).eq.9.and.idprt(idaprt(1,i)).ne.9.and. + & ((idprt(idaprt(1,i)).lt.0.and.jt.eq.2).or. + & (idprt(idaprt(1,i)).gt.0.and.jt.eq.1)))then + js=3-jt + endif + jorprt2(idaprt(3-js,i))=jorprt2(i) + jorprt2(i)=idaprt(js,i) + jorprt2(idaprt(js,i))=idaprt(3-js,i) + else + j=i + do while(iorprt(j).ne.0) + ng(i)=ng(i)+1 + j=iorprt(j) + enddo + endif + enddo + + if(ish.ge.5)then + i=1 + do while(i.ne.0) + if(idaprt(1,i) .eq. 0 ) then + write(ifch,*) idprt(i) + write(ifch,*) '|' + endif + i=jorprt2(i) + enddo + endif + + iptl=nptl + i=1 + do while(i.gt.0) + if(idaprt(1,i) .eq. 0) then + nptl=nptl+1 + do j=1,5 + pptl(j,nptl)=pprt(j,i) + enddo + idptl(nptl)=idprt(i) + istptl(nptl)=20 + ityptl(nptl)=30 + iorptl(nptl)=iptl + jorptl(nptl)=jorprt(i) !type of mother parton + qsqptl(nptl)=q2prt(i) + endif + i=jorprt2(i) + enddo + ifrptl(1,iptl)=iptl+1 + ifrptl(2,iptl)=nptl + + nk1=iptl+1 + 441 nk2=nk1+1 + do while (idptl(nk2).eq.9) + nk2=nk2+1 + enddo + do i=1,4 + p1(i)=0. + do j=nk1,nk2 + p1(i)=p1(i)+pptl(i,j) + enddo + enddo + p1(5)=sqrt(max(0.,p1(4)**2-p1(3)**2-p1(2)**2-p1(1)**2)) + do i=1,2 + do j=1,6 + jcm(j,i)=0 + jcp(j,i)=0 + enddo + enddo + ii=1 + if(idptl(nk1).lt.0)ii=2 + jcp(abs(idptl(nk1)),ii)=1 + jcm(abs(idptl(nk2)),3-ii)=1 + amm= utamnx(jcp,jcm) + if(amm.gt.p1(5))goto 123 + nk1=nk2+1 + if(nk1.lt.nptl)goto 441 + + + if(ish.ge.5)then + write(ifch,*) + do i=1,nprtj + write(ifch,98) i,(pprt(j,i),j=1,5),idprt(i) + & ,iorprt(i),idaprt(1,i),idaprt(2,i),jorprt2(i),ng(i) + enddo + write(ifch,*) + do i=1,nprtj + if(pprt(5,i).eq.0.) + & write(ifch,99) i,(pprt(j,i),j=1,5),idprt(i),ng(i) + enddo + write(ifch,*) + write(ifch,*) + endif + + 99 format(i4,5g10.3,2i4) + 98 format(i4,5g10.3,6i4) + + call utprix('timann',ish,ishini,5) + return + end + +c--------------------------------------------------------------------- + subroutine timsh1(q20,en,idfla,jo) +c--------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + common/nfla/nfla + parameter (ntim=1000) + common/cprt/pprt(5,ntim),q2prt(ntim),idaprt(2,ntim),idprt(ntim) + &,iorprt(ntim),jorprt(ntim),nprtj + common/cprtx/nprtjx,pprtx(5,2) + nfla=naflav + nprtj=1 + pprt(1,nprtj)=0. + pprt(2,nprtj)=0. + pprt(3,nprtj)=0. + pprt(4,nprtj)=en + pprt(5,nprtj)=sqrt(q20) + q2prt(nprtj)=q20 + idprt(nprtj)=idfla + iorprt(nprtj)=nprtj + jorprt(nprtj)=jo + call timsho(1,0) + nprtjx=0 + return + end + + +c--------------------------------------------------------------------- + subroutine timsh2(q20,q21,en,idfla1,idfla2,jo1,jo2) +c--------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + common/nfla/nfla + parameter (ntim=1000) + common/cprt/pprt(5,ntim),q2prt(ntim),idaprt(2,ntim),idprt(ntim) + &,iorprt(ntim),jorprt(ntim),nprtj + common/cprtx/nprtjx,pprtx(5,2) + nfla=naflav + + nprtj=1 + pprt(1,nprtj)=0. + pprt(2,nprtj)=0. + pprt(3,nprtj)=0. + pprt(4,nprtj)=en/2. + pprt(5,nprtj)=sqrt(q20) + q2prt(nprtj)=q20 + idprt(nprtj)=idfla1 + iorprt(nprtj)=nprtj + jorprt(nprtj)=jo1 + + nprtj=2 + pprt(1,nprtj)=0. + pprt(2,nprtj)=0. + pprt(3,nprtj)=0. + pprt(4,nprtj)=en/2. + pprt(5,nprtj)=sqrt(q21) + q2prt(nprtj)=q21 + idprt(nprtj)=idfla2 + iorprt(nprtj)=nprtj + jorprt(nprtj)=jo2 + + call timsho(1,2) + + nprtjx=1 + pprtx(1,nprtjx)=0. + pprtx(2,nprtjx)=0. + pprtx(3,nprtjx)=en/2. + pprtx(4,nprtjx)=en/2. + pprtx(5,nprtjx)=0 + nprtjx=2 + pprtx(1,nprtjx)=0. + pprtx(2,nprtjx)=0. + pprtx(3,nprtjx)=-en/2. + pprtx(4,nprtjx)=en/2. + pprtx(5,nprtjx)=0 + + return + end + +c--------------------------------------------------------------------- + subroutine timsho(j1,j2) +c--------------------------------------------------------------------- + + + include 'epos.inc' + include 'epos.incsem' + parameter (ntim=1000) + common/cprt/pprt(5,ntim),q2prt(ntim),idaprt(2,ntim),idprt(ntim) + &,iorprt(ntim),jorprt(ntim),nprtj + dimension pz(ntim),id(2,ntim) + dimension ij(2),jo(2,2),ee(2),amm2(-6:10),q2s(2) + logical first + common/nfla/nfla + call utpri('timsho',ish,ishini,5) + if(iappl.eq.6)then + do i=1,6 + call idmass(i,am) + amm2(i)=am**2 + amm2(-i)=am**2 + enddo + else + do i=1,6 + amm2(i)=0. + amm2(-i)=0. + enddo + endif + amm2(9)=0. + amm2(0)=0. + amm2(10)=0. + nn=nprtj + ij(1)=j1 + ij(2)=j2 + ii2=2 + if(j2.eq.0)ii2=1 + + ii=1 + first=.true. + n10=0 + 10 n10=n10+1 + if(float(n10).gt.1e7)then + goto9999 + endif + io=iorprt(ij(ii)) + idfl=idprt(ij(ii)) + q2start=pprt(5,ij(ii))**2 + E=pprt(4,ij(ii)) + if(ij(2).eq.j2.and.ii2.eq.2)E=pprt(4,ij(1))+pprt(4,ij(2)) + zetamx=0. + if(ij(1).ne.j1)then + zetamx=pprt(5,io)/pprt(4,io)/sqrt(pz(io)*(1.-pz(io))) + endif + + +c call timdev(idfl,q2start,E,zetamx,idfla,idflb,qa2,z) +c...................................................................... + q2=q2start + z=0.5 + PT2MIN=max(qcdlam*1.1,q2fin) + ALFM=LOG(PT2MIN/qcdlam) + if(ish.ge.9)then + write (ifch,*) '---------------------',ii + $ ,pprt(5,ij(1)) !,pprt(5,ij(2)) + write(ifch,*) ' idfl,q2start,zetamx:',idfl,q2start,zetamx + endif + if (q2.lt.4.*q2fin+2.*amm2(idfl) )then + if(ish.ge.9)then + write(ifch,'(a,f3.0)') 'null:',0. + endif + q2=amm2(idfl) + idfla=0 + idflb=0 + goto 999 + endif + + + 390 zc=.5*(1.-sqrt(max(0.000001,1.-4.*q2fin/q2))) + if(ish.ge.9)then + write(ifch,*) 'zc=',zc + endif + IF(idfl.EQ.9) THEN + FBRqqb=nfla*(0.5-ZC) + FBR=6.*LOG((1.-ZC)/ZC)+FBRqqb + ELSE + FBRqqb=0. + FBR=(8./3.)*LOG((1.-ZC)/ZC) + endif + + B0=(33.-2.*nfla)/6. + + +c.....select new q2 + r=rangen() + q2=q2*exp(log(r)*B0*ALFM/FBR) + if(ish.ge.9)then + write(ifch,*) 'q^2=',q2 + endif + if (q2.lt.4.*q2fin+2.*amm2(idfl))then + q2=amm2(idfl) + if(ish.ge.9)then + write(ifch,'(a,f3.0)') 'null:',0. + endif + idfla=0 + idflb=0 + goto 999 + endif + + +c.....select flavor and z-value ..................................... + IF(idfl.EQ.9) THEN + if(rangen()*FBR.lt.FBRqqb)then + ! .................g -> qqbar + Z=ZC+(1.-2.*ZC)*rangen() + IF(Z**2+(1.-Z)**2.LT.rangen()) GOTO 390 + idfla=int(1.+rangen()*real(nfla)) + idflb=-idfla + else !..................g -> gg + Z=(1.-ZC)*(ZC/(1.-ZC))**rangen() + IF(rangen().GT.0.5) Z=1.-Z + IF((1.-Z*(1.-Z))**2.lt.rangen()) GOTO 390 + idfla=9 + idflb=9 + endif + ELSE + Z=1.-(1.-ZC)*(ZC/(1.-ZC))**rangen() !!........q -> qg + IF(1.+Z**2.LT.2.*rangen()) GOTO 390 + idfla=idfl + idflb=9 + endif + + if(q2*z*(1.-z).le.qcdlam) goto 390 + if(alfm.lt.rangen()*log(q2*z*(1.-z)/qcdlam)) goto 390 + + + if(ij(1).ne.j1.or.ij(2).eq.0)then + if(E.le.sqrt(q2))goto 390 + pzz=sqrt((E-sqrt(q2))*(E+sqrt(q2))) + pt2=(E**2*(z*(1.-z)*q2-z*amm2(idflb)-(1.-z)*amm2(idfla)) + $ -.25*(amm2(idflb)-amm2(idfla)-q2)**2+q2*amm2(idfla))/pzz**2 + if (pt2.le.0.) then + if(ish.ge.9)then + write(ifch,*) 'z not good for pt2:',z,pt2 + endif + goto 390 + endif + endif + + zeta = sqrt(q2)/E/sqrt(z*(1.-z)) + if(zetamx.gt.0)then + if (zeta.gt.zetamx)then + if(ish.ge.9)then + write(ifch,*) zeta,' > ',zetamx,'zeta-Ablehnung' + endif + goto 390 + endif + endif + 999 continue + +c...................................................................... + if(zeta.gt.zetacut)then + q2s(ii)=q2 + if(idfla.eq.9)then !anything -> gluon jet + jo(1,ii)=-9 + elseif(jorprt(ij(ii)).eq.-9)then !gluon -> quark jet + jo(1,ii)=idfla + else !no change + jo(1,ii)=jorprt(ij(ii)) + endif + if(idflb.eq.9)then !anything -> gluon jet + jo(2,ii)=-9 + elseif(jorprt(ij(ii)).eq.-9)then !gluon -> quark jet + jo(2,ii)=idflb + else + jo(2,ii)=jorprt(ij(ii)) + endif + else !no change + jo(1,ii)=jorprt(ij(ii)) + jo(2,ii)=jorprt(ij(ii)) + q2s(ii)=q2prt(ij(ii)) + endif + + pprt(5,ij(ii))=sqrt(q2) + id(1,ii)=idfla + id(2,ii)=idflb + pz(ij(ii))=z + if(first)then + ii=2 + first=.false. + if(ii2.eq.2)goto 10 + endif + + if(ij(2).eq.0)then + z1=1. + z2=0. + pt=0. + alpha=0. + pprt(3,ij(1))=sqrt(E**2-pprt(5,ij(1))**2) + elseif(ij(1).eq.j1.and.ij(2).eq.j2)then + E=pprt(4,ij(1))+pprt(4,ij(2)) + ee(1)=E*.5+(pprt(5,ij(1))**2-pprt(5,ij(2))**2)/2./E + ee(2)=E-ee(1) + ii=1 + do while (ii.le.2) + if(ee(ii)-pprt(5,ij(ii)).lt.0.) then + if(ish.ge.5)then + write(ifch,*) 'goto 11' + endif + ii=1 + if ( pprt(5,ij(1))**2-amm2(idprt(ij(1))).lt. + $ pprt(5,ij(2))**2-amm2(idprt(ij(2))) ) ii=2 + goto 10 + endif +c zc=.5*(1.-sqrt(1.-pprt(5,ij(ii))**2/ee(ii)**2)) +c if(pz(ij(ii)).lt.zc.or.pz(ij(ii)).gt.1.-zc)then +c if(ish.ge.7)then +c write(ifch,*) 'first branching rejected' +c endif +c goto 10 +c endif + z=pz(ij(ii)) + q2=pprt(5,ij(ii))**2 + pzz=sqrt((ee(ii)-pprt(5,ij(ii)))*(ee(ii)+pprt(5,ij(ii)))) + if(pzz.gt.0.)then + pt2=(ee(ii)**2*(z*(1.-z)*q2-z*amm2(id(2,ii)) + $ -(1.-z)*amm2(id(1,ii))) + $ -.25*(amm2(id(2,ii))-amm2(id(1,ii))-q2)**2 + $ +q2*amm2(id(1,ii)))/pzz**2 + else + pt2=0. + endif + if(id(1,ii).ne.0.and.pt2.le.0.)then + if(ish.ge.7)then + write(ifch,*) 'first branching rejected for pt2',ii + $ ,z1,q2,ee(ii),pprt(5,ij(ii)),id(1,ii),id(2,ii) + endif + goto 10 + endif + ii=ii+1 + enddo + z1=ee(1)/E + z2=ee(2)/E + if(ish.ge.7)then + write(ifch,*) 'z of first branching',z1 + endif + pprt(3,ij(1))= sqrt(max(0.,ee(1)**2-pprt(5,ij(1))**2)) + pprt(3,ij(2))=-sqrt(max(0.,ee(2)**2-pprt(5,ij(2))**2)) + pt=0. + alpha=0. + else + E=pprt(4,io) + z1=pz(io) + z2=1.-z1 + am0=pprt(5,io) + am1=pprt(5,ij(1)) + am2=pprt(5,ij(2)) + aM=am2**2-am0**2-am1**2 + pzz=sqrt((E-am0)*(E+am0)) + pprt(3,ij(1))=.5*(aM+2.*z1*E**2)/pzz + pprt(3,ij(2))=pzz-pprt(3,ij(1)) + pt2=(E**2*(z1*z2*am0**2-z1*am2**2-z2*am1**2) + $ -.25*aM**2+am0**2*am1**2)/pzz**2 + if(ish.ge.8)then + write(ifch,*) 'pt2,pzz=',pt2,pzz,z1**2*E*pprt(5,io),z1,E + $ ,pprt(5,io) + endif + if(pt2.lt.0.) then + ii=1 + if ( pprt(5,ij(1))**2-amm2(idprt(ij(1))).lt. + $ pprt(5,ij(2))**2-amm2(idprt(ij(2))) ) ii=2 + goto 10 + endif + pt=sqrt(pt2) + alpha=2.*pi*rangen() + endif + pprt(4,ij(1))=z1*E + pprt(1,ij(1))=cos(alpha)*pt + pprt(2,ij(1))=sin(alpha)*pt + if(ii2.eq.2)then + pprt(4,ij(2))=z2*E + pprt(1,ij(2))=-cos(alpha)*pt + pprt(2,ij(2))=-sin(alpha)*pt + endif + if(ij(1).ne.j1)then + if(pprt(1,io).ne.0..or.pprt(2,io).ne.0.)then + do ii=1,2 + call utrota(-1,pprt(1,io),pprt(2,io),pprt(3,io) + & ,pprt(1,ij(ii)),pprt(2,ij(ii)),pprt(3,ij(ii))) + enddo + endif + endif + if(ij(1).ne.j1)then + if(pprt(3,io).lt.0.)then + do k=1,3 + do ii=1,2 + pprt(k,ij(ii)) = -pprt(k,ij(ii)) + enddo + enddo + endif + endif + do ii=1,ii2 + if(id(1,ii).ne.0)then + idprt(nprtj+1)=id(1,ii) + idprt(nprtj+2)=id(2,ii) + pprt(4,nprtj+1)=pz(ij(ii))*pprt(4,ij(ii)) + pprt(5,nprtj+1)=pz(ij(ii))*pprt(5,ij(ii)) + pprt(4,nprtj+2)=(1.-pz(ij(ii)))*pprt(4,ij(ii)) + pprt(5,nprtj+2)=(1.-pz(ij(ii)))*pprt(5,ij(ii)) + q2prt(nprtj+1)=q2s(ii) + q2prt(nprtj+2)=q2s(ii) + iorprt(nprtj+1)=ij(ii) + iorprt(nprtj+2)=ij(ii) + jorprt(nprtj+1)=jo(1,ii) + jorprt(nprtj+2)=jo(2,ii) + idaprt(1,ij(ii))=nprtj+1 + idaprt(2,ij(ii))=nprtj+2 + idaprt(1,nprtj+1)=0 + idaprt(2,nprtj+1)=0 + idaprt(1,nprtj+2)=0 + idaprt(2,nprtj+2)=0 + nprtj=nprtj+2 + else + idaprt(1,ij(ii))=0 + idaprt(2,ij(ii))=0 + endif + enddo + if(ish.ge.5)then + if(ij(1).ne.j1)then + write(ifch,98) io,(pprt(j,io),j=1,5),pz(io),jorprt(io) + & ,idprt(io) + write(ifch,*) '->' + endif + write(ifch,99) ij(1),(pprt(j,ij(1)),j=1,5),pz(ij(1)) + & ,jo(1,1),jo(2,1),idprt(ij(1)),'->',id(1,1),id(2,1) + if(ij(2).ne.0)write(ifch,99) ij(2), + & (pprt(j,ij(2)),j=1,5),pz(ij(2)) + & ,jo(1,2),jo(2,2),idprt(ij(2)),'->',id(1,2),id(2,2) + write(ifch,*) + endif + + 98 format(i4,6g10.3,3i3) + 99 format(i4,6g10.3,3i3,a,2i4) + + + if(ij(1).le.nn)ij(1)=nn-1 + ij(1)=ij(1)+2 + ij(2)=ij(1)+1 + ii=1 + ii2=2 + first=.true. + if(ij(1).le.nprtj)goto 10 + + if(ish.ge.5)then + write(ifch,*) + do i=1,nprtj + write(ifch,'(i4,1x,5g10.4,2i4,a,2i4)') + & i,(pprt(j,i),j=1,5),idprt(i) + & ,iorprt(i),' -->',idaprt(1,i),idaprt(2,i) + enddo + write(ifch,*) + endif + 9999 call utprix('timsho',ish,ishini,5) + return + end + diff --git a/modules/epos/epos-uti-lhc.f b/modules/epos/epos-uti-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..58ba27bd18d3e5fbccd788f52fb5527fb9ba80d1 --- /dev/null +++ b/modules/epos/epos-uti-lhc.f @@ -0,0 +1,3943 @@ +c----------------------------------------------------------------------- + subroutine utresc(iret) +c----------------------------------------------------------------------- +c if irescl=1 rescaling is done, otherwise the purpose of going through +c this routine is to not change the seed in case of no rescaling +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + double precision p1,esoll,ppp,seedp,psoll,pt1soll,pt2soll + dimension p1(5),p2(4),p0(5,mamx+mamx),pini(mxptl) + logical force,nolead(mxptl),lspec(mxptl),lim + data scalmean/0./scalevt/0./ + save scalmean,scalevt + call utpri('utresc',ish,ishini,4) + + errlim=0.005 !max(0.001,1./engy) + if(iLHC.eq.1)errlim=max(0.00005,0.5/engy) + + iret=0 + nptlpt=iabs(maproj)+iabs(matarg) + call ranfgt(seedp) !not to change the seed ... + if(nptl.le.nptlpt) goto 9999 + + if(ish.ge.8)then + call alistf('list before boost&') + endif + esoll=0.d0 + psoll=0.d0 + p1(1)=0.d0 + p1(2)=0.d0 + p1(3)=0.d0 + p1(4)=0.d0 + p2(3)=0.d0 + p2(4)=0.d0 + ipmax=4 + imin=nptlpt+1 + if(iappl.eq.1)then + imin=1 + ipmax=2 + if(iLHC.eq.1)ipmax=0 + endif +c store projectile and target in p0 and sum pz an E in p1(3) and p1(4) + do i=1,nptlpt + nolead(i)=.false. + do j=1,5 + p0(j,i)=dble(pptl(j,i)) + enddo +c calculate total energy of primaries +c if(mod(istptl(i),10).eq.1)then + do j=ipmax+1,4 + p1(j)=p1(j)+dble(pptl(j,i)) + enddo +c endif +c calculate total energy of secondaries + if(mod(istptl(i),10).eq.0)then + do j=ipmax+1,4 + p2(j)=p2(j)+dble(pptl(j,i)) + enddo + endif + enddo +c fix secondaries counted in the system + do i=nptlpt+1,nptl + if(mod(istptl(i),10).eq.0)then +c check maximum energy + if(iLHC.eq.1.and.pptl(4,i).gt.engy*0.51)then + if(ish.ge.1)write(ifch,*)'Energy of particle too high !' + & ,i,ityptl(i),pptl(4,i) +c call utstop('utresc&') + if(ityptl(i).eq.48.or.ityptl(i).eq.58 !diffractive resonance + & .or.ityptl(i).eq.47.or.ityptl(i).eq.57)then !active spectators + pptl(4,i)=0.5*engy + amt=sqrt(pptl(1,i)**2+pptl(2,i)**2+pptl(5,i)**2) + pptl(3,i)=(pptl(4,i)+amt)*(pptl(4,i)-amt) + if(pptl(3,i).gt.0.)then + pptl(3,i)=sqrt(pptl(3,i)) + else + iret=1 + endif + else + iret=1 + endif + if(iret.eq.1)then + if(ish.ge.1)write(ifch,*)'Warning in utresc: redo event...' +c call utstop('Energy of particle too high !&') + goto 9999 + endif + endif +c fix pt (p1(1) and p2(1)) from secondaries + do j=1,ipmax + p1(j)=p1(j)+dble(pptl(j,i)) + enddo +c calculate total energy of secondaries + do j=ipmax+1,4 + p2(j)=p2(j)+dble(pptl(j,i)) + enddo + lspec(i)=.false. + if(((ityptl(i).eq.45.or.ityptl(i).eq.48).and.maproj.ge.100) + & .or.((ityptl(i).eq.55.or.ityptl(i).eq.58).and.matarg.ge.100)) + & lspec(i)=.true. + if((abs(pptl(3,i)/pnullx).le.0.9 + & .and.abs(pptl(3,i)).gt.pptl(5,i)).or.lspec(i))then + nolead(i)=.true. +c write(ifch,*)'nolead',i + else + nolead(i)=.false. +c write(ifch,*)'lead',i + endif + endif + enddo + psoll=max(dble(pnullx),abs(p1(3))) +c check if energy is conserved before boost + if(iappl.eq.1)then + diff=abs(p2(3)-p1(3)) + scal=p2(4)/p1(4) + if(abs(scal-1.).le.errlim.and.abs(diff/psoll).lt.errlim + & .and.(iLHC.eq.0.or. + & (abs(p2(1)).lt.errlim.and.abs(p2(2)).lt.errlim)))then + if(ish.ge.4) + & write (ifch,'(2x,a,2g14.6)') 'Energy OK: ',scal,abs(diff/psoll) + goto 9999 + else + diff=0. + scal=1. + endif + endif +c calculate boost vector to have sum of pt=0 and sum of pz=0 + ppp=(p1(4)+p1(3))*(p1(4)-p1(3))-p1(2)*p1(2)-p1(1)*p1(1) + if(ppp.gt.0.d0)then + p1(5)=sqrt(ppp) + else + iret=1 + write(ifch,*)'p1',p1(1),p1(2),p1(3),p1(4),ppp + if(ish.ge.2)write (ifch,*) 'Problem in utresc (1): redo event' + write (ifmt,*) 'Problem in utresc (1): redo event' +c call utstop('utresc&') + goto 9999 + endif + esoll=p1(5) + if(ish.ge.4) write (ifch,'(a,5g14.6)') 'boost-vector: ',p1 + +c trafo +c ----- + pmax=0.d0 + npart=0 + pt1soll=0.d0 + pt2soll=0.d0 + do i=imin,nptl + if(mod(istptl(i),10).le.1)then + call utlob4(1,p1(1),p1(2),p1(3),p1(4),p1(5) + $ ,pptl(1,i),pptl(2,i),pptl(3,i),pptl(4,i)) + if(mod(istptl(i),10).eq.0.and.i.gt.nptlpt)then + npart=npart+1 + pt1soll=pt1soll+dble(pptl(1,i)) + pt2soll=pt2soll+dble(pptl(2,i)) + endif + endif + if(i.gt.nptlpt.and.nolead(i))pmax=max(pmax,abs(pptl(3,i))) + enddo + + if(ish.ge.6)then + call alistf('list after boost&') + endif + + if(ish.ge.5)write(ifch,'(a)')'--------rescale momenta----------' + + if(iLHC.eq.1)then + + if(ish.ge.6)write(ifch,*)'ptsoll:',pt1soll,pt2soll,npart + pt1soll=pt1soll/dble(npart) + pt2soll=pt2soll/dble(npart) + do i=nptlpt+1,nptl + if(mod(istptl(i),10).eq.0)then + pptl(1,i)=pptl(1,i)-sngl(pt1soll) + pptl(2,i)=pptl(2,i)-sngl(pt2soll) + pptl(4,i)=sqrt(pptl(1,i)**2+pptl(2,i)**2 + & +pptl(3,i)**2+pptl(5,i)**2) + endif + enddo + + endif + + if(ish.ge.6)write(ifch,*)'esoll,psoll,pmax:',esoll,psoll,pmax + +c rescale momenta in rest frame +c ----------------------------- + scal=1. + diff0=0. +c ndif0=1 + ferr=0.05 + force=.false. + npart=nptl-imin+1 + do ipass=1,300 + sum=0. + sum3=0. + difft=diff0 + ndif=0 + nfirst=int(rangen()*float(npart)) !start list randomly + do i=0,npart-1 + j=imin+i+nfirst + if(j.gt.nptl)j=imin+i+nfirst-npart + if(mod(istptl(j),10).eq.0)then +c modified particles + if(nolead(j))then +c if(j.gt.nptlpt)then +c if(abs(pptl(3,j))/pnullx.lt.0.9)then !not spectator or diffraction + if(scal.eq.1..and.abs(diff0).lt.1.e-6)then + ndif=ndif+1 + pini(j)=pptl(3,j) + else + pptl3new=0. + if( force .or.( + & ityptl(j)/10.eq.4.or.ityptl(j)/10.eq.5 + & ))then !try just remnant first + ndif=ndif+1 + diff=sign(min(0.3*abs(pini(j)), + & rangen()*abs(difft)),difft) + pptl3new=scal*(pptl(3,j)-diff) +c write(ifch,*)'par',j,pptl3new,pptl(3,j),diff,difft +c & ,ndif,pmax,scal + if(abs(pptl3new).lt.pmax)then +c particle should not be too fast or too modified + if(abs(pptl3new-pini(j)).lt.ferr*abs(pini(j)) + & .or.(lspec(j).and.abs(pptl3new).lt.abs(0.8*pini(j))))then +c write(ifch,*)'used' + difft=difft-diff + pptl(3,j)=scal*(pptl(3,j)-diff) + pptl(4,j)=sqrt(pptl(1,j)**2+pptl(2,j)**2 + * +pptl(3,j)**2+pptl(5,j)**2) + endif + endif + endif + endif + endif +c sum over all particles + sum=sum+pptl(4,j) + sum3=sum3+pptl(3,j) + endif + enddo + + diff=sum3 + scal=sngl(esoll)/(sum-diff) + if(ish.ge.6)write(ifch,*) + $ 'ipass,scal,diff/psoll,e,pz,ndif,f:' + $ ,ipass,scal,diff/psoll,sum,sum3,ndif,force + if(abs(scal-1.).le.errlim.and.abs(diff/psoll).lt.errlim) + $ goto 300 + if(ndif.gt.0.and.(force.or.ipass.lt.150))then +c ndif0=ndif + diff0=diff + elseif(abs(scal-1.).le.1e-2.and.abs(diff/psoll).lt.5e-2 + & .and.iLHC.eq.0)then + goto 300 + elseif(force)then + if(ish.ge.2) + $ write(ifmt,*)'Warning in utresc: no more allowed particle' + goto 302 + else + force=.true. + ferr=0.1 + diff=0. + endif + enddo + 302 if(iLHC.eq.1)then + lim=.not.(abs(scal-1.).le.errlim.and.abs(diff/psoll).lt.errlim) + else + lim=abs(scal)+abs(diff/psoll).gt.2.5 + endif + + if(ish.ge.1)then + call utmsg('utrescl') + write(ifch,*)'***** scal=',scal,diff/psoll,lim + call utmsgf + endif + + if(lim)then + if(ish.ge.1)then + write(ifmt,*)'Warning in utresc !' + write(ifch,'(a,i10,d25.15)')'redo EPOS event ...' + & ,nint(seedj),seedc + endif + iret=1 + goto 9999 + endif + +c trafo +c ----- + 300 continue + + do i=1,nptl + if(i.le.nptlpt)then + do j=1,5 + pptl(j,i)=p0(j,i) + enddo + else + if(mod(istptl(i),10).le.1)then + call utlob4(-1,p1(1),p1(2),p1(3),p1(4),p1(5) + $ ,pptl(1,i),pptl(2,i),pptl(3,i),pptl(4,i)) + endif + endif + enddo + + if(ish.ge.4)call alist('list after rescaling&',1,nptl) + + 9999 continue + if(ish.ge.2)then + scalevt=scalevt+1. + scalmean=scalmean+scal + write(ifch,*)' average rescaling factor: ',scalmean + & /scalevt + endif + call ranfst(seedp) ! ... after this subroutine + call utprix('utresc',ish,ishini,4) + + end + +c----------------------------------------------------------------------- + subroutine utghost(iret) +c----------------------------------------------------------------------- +c if irescl=1 make particle on-shell if not +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + double precision seedp + call utpri('ughost',ish,ishini,4) + + iret=0 + nptlpt=iabs(maproj)+iabs(matarg) + if(iappl.eq.6.or.iappl.eq.8)nptlpt=3 ! ee or DIS + call ranfgt(seedp) !not to change the seed ... + if(nptl.le.nptlpt) goto 9999 + + if(ish.ge.5)write(ifch,'(a)')'---------mark ghosts---------' + +c mark ghosts +c ----------- + do j=nptlpt+1,nptl + if(istptl(j).le.1.and.pptl(4,j).gt.0.d0)then + if(iLHC.eq.0.or.mod(abs(idptl(j)),10).le.1)then !for LHC tune don't fix mass of resonnances (to keep width) + amass=pptl(5,j) + call idmass(idptl(j),amass) + if(abs(idptl(j)).gt.100.and. + & abs(pptl(5,j)-amass).gt.0.01*amass)then + if(ish.ge.5)write(ifch,*)'wrong particle mass',j,idptl(j) + & ,pptl(5,j),amass + amass=pptl(5,j) + call idres(idptl(j),amass,idr,iadj) + if(idr.ne.0)then + pptl(5,j)=amass + idptl(j)=idr + else + call idmass(idptl(j),amass) + pptl(5,j)=amass + endif + call idtau(idptl(j),pptl(4,j),pptl(5,j),taugm) + tivptl(2,j)=tivptl(1,j)+taugm*(-alog(rangen())) + else + pptl(5,j)=amass + endif + endif + if(abs((pptl(4,j)+pptl(3,j))*(pptl(4,j)-pptl(3,j)) + $ -pptl(2,j)**2-pptl(1,j)**2-pptl(5,j)**2).gt.0.3 + $ .and.abs(1.-abs(pptl(3,j))/pptl(4,j)).gt.0.01)then + !print*,'ghost',ityptl(j),idptl(j) + if(ish.ge.1)write(ifmt,*)'ghost:',j,idptl(j),ityptl(j) + if(ish.ge.5)then + write(ifch,'(a,$)')'ghost:' + call alistc("&",j,j) + endif + ityptl(j)=100+ityptl(j)/10 + elseif(irescl.ge.1)then +c ensure that all particles are really on-shell + pptl(4,j)=sqrt(pptl(1,j)**2+pptl(2,j)**2 + * +pptl(3,j)**2+pptl(5,j)**2) + endif + elseif(mod(istptl(j),10).eq.0)then +c if not droplet with fusion + if(istptl(j).ne.10.or.iorsdf.ne.3)then + if(ish.ge.1)then + write(ifmt,*)'Lost particle (E=0)' + write(ifch,*)'Lost particle (E=0) :' + call alistc("utghost&",j,j) + endif + istptl(j)=istptl(j)+2 + endif + endif + enddo + + if(ish.ge.5)write(ifch,'(a)')'---------treat ghosts---------' + +c treat ghosts +c ------------ + ifirst=1 + scal=1. + pfif=0. + efif=0. + ntry=0 + 132 nfif=0 + psum=0 + esum=0. + ntry=ntry+1 + do j=nptlpt+1,nptl + if(mod(istptl(j),10).eq.0)then + if(ityptl(j).gt.100)then + nfif=nfif+1 + if(ifirst.eq.1)then + pfif=pfif+pptl(3,j) + if(pptl(4,j).gt.0.)efif=efif+pptl(4,j) + endif + if(irescl.ge.1) then + if(ifirst.gt.1)then + if(pptl(4,j).gt.0.)then + Einv=1./pptl(4,j) + amt=1.-(pptl(5,j)*Einv)**2+(pptl(1,j)*Einv)**2 + $ +(pptl(2,j)*Einv)**2 + else + amt=-1. + endif + if(amt.gt.0.)then + pptl(3,j)=sign(pptl(4,j),pptl(3,j))*sqrt(amt) + else + y=(rangen()+rangen()+rangen()+rangen()-2.)/2.*yhaha + y=sign(abs(y),pptl(3,j)) + pptl(3,j) + $ =sqrt(pptl(5,j)**2+pptl(1,j)**2 + $ +pptl(2,j)**2)*sinh(y) + pptl(4,j) + $ =sqrt(pptl(5,j)**2+pptl(1,j)**2 + $ +pptl(2,j)**2)*cosh(y) + efif=efif+pptl(4,j) + endif + ifirst=0 + else +c do k=1,3 + do k=3,3 + pptl(k,j)=pptl(k,j)*scal + enddo + pptl(4,j)=sqrt(pptl(1,j)**2+pptl(2,j)**2+pptl(3,j)**2 + * +pptl(5,j)**2) + endif + endif + psum=psum+pptl(3,j) + esum=esum+pptl(4,j) + if(ish.ge.5) + $ write (ifch,*) 'nrevt,psum,esum,pfif,efif,nfif,scal' + $ ,nrevt,psum,esum,pfif,efif,nfif,scal + endif + endif + enddo + if ( ish.ge.5 ) write (ifch,*) 'tot',nfif,efif,pfif,esum,psum + + + if(nfif.gt.5.or.(esum.gt.0.05*engy.and.nfif.ne.1))then + if(ifirst.eq.0)then + do j=nptlpt+1,nptl + if ( ityptl(j).ge.101 .and. ityptl(j).le.105 )then + if((psum-pfif)*(1.-scal).ge.0) + & pptl(3,j)=pptl(3,j)-(psum-pfif)/nfif + endif + enddo + else + ifirst=2 + goto 132 + endif + scal=efif/esum + if ( ish.ge.5 ) write (ifch,*) 'scal',scal + if ( abs(scal-1.) .gt. 0.05 ) then + if(ntry.le.1000)then + goto 132 + else + iret=1 + if(ish.ge.2)write (ifch,*) 'Problem in utghost : redo event' + if(ish.ge.1)write (ifmt,*) 'Problem in utghost : redo event' + goto 9999 + endif + endif + else + do j=nptlpt+1,nptl + if ( ityptl(j).ge.101 .and. ityptl(j).le.105 )then + pptl(4,j)=sqrt(pptl(1,j)**2+pptl(2,j)**2+pptl(3,j)**2 + * +pptl(5,j)**2) + endif + enddo + endif + + if(ish.ge.5)write(ifch,'(a)')'---------Check Ghost list---------' + +c Check Ghost list + + if(ish.ge.5)then + do j=nptlpt+1,nptl + if(mod(istptl(j),10).eq.0)then + if(ityptl(j).le.105.and.ityptl(j).ge.101)then + write(ifch,'(a,$)')'ghost:' + call alistc("&",j,j) + endif + endif + enddo + endif + + + 9999 continue + call ranfst(seedp) ! ... after this subroutine + call utprix('ughost',ish,ishini,4) + + end + +c----------------------------------------------------------------------- + subroutine utrsph(iret) +c----------------------------------------------------------------------- +c if irescl=1 and ispherio=1 rescaling is done for particle used by +c spherio as initial condition. +c----------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + double precision p1,esoll + dimension p1(5),p0(5,mamx+mamx) + call utpri('utrsph',ish,ishini,4) + + errlim=0.0001 + + iret=0 + nptlpt=iabs(maproj)+iabs(matarg) + if(nptl.le.nptlpt) goto 9999 + + esoll=0.d0 + p1(1)=0.d0 + p1(2)=0.d0 + p1(3)=0.d0 + p1(4)=0.d0 + do i=nptlpt+1,nptl + if((istptl(i).le.11 + $ .and.(iorptl(i).ge.1.and.istptl(iorptl(i)).eq.41)) + $ .or.istptl(i).eq.20.or.istptl(i).eq.21)then + do j=1,2 + p1(j)=p1(j)+dble(pptl(j,i)) + enddo + endif + enddo + do i=1,nptlpt + do j=1,5 + p0(j,i)=pptl(j,i) + enddo + do j=3,4 + p1(j)=p1(j)+dble(pptl(j,i)) + enddo + enddo + p1(5)=dsqrt((p1(4)+p1(3))*(p1(4)-p1(3))-p1(2)**2.d0-p1(1)**2.d0) + esoll=p1(5) + if(ish.ge.4) write (ifch,'(a,5g13.6)') 'boost-vector',p1 + +c trafo +c ----- + do i=1,nptl + if((istptl(i).le.11 + $ .and.(iorptl(i).ge.1.and.istptl(iorptl(i)).eq.41)) + $ .or.istptl(i).eq.20.or.istptl(i).eq.21 + $ .or.(istptl(i).eq.0.and.i.le.nptlpt))then + call utlob4(1,p1(1),p1(2),p1(3),p1(4),p1(5) + $ ,pptl(1,i),pptl(2,i),pptl(3,i),pptl(4,i)) + endif + enddo + + + if(ish.ge.5)write(ifch,'(a)')'------------------' + +c rescale momenta in rest frame +c ----------------------------- + + scal=1. + diff=0. + do ipass=1,1000 + sum=0. + sum3=0. + ndif=0 + do j=1,nptl + if((istptl(j).le.11 + $ .and.(iorptl(j).ge.1.and.istptl(iorptl(j)).eq.41)) + $ .or.istptl(j).eq.20.or.istptl(j).eq.21 + $ .or.(istptl(j).eq.0.and.j.le.nptlpt))then + if(j.gt.nptlpt)then + ndif=ndif+1 + pptl(3,j)=scal*(pptl(3,j)-diff) + pptl(4,j)=sqrt(pptl(1,j)**2+pptl(2,j)**2+pptl(3,j)**2 + * +pptl(5,j)**2) + endif + sum=sum+pptl(4,j) + sum3=sum3+pptl(3,j) + endif + enddo + + diff=sum3/real(ndif) + scal=real(esoll)/sum + if(ish.ge.6)write(ifch,*)'ipass,scal,diff,e,esoll,pz,ndif:' + $ ,ipass,scal,diff,sum,esoll,sum3,ndif + if(abs(scal-1.).le.errlim.and.abs(diff).lt.10.*errlim) goto300 + enddo + if(ish.ge.1)then + call utmsg('hresph') + write(ifch,*)'***** scal=',scal,diff + call utmsgf + endif + + +c trafo +c ----- + 300 continue +c do i=nptlpt+1,nptl + do i=1,nptl + if((istptl(i).le.11 + $ .and.(iorptl(i).ge.1.and.istptl(iorptl(i)).eq.41)) + $ .or.istptl(i).eq.20.or.istptl(i).eq.21 + $ .or.(istptl(i).eq.0.and.i.le.nptlpt))then + call utlob4(-1,p1(1),p1(2),p1(3),p1(4),p1(5) + $ ,pptl(1,i),pptl(2,i),pptl(3,i),pptl(4,i)) + endif + if(i.le.nptlpt)then + do j=1,5 + pptl(j,i)=p0(j,i) + enddo + endif + enddo + + 9999 call utprix('utrsph',ish,ishini,4) + + end + +cc----------------------------------------------------------------------- +c double precision function dddlog(xxx) +cc----------------------------------------------------------------------- +c double precision xxx +c dddlog=-1d50 +c if(xxx.gt.0d0)dddlog=dlog(xxx) +c end +c +ccc----------------------------------------------------------------------- +c subroutine randfl(jc,iqa0,iflav,ic,isame) +cc----------------------------------------------------------------------- +cc returns random flavour ic(2) (iqa0=1:quark,2:antiquark,11:diquark) +cc----------------------------------------------------------------------- +c include 'epos.inc' +c real probab(nflav),probsu(nflav+1) +c integer jc(nflav,2),jc0(nflav,2),ic(2) +c if(ish.ge.6)then +c write(ifch,*)('-',i=1,10) +c *,' entry sr randfl ',('-',i=1,30) +c write(ifch,*)'iqa0:',iqa0 +c write(ifch,*)'jc:' +c write(ifch,*)jc +c endif +c iflav=0 +c ic(1)=0 +c ic(2)=0 +c do 10 n=1,nflav +c do 10 i=1,2 +c10 jc0(n,i)=0 +c iqa1=iqa0*10 +c9999 iqa1=iqa1/10 +c if(iqa1.eq.0)goto9998 +c iqa=mod(iqa1,10) +c su=0 +c do 20 i=1,nflav +c probab(i)=jc(i,iqa)-jc0(i,iqa) +c if(isame.eq.1)probab(i)=probab(i)*(jc(i,3-iqa)-jc0(i,3-iqa)) +c20 su=su+probab(i) +c if(su.lt..5)then +c iflav=0 +c ic(1)=0 +c ic(2)=0 +c goto9998 +c endif +c probsu(1)=0. +c do 30 i=1,nflav +c probsu(i+1)=probsu(i)+probab(i)/su +c if(probsu(i+1)-probsu(i).lt.1e-5)probsu(i+1)=probsu(i) +c30 continue +c r=rangen()*probsu(nflav+1) +c do 50 i=1,nflav +c if(probsu(i).le.r.and.r.lt.probsu(i+1))iflav=i +c50 continue +c jc0(iflav,iqa)=jc0(iflav,iqa)+1 +c if(isame.eq.1)jc0(iflav,3-iqa)=jc0(iflav,3-iqa)+1 +c call idenco(jc0,ic,ireten) +c if(ireten.eq.1)call utstop('randfl: idenco ret code = 1&') +c if(ish.ge.6)then +c write(ifch,*)'probab:' +c write(ifch,*)probab +c write(ifch,*)'probsu:' +c write(ifch,*)probsu +c write(ifch,*)'ran#:',r,' flav:',iflav +c endif +c goto9999 +c9998 continue +c if(ish.ge.6)write(ifch,*)('-',i=1,30) +c *,' exit sr randfl ',('-',i=1,10) +c return +c end +c +c +cc----------------------------------------------------------------------- +c subroutine ranhvy(x,eps) +cc----------------------------------------------------------------------- +cc generates x for heavy particle fragmentation according to +cc the peterson form +cc d(x)=1/(x*(1-1/x-eps/(1-x))**2) +cc =d0(x)*d1(x)*d2(x) +cc d0(x)=(1-x)**2/((1-x)**2+eps)**2 +cc d1(x)=x +cc d2(x)=(((1-x)**2+eps)/((1-x)**2+eps*x))**2 +cc using x=1-y**pow +cc generates flat in x if eps>1. +cc----------------------------------------------------------------------- +c data aln4/1.3863/ +c if(eps.lt.1.) then +c pow=alog((3.+eps)/eps)/aln4 +c ymx=(eps*(3.*pow-1.)/(pow+1.))**(.5/pow) +c zmx=1-ymx**pow +c d0mx=(1-zmx)**2/((1.-zmx)**2+eps)**2*pow*ymx**(pow-1.) +c d2mx=2./(2.-sqrt(eps)) +c else +c pow=1. +c zmx=0. +c d0mx=(1.-zmx)**2/((1.-zmx)**2+eps)**2 +c d2mx=1.+eps +c endif +cc +cc generate z according to (1-z)**2/((1-z)**2+eps*z)**2 +c1 continue +c y=rangen() +c z=1.-y**pow +cc +c d0z=(1.-z)**2/((1.-z)**2+eps)**2*pow*y**(pow-1.) +c if(d0z.lt.rangen()*d0mx) goto1 +cc +cc check remaining factors +c d1=z +c d2=(((1.-z)**2+eps)/((1.-z)**2+eps*z))**2 +c if(d1*d2.lt.rangen()*d2mx) goto1 +cc +cc good x +c x=z +c return +c end +c +*-- Author : D. HECK IK FZK KARLSRUHE 27/04/1994 +C======================================================================= + + SUBROUTINE EPOVAPOR( MAPRO,INEW,JFIN,ITYP,PFRX,PFRY,PFRZ ) + +C----------------------------------------------------------------------- +C (E)VAPOR(ATION OF NUCLEONS AND ALPHA PARTICLES FROM FRAGMENT) +C +C TREATES THE REMAINING UNFRAGMENTED NUCLEUS +C EVAPORATION FOLLOWING CAMPI APPROXIMATION. +C SEE: X. CAMPI AND J. HUEFNER, PHYS.REV. C24 (1981) 2199 +C AND J.J. GAIMARD, THESE UNIVERSITE PARIS 7, (1990) +C THIS SUBROUTINE IS CALLED FROM SDPM, DPMJST, NSTORE, AND VSTORE. +C ARGUMENTS INPUT: +C MAPRO = NUMBER OF NUCLEONS OF PROJECTILE +C INEW = PARTICLE TYPE OF SPECTATOR FRAGMENT +C ARGUMENTS OUTPUT: +C JFIN = NUMBER OF FRAGMENTS +C ITYP(1:JFIN) = NATURE (PARTICLE CODE) OF FRAGMENTS +C PFRX(1:JFIN) = TRANSVERSE MOMENTUM OF FRAGMENTS IN X-DIRECTION +C PFRY(1:JFIN) = TRANSVERSE MOMENTUM OF FRAGMENTS IN Y-DIRECTION +C PFRZ(1:JFIN) = LONGITUDINAL MOMENTUM OF FRAGMENTS IN Z-DIRECTION +C +C FROM CORSIKA AND ADAPTED BY T. PIEROG TO INCLUDE LONG MOMENTUM AND +C MORE REALISTIC FRAGMENTS +C----------------------------------------------------------------------- + + IMPLICIT NONE + include 'epos.inc' + common/eporansto2/irndmseq + integer irndmseq + + DOUBLE PRECISION PFR(mamxx),PFRX(mamxx),PFRY(mamxx),PFRZ(mamxx) + * ,RD(2*mamxx),SPFRY,SPFRZ,drangen + DOUBLE PRECISION AFIN,AGLH,APRF,BGLH,EEX,PHIFR,RANNORM,SPFRX + INTEGER ITYP(mamxx),IARM,INEW,ITYPRM,INRM,IS,IZRM,JC,lseq + * ,JFIN,K,L,LS,MAPRO,MF,NFIN,NINTA,NNUC,NPRF,NNSTEP + SAVE + EXTERNAL RANNORM +C----------------------------------------------------------------------- + + IF(ish.ge.7)WRITE(ifch,*)'EPOVAPOR : MAPRO,INEW=',MAPRO,INEW + + JC = 0 + JFIN = 0 + lseq = irndmseq + ITYPRM = INEW + NPRF = INEW/100 + NINTA = MAPRO - NPRF + IF ( NINTA .EQ. 0 ) THEN +C NO NUCLEON HAS INTERACTED + JFIN = 1 + PFRX(1) = 0.D0 + PFRY(1) = 0.D0 + PFRZ(1) = 0.D0 + ITYP(1) = ITYPRM + IF(ish.ge.7)WRITE(ifch,*) 'EPOVAPOR : JFIN,NINTA=',JFIN,NINTA + GOTO 50 + ENDIF + +C EXCITATION ENERGY EEX OF PREFRAGMENT +C SEE: J.J. GAIMARD, THESE UNIVERSITE PARIS 7, (1990), CHPT. 4.2 + EEX = 0.D0 + CALL RMMARD( RD,2*NINTA,lseq ) + DO L = 1, NINTA + IF ( RD(NINTA+L) .LT. RD(L) ) RD(L) = 1.D0 - RD(L) + EEX = EEX + RD(L) + ENDDO +C DEPTH OF WOODS-SAXON POTENTIAL TO FERMI SURFACE IS 0.040 GEV + IF(ish.ge.7)WRITE(ifch,*)'EPOVAPOR : EEX=',SNGL(EEX*0.04D0), + & ' GEV' +C EVAPORATION: EACH EVAPORATION STEP NEEDS ABOUT 0.020 GEV, THEREFORE +C NNSTEP IS EEX * 0.04/0.02 = EEX * 2. + NNSTEP = INT( EEX*2.D0 ) + + IF ( NNSTEP .LE. 0 ) THEN +C EXCITATION ENERGY TOO SMALL, NO EVAPORATION + JFIN = 1 + PFRX(1) = 0.D0 + PFRY(1) = 0.D0 + PFRZ(1) = 0.D0 + ITYP(1) = ITYPRM + IF(ish.ge.7)WRITE(ifch,*) 'EPOVAPOR : JFIN,EEX=',JFIN,SNGL(EEX) + GOTO 50 + + ENDIF + +C AFIN IS ATOMIC NUMBER OF FINAL NUCLEUS + APRF = DBLE(NPRF) + AFIN = APRF - 1.6D0 * DBLE(NNSTEP) + NFIN = MAX( 0, INT( AFIN+0.5D0 ) ) +C CORRESPONDS TO DEFINITION; FRAGMENTATION-EVAPORATION +C CONVOLUTION EMU07 /MODEL ABRASION EVAPORATION (JNC FZK APRIL 94) +C NNUC IS NUMBER OF EVAPORATING NUCLEONS + NNUC = NPRF - NFIN + IF(ish.ge.7)WRITE(ifch,*) 'EPOVAPOR : NFIN,NNUC=',NFIN,NNUC + + IF ( NNUC .LE. 0 ) THEN +C NO EVAPORATION + JFIN = 1 + PFRX(1) = 0.D0 + PFRY(1) = 0.D0 + PFRZ(1) = 0.D0 + ITYP(1) = ITYPRM + GOTO 50 + + ELSEIF ( NNUC .GE. 4 ) THEN +C EVAPORATION WITH FORMATION OF ALPHA PARTICLES POSSIBLE +C IARM, IZRM, INRM ARE NUMBER OF NUCLEONS, PROTONS, NEUTRONS OF +C REMAINDER + DO LS = 1, NNSTEP + IARM = ITYPRM/100 + IF ( IARM .LE. 0 ) GOTO 100 + IZRM = MOD(ITYPRM,100) + INRM = IARM - IZRM + JC = JC + 1 + CALL RMMARD( RD,2,lseq ) + IF ( RD(1) .LT. 0.2D0 .AND. IZRM .GE. 2 + * .AND. INRM .GE. 2 ) THEN + ITYP(JC) = -402 !alpha + NNUC = NNUC - 4 + ITYPRM = ITYPRM - 402 + ELSE + IF ( IZRM .EQ. 1 .AND. INRM .GT. IZRM ) THEN + ITYP(JC) = 1220 + ITYPRM = ITYPRM - 100 + ELSEIF ( INRM .EQ. 1 .AND. IZRM .GT. INRM ) THEN + ITYP(JC) = 1120 + ITYPRM = ITYPRM - 101 + ELSEIF(RD(2)*(IZRM+INRM).LT.IZRM.AND.IZRM.GE.INRM)THEN + ITYP(JC) = 1120 + ITYPRM = ITYPRM - 101 + ELSE + ITYP(JC) = 1220 + ITYPRM = ITYPRM - 100 + ENDIF + NNUC = NNUC - 1 + ENDIF + IF ( NNUC .LE. 0 ) GOTO 50 + ENDDO + ENDIF + + IF ( NNUC .LT. 4 ) THEN +C EVAPORATION WITHOUT FORMATION OF ALPHA PARTICLES + CALL RMMARD( RD,NNUC,lseq ) + DO IS = 1, NNUC + IARM = ITYPRM/100 + IF ( IARM .LE. 0 ) GOTO 100 + IZRM = MOD(ITYPRM,100) + INRM = IARM - IZRM + JC = JC + 1 + IF ( IZRM .EQ. 1 .AND. INRM .GT. IZRM ) THEN + ITYP(JC) = 1220 + ITYPRM = ITYPRM - 100 + ELSEIF ( INRM .EQ. 1 .AND. IZRM .GT. IZRM ) THEN + ITYP(JC) = 1120 + ITYPRM = ITYPRM - 101 + ELSEIF ( RD(IS)*IARM .LT. IZRM .AND. IZRM .GE. INRM ) THEN + ITYP(JC) = 1120 + ITYPRM = ITYPRM - 101 + ELSE + ITYP(JC) = 1220 + ITYPRM = ITYPRM - 100 + ENDIF + ENDDO + ENDIF + + 50 CONTINUE + IARM = ITYPRM/100 + IF ( IARM .LE. 0 ) GOTO 100 + IZRM = MOD(ITYPRM,100) + INRM = IARM - IZRM + JC = JC + 1 +C CLEAN FRAGMENT TO HAVE ALWAYS AT LEAST TWO TIMES MORE N THAN P + CALL RMMARD( RD,2,lseq ) + DO WHILE ( INRM .GT. INT( 1.15D0 * DBLE(IZRM) + RD(1) ) ) + ITYP(JC) = 1220 + ITYPRM = ITYPRM - 100 + IARM = ITYPRM/100 + IZRM = MOD(ITYPRM,100) + INRM = IARM - IZRM + JC = JC + 1 + ENDDO +C CLEAN FRAGMENT NOT TO HAVE TOO MANY P + DO WHILE ( IZRM .GE. NINT( (DBLE(INRM)+1.D0+RD(2)) / 1.15D0 ) ) + ITYP(JC) = 1120 + ITYPRM = ITYPRM - 101 + IARM = ITYPRM/100 + IZRM = MOD(ITYPRM,100) + INRM = IARM - IZRM + JC = JC + 1 + ENDDO + IF ( IARM .EQ. 8 ) THEN !EXCLUDED + DO WHILE ( IZRM .GE. 2 .AND. INRM .GE. 2 ) + ITYP(JC) = -402 + ITYPRM = ITYPRM - 402 + IARM = ITYPRM/100 + IZRM = MOD(ITYPRM,100) + INRM = IARM - IZRM + JC = JC + 1 + ENDDO + IF ( ITYPRM .GT. 0 ) THEN + IF ( ITYPRM/100 .EQ. 5 ) THEN !EXCLUDED BUT SHOULD NOT HAPPEN HERE + IF ( IZRM .GE. INRM ) THEN + ITYP(JC) = 1120 + ITYPRM = ITYPRM - 101 + ELSE + ITYP(JC) = 1220 + ITYPRM = ITYPRM - 100 + ENDIF + JC = JC + 1 + ENDIF + ITYP(JC) = -ITYPRM + ELSE + JC = JC - 1 + ENDIF + ELSEIF ( IARM .EQ. 5 ) THEN !EXCLUDED + IF ( IZRM .GE. INRM ) THEN + ITYP(JC) = 1120 + ITYPRM = ITYPRM - 101 + ELSE + ITYP(JC) = 1220 + ITYPRM = ITYPRM - 100 + ENDIF + JC = JC + 1 + ITYP(JC) = -ITYPRM + ELSEIF ( ITYPRM .GT. 200 ) THEN + ITYP(JC) = -ITYPRM + ELSEIF ( ITYPRM .EQ. 101 ) THEN + ITYP(JC) = 1120 + ELSEIF ( ITYPRM .EQ. 100 ) THEN + ITYP(JC) = 1220 + ELSE + JC = JC - 1 + IF ( ITYPRM .NE. 0 ) WRITE(*,*) + * 'EPOVAPOR : ILLEGAL PARTICLE ITYPRM =',ITYPRM + ENDIF + + 100 CONTINUE + IF ( JC .GT. JFIN ) THEN + JFIN = JC + IF(ish.ge.7)WRITE(ifch,*) + * 'EPOVAPOR : NO ITYP PFR PFL' + IF ( infragm .EQ. 2 ) THEN +C EVAPORATION WITH PT AFTER PARAMETRIZED JACEE DATA + DO MF = 1, JFIN + IF(ITYP(MF).LT.0)THEN + IARM=-ITYP(MF)/100 + ELSE + IARM=1 + ENDIF + PFR(MF) = RANNORM(0.088D0,0.044D0) + PFRZ(MF)= (2*int(drangen(PFR(MF))+0.5d0)-1) + & *RANNORM(0.300D0/DBLE(IARM),0.100D0/SQRT(DBLE(IARM))) !Fermi motion about 300 MeV + IF(ish.ge.7)WRITE(ifch,*) MF,ITYP(MF),SNGL(PFR(MF)) + & ,SNGL(PFRZ(MF)) + ENDDO + ELSEIF ( infragm .EQ. 3 ) THEN +C EVAPORATION WITH PT AFTER GOLDHABER''S MODEL (PHYS.LETT.53B(1974)306) + DO MF = 1, JFIN + K = MAX( 1, -ITYP(MF)/100 ) + BGLH = K * (MAPRO - K) / DBLE(MAPRO-1) +C THE VALUE 0.103 [GEV] IS SIGMA(0)=P(FERMI)/SQRT(5.) +* AGLH = 0.103D0 * SQRT( BGLH ) +C THE VALUE 0.090 [GEV] IS EXPERIMENTALLY DETERMINED SIGMA(0) + AGLH = 0.090D0 * SQRT( BGLH ) + PFR(MF) = RANNORM(0.D0,AGLH) + PFRZ(MF)= RANNORM(0.000D0,0.500D0) !from pAg at 100 GeV + IF(ish.ge.7)WRITE(ifch,*) MF,ITYP(MF),SNGL(PFR(MF)) + & ,SNGL(PFRZ(MF)) + ENDDO + ELSE +C EVAPORATION WITHOUT TRANSVERSE MOMENTUM + DO MF = 1, JFIN + PFR(MF) = 0.D0 + PFRZ(MF)= 0.D0 + IF(ish.ge.7)WRITE(ifch,*) MF,ITYP(MF),SNGL(PFR(MF)) + & ,SNGL(PFRZ(MF)) + ENDDO + ENDIF +C CALCULATE RESIDUAL TRANSVERSE MOMENTUM + SPFRX = 0.D0 + SPFRY = 0.D0 + SPFRZ = 0.D0 + CALL RMMARD( RD,JFIN,lseq ) + DO MF = 1, JFIN + PHIFR = PI * RD(MF) + PFRX(MF) = PFR(MF) * COS( PHIFR ) + PFRY(MF) = PFR(MF) * SIN( PHIFR ) + SPFRY = SPFRY + PFRY(MF) + SPFRX = SPFRX + PFRX(MF) + SPFRZ = SPFRZ + PFRZ(MF) + ENDDO +C CORRECT ALL TRANSVERSE MOMENTA FOR MOMENTUM CONSERVATION + SPFRX = SPFRX / JFIN + SPFRY = SPFRY / JFIN + SPFRZ = SPFRZ / JFIN + DO MF = 1, JFIN + PFRX(MF) = PFRX(MF) - SPFRX + PFRY(MF) = PFRY(MF) - SPFRY + PFRZ(MF) = PFRZ(MF) - SPFRZ + ENDDO + ENDIF + + IF(ish.ge.7)WRITE(ifch,*) 'EPOVAPOR : NINTA,JFIN=',NINTA,JFIN + + RETURN + END + +*-- Author : The CORSIKA development group 21/04/1994 +C======================================================================= + + DOUBLE PRECISION FUNCTION RANNORM( A,B ) + +C----------------------------------------------------------------------- +C RAN(DOM NUMBER) NOR(MALLY DISTRIBUTED) +C +C GENERATES NORMAL DISTRIBUTED RANDOM NUMBER +C DELIVERS 2 UNCORRELATED RANDOM NUMBERS, +C THEREFORE RANDOM CALLS ARE ONLY NECESSARY EVERY SECOND TIME. +c but to be used with CONEX/CORSIKA we should always use 2 new number +c to be able to reproduce the shower +C REFERENCE : NUMERICAL RECIPES, W.H. PRESS ET AL., +C CAMBRIDGE UNIVERSITY PRESS, 1992 ISBN 0 521 43064 X +C ARGUMENTS: +C A = MEAN VALUE +C B = STANDARD DEVIATION +C +C FROM CORSIKA +C----------------------------------------------------------------------- + + IMPLICIT NONE + double precision facrdm,u1rdm,u2rdm,drangen +c logical knordm +c data knordm/.true./ + + DOUBLE PRECISION A,B,RR + SAVE facrdm,u1rdm,u2rdm!,knordm +C----------------------------------------------------------------------- + +c IF ( KNORdm ) THEN + 1 CONTINUE + U1rdm = 2.D0*drangen(a) - 1.D0 + U2rdm = 2.D0*drangen(b) - 1.D0 + RR = U1rdm**2 + U2rdm**2 + IF ( RR .GE. 1.D0 .OR. RR .EQ. 0.D0 ) GOTO 1 + FACrdm = SQRT( (-2.D0) * LOG(RR) / RR ) + + RANNORM = FACrdm * U1rdm * B + A +c KNORdm = .FALSE. +c ELSE +c RANNORM = FACrdm * U2rdm * B + A +c KNORdm = .TRUE. +c ENDIF + + RETURN + END + +c----------------------------------------------------------------------- + function ransig() +c----------------------------------------------------------------------- +c returns randomly +1 or -1 +c----------------------------------------------------------------------- + ransig=1 + if(rangen().gt.0.5)ransig=-1 + return + end + +cc----------------------------------------------------------------------- +c function ranxq(n,x,q,xmin) +cc----------------------------------------------------------------------- +cc returns random number according to x(i) q(i) with x>=xmin +cc----------------------------------------------------------------------- +c include 'epos.inc' +c real x(n),q(n) +c imin=1 +c if(xmin.eq.0.)goto3 +c i1=1 +c i2=n +c1 i=i1+(i2-i1)/2 +c if(x(i).lt.xmin)then +c i1=i +c elseif(x(i).gt.xmin)then +c i2=i +c else +c imin=i +c goto3 +c endif +c if(i2-i1.gt.1)goto1 +c imin=i2 +c3 continue +c if(q(imin).gt.q(n)*.9999)then +c ranxq=xmin +c goto4 +c endif +c qran=q(imin)+rangen()*(q(n)-q(imin)) +c ranxq=utinvt(n,x,q,qran) +c4 continue +c +c if(ranxq.lt.xmin)then +c call utmsg('ranxq ') +c write(ifch,*)'***** ranxq=',ranxq,' < xmin=',xmin +c write(ifch,*)'q(imin) q q(n):',q(imin),qran,q(n) +c write(ifch,*)'x(imin) x x(n):',x(imin),ranxq,x(n) +c call utmsgf +c ranxq=xmin +c endif +c +c return +c end +c +cc ***** end r-routines +cc ***** beg s-routines +c +cc----------------------------------------------------------------------- +c function sbet(z,w) +cc----------------------------------------------------------------------- +c sbet=utgam1(z)*utgam1(w)/utgam1(z+w) +c return +c end +c +cc----------------------------------------------------------------------- +c function smass(a,y,z) +cc----------------------------------------------------------------------- +cc returns droplet mass (in gev) (per droplet, not (!) per nucleon) +cc according to berger/jaffe mass formula, prc35(1987)213 eq.2.31, +cc see also c. dover, BNL-46322, intersections-meeting, tucson, 91. +cc a: massnr, y: hypercharge, z: charge, +cc----------------------------------------------------------------------- +c common/cmass/thet,epsi,as,ac,dy,dz,ym,cz,zm,sigma,rzero +c ymin=ym*a +c zmin=cz/(dz/a+zm/a**(1./3.)) +c smass=epsi*a+as*a**(2./3.)+(ac/a**(1./3.)+dz/a/2.)*(z-zmin)**2 +c *+dy/a/2.*(y-ymin)**2 +c return +c end +c +cc----------------------------------------------------------------------- +c subroutine smassi(theta) +cc----------------------------------------------------------------------- +cc initialization for smass. +cc calculates parameters for berger/jaffe mass formula +cc (prc35(1987)213 eq.2.31, see also c. dover, BNL-46322). +cc theta: parameter that determines all parameters in mass formula. +cc----------------------------------------------------------------------- +c common/cmass/thet,epsi,as,ac,dy,dz,ym,cz,zm,sigma,rzero +c thet=theta +c +c astr=.150 +c pi=3.14159 +c alp=1./137. +c +c co=cos(theta) +c si=sin(theta) +c bet=(1+co**3)/2. +c rzero=si/astr/( 2./3./pi*(1+co**3) )**(1./3.) +cctp060829 cs=astr/si +c cz=-astr/si*( ( .5*(1+co**3) )**(1./3.)-1 ) +c sigma=6./8./pi*(astr/si)**3*(co**2/6.-si**2*(1-si)/3.- +c *1./3./pi*(pi/2.-theta-sin(2*theta)+si**3*alog((1+co)/si))) +c +c epsi=astr*((.5*(1+co**3))**(1./3.)+2)/si +c as=4*pi*sigma*rzero**2 +c ac=3./5.*alp/rzero +c dz=astr/si*bet**(1./3.)*co**2* +c *(co**4*(1+bet**(2./3.))+(1+bet)**2)/ +c *( (2*co**2+bet**(1./3.))*(co**4*(1+bet**(2./3.))+(1+bet)**2)- +c *(co**4+bet**(1./3.)*(1+bet))*((2*bet**(2./3.)-1)*co**2+1+bet) ) +c dy=astr/6.*(1+co**3)**3/si* +c *( 1+(1+co)/(4*(1+co**3))**(2./3.) )/ +c *(co**6+co+co*(.5*(1+co**3))**(4./3.)) +c zm=6*alp/(5*rzero) +c ym=(1-co**3)/(1+co**3) +c +c return +c end +c +cc----------------------------------------------------------------------- +c subroutine smassp +cc----------------------------------------------------------------------- +cc prints smass. +cc----------------------------------------------------------------------- +c include 'epos.inc' +c common/cmass/thet,epsi,as,ac,dy,dz,ym,cz,zm,sigma,rzero +c real eng(14),ymi(14),zmi(14) +c pi=3.14159 +c write(ifch,*)'parameters of mass formula:' +c write(ifch,*)'theta=',thet,' epsi=',epsi +c write(ifch,*)'as=',as,' ac=',ac +c write(ifch,*)'dy=',dy,' dz=',dz +c write(ifch,*)'ym=',ym +c write(ifch,*)'cz dz zm=',cz,dz,zm +c write(ifch,*)'sigma**1/3=',sigma**(1./3.),' rzero=',rzero +c write(ifch,*)'mass:' +c write(ifch,5000)(j,j=1,14) +c5000 format(5x,'a:',14i5) +c do 4 j=1,14 +c a=j +c ymi(j)=ym*a +c4 zmi(j)=cz/(dz/a+zm/a**(1./3.)) +c write(ifch,5002)(ymi(j),j=1,14) +c5002 format(1x,'ymin: ',14f5.2) +c write(ifch,5003)(zmi(j),j=1,14) +c5003 format(1x,'zmin: ',14f5.2) +c do 2 i=1,15 +c ns=11-i +c do 3 j=1,14 +c a=j +c y=a-ns +c z=0. +c3 eng(j)=smass(a,y,z)/a +c write(ifch,5001)ns,(eng(j),j=1,14) +c5001 format(1x,'s=',i2,2x,14f5.2) +c2 continue +c write(ifch,*)'mass-mass(free):' +c write(ifch,5000)(j,j=1,14) +c do 5 i=1,15 +c ns=11-i +c do 6 j=1,14 +c a=j +c y=a-ns +c z=0. +c call smassu(a,y,z,ku,kd,ks,kc) +c6 eng(j)=(smass(a,y,z)-utamnu(ku,kd,ks,kc,0,0,3))/a +c write(ifch,5001)ns,(eng(j),j=1,14) +c5 continue +c +c stop +c end +c +cc----------------------------------------------------------------------- +c subroutine smasst(kux,kdx,ksx,kcx,a,y,z) +cc----------------------------------------------------------------------- +cc input: kux,kdx,ksx,kcx = net quark numbers (for u,d,s,c quarks). +cc output: massnr a, hypercharge y and charge z. +cc----------------------------------------------------------------------- +c sg=1 +c if(kux+kdx+ksx+kcx.lt.0.)sg=-1 +c ku=sg*kux +c kd=sg*kdx +c ks=sg*ksx +c kc=sg*kcx +c k=ku+kd+ks+kc +c if(mod(k,3).ne.0)stop'noninteger baryon number' +c a=k/3 +c y=a-ks +c nz=2*ku-kd-ks+2*kc +c if(mod(nz,3).ne.0)stop'noninteger charge' +c z=nz/3 +c return +c end +c +cc----------------------------------------------------------------------- +c subroutine smassu(ax,yx,zx,ku,kd,ks,kc) +cc----------------------------------------------------------------------- +cc input: massnr ax, hypercharge yx and charge zx. +cc output: ku,kd,ks,kc = net quark numbers (for u,d,s,c quarks). +cc----------------------------------------------------------------------- +c sg=1 +c if(ax.lt.0.)sg=-1 +c a=sg*ax +c y=sg*yx +c z=sg*zx +c ku=nint(a+z) +c kd=nint(a-z+y) +c ks=nint(a-y) +c kc=0 +c return +c end +c +cc----------------------------------------------------------------------- +c function spoc(a,b,c,d,x) +cc----------------------------------------------------------------------- +cc power fctn with cutoff +cc----------------------------------------------------------------------- +c spoc=0 +c if(a.eq.0..and.b.eq.0.)return +c spoc =a+b*x**c +c spoc0=a+b*d**c +c spoc=amin1(spoc,spoc0) +c spoc=amax1(0.,spoc) +c return +c end +c +c----------------------------------------------------------------------- + function utacos(x) +c----------------------------------------------------------------------- +c returns acos(x) for -1 <= x <= 1 , acos(+-1) else +c----------------------------------------------------------------------- + include 'epos.inc' + argum=x + if(x.lt.-1.)then + if(ish.ge.1)then + call utmsg('utacos') + write(ifch,*)'***** argum = ',argum,' set -1' + call utmsgf + endif + argum=-1. + elseif(x.gt.1.)then + if(ish.ge.1)then + call utmsg('utacos') + write(ifch,*)'***** argum = ',argum,' set 1' + call utmsgf + endif + argum=1. + endif + utacos=acos(argum) + return + end + +c---------------------------------------------------------------------- + function utamnu(keux,kedx,kesx,kecx,kebx,ketx,modus) +c---------------------------------------------------------------------- +c returns min mass of droplet with given u,d,s,c content +c keux: net u quark number +c kedx: net d quark number +c kesx: net s quark number +c kecx: net c quark number +c kebx: net b quark number +c ketx: net t quark number +c modus: 4=two lowest multiplets; 5=lowest multiplet +c---------------------------------------------------------------------- + common/files/ifop,ifmt,ifch,ifcx,ifhi,ifdt,ifcp,ifdr + common/csjcga/amnull,asuha(7) + common/drop4/asuhax(7),asuhay(7) + + if(modus.lt.4.or.modus.gt.5)stop'UTAMNU: not supported' +c 1 format(' flavours:',6i5 ) +c 100 format(' flavours+mass:',6i5,f8.2 ) +c write(ifch,1)keux,kedx,kesx,kecx,kebx,ketx + + amnull=0. + + do i=1,7 + if(modus.eq.4)asuha(i)=asuhax(i) !two lowest multiplets + if(modus.eq.5)asuha(i)=asuhay(i) !lowest multiplet + enddo + + ke=iabs(keux+kedx+kesx+kecx+kebx+ketx) + + if(keux+kedx+kesx+kecx+kebx+ketx.ge.0)then + keu=keux + ked=kedx + kes=kesx + kec=kecx + keb=kebx + ket=ketx + else + keu=-keux + ked=-kedx + kes=-kesx + kec=-kecx + keb=-kebx + ket=-ketx + endif + +c write(ifch,*)keu,ked,kes,kec,keb,ket + +c removing top mesons to remove t quarks or antiquarks + if(ket.ne.0)then +12 continue + ii=sign(1,ket) + ket=ket-ii + if(ii*keu.le.ii*ked)then + keu=keu+ii + else + ked=ked+ii + endif + amnull=amnull+200. ! ??????? + if(ket.ne.0)goto12 + endif + +c removing bottom mesons to remove b quarks or antiquarks + if(keb.ne.0)then +11 continue + ii=sign(1,keb) + keb=keb-ii + if(ii*keu.le.ii*ked)then + keu=keu+ii + else + ked=ked+ii + endif + amnull=amnull+6. !5.28 ! (more than B-meson) + if(keb.ne.0)goto11 + endif + +c removing charm mesons to remove c quarks or antiquarks + if(kec.ne.0)then +10 continue + ii=sign(1,kec) + kec=kec-ii + if(keu*ii.le.ked*ii)then + keu=keu+ii + else + ked=ked+ii + endif + amnull=amnull+2.2 !1.87 ! (more than D-meson) + if(kec.ne.0)goto10 + endif + +c write(ifch,100)keu,ked,kes,kec,keb,ket,amnull + +c removing mesons to remove s antiquarks +5 continue + if(kes.lt.0)then + amnull=amnull+asuha(6) + if(keu.ge.ked)then + keu=keu-1 + else + ked=ked-1 + endif + kes=kes+1 + goto5 + endif + +c removing mesons to remove d antiquarks +6 continue + if(ked.lt.0)then + if(keu.ge.kes)then + amnull=amnull+asuha(5) + keu=keu-1 + else + amnull=amnull+asuha(6) + kes=kes-1 + endif + ked=ked+1 + goto6 + endif + +c removing mesons to remove u antiquarks +7 continue + if(keu.lt.0)then + if(ked.ge.kes)then + amnull=amnull+asuha(5) + ked=ked-1 + else + amnull=amnull+asuha(6) + kes=kes-1 + endif + keu=keu+1 + goto7 + endif + +c write(ifch,100)keu,ked,kes,kec,keb,ket,amnull +c print*,keu,ked,kes,kec,keb,ket,amnull + + if(keu+ked+kes+kec+keb+ket.ne.ke) + *call utstop('utamnu: sum_kei /= ke&') + keq=keu+ked + keqx=keq + amnux=0 + +c removing strange baryons + i=4 +2 i=i-1 +3 continue + if((4-i)*kes.gt.(i-1)*keq)then + amnux=amnux+asuha(1+i) + kes=kes-i + keq=keq-3+i + if(kes.lt.0)call utstop('utamnu: negative kes&') + if(keq.lt.0)call utstop('utamnu: negative keq&') + goto3 + endif + if(i.gt.1)goto2 + if(keqx.gt.keq)then + do 8 k=1,keqx-keq + if(keu.ge.ked)then + keu=keu-1 + else + ked=ked-1 + endif +8 continue + endif + + if(keu+ked.ne.keq)call utstop('utamnu: keu+ked /= keq&') +c write(ifch,100)keu,ked,kes,kec,keb,ket,amnull+amnux +c print*,keu,ked,kes,kec,keb,ket,amnull+amnux + +c removing nonstrange baryons +9 continue + if(keu.gt.2*ked)then + amnux=amnux+asuha(7) + keu=keu-3 + if(keu.lt.0)call utstop('utamnu: negative keu&') + goto9 + endif + if(ked.gt.2*keu)then + amnux=amnux+asuha(7) + ked=ked-3 + if(ked.lt.0)call utstop('utamnu: negative ked&') + goto9 + endif + keq=keu+ked + +c write(ifch,100)keu,ked,kes,kec,keb,ket,amnull+amnux +c print*,keu,ked,kes,kec,keb,ket,amnull+amnux + + if(mod(keq,3).ne.0)call utstop('utamnu: mod(keq,3) /= 0&') + amnux=amnux+asuha(1)*keq/3 + +c write(ifch,100)keu,ked,kes,kec,keb,ket,amnull+amnux +c print*,keu,ked,kes,kec,keb,ket,amnull+amnux + + amnull=amnull+amnux + + if(amnull.eq.0)amnull=asuha(5) + + utamnu=amnull + return + end + +c----------------------------------------------------------------------- + function utamnx(jcp,jcm) +c----------------------------------------------------------------------- +c returns minimum mass for the decay of jcp---jcm (by calling utamnu). +c----------------------------------------------------------------------- + parameter (nflav=6) + integer jcp(nflav,2),jcm(nflav,2) + + do i=1,nflav + do j=1,2 + if(jcp(i,j).ne.0)goto1 + enddo + enddo + keu=jcm(1,1)-jcm(1,2) + ked=jcm(2,1)-jcm(2,2) + kes=jcm(3,1)-jcm(3,2) + kec=jcm(4,1)-jcm(4,2) + keb=jcm(5,1)-jcm(5,2) + ket=jcm(6,1)-jcm(6,2) + utamnx=utamnu(keu,ked,kes,kec,keb,ket,5) + return +1 continue + + do i=1,nflav + do j=1,2 + if(jcm(i,j).ne.0)goto2 + enddo + enddo + keu=jcp(1,1)-jcp(1,2) + ked=jcp(2,1)-jcp(2,2) + kes=jcp(3,1)-jcp(3,2) + kec=jcp(4,1)-jcp(4,2) + keb=jcp(5,1)-jcp(5,2) + ket=jcp(6,1)-jcp(6,2) + utamnx=utamnu(keu,ked,kes,kec,keb,ket,5) + return +2 continue + + keu=jcp(1,1)-jcp(1,2) + ked=jcp(2,1)-jcp(2,2) + kes=jcp(3,1)-jcp(3,2) + kec=jcp(4,1)-jcp(4,2) + keb=jcp(5,1)-jcp(5,2) + ket=jcp(6,1)-jcp(6,2) + ke=keu+ked+kes+kec+keb+ket + if(mod(ke+1,3).eq.0)then + keu=keu+1 + amms1=utamnu(keu,ked,kes,kec,keb,ket,5) + keu=keu-1 + ked=ked+1 + amms2=utamnu(keu,ked,kes,kec,keb,ket,5) + elseif(mod(ke-1,3).eq.0)then + keu=keu-1 + amms1=utamnu(keu,ked,kes,kec,keb,ket,5) + keu=keu+1 + ked=ked-1 + amms2=utamnu(keu,ked,kes,kec,keb,ket,5) + else + amms1=0 + amms2=0 + amms3=0 + amms4=0 + call utstop('utamnx: no singlet possible (1)&') + endif + keu=jcm(1,1)-jcm(1,2) + ked=jcm(2,1)-jcm(2,2) + kes=jcm(3,1)-jcm(3,2) + kec=jcm(4,1)-jcm(4,2) + keb=jcm(5,1)-jcm(5,2) + ket=jcm(6,1)-jcm(6,2) + ke=keu+ked+kes+kec+keb+ket + if(mod(ke+1,3).eq.0)then + keu=keu+1 + amms3=utamnu(keu,ked,kes,kec,keb,ket,5) + keu=keu-1 + ked=ked+1 + amms4=utamnu(keu,ked,kes,kec,keb,ket,5) + elseif(mod(ke-1,3).eq.0)then + keu=keu-1 + amms3=utamnu(keu,ked,kes,kec,keb,ket,5) + keu=keu+1 + ked=ked-1 + amms4=utamnu(keu,ked,kes,kec,keb,ket,5) + else + call utstop('utamnx: no singlet possible (2)&') + endif + utamnx=min(amms1+amms3,amms2+amms4) +c print *,amms1,amms3,amms2,amms4,jcp,jcm + return + end + + + +cc----------------------------------------------------------------------- +c function utamny(jcp,jcm) +cc----------------------------------------------------------------------- +cc returns minimum mass of jcp+jcm (by calling utamnu). +cc----------------------------------------------------------------------- +c parameter (nflav=6) +c integer jcp(nflav,2),jcm(nflav,2),jc(nflav,2) +c do 7 nf=1,nflav +c jc(nf,1)=jcp(nf,1)+jcm(nf,1) +c7 jc(nf,2)=jcp(nf,2)+jcm(nf,2) +c keu=jc(1,1)-jc(1,2) +c ked=jc(2,1)-jc(2,2) +c kes=jc(3,1)-jc(3,2) +c kec=jc(4,1)-jc(4,2) +c keb=jc(5,1)-jc(5,2) +c ket=jc(6,1)-jc(6,2) +c utamny=utamnu(keu,ked,kes,kec,keb,ket,5) +c return +c end +c +c----------------------------------------------------------------------- + function utamnz(jc,modus) +c----------------------------------------------------------------------- +c returns minimum mass of jc (by calling utamnu). +c----------------------------------------------------------------------- + parameter (nflav=6) + integer jc(nflav,2) + keu=jc(1,1)-jc(1,2) + ked=jc(2,1)-jc(2,2) + kes=jc(3,1)-jc(3,2) + kec=jc(4,1)-jc(4,2) + keb=jc(5,1)-jc(5,2) + ket=jc(6,1)-jc(6,2) + utamnz=utamnu(keu,ked,kes,kec,keb,ket,modus) + return + end + +c----------------------------------------------------------------------- + subroutine utar(i1,i2,i3,x0,x1,x2,x3,xx) +c----------------------------------------------------------------------- +c returns the array xx with xx(1)=x0 <= xx(i) <= xx(i3)=x3 +c----------------------------------------------------------------------- + real xx(i3) + do 1 i=1,i1-1 + 1 xx(i)=x0+(i-1.)/(i1-1.)*(x1-x0) + do 2 i=i1,i2-1 + 2 xx(i)=x1+(i-i1*1.)/(i2-i1*1.)*(x2-x1) + do 3 i=i2,i3 + 3 xx(i)=x2+(i-i2*1.)/(i3-i2*1.)*(x3-x2) + return + end + +cc--------------------------------------------------------------------- +c subroutine utaxis(i,j,a1,a2,a3) +cc----------------------------------------------------------------------- +cc calculates the axis defined by the ptls i,j in the i,j cm system +cc--------------------------------------------------------------------- +c include 'epos.inc' +c double precision pi1,pi2,pi3,pi4,pj1,pj2,pj3,pj4,p1,p2,p3,p4,p5 +c *,err,a +c a1=0 +c a2=0 +c a3=1 +c pi1=dble(pptl(1,i)) +c pi2=dble(pptl(2,i)) +c pi3=dble(pptl(3,i)) +c pi4=dble(pptl(4,i)) +c pj1=dble(pptl(1,j)) +c pj2=dble(pptl(2,j)) +c pj3=dble(pptl(3,j)) +c pj4=dble(pptl(4,j)) +c p1=pi1+pj1 +c p2=pi2+pj2 +c p3=pi3+pj3 +c p4=pi4+pj4 +c p5=dsqrt(p4**2-p3**2-p2**2-p1**2) +c call utlob2(1,p1,p2,p3,p4,p5,pi1,pi2,pi3,pi4,50) +c call utlob2(1,p1,p2,p3,p4,p5,pj1,pj2,pj3,pj4,51) +c err=(pi1+pj1)**2+(pi2+pj2)**2+(pi3+pj3)**2 +c if(err.gt.1d-3)then +c call utmsg('utaxis') +c write(ifch,*)'***** err=',err +c write(ifch,*)'pi:',pi1,pi2,pi3,pi4 +c write(ifch,*)'pj:',pj1,pj2,pj3,pj4 +c call utmsgf +c endif +c a=dsqrt( (pj1-pi1)**2 + (pj2-pi2)**2 + (pj3-pi3)**2 ) +c if(a.eq.0.d0)return +c a1=sngl((pi1-pj1)/a) +c a2=sngl((pi2-pj2)/a) +c a3=sngl((pi3-pj3)/a) +c return +c end +c +cc--------------------------------------------------------------------- +c subroutine uthalf(i,j,zz1,zz2,iret) +cc----------------------------------------------------------------------- +cc give equal energy (E_i+E_j)/2 to particle i+j in their cm system +cc--------------------------------------------------------------------- +c include 'epos.inc' +c double precision pi1,pi2,pi3,pi4,pi5,pj1,pj2,pj3,pj4,pj5 +c *,p1,p2,p3,p4,p5,err,pt,pti,sinp,cosp,pmax,phi,drangen!,rrr +c iret=0 +c pi1=dble(pptl(1,i)) +c pi2=dble(pptl(2,i)) +c pi3=dble(pptl(3,i)) +c pi5=dble(pptl(5,i)) +c pi4=sqrt(pi1**2+pi2**2+pi3**2+pi5**2) +c pj1=dble(pptl(1,j)) +c pj2=dble(pptl(2,j)) +c pj3=dble(pptl(3,j)) +c pj5=dble(pptl(5,j)) +c pj4=sqrt(pj1**2+pj2**2+pj3**2+pj5**2) +c if(ish.ge.6)then +c write(ifch,*)'uthalf for ',i,' and ',j +c write(ifch,*)'in ',idptl(i),pi1,pi2,pi3,pi4,pi5 +c write(ifch,*)'<> ',idptl(j),pj1,pj2,pj3,pj4,pj5 +c endif +c p1=pi1+pj1 +c p2=pi2+pj2 +c p3=pi3+pj3 +c p4=pi4+pj4 +c p5=(p4-p3)*(p4+p3)-p2**2-p1**2 +c if(p5.lt.0d0.or.(pi3.lt.0.99d0*pj3.and.mod(ityptl(j)/10,10).eq.4) +c & .or.(pi3.gt.0.99d0*pj3.and.mod(ityptl(j)/10,10).eq.5))then +cc if(p5.lt.0d0)then +c if(ish.ge.7)write(ifch,*)'Inversion not possible (1)',p5,pi3,pj3 +c iret=1 +c return +c else +c p5=sqrt(p5) +c endif +c call utlob2(1,p1,p2,p3,p4,p5,pi1,pi2,pi3,pi4,50) +c call utlob2(1,p1,p2,p3,p4,p5,pj1,pj2,pj3,pj4,51) +c err=(pi1+pj1)**2+(pi2+pj2)**2+(pi3+pj3)**2 +c if(err.gt.1d-3)then +c call utmsg('uthalf') +c write(ifch,*)'***** err=',err +c write(ifch,*)'pi:',pi1,pi2,pi3,pi4 +c write(ifch,*)'pj:',pj1,pj2,pj3,pj4 +c call utmsgf +c endif +c if(ish.ge.8)then +c write(ifch,*)'pi 1:',pi1,pi2,pi3,pi4,pi5 +c & ,sqrt(pi1**2+pi2**2+pi3**2+pi5**2) +c write(ifch,*)'pj 1:',pj1,pj2,pj3,pj4,pj5 +c & ,sqrt(pj1**2+pj2**2+pj3**2+pj5**2) +c endif +c +c phi=drangen(p5)*2d0*dble(pi) +c pti=sqrt(pi1*pi1+pi2*pi2) +c +cc sinp=abs(asin(pi2/pti)) +c +c cosp=cos(phi) +c sinp=sin(phi) +cc cosp=pi1/pti +cc sinp=pi2/pti +c pini=abs(pi3) +c pmax=pini +c +c ntry=0 +c 10 ntry=ntry+1 +c pi1=-pj1 +c pi2=-pj2 +c pi3=-pj3 +c +c +cc rrr=dble(ranptcut(4.))*max(0.1d0,dble(zz))+0.01d0 +cc rrr=dble(ranptcut(zz*max(1.,float(ntry/10)**3))) !flip if pt too large +cc rrr=dble(min(1.,ranptcut(zz/float(max(1,ntry/10))))) !return if pt too large +c +c rrr=rangen() +c phi=dble(pi*zz1*(1.-rrr*zz2/float(max(1,ntry/10)))) +c call utroa2(phi,cosp,sinp,0d0,pi1,pi2,pi3) !rotation around an axis perpendicular to p3 +c pt=pi1*pi1+pi2*pi2 +c +ccc pi3=pini*(1d0-(pmax/pini+1d0)*min(1d0,rrr)) +ccc & *sign(1.d0,pi3) +cc pi3=pini*(1d0-(pmax/pini+1d0)*(1d0-min(1d0,rrr))) +cc & *sign(1.d0,pi3) +cccc pi3=(1d0-exp(-drangen(pti)))*pi3 +cccc pi3=min(1d0,(drangen()+exp(-min(100d0,dble(zz)))))*pi3 +cccc pi3=(dble(reminv)+exp(-min(100d0,dble(zz))))*pi3 +cc pt=((pi4+pi3)*(pi4-pi3)-pi5*pi5) +c if(ish.ge.8)write(ifch,*)'ut',ntry,zz,rrr,-pi3/pj3,pt,pti*pti +c &,idptl(i),idptl(j) +c if((pt.lt.0d0.or.pt.gt.max(2.*pti*pti,1.d0)) +cc if(pt.lt.0d0 +c & .and.ntry.lt.1000)then +c goto 10 +c elseif(ntry.ge.1000)then +c if(ish.ge.7)write(ifch,*)'Inversion not possible (2)',pt,pti*pti +c iret=1 +c return !pion distribution fall at xf=1 +cc pi3=pj3 !if flip all particle with large pt +cc pt=pti*pti !then very very hard pi+ spectra (flat at xf=1 like in pp400 !) +c !but to hard for K, rho, eta, etc .. +c endif +cc print *,'ut',ntry,phi/(pi-sinp),zz,rrr,-pi3/pj3,pt/pti/pti +cc pt=sqrt(pt) +cc pi1=cosp*pt +cc pi2=sinp*pt +c +c pj1=-pi1 +c pj2=-pi2 +c pj3=-pi3 +cc pi4=sqrt(pi3*pi3+pt*pt+pi5*pi5) +cc pj4=sqrt(pj3*pj3+pt*pt+pj5*pj5) +c pi4=sqrt(pi3*pi3+pt+pi5*pi5) +c pj4=sqrt(pj3*pj3+pt+pj5*pj5) +c if(ish.ge.8)then +c write(ifch,*)'pi 2:',pi1,pi2,pi3,pi4,pi5 +c & ,sqrt(pi1**2+pi2**2+pi3**2+pi5**2) +c write(ifch,*)'pj 2:',pj1,pj2,pj3,pj4,pj5 +c & ,sqrt(pj1**2+pj2**2+pj3**2+pj5**2) +c endif +c call utlob2(-1,p1,p2,p3,p4,p5,pi1,pi2,pi3,pi4,-50) +c call utlob2(-1,p1,p2,p3,p4,p5,pj1,pj2,pj3,pj4,-51) +c if(pi3/dble(pptl(3,i)).gt.1.00001d0 +c &.or.(pi3.gt.1.001d0*pj3.and.mod(ityptl(j)/10,10).eq.4) +c &.or.(pi3.lt.1.001d0*pj3.and.mod(ityptl(j)/10,10).eq.5))then +c if(ish.ge.7)write(ifch,*)'Inversion not possible (3)',pi3,pj3 +c iret=1 +c return +c endif +c id=idptl(i) +c pptl(1,i)=sngl(pi1) +c pptl(2,i)=sngl(pi2) +c pptl(3,i)=sngl(pi3) +c pptl(4,i)=sngl(pi4) +c pptl(5,i)=sngl(pi5) +cc pptl(5,i)=sngl(pj5) +cc idptl(i)=idptl(j) +c pptl(1,j)=sngl(pj1) +c pptl(2,j)=sngl(pj2) +c pptl(3,j)=sngl(pj3) +c pptl(4,j)=sngl(pj4) +c pptl(5,j)=sngl(pj5) +cc pptl(5,j)=sngl(pi5) +cc idptl(j)=id +c if(ish.ge.6)then +c write(ifch,*)'out ',idptl(i),pi1,pi2,pi3,pi4 +c write(ifch,*)' <> ',idptl(j),pj1,pj2,pj3,pj4 +c endif +c +c return +c end +c +cc----------------------------------------------------------------------- +c subroutine utchm(arp,arm,ii) +cc----------------------------------------------------------------------- +cc checks whether arp**2=0 and arm**2=0. +cc----------------------------------------------------------------------- +c include 'epos.inc' +c double precision arp(4),arm(4),difp,difm +c difp=arp(4)**2-arp(1)**2-arp(2)**2-arp(3)**2 +c difm=arm(4)**2-arm(1)**2-arm(2)**2-arm(3)**2 +c if(dabs(difp).gt.1e-3*arp(4)**2 +c *.or.dabs(difm).gt.1e-3*arm(4)**2)then +c call utmsg('utchm ') +c write(ifch,*)'***** mass non zero - ',ii +c write(ifch,*)'jet-mass**2`s: ',difp,difm +c write(ifch,*)'energy**2`s: ',arp(4)**2,arm(4)**2 +c write(ifch,*)(sngl(arp(i)),i=1,4) +c write(ifch,*)(sngl(arm(i)),i=1,4) +c call utmsgf +c endif +c return +c end +c +c----------------------------------------------------------------------- + subroutine utclea(nptlii,nptl0) +c----------------------------------------------------------------------- +c starting from nptlii +c overwrites istptl=99 particles in /cptl/, reduces so nptl +c and update minfra and maxfra +c----------------------------------------------------------------------- + include 'epos.inc' + integer newptl(mxptl)!,oldptl(mxptl),ii(mxptl) + + ish0=ish + if(ishsub/100.eq.18)ish=mod(ishsub,100) + + call utpri('utclea',ish,ishini,2) + + nptli=max(maproj+matarg+1,nptlii) + minfra0=minfra + maxfra0=maxfra + minfra1=maxfra + maxfra1=minfra + if(ish.ge.2)write(ifch,*)'entering subr utclea:',nptl + & ,minfra,maxfra + if(ish.ge.7)then + write(ifch,*)('-',l=1,68) + write(ifch,*)'sr utclea. initial.' + write(ifch,*)('-',l=1,68) + do 34 n=nptli,nptl + write(ifch,116)iorptl(n),jorptl(n),n,ifrptl(1,n),ifrptl(2,n) + *,idptl(n),sqrt(pptl(1,n)**2+pptl(2,n)**2),pptl(3,n),pptl(5,n) + *,istptl(n),ityptl(n) +34 continue +116 format(1x,i6,i6,4x,i6,4x,i6,i6,i12,3x,3(e8.2,1x),i3,i3) + endif + +c ish=ish0 +c ish0=ish +c if(ishsub/100.eq.18)ish=mod(ishsub,100) + + i=nptli-1 +1 i=i+1 + if(i.gt.nptl)goto 1000 + if(istptl(i).eq.99)goto 2 + newptl(i)=i +c oldptl(i)=i + goto 1 + +2 i=i-1 + j=i +3 i=i+1 +4 j=j+1 + if(j.gt.nptl)goto 5 + newptl(j)=0 + if(istptl(j).eq.99)goto 4 + newptl(j)=i +c oldptl(i)=j +c write(ifch,*)'move',j,' to ',i +c write(ifch,*)idptl(i),ityptl(i),idptl(j),ityptl(j),minfra,maxfra + call utrepl(i,j) + if(j.ge.minfra0.and.j.le.maxfra0)then + minfra1=min(minfra1,i) + maxfra1=max(maxfra1,i) + endif + goto 3 + +5 nptl=i-1 + if(nptl.eq.0)then + nptl0=0 + goto 1000 + endif + +20 n0=newptl(nptl0) + if(n0.gt.0)then + nptl0=n0 + else + nptl0=nptl0-1 + if(nptl0.gt.0)goto 20 + endif + + +c do 11 k=1,nptl +c io=iorptl(k) +c if(io.le.0)ii(k)=io +c if(io.gt.0)ii(k)=newptl(io) +c11 continue +c do 12 k=1,nptl +c12 iorptl(k)=ii(k) +c +c do 13 k=1,nptl +c jo=jorptl(k) +c if(jo.le.0)ii(k)=jo +c if(jo.gt.0)ii(k)=newptl(jo) +c13 continue +c do 14 k=1,nptl +c14 jorptl(k)=ii(k) +c +c do 15 k=1,nptl +c if1=ifrptl(1,k) +c if(if1.le.0)ii(k)=if1 +c if(if1.gt.0)ii(k)=newptl(if1) +c15 continue +c do 16 k=1,nptl +c16 ifrptl(1,k)=ii(k) +c +c do 17 k=1,nptl +c if2=ifrptl(2,k) +c if(if2.le.0)ii(k)=if2 +c if(if2.gt.0)ii(k)=newptl(if2) +c17 continue +c do 18 k=1,nptl +c18 ifrptl(2,k)=ii(k) +c +c do 19 k=1,nptl +c if(ifrptl(1,k).eq.0.and.ifrptl(2,k).gt.0)ifrptl(1,k)=ifrptl(2,k) +c if(ifrptl(2,k).eq.0.and.ifrptl(1,k).gt.0)ifrptl(2,k)=ifrptl(1,k) +c19 continue + +1000 continue + + if(minfra1.lt.minfra0)minfra=minfra1 + if(maxfra1.ge.minfra1)maxfra=maxfra1 + + if(ish.ge.2)then + write(ifch,*)'exiting subr utclea:' + do 35 n=1,nptl + write(ifch,116)iorptl(n),jorptl(n),n,ifrptl(1,n),ifrptl(2,n) + *,idptl(n),sqrt(pptl(1,n)**2+pptl(2,n)**2),pptl(3,n),pptl(5,n) + *,istptl(n),ityptl(n) +35 continue + endif + + if(ish.ge.2)write(ifch,*)'exiting subr utclea:',nptl + & ,minfra,maxfra + + call utprix('utclea',ish,ishini,2) + ish=ish0 + return + end + +c--------------------------------------------------------------------- + subroutine utfit(x,y,ndata,sig,mwt,a,b,siga,sigb,chi2,q) +c--------------------------------------------------------------------- +c linear fit to data +c input: +c ndata: nr of data points +c x(),y(),sig(): data +c mwt: unweighted (0) or weighted (else) data points +c output: +c a,b: parameters of linear fit a+b*x +c--------------------------------------------------------------------- + INTEGER mwt,ndata + REAL a,b,chi2,q,siga,sigb,sig(ndata),x(ndata),y(ndata) +CU USES utgmq + INTEGER i + REAL sigdat,ss,st2,sx,sxoss,sy,t,wt,utgmq + sx=0. + sy=0. + st2=0. + b=0. + if(mwt.ne.0) then + ss=0. + do 11 i=1,ndata + wt=1./(sig(i)**2) + ss=ss+wt + sx=sx+x(i)*wt + sy=sy+y(i)*wt +11 continue + else + do 12 i=1,ndata + sx=sx+x(i) + sy=sy+y(i) +12 continue + ss=float(ndata) + endif + sxoss=sx/ss + if(mwt.ne.0) then + do 13 i=1,ndata + t=(x(i)-sxoss)/sig(i) + st2=st2+t*t + b=b+t*y(i)/sig(i) +13 continue + else + do 14 i=1,ndata + t=x(i)-sxoss + st2=st2+t*t + b=b+t*y(i) +14 continue + endif + b=b/st2 + a=(sy-sx*b)/ss + siga=sqrt((1.+sx*sx/(ss*st2))/ss) + sigb=sqrt(1./st2) + chi2=0. + if(mwt.eq.0) then + do 15 i=1,ndata + chi2=chi2+(y(i)-a-b*x(i))**2 +15 continue + q=1. + sigdat=sqrt(chi2/(ndata-2)) + siga=siga*sigdat + sigb=sigb*sigdat + else + do 16 i=1,ndata + chi2=chi2+((y(i)-a-b*x(i))/sig(i))**2 +16 continue + q=utgmq(0.5*(ndata-2),0.5*chi2) + endif + return + END + +c----------------------------------------------------------------------- + function utgam1(x) +c----------------------------------------------------------------------- +c gamma fctn tabulated +c single precision +c----------------------------------------------------------------------- + double precision utgamtab,utgam,al,dl + common/gamtab/utgamtab(10000) + + if(x.gt.0.01.and.x.lt.99.99)then + al=100.d0*dble(x) + k1=int(al) + k2=k1+1 + dl =al-dble(k1) + utgam1=real(utgamtab(k2)*dl+utgamtab(k1)*(1.d0-dl)) + elseif(x.eq.0.)then + utgam1=0. + else + utgam1=real(utgam(dble(x))) + endif + + end + +c----------------------------------------------------------------------- + double precision function utgam2(x) +c----------------------------------------------------------------------- +c gamma fctn tabulated +c double precision +c----------------------------------------------------------------------- + double precision utgamtab,x,al,dl,utgam + common/gamtab/utgamtab(10000) + + if(x.gt.0.01d0.and.x.le.99.99d0)then + al=100.d0*x + k1=int(al) + k2=k1+1 + dl =al-dble(k1) + utgam2=utgamtab(k2)*dl+utgamtab(k1)*(1.d0-dl) + elseif(x.eq.0.d0)then + utgam2=0.d0 + else + utgam2=utgam(x) + endif + + end + +c----------------------------------------------------------------------- + double precision function utgam(x) +c----------------------------------------------------------------------- +c gamma fctn +c double precision +c----------------------------------------------------------------------- + include 'epos.inc' + double precision c(13),x,z,f + data c + 1/ 0.00053 96989 58808, 0.00261 93072 82746, 0.02044 96308 23590, + 2 0.07309 48364 14370, 0.27964 36915 78538, 0.55338 76923 85769, + 3 0.99999 99999 99998,-0.00083 27247 08684, 0.00469 86580 79622, + 4 0.02252 38347 47260,-0.17044 79328 74746,-0.05681 03350 86194, + 5 1.13060 33572 86556/ + utgam=0d0 + z=x + if(x .gt. 170.d0) goto6 + if(x .gt. 0.0d0) goto1 + if(x .eq. int(x)) goto5 + z=1.0d0-z + 1 f=1.0d0/z + if(z .le. 1.0d0) goto4 + f=1.0d0 + 2 continue + if(z .lt. 2.0d0) goto3 + z=z-1.0d0 + f=f*z + goto2 + 3 z=z-1.0d0 + 4 utgam= + 1 f*((((((c(1)*z+c(2))*z+c(3))*z+c(4))*z+c(5))*z+c(6))*z+c(7))/ + 2 ((((((c(8)*z+c(9))*z+c(10))*z+c(11))*z+c(12))*z+c(13))*z+1.0d0) + if(x .gt. 0.0d0) return + utgam=3.141592653589793d0/(sin(3.141592653589793d0*x)*utgam) + return + 5 write(ifch,10)sngl(x) + 10 format(1x,'argument of gamma fctn = ',e20.5) + call utstop('utgam : negative integer argument&') + 6 write(ifch,11)sngl(x) + 11 format(1x,'argument of gamma fctn = ',e20.5) + call utstop('utgam : argument too large&') + end + +c--------------------------------------------------------------------- + subroutine utgcf(gammcf,a,x,gln) +c--------------------------------------------------------------------- + INTEGER ITMAX + REAL a,gammcf,gln,x,EPS,FPMIN + PARAMETER (ITMAX=100,EPS=3.e-7,FPMIN=1.e-30) +CU USES utgmln + INTEGER i + REAL an,b,c,d,del,h,utgmln + gln=utgmln(a) + b=x+1.-a + c=1./FPMIN + d=1./b + h=d + do 11 i=1,ITMAX + an=-i*(i-a) + b=b+2. + d=an*d+b + if(abs(d).lt.FPMIN)d=FPMIN + c=b+an/c + if(abs(c).lt.FPMIN)c=FPMIN + d=1./d + del=d*c + h=h*del + if(abs(del-1.).lt.EPS)goto 1 +11 continue + call utstop("a too large, ITMAX too small in utgcf&") +1 gammcf=exp(-x+a*log(x)-gln)*h + return + END + +c--------------------------------------------------------------------- + function utgmln(xx) +c--------------------------------------------------------------------- + REAL utgmln,xx + INTEGER j + DOUBLE PRECISION ser,stp,tmp,x,y,cof(6) + SAVE cof,stp + DATA cof,stp/76.18009172947146d0,-86.50532032941677d0, + *24.01409824083091d0,-1.231739572450155d0,.1208650973866179d-2, + *-.5395239384953d-5,2.5066282746310005d0/ + x=xx + y=x + tmp=x+5.5d0 + tmp=(x+0.5d0)*log(tmp)-tmp + ser=1.000000000190015d0 + do 11 j=1,6 + y=y+1.d0 + ser=ser+cof(j)/y +11 continue + utgmln=tmp+log(stp*ser/x) + return + END + +c--------------------------------------------------------------------- + function utgmq(a,x) +c--------------------------------------------------------------------- + REAL a,utgmq,x +CU USES utgcf,utgser + REAL gammcf,gamser,gln + if(x.lt.0..or.a.le.0.) call utstop("bad arguments in utgmq&") + if(x.lt.a+1.)then + call utgser(gamser,a,x,gln) + utgmq=1.-gamser + else + call utgcf(gammcf,a,x,gln) + utgmq=gammcf + endif + return + END + +c--------------------------------------------------------------------- + subroutine utgser(gamser,a,x,gln) +c--------------------------------------------------------------------- + INTEGER ITMAX + REAL a,gamser,gln,x,EPS + PARAMETER (ITMAX=100,EPS=3.e-7) +CU USES utgmln + INTEGER n + REAL ap,del,sum,utgmln + gln=utgmln(a) + if(x.le.0.)then + if(x.lt.0.)call utstop("x < 0 in utgser&") + gamser=0. + return + endif + ap=a + sum=1./a + del=sum + do 11 n=1,ITMAX + ap=ap+1. + del=del*x/ap + sum=sum+del + if(abs(del).lt.abs(sum)*EPS)goto 1 +11 continue + call utstop("a too large, ITMAX too small in utgser&") +1 gamser=sum*exp(-x+a*log(x)-gln) + return + END + +c------------------------------------------------------------------------- + subroutine uticpl(ic,ifla,iqaq,iret) +c------------------------------------------------------------------------- +c adds a quark (iqaq=1) or antiquark (iqaq=2) of flavour ifla +c to 2-id ic +c------------------------------------------------------------------------- + include 'epos.inc' + integer jc(nflav,2),ic(2) + iret=0 + if(ifla.eq.0)return + call iddeco(ic,jc) + if(ish.ge.8)write(ifch,'(2i8,12i3)')ic,jc + jqaq=3-iqaq + if(jc(ifla,jqaq).gt.0)then + jc(ifla,jqaq)=jc(ifla,jqaq)-1 + else + jc(ifla,iqaq)=jc(ifla,iqaq)+1 + endif + call idcomj(jc) + call idenco(jc,ic,ireten) + if(ish.ge.8)write(ifch,'(2i8,12i3)')ic,jc + if(ireten.eq.1)iret=1 + if(ic(1).eq.0.and.ic(2).eq.0.and.ireten.eq.0)then + ic(1)=100000 + ic(2)=100000 + endif + return + end + +cc----------------------------------------------------------------------- +c subroutine utindx(n,xar,x,i) +cc----------------------------------------------------------------------- +cc input: dimension n +cc array xar(n) with xar(i) > xar(i-1) +cc some number x between xar(1) and xar(n) +cc output: the index i such that x is between xar(i) and xar(i+1) +cc----------------------------------------------------------------------- +c include 'epos.inc' +c real xar(n) +c if(x.lt.xar(1))then +c if(ish.ge.5)then +c call utmsg('utindx') +c write(ifch,*)'***** x=',x,' < xar(1)=',xar(1) +c call utmsgf +c endif +c i=1 +c return +c elseif(x.gt.xar(n))then +c if(ish.ge.5)then +c call utmsg('utindx') +c write(ifch,*)'***** x=',x,' > xar(n)=',xar(n) +c call utmsgf +c endif +c i=n +c return +c endif +c lu=1 +c lo=n +c1 lz=(lo+lu)/2 +c if((xar(lu).le.x).and.(x.le.xar(lz)))then +c lo=lz +c elseif((xar(lz).lt.x).and.(x.le.xar(lo)))then +c lu=lz +c else +c call utstop('utindx: no interval found&') +c endif +c if((lo-lu).ge.2) goto1 +c if(lo.le.lu)call utstop('utinvt: lo.le.lu&') +c i=lu +c return +c end +c +c----------------------------------------------------------------------- + function utinvt(n,x,q,y) +c----------------------------------------------------------------------- +c returns x with y=q(x) +c----------------------------------------------------------------------- + include 'epos.inc' + real x(n),q(n) + if(q(n).eq.0.)call utstop('utinvt: q(n)=0&') + if(y.lt.0.)then + if(ish.ge.1)then + call utmsg('utinvt') + write(ifch,*)'***** y=',y,' < 0' + call utmsgf + endif + y=0. + elseif(y.gt.q(n))then + if(ish.ge.1)then + call utmsg('utinvt') + write(ifch,*)'***** y=',y,' > ',q(n) + call utmsgf + endif + y=q(n) + endif + lu=1 + lo=n +1 lz=(lo+lu)/2 + if((q(lu).le.y).and.(y.le.q(lz)))then + lo=lz + elseif((q(lz).lt.y).and.(y.le.q(lo)))then + lu=lz + else + write(ifch,*)'q(1),y,q(n):',q(1),y,q(n) + write(ifch,*)'lu,lz,lo:',lu,lz,lo + write(ifch,*)'q(lu),q(lz),q(lo):',q(lu),q(lz),q(lo) + call utstop('utinvt: no interval found&') + endif + if((lo-lu).ge.2) goto1 + if(lo.le.lu)call utstop('utinvt: lo.le.lu&') + utinvt=x(lu)+(y-q(lu))*(x(lo)-x(lu))/(q(lo)-q(lu)) + return + end + +c----------------------------------------------------------------------- + subroutine utlob2(isig,p1,p2,p3,p4,p5,x1,x2,x3,x4,idi) +c----------------------------------------------------------------------- +c performs a lorentz boost, double prec. +c isig=+1 is to boost the four vector x1,x2,x3,x4 such as to obtain it +c in the frame specified by the 5-vector p1...p5 (5-vector=4-vector+mass). +c isig=-1: the other way round, that means, +c if the 4-vector x1...x4 is given in some frame characterized by +c p1...p5 with respect to to some lab-frame, utlob2 returns the 4-vector +c x1...x4 in the lab frame. +c idi is a call identifyer (integer) to identify the call in case of problem +c----------------------------------------------------------------------- + include 'epos.inc' + double precision beta(4),z(4),p1,p2,p3,p4,p5,pp,bp,x1,x2,x3,x4 + *,xx0,x10,x20,x30,x40,x4x,x0123 + if(ish.ge.2)then + if(ish.ge.9)then + write(ifch,101)x1,x2,x3,x4,(x4-x3)*(x4+x3)-x2*x2-x1*x1 + write(ifch,301)p1,p2,p3,p4,p5,(p4-p3)*(p4+p3)-p2*p2-p1*p1 +101 format(' utlob2: x = ',5e13.5) +301 format(' p = ',6e13.5) + endif + pp=(p4-p3)*(p4+p3)-p2*p2-p1*p1 + if(dabs(pp-p5*p5).gt.1e-3*p4*p4.and.dabs(pp-p5*p5).gt.1e-3)then + call utmsg('utlob2') + write(ifch,*)'***** p**2 .ne. p5**2' + write(ifch,*)'call identifyer:',idi + write(ifch,*)'p**2,p5**2: ',pp,p5*p5 + write(ifch,*)'p: ',p1,p2,p3,p4,p5 + call utmsgf + endif + x10=x1 + x20=x2 + x30=x3 + x40=x4 + endif + xx0=(x4-x3)*(x4+x3)-x2*x2-x1*x1 + if(p5.le.0.)then + call utmsg('utlob2') + write(ifch,*)'***** p5 negative.' + write(ifch,*)'call identifyer:',idi + write(ifch,*)'p(5): ',p1,p2,p3,p4,p5 + write(ifmt,*)'call identifyer:',idi + write(ifmt,*)'p(5): ',p1,p2,p3,p4,p5 + call utmsgf + call utstop('utlob2: p5 negative.&') + endif + z(1)=x1 + z(2)=x2 + z(3)=x3 + z(4)=x4 + beta(1)=-p1/p5 + beta(2)=-p2/p5 + beta(3)=-p3/p5 + beta(4)= p4/p5 + bp=0. + do 220 k=1,3 +220 bp=bp+z(k)*isig*beta(k) + do 230 k=1,3 +230 z(k)=z(k)+isig*beta(k)*z(4) + *+isig*beta(k)*bp/(beta(4)+1.) + z(4)=beta(4)*z(4)+bp + x1=z(1) + x2=z(2) + x3=z(3) + x4=z(4) + if(ish.ge.9) + *write(ifch,101)x1,x2,x3,x4,(x4-x3)*(x4+x3)-x2*x2-x1*x1 + x4x=x4 + x0123=xx0+x1*x1+x2*x2+x3*x3 + if(x0123.gt.0.)then + x4=sign( dsqrt(x0123) , x4x ) + else + x4=0 + endif + if(ish.ge.9)then + write(ifch,101)x1,x2,x3,x4,(x4-x3)*(x4+x3)-x2*x2-x1*x1 + endif + if(ish.ge.2)then + if(ish.ge.9)write(ifch,*)'check x**2_ini -- x**2_fin' + if(dabs(x4-x4x).gt.1d-2*dabs(x4).and.dabs(x4-x4x).gt.1d-2)then + call utmsg('utlob2') + write(ifch,*)'***** x**2_ini .ne. x**2_fin.' + write(ifch,*)'call identifyer:',idi + write(ifch,*)'x1 x2 x3 x4 x**2 (initial/final/corrected):' +102 format(5e13.5) + write(ifch,102)x10,x20,x30,x40,(x40-x30)*(x40+x30)-x20*x20-x10*x10 + write(ifch,102)x1,x2,x3,x4x,(x4x-x3)*(x4x+x3)-x2*x2-x1*x1 + write(ifch,102)x1,x2,x3,x4,(x4-x3)*(x4+x3)-x2*x2-x1*x1 + call utmsgf + endif + endif + if(ish.ge.9)write(ifch,*)'return from utlob2' + return + end + +c----------------------------------------------------------------------- + subroutine utlob3(isig,p1,p2,p3,p4,p5,x1,x2,x3,x4) +c----------------------------------------------------------------------- +c performs a lorentz boost, double prec. +c but arguments are single precision +c----------------------------------------------------------------------- + double precision xx1,xx2,xx3,xx4 + xx1=dble(x1) + xx2=dble(x2) + xx3=dble(x3) + xx4=dble(x4) + call utlob2(isig + *,dble(p1),dble(p2),dble(p3),dble(p4),dble(p5) + *,xx1,xx2,xx3,xx4,52) + x1=sngl(xx1) + x2=sngl(xx2) + x3=sngl(xx3) + x4=sngl(xx4) + return + end + +c----------------------------------------------------------------------- + subroutine utlob5(yboost,x1,x2,x3,x4,x5) +c----------------------------------------------------------------------- + amt=sqrt(x5**2+x1**2+x2**2) + y=sign(1.,x3)*alog((x4+abs(x3))/amt) + y=y-yboost + x4=amt*cosh(y) + x3=amt*sinh(y) + return + end + +c----------------------------------------------------------------------- + subroutine utlob4(isig,pp1,pp2,pp3,pp4,pp5,x1,x2,x3,x4) +c----------------------------------------------------------------------- +c performs a lorentz boost, double prec. +c but arguments are partly single precision +c----------------------------------------------------------------------- + double precision xx1,xx2,xx3,xx4,pp1,pp2,pp3,pp4,pp5 + xx1=dble(x1) + xx2=dble(x2) + xx3=dble(x3) + xx4=dble(x4) + call utlob2(isig,pp1,pp2,pp3,pp4,pp5,xx1,xx2,xx3,xx4,53) + x1=sngl(xx1) + x2=sngl(xx2) + x3=sngl(xx3) + x4=sngl(xx4) + return + end + + +c----------------------------------------------------------------------- + subroutine utlobo(isig,p1,p2,p3,p4,p5,x1,x2,x3,x4) +c----------------------------------------------------------------------- +c performs a lorentz boost +c----------------------------------------------------------------------- + include 'epos.inc' + real beta(4),z(4) + if(p5.le.0.)then + call utmsg('utlobo') + write(ifch,*)'***** mass <= 0.' + write(ifch,*)'p(5): ',p1,p2,p3,p4,p5 + call utmsgf + call utstop('utlobo: mass <= 0.&') + endif + z(1)=x1 + z(2)=x2 + z(3)=x3 + z(4)=x4 + beta(1)=-p1/p5 + beta(2)=-p2/p5 + beta(3)=-p3/p5 + beta(4)= p4/p5 + bp=0. + do 220 k=1,3 +220 bp=bp+z(k)*isig*beta(k) + do 230 k=1,3 +230 z(k)=z(k)+isig*beta(k)*z(4) + *+isig*beta(k)*bp/(beta(4)+1.) + z(4)=beta(4)*z(4)+bp + x1=z(1) + x2=z(2) + x3=z(3) + x4=z(4) + return + end + +c----------------------------------------------------------------------- + subroutine utloc(ar,n,a,l) +c----------------------------------------------------------------------- + real ar(n) + do 1 i=1,n + l=i-1 + if(a.lt.ar(i))return +1 continue + l=n + return + end + +cc----------------------------------------------------------------------- +c subroutine utlow(cone) +cc----------------------------------------------------------------------- +c character*1 cone +c if(cone.eq.'A')cone='a' +c if(cone.eq.'B')cone='b' +c if(cone.eq.'C')cone='c' +c if(cone.eq.'D')cone='d' +c if(cone.eq.'E')cone='e' +c if(cone.eq.'F')cone='f' +c if(cone.eq.'G')cone='g' +c if(cone.eq.'H')cone='h' +c if(cone.eq.'I')cone='i' +c if(cone.eq.'J')cone='j' +c if(cone.eq.'K')cone='k' +c if(cone.eq.'L')cone='l' +c if(cone.eq.'M')cone='m' +c if(cone.eq.'N')cone='n' +c if(cone.eq.'O')cone='o' +c if(cone.eq.'P')cone='p' +c if(cone.eq.'Q')cone='q' +c if(cone.eq.'R')cone='r' +c if(cone.eq.'S')cone='s' +c if(cone.eq.'T')cone='t' +c if(cone.eq.'U')cone='u' +c if(cone.eq.'V')cone='v' +c if(cone.eq.'W')cone='w' +c if(cone.eq.'X')cone='x' +c if(cone.eq.'Y')cone='y' +c if(cone.eq.'Z')cone='z' +c return +c end +c +cc----------------------------------------------------------------------- +c subroutine utlow3(cthree) +cc----------------------------------------------------------------------- +c character cthree*3 +c do 1 i=1,3 +c1 call utlow(cthree(i:i)) +c return +c end +c +cc----------------------------------------------------------------------- +c subroutine utlow6(csix) +cc----------------------------------------------------------------------- +c character csix*6 +c do 1 i=1,6 +c1 call utlow(csix(i:i)) +c return +c end +c +cc----------------------------------------------------------------------- +c function utmom(k,n,x,q) +cc----------------------------------------------------------------------- +cc calculates kth moment for f(x) with q(i)=int[0,x(i)]f(z)dz +cc----------------------------------------------------------------------- +c real x(n),q(n) +c if(n.lt.2)call utstop('utmom : dimension too small&') +c utmom=0 +c do 1 i=2,n +c1 utmom=utmom+((x(i)+x(i-1))/2)**k*(q(i)-q(i-1)) +c utmom=utmom/q(n) +c return +c end +c +c----------------------------------------------------------------------- + function utpcm(a,b,c) +c----------------------------------------------------------------------- +c calculates cm momentum for a-->b+c +c----------------------------------------------------------------------- + val=(a*a-b*b-c*c)*(a*a-b*b-c*c)-(2.*b*c)*(2.*b*c) + if(val.lt.0..and.val.gt.-1e-4)then + utpcm=0 + return + endif + utpcm=sqrt(val)/(2.*a) + return + end + +c----------------------------------------------------------------------- + double precision function utpcmd(a,b,c,iret) +c----------------------------------------------------------------------- +c calculates cm momentum for a-->b+c +c----------------------------------------------------------------------- + double precision a,b,c,val + iret=0 + val=(a*a-b*b-c*c)*(a*a-b*b-c*c)-(2.*b*c)*(2.*b*c) + utpcmd=0d0 + if(val.lt.0d0.and.val.gt.-1d-4)then + return + elseif(val.lt.0d0)then + iret=1 + return + endif + utpcmd=sqrt(val)/(2.d0*a) + return + end + +c----------------------------------------------------------------------- + subroutine utpri(text,ishi,ishini,ishx) +c----------------------------------------------------------------------- + include 'epos.inc' + character*(*) text +c double precision seedx !!! + ishini=ishi + if(ishevt.ne.0.and.nrevt+1.ne.ishevt)return + if(nrpri.gt.0)then + do nr=1,nrpri + if(subpri(nr)(1:6).eq.text)then + ishi=ishpri(nr) + endif + enddo + endif + if(ish.ge.ishx)then + write(ifch,'(1x,43a)') + * ('-',i=1,10),' entry ',text,' ',('-',i=1,30) +c call ranfgt(seedx) !!! +c if(ish.ge.ishx)write(ifch,*)'seed:',seedx !!! + endif + return + end + +c----------------------------------------------------------------------- + subroutine utprix(text,ishi,ishini,ishx) +c----------------------------------------------------------------------- + include 'epos.inc' + character*(*) text + if(ishevt.ne.0.and.nrevt+1.ne.ishevt)return + if(ish.ge.ishx)write(ifch,'(1x,44a)') + *('-',i=1,30),' exit ',text,' ',('-',i=1,11) + ishi=ishini + return + end + +c----------------------------------------------------------------------- + subroutine utprj(text,ishi,ishini,ishx) +c----------------------------------------------------------------------- + include 'epos.inc' + character*(*) text +c double precision seedx !!! + idx=index(text,' ')-1 + ishini=ishi + if(ishevt.ne.0.and.nrevt+1.ne.ishevt)return + if(nrpri.gt.0)then + do nr=1,nrpri + if(subpri(nr)(1:idx).eq.text(1:idx))then + ishi=ishpri(nr) + endif + enddo + endif + if(ish.ge.ishx)then + write(ifch,'(1x,43a)') + * ('-',i=1,10),' entry ',text(1:idx),' ',('-',i=1,30) +c call ranfgt(seedx) !!! +c if(ish.ge.ishx)write(ifch,*)'seed:',seedx !!! + endif + return + end + +c----------------------------------------------------------------------- + subroutine utprjx(text,ishi,ishini,ishx) +c----------------------------------------------------------------------- + include 'epos.inc' + character*(*) text + idx=index(text,' ')-1 + if(ishevt.ne.0.and.nrevt+1.ne.ishevt)return + if(ish.ge.ishx)write(ifch,'(1x,44a)') + *('-',i=1,30),' exit ',text(1:idx),' ',('-',i=1,11) + ishi=ishini + return + end + +c----------------------------------------------------------------------- + function utquad(m,x,f,k) +c----------------------------------------------------------------------- +c performs an integration according to simpson +c----------------------------------------------------------------------- + real x(m),f(m) + utquad=0 + do 1 i=1,k-1 + 1 utquad=utquad+(f(i)+f(i+1))/2*(x(i+1)-x(i)) + return + end + +c----------------------------------------------------------------------- + subroutine utquaf(fu,n,x,q,x0,x1,x2,x3) +c----------------------------------------------------------------------- +c returns q(i) = integral [x(1)->x(i)] fu(x) dx +c----------------------------------------------------------------------- + include 'epos.inc' + real x(n),q(n) + parameter (m=10) + real xa(m),fa(m) + external fu + if(x1.lt.x0.or.x2.lt.x1.or.x3.lt.x2)then + if(ish.ge.1)then + call utmsg('utquaf') + write(ifch,*)' xi=',x0,x1,x2,x3 + call utmsgf + endif + endif + call utar(n/3,n*2/3,n,x0,x1,x2,x3,x) + q(1)=0 + do 2 i=2,n + do 3 k=1,m + z=x(i-1)+(k-1.)/(m-1.)*(x(i)-x(i-1)) + xa(k)=z +3 fa(k)=fu(z) + q(i)=q(i-1)+utquad(m,xa,fa,m) +2 continue + return + end + +c----------------------------------------------------------------------- + subroutine utrepl(i,j) +c----------------------------------------------------------------------- +c i is replaced by j in /cptl/ +c----------------------------------------------------------------------- + include 'epos.inc' + do 1 k=1,5 +1 pptl(k,i) =pptl(k,j) + iorptl(i) = 0 !iorptl(j) + idptl(i) =idptl(j) + istptl(i) =istptl(j) + do 2 k=1,2 +2 tivptl(k,i)=tivptl(k,j) + do 3 k=1,2 +3 ifrptl(k,i)= 0 !ifrptl(k,j) + jorptl(i) = 0 !jorptl(j) + do 4 k=1,4 +4 xorptl(k,i)=xorptl(k,j) + do 5 k=1,4 +5 ibptl(k,i) =ibptl(k,j) + ityptl(i) =ityptl(j) + iaaptl(i) =iaaptl(j) + radptl(i) =radptl(j) + desptl(i) =desptl(j) + dezptl(i) =dezptl(j) + qsqptl(i) =qsqptl(j) + zpaptl(1,i)=zpaptl(1,j) + zpaptl(2,i)=zpaptl(2,j) + itsptl(i) =itsptl(j) + rinptl(i) =rinptl(j) + return + end + +c----------------------------------------------------------------------- + subroutine utrepla(i,j) +c----------------------------------------------------------------------- +c i is replaced by j in /cptl/ +c----------------------------------------------------------------------- + include 'epos.inc' + do 1 k=1,5 +1 pptl(k,i) =pptl(k,j) + iorptl(i) = iorptl(j) + idptl(i) =idptl(j) + istptl(i) =istptl(j) + do 2 k=1,2 +2 tivptl(k,i)=tivptl(k,j) + do 3 k=1,2 +3 ifrptl(k,i)= ifrptl(k,j) + jorptl(i) = jorptl(j) + do 4 k=1,4 +4 xorptl(k,i)=xorptl(k,j) + do 5 k=1,4 +5 ibptl(k,i) =ibptl(k,j) + ityptl(i) =ityptl(j) + iaaptl(i) =iaaptl(j) + radptl(i) =radptl(j) + desptl(i) =desptl(j) + dezptl(i) =dezptl(j) + qsqptl(i) =qsqptl(j) + zpaptl(1,i)=zpaptl(1,j) + zpaptl(2,i)=zpaptl(2,j) + itsptl(i) =itsptl(j) + rinptl(i) =rinptl(j) + return + end + +cc----------------------------------------------------------------------- +c subroutine utresm(icp1,icp2,icm1,icm2,amp,idpr,iadj,ireten) +cc----------------------------------------------------------------------- +c parameter (nflav=6) +c integer icm(2),icp(2),jcm(nflav,2),jcp(nflav,2) +c icm(1)=icm1 +c icm(2)=icm2 +c icp(1)=icp1 +c icp(2)=icp2 +c CALL IDDECO(ICM,JCM) +c CALL IDDECO(ICP,JCP) +c do 37 nf=1,nflav +c do 37 k=1,2 +c37 jcP(nf,k)=jcp(nf,k)+jcm(nf,k) +c CALL IDENCO(JCP,ICP,IRETEN) +c IDP=IDTRA(ICP,0,0,3) +c call idres(idp,amp,idpr,iadj) +c return +c end +c +cc----------------------------------------------------------------------- +c subroutine utroa1(phi,a1,a2,a3,x1,x2,x3) +cc----------------------------------------------------------------------- +cc rotates x by angle phi around axis a. +cc normalization of a is irrelevant. +cc----------------------------------------------------------------------- +c double precision aaa,aa(3),xxx,xx(3),e1(3),e2(3),e3(3),xp,xt,dphi +c dphi=phi +c xx(1)=x1 +c xx(2)=x2 +c xx(3)=x3 +c aa(1)=a1 +c aa(2)=a2 +c aa(3)=a3 +c aaa=0 +c xxx=0 +c do i=1,3 +c aaa=aaa+aa(i)**2 +c xxx=xxx+xx(i)**2 +c enddo +c if(xxx.eq.0d0)return +c if(aaa.eq.0d0)call utstop('utroa1: zero rotation axis&') +c aaa=dsqrt(aaa) +c xxx=dsqrt(xxx) +cc e3 = a / !a! +c do i=1,3 +c e3(i)=aa(i)/aaa +c enddo +cc x_parallel +c xp=0 +c do i=1,3 +c xp=xp+xx(i)*e3(i) +c enddo +cc x_transverse +c if(xxx**2-xp**2.le.0.)return +c xt=dsqrt(xxx**2-xp**2) +cc e1 = vector x_transverse / absolute value x_transverse +c do i=1,3 +c e1(i)=(xx(i)-e3(i)*xp)/xt +c enddo +cc e2 orthogonal e3,e1 +c call utvec2(e3,e1,e2) +cc rotate x +c do i=1,3 +c xx(i)=xp*e3(i)+xt*dcos(dphi)*e1(i)+xt*dsin(dphi)*e2(i) +c enddo +cc back to single precision +c x1=xx(1) +c x2=xx(2) +c x3=xx(3) +c return +c end +c +c----------------------------------------------------------------------- + subroutine utroa1(phi,a1,a2,a3,x1,x2,x3) +c----------------------------------------------------------------------- +c rotates x by angle phi around axis a (argument single precision) +c normalization of a is irrelevant. +c----------------------------------------------------------------------- + double precision aa(3),xx(3),dphi + dphi=phi + xx(1)=x1 + xx(2)=x2 + xx(3)=x3 + aa(1)=a1 + aa(2)=a2 + aa(3)=a3 + call utroa2(dphi,aa(1),aa(2),aa(3),xx(1),xx(2),xx(3)) +c back to single precision + x1=sngl(xx(1)) + x2=sngl(xx(2)) + x3=sngl(xx(3)) + return + end + +c----------------------------------------------------------------------- + subroutine utroa2(phi,a1,a2,a3,x1,x2,x3) +c----------------------------------------------------------------------- +c rotates x by angle phi around axis a. +c normalization of a is irrelevant. +c double precision phi,a1,a2,a3,x1,x2,x3 +c----------------------------------------------------------------------- + double precision phi,a1,a2,a3,x1,x2,x3 + double precision aaa,aa(3),xxx,xx(3),e1(3),e2(3),e3(3),xp,xt,dphi + dphi=phi + xx(1)=x1 + xx(2)=x2 + xx(3)=x3 + aa(1)=a1 + aa(2)=a2 + aa(3)=a3 + aaa=0d0 + xxx=0d0 + do i=1,3 + aaa=aaa+aa(i)**2 + xxx=xxx+xx(i)**2 + enddo + if(xxx.eq.0d0)return + if(aaa.eq.0d0)call utstop('utroa1: zero rotation axis&') + aaa=1.0/dsqrt(aaa) +c e3 = a / !a! + do i=1,3 + e3(i)=aa(i)*aaa + enddo +c x_parallel + xp=0 + do i=1,3 + xp=xp+xx(i)*e3(i) + enddo +c x_transverse + if(xxx-xp**2.le.0.)return + xt=dsqrt(xxx-xp**2) +c e1 = vector x_transverse / absolute value x_transverse + do i=1,3 + e1(i)=(xx(i)-e3(i)*xp)/xt + enddo +c e2 orthogonal e3,e1 + call utvec2(e3,e1,e2) +c rotate x + do i=1,3 + xx(i)=xp*e3(i)+xt*cos(dphi)*e1(i)+xt*sin(dphi)*e2(i) + enddo + xxx=0d0 + do i=1,3 + xxx=xxx+xx(i)**2 + enddo +c back to single precision + x1=xx(1) + x2=xx(2) + x3=xx(3) + return + end + +cc-------------------------------------------------------------------- +c function utroot(funcd,x1,x2,xacc) +cc-------------------------------------------------------------------- +cc combination of newton-raphson and bisection method for root finding +cc input: +cc funcd: subr returning fctn value and first derivative +cc x1,x2: x-interval +cc xacc: accuracy +cc output: +cc utroot: root +cc-------------------------------------------------------------------- +c include 'epos.inc' +c INTEGER MAXIT +c REAL utroot,x1,x2,xacc +c EXTERNAL funcd +c PARAMETER (MAXIT=100) +c INTEGER j +c REAL df,dx,dxold,f,fh,fl,temp,xh,xl +c call funcd(x1,fl,df) +c call funcd(x2,fh,df) +c if((fl.gt.0..and.fh.gt.0.).or.(fl.lt.0..and.fh.lt.0.)) +c *call utstop('utroot: root must be bracketed&') +c if(fl.eq.0.)then +c utroot=x1 +c return +c else if(fh.eq.0.)then +c utroot=x2 +c return +c else if(fl.lt.0.)then +c xl=x1 +c xh=x2 +c else +c xh=x1 +c xl=x2 +c endif +c utroot=.5*(x1+x2) +c dxold=abs(x2-x1) +c dx=dxold +c call funcd(utroot,f,df) +c do 11 j=1,MAXIT +c if(((utroot-xh)*df-f)*((utroot-xl)*df-f).ge.0..or. abs(2.* +c *f).gt.abs(dxold*df) ) then +c dxold=dx +c dx=0.5*(xh-xl) +c utroot=xl+dx +c if(xl.eq.utroot)return +c else +c dxold=dx +c dx=f/df +c temp=utroot +c utroot=utroot-dx +c if(temp.eq.utroot)return +c endif +c if(abs(dx).lt.xacc) return +c call funcd(utroot,f,df) +c if(f.lt.0.) then +c xl=utroot +c else +c xh=utroot +c endif +c11 continue +c call utmsg('utroot') +c write(ifch,*)'***** exceeding maximum iterations' +c write(ifch,*)'dx:',dx +c call utmsgf +c return +c END +c +c----------------------------------------------------------------------- + subroutine utrot2(isig,ax,ay,az,x,y,z) +c----------------------------------------------------------------------- +c performs a rotation, double prec. +c----------------------------------------------------------------------- + include 'epos.inc' + double precision ax,ay,az,x,y,z,rx,ry,rz + *,alp,bet,cosa,sina,cosb,sinb,xs,ys,zs + if(ax**2.eq.0.and.ay**2.eq.0.and.az**2.eq.0.)then + write(ifch,*)'ax**2,ay**2,az**2:',ax**2,ay**2,az**2 + write(ifch,*)'ax,ay,az:',ax,ay,az + call utstop('utrot2: zero vector.&') + endif + if(az.ge.0.)then + rx=ax + ry=ay + rz=az + else + rx=-ax + ry=-ay + rz=-az + endif + if(rz**2+ry**2.ne.0.)then + alp=dabs(dacos(rz/dsqrt(rz**2+ry**2)))*sign(1.,sngl(ry)) + bet= + *dabs(dacos(dsqrt(rz**2+ry**2)/dsqrt(rz**2+ry**2+rx**2)))* + *sign(1.,sngl(rx)) + else + alp=3.1415927d0/2d0 + bet=3.1415927d0/2d0 + endif + cosa=dcos(alp) + sina=dsin(alp) + cosb=dcos(bet) + sinb=dsin(bet) + if(isig.ge.0)then + xs=x*cosb-y*sina*sinb-z*cosa*sinb + ys= y*cosa -z*sina + zs=x*sinb+y*sina*cosb+z*cosa*cosb + else !if(isig.lt.0)then + xs= x*cosb +z*sinb + ys=-x*sinb*sina+y*cosa+z*cosb*sina + zs=-x*sinb*cosa-y*sina+z*cosb*cosa + endif + x=xs + y=ys + z=zs + return + end + + +c----------------------------------------------------------------------- + subroutine utrot4(isig,ax,ay,az,x,y,z) +c----------------------------------------------------------------------- +c performs a rotation, double prec. +c arguments partly single +c----------------------------------------------------------------------- + double precision ax,ay,az,xx,yy,zz + xx=dble(x) + yy=dble(y) + zz=dble(z) + call utrot2(isig,ax,ay,az,xx,yy,zz) + x=sngl(xx) + y=sngl(yy) + z=sngl(zz) + return + end + +c----------------------------------------------------------------------- + subroutine utrota(isig,ax,ay,az,x,y,z) +c----------------------------------------------------------------------- +c performs a rotation +c----------------------------------------------------------------------- + if(az.ge.0.)then + rx=ax + ry=ay + rz=az + else + rx=-ax + ry=-ay + rz=-az + endif + if(rz.eq.0..and.ry.eq.0.)then + alp=0. + stop + else + alp=abs(utacos(rz/sqrt(rz**2+ry**2)))*sign(1.,ry) + endif + bet= + *abs(utacos(sqrt(rz**2+ry**2)/sqrt(rz**2+ry**2+rx**2)))*sign(1.,rx) + cosa=cos(alp) + sina=sin(alp) + cosb=cos(bet) + sinb=sin(bet) + if(isig.ge.0)then + xs=x*cosb-y*sina*sinb-z*cosa*sinb + ys= y*cosa -z*sina + zs=x*sinb+y*sina*cosb+z*cosa*cosb + else !if(isig.lt.0)then + xs= x*cosb +z*sinb + ys=-x*sinb*sina+y*cosa+z*cosb*sina + zs=-x*sinb*cosa-y*sina+z*cosb*cosa + endif + x=xs + y=ys + z=zs + return + end + +c----------------------------------------------------------------------- + subroutine utstop(text) +c----------------------------------------------------------------------- +c returns error message and stops execution. +c text is an optonal text to appear in the error message. +c text is a character string of length 40; +c for shorter text, it has to be terminated by &; +c example: call utstop('error in subr xyz&') +c----------------------------------------------------------------------- + include 'epos.inc' +c parameter(itext=40) + character text*(*) ,txt*6 + imax=index(text,'&') + do 1 j=1,2 + if(j.eq.1)then + ifi=ifch + else !if(j.eq.2) + ifi=ifmt + endif + if(imax.gt.1)then + write(ifi,101)('*',k=1,72),text(1:imax-1) + *,nrevt+1,nint(seedj),seedc,('*',k=1,72) + else + write(ifi,101)('*',k=1,72),' ' + *,nrevt+1,nint(seedj),seedc,('*',k=1,72) + endif +101 format( + *1x,72a1 + */1x,'***** stop in ',a + */1x,'***** current event number: ',i12 + */1x,'***** initial seed for current run:',i10 + */1x,'***** initial seed for current event:',d25.15 + */1x,72a1) +1 continue +c c=0. +c b=a/c + stop + entry utmsg(txt) + imsg=imsg+1 + write(ifch,'(1x,74a1)')('*',j=1,72) + write(ifch,100)txt,nrevt+1,nint(seedj),seedc +100 format(1x,'***** msg from ',a6,'. es:',i7,2x,i9,2x,d23.17) + return + entry utmsgf + if(ish.eq.1)return + write(ifch,'(1x,74a1)')('*',j=1,72) + end + +c----------------------------------------------------------------- + subroutine uttrap(func,a,b,s) +c----------------------------------------------------------------- +c trapezoidal method for integration. +c input: fctn func and limits a,b +c output: value s of the integral +c----------------------------------------------------------------- + include 'epos.inc' + + INTEGER JMAX + REAL a,b,func,s + EXTERNAL func + PARAMETER (JMAX=10) +CU USES uttras + INTEGER j + REAL olds + olds=-1.e30 + do 11 j=1,JMAX + if(ish.ge.9)write(ifch,*)'sr uttrap: j:',j + call uttras(func,a,b,s,j) + ds=abs(s-olds) + if (ds.lt.epsr*abs(olds)) return + olds=s +11 continue + +c-c nepsr=nepsr+1 + if(ish.ge.9)then + call utmsg('uttrap') + write(ifch,*) + *'***** requested accuracy could not be achieved' + write(ifch,*)'achieved accuracy: ',ds/abs(olds) + write(ifch,*)'requested accuracy:',epsr + call utmsgf + endif + + END + +c----------------------------------------------------------------- + subroutine uttraq(func,a,b,s) +c----------------------------------------------------------------- +c trapezoidal method for integration. +c input: function func and limits a,b +c output: value s of the integral +c----------------------------------------------------------------- + + REAL a,b,func,s + EXTERNAL func + PARAMETER (eps=1.e-6) +CU USES uttras + INTEGER j + REAL olds + olds=-1.e30 + j=1 +10 call uttras(func,a,b,s,j) + ds=abs(s-olds) + if (ds.le.eps*abs(olds)) return + olds=s + if(j.ge.15)return + j=j+1 + goto10 + END + +c----------------------------------------------------------------- + subroutine uttras(func,a,b,s,n) +c----------------------------------------------------------------- +c performs one iteration of the trapezoidal method for integration +c----------------------------------------------------------------- + INTEGER n + REAL a,b,s,func + EXTERNAL func + INTEGER it,j + REAL del,sum,tnm,x + if (n.eq.1) then + s=0.5*(b-a)*(func(a)+func(b)) + else + it=2**(n-2) + tnm=it + del=(b-a)/tnm + x=a+0.5*del + sum=0. + do 11 j=1,it + sum=sum+func(x) + x=x+del +11 continue + s=0.5*(s+(b-a)*sum/tnm) + endif + return + END + +cc----------------------------------------------------------------------- +c subroutine utvec1(a,b,c) +cc----------------------------------------------------------------------- +cc returns vector product c = a x b . +cc----------------------------------------------------------------------- +c real a(3),b(3),c(3) +c c(1)=a(2)*b(3)-a(3)*b(2) +c c(2)=a(3)*b(1)-a(1)*b(3) +c c(3)=a(1)*b(2)-a(2)*b(1) +c return +c end +c +c----------------------------------------------------------------------- + subroutine utvec2(a,b,c) +c----------------------------------------------------------------------- +c returns vector product c = a x b . +c a,b,c double precision. +c----------------------------------------------------------------------- + double precision a(3),b(3),c(3) + c(1)=a(2)*b(3)-a(3)*b(2) + c(2)=a(3)*b(1)-a(1)*b(3) + c(3)=a(1)*b(2)-a(2)*b(1) + return + end + +c------------------------------------------------------------------- + subroutine utword(line,i,j,iqu) +c------------------------------------------------------------------- +c finds the first word of the character string line(j+1:1000). +c the word is line(i:j) (with new i and j). +c if j<0 or if no word found --> new line read. +c a text between quotes "..." is considered one word; +c stronger: a text between double quotes ""..."" is consid one word +c stronger: a text between "{ and }" is considered one word +c------------------------------------------------------------------- +c input: +c line: character string (*1000) +c i: integer between 1 and 1000 +c iqu: for iqu=1 a "?" is written to output before reading a line, +c otherwise (iqu/=1) nothing is typed +c output: +c i,j: left and right end of word (word=line(i:j)) +c------------------------------------------------------------------- + include 'epos.inc' + parameter(mempty=2) + character*1 empty(mempty),mk + character line*1000 + character*2 mrk + data empty/' ',','/ + parameter(mxdefine=40) + character w1define*100,w2define*100 + common/cdefine/ndefine,l1define(mxdefine),l2define(mxdefine) + & ,w1define(mxdefine),w2define(mxdefine) + + j0=0 + if(j.ge.0)then + i=j + goto 1 + endif + + 5 continue + if(iqu.eq.1.and.iprmpt.gt.0)write(ifmt,'(a)')'?' + if(nopen.eq.0)then + ifopx=ifop + elseif(nopen.gt.0)then + ifopx=20+nopen + else !if(nopen.lt.0) + ifopx=ifcp + endif + read(ifopx,'(a1000)',end=9999)line + if(iecho.eq.1.or.(nopen.ge.0.and.kcpopen.eq.1))then + kmax=2 + do k=3,1000 + if(line(k:k).ne.' ')kmax=k + enddo + else + kmax=0 + endif + if(nopen.ge.0.and.kcpopen.eq.1) + & write(ifcp,'(a)')line(1:kmax) + if(iecho.eq.1) + & write(ifmt,'(a)')line(1:kmax) + i=0 + + 1 i=i+1 + if(i.gt.1000)goto 5 + if(line(i:i).eq.'!')goto 5 + do ne=1,mempty + if(line(i:i).eq.empty(ne))goto 1 + enddo + + nbla=1 + mrk=' ' + mk=' ' + if(line(i:i).eq.'~')mk='~' + if(line(i:i+1).eq.'"{')mrk='}"' + if(line(i:i+1).eq.'""')mrk='""' + if(mrk.ne.' ')goto 10 + if(line(i:i).eq.'"')mk='"' + if(mk.ne.' ')goto 8 + j=i-1 + 6 j=j+1 + if(j.gt.1000)goto 7 + if(line(j:j).eq.'!')goto 7 + do ne=1,mempty + if(line(j:j).eq.empty(ne))goto 7 + enddo + goto 6 + + 8 continue + if(i.ge.1000-1)stop'utword: make line shorter!!! ' + i=i+1 + j=i + if(line(j:j).eq.mk)stop'utword: empty string!!! ' + 9 j=j+1 + if(j.gt.1000)then !reach the end of the line + j=j-nbla+2 + goto 7 + endif + if(line(j:j).eq.' ')then + nbla=nbla+1 + else + nbla=2 + endif + if(line(j:j).eq.mk)then + line(i-1:i-1)=' ' + line(j:j)=' ' + goto 7 + endif + goto 9 + + 10 continue + if(i.ge.1000-3)stop'utword: make line shorter!!!! ' + i=i+2 + j=i + if(line(j:j+1).eq.mrk)stop'utword: empty string!!!! ' + 11 j=j+1 + if(j.gt.1000-1)then !reach the end of the line + j=j-nbla+2 + goto 7 + endif + if(line(j:j+1).eq.mrk)then + line(i-2:i-1)=' ' + line(j:j+1)=' ' + goto 7 + endif + if(line(j:j).eq.' ')then + nbla=nbla+1 + else + nbla=2 + endif + goto 11 + + 7 j=j-1 + !--------#define--------------- + if(ndefine.gt.0)then + do ndf=1,ndefine + l1=l1define(ndf) + l2=l2define(ndf) + do i0=i,j+1-l1 + if(line(i0:i0-1+l1).eq.w1define(ndf)(1:l1))then + if(l2.eq.l1)then + line(i0:i0-1+l1)=w2define(ndf)(1:l2) + elseif(l2.lt.l1)then + line(i0:i0+l2-1)=w2define(ndf)(1:l2) + do k=i0+l2,i0-1+l1 + line(k:k)=' ' + enddo + elseif(l2.gt.l1)then + do k=i0+l1,i0+l2-1 + if(line(k:k).ne.' ') + & stop'utword: no space for `define` replacement. ' + enddo + line(i0:i0+l2-1)=w2define(ndf)(1:l2) + j=i0+l2-1 + endif + endif + enddo + enddo + do k=i,j + if(line(k:k).ne.' ')j0=j + enddo + j=j0 + endif + !-------- + return + +9999 close(ifopx) + nopen=nopen-1 + if(nopen.eq.0.and.iprmpt.eq.-1)iprmpt=1 + goto 5 + end + +c-------------------------------------------------------------------- + subroutine utworn(line,j,ne) +c-------------------------------------------------------------------- +c returns number ne of nonempty characters of line(j+1:1000) +c-------------------------------------------------------------------- + character line*1000 + ne=0 + do l=j+1,1000 + if(line(l:l).ne.' ')ne=ne+1 + enddo + return + end + +c----------------------------------------------------------------------- + subroutine getairmol(iz,ia) +c----------------------------------------------------------------------- + include 'epos.inc' + i=0 + r=rangen() + do while(r.gt.0.) ! choose air-molecule + i=i+1 + r=r-airwnxs(i) + enddo + iz = nint(airznxs(i)) + ia = nint(airanxs(i)) + end + +c---------------------------------------------------------------------- + + subroutine factoriel + +c---------------------------------------------------------------------- +c tabulation of fctrl(n)=n!, facto(n)=1/n! and utgamtab(x) for x=0 to 50 +c---------------------------------------------------------------------- + include 'epos.incems' + double precision utgamtab,utgam,x + common/gamtab/utgamtab(10000) + + nfctrl=100 + fctrl(0)=1.D0 + facto(0)=1.D0 + do i=1,min(npommx,nfctrl) + fctrl(i)=fctrl(i-1)*dble(i) + facto(i)=1.d0/fctrl(i) + enddo + + do k=1,10000 + x=dble(k)/100.d0 + utgamtab(k)=utgam(x) + enddo + + return + end + +c----------------------------------------------------------------------- + subroutine fremnu(amin,ca,cb,ca0,cb0,ic1,ic2,ic3,ic4) +c----------------------------------------------------------------------- + common/hadr2/iomodl,idproj,idtarg,wexcit + real pnll,ptq + common/hadr1/pnll,ptq,exmass,cutmss,wproj,wtarg + parameter (nflav=6) + integer ic(2),jc(nflav,2) + ic(1)=ca + ic(2)=cb + call iddeco(ic,jc) + keu=jc(1,1)-jc(1,2) + ked=jc(2,1)-jc(2,2) + kes=jc(3,1)-jc(3,2) + kec=jc(4,1)-jc(4,2) + keb=jc(5,1)-jc(5,2) + ket=jc(6,1)-jc(6,2) + amin=utamnu(keu,ked,kes,kec,keb,ket,5) !???4=2mults, 5=1mult + if(ca-ca0.eq.0..and.cb-cb0.eq.0..and.rangen().gt.wexcit)then + ic3=0 + ic4=0 + ic1=ca + ic2=cb + else + amin=amin+exmass + n=0 + do i=1,4 + do j=1,2 + n=n+jc(i,j) + enddo + enddo + k=1+rangen()*n + do i=1,4 + do j=1,2 + k=k-jc(i,j) + if(k.le.0)goto 1 + enddo + enddo +1 if(j.eq.1)then + ic3=10**(6-i) + ic4=0 + else + ic3=0 + ic4=10**(6-i) + endif + ic1=int(ca)-ic3 + ic2=int(cb)-ic4 + endif + return + end + + +c----------------------------------------------------------------------- + function fremnux(jc) +c----------------------------------------------------------------------- + real pnll,ptq + common/hadr1/pnll,ptq,exmass,cutmss,wproj,wtarg + parameter (nflav=6) + integer jc(nflav,2)!,ic(2) +c ic(1)=210000 +c ic(2)=0 +c call iddeco(ic,jc) + keu=jc(1,1)-jc(1,2) + ked=jc(2,1)-jc(2,2) + kes=jc(3,1)-jc(3,2) + kec=jc(4,1)-jc(4,2) + keb=jc(5,1)-jc(5,2) + ket=jc(6,1)-jc(6,2) + fremnux=utamnu(keu,ked,kes,kec,keb,ket,4) !+exmass !???4=2mults, 5=1mult + return + end + +c----------------------------------------------------------------------- + function fremnux2(jc) +c----------------------------------------------------------------------- + real pnll,ptq + common/hadr1/pnll,ptq,exmass,cutmss,wproj,wtarg + parameter (nflav=6) + integer jc(nflav,2)!,ic(2) +c ic(1)=210000 +c ic(2)=0 +c call iddeco(ic,jc) + keu=jc(1,1)-jc(1,2) + ked=jc(2,1)-jc(2,2) + kes=jc(3,1)-jc(3,2) + kec=jc(4,1)-jc(4,2) + keb=jc(5,1)-jc(5,2) + ket=jc(6,1)-jc(6,2) + fremnux2=utamnu(keu,ked,kes,kec,keb,ket,5) !+exmass !???4=2mults, 5=1mult + return + end + +c----------------------------------------------------------------------- + function fremnux3(jci) +c----------------------------------------------------------------------- +c minimum mass from ic counting all quarks +c----------------------------------------------------------------------- + include 'epos.inc' + integer jc(nflav,2),jci(nflav,2)!,ic(2) +c ic(1)=210000 +c ic(2)=0 +c print *,'start',ic + fremnux3=0. + do j=1,2 + do i=1,nflav + jc(i,j)=jci(i,j) + enddo + enddo +c call iddeco(ic,jc) + call idquacjc(jc,nqua,naqu) + do ii=1,2 + if(ii.eq.1)then + nqu=nqua + else + nqu=naqu + endif + if(nqu.ge.3)then + do while(jc(3,ii).ne.0.and.nqu.ge.3) !count baryons with s quark + jc(3,ii)=jc(3,ii)-1 + if(jc(3,ii).gt.0)then + jc(3,ii)=jc(3,ii)-1 + if(jc(3,ii).gt.0)then + jc(3,ii)=jc(3,ii)-1 + fremnux3=fremnux3+asuhax(4) + elseif(jc(2,ii).gt.0)then + jc(2,ii)=jc(2,ii)-1 + fremnux3=fremnux3+asuhax(4) + elseif(jc(1,ii).gt.0)then + jc(1,ii)=jc(1,ii)-1 + fremnux3=fremnux3+asuhax(4) + endif + elseif(jc(2,ii).gt.0)then + jc(2,ii)=jc(2,ii)-1 + if(jc(1,ii).gt.0)then + jc(1,ii)=jc(1,ii)-1 + fremnux3=fremnux3+asuhax(3) + elseif(jc(2,ii).gt.0)then + jc(2,ii)=jc(2,ii)-1 + fremnux3=fremnux3+asuhax(3) + endif + elseif(jc(1,ii).gt.0)then + jc(1,ii)=jc(1,ii)-2 + fremnux3=fremnux3+asuhay(3) + endif + nqu=nqu-3 + enddo + do while(jc(2,ii).ne.0.and.nqu.ge.3) !count baryons with d quark + jc(2,ii)=jc(2,ii)-1 + if(jc(1,ii).gt.0)then + jc(1,ii)=jc(1,ii)-1 + if(jc(2,ii).gt.0)then + jc(2,ii)=jc(2,ii)-1 + fremnux3=fremnux3+asuhay(2) + elseif(jc(1,ii).gt.0)then + jc(1,ii)=jc(1,ii)-1 + fremnux3=fremnux3+asuhay(2) + endif + elseif(jc(2,ii).gt.0)then + jc(2,ii)=jc(2,ii)-2 + fremnux3=fremnux3+asuhay(3) + endif + nqu=nqu-3 + enddo + do while(jc(1,ii).ne.0.and.nqu.ge.3) !count baryons with s quark + jc(1,ii)=jc(1,ii)-3 + fremnux3=fremnux3+asuhay(3) + nqu=nqu-3 + enddo + if(ii.eq.1)then + nqua=nqu + else + naqu=nqu + endif + endif +c print *,ii,nqua,naqu,jc,fremnux3 + enddo + if(nqua+naqu.ne.0)then + do while(jc(3,1).ne.0) !count mesons with s quark + jc(3,1)=jc(3,1)-1 + if(jc(3,2).gt.0)then + jc(3,2)=jc(3,2)-1 + fremnux3=fremnux3+asuhax(6) + elseif(jc(2,2).gt.0)then + jc(2,2)=jc(2,2)-1 + fremnux3=fremnux3+asuhay(6) + elseif(jc(1,2).gt.0)then + jc(1,2)=jc(1,2)-1 + fremnux3=fremnux3+asuhay(6) + endif + enddo + do while(jc(2,1).ne.0) !count mesons with d quark + jc(2,1)=jc(2,1)-1 + if(jc(2,2).gt.0)then + jc(2,2)=jc(2,2)-1 + fremnux3=fremnux3+asuhay(5) + elseif(jc(1,2).gt.0)then + jc(1,2)=jc(1,2)-1 + fremnux3=fremnux3+asuhay(5) + endif + enddo + do while(jc(1,1).ne.0) !count mesons with s quark + jc(1,1)=jc(1,1)-1 + if(jc(1,2).gt.0)then + jc(1,2)=jc(1,2)-1 + fremnux3=fremnux3+asuhay(5) + endif + enddo + endif +c fremnux3=fremnux3+0.5 +c print *,'stop',nqua,naqu,fremnux3 + + return + end + +c----------------------------------------------------------------------- + subroutine fremnx(ammax,amin,sm,ic3,ic4,iret) +c----------------------------------------------------------------------- + common/psar9/ alpr + include 'epos.inc' + iret=0 + if(ic3.eq.0.and.ic4.eq.0)then + if(ammax.lt.amin**2)then + iret=1 + return + endif + sm=amin**2 + else +c ammax1=min(ammax,(engy/4.)**2) + ammax1=ammax + if(ammax1.lt.amin**2)then + iret=1 + return + endif + if(alpr.eq.-1.)then + sm=amin**2*(ammax1/amin**2)**rangen() + else + sm=amin**2*(1.+((ammax1/amin**2)**(1.+alpr)-1.) + * *rangen())**(1./(1.+alpr)) + endif + endif + return + end + + SUBROUTINE gaulag(x,w,n,alf) + INTEGER n,MAXIT + REAL alf,w(n),x(n) + DOUBLE PRECISION EPS + PARAMETER (EPS=3.D-14,MAXIT=10) +CU USES gammln + INTEGER i,its,j + REAL ai,gammln + DOUBLE PRECISION p1,p2,p3,pp,z,z1 + z=0. + do 13 i=1,n + if(i.eq.1)then + z=(1.+alf)*(3.+.92*alf)/(1.+2.4*n+1.8*alf) + else if(i.eq.2)then + z=z+(15.+6.25*alf)/(1.+.9*alf+2.5*n) + else + ai=i-2 + z=z+((1.+2.55*ai)/(1.9*ai)+1.26*ai*alf/(1.+3.5*ai))* + *(z-x(i-2))/(1.+.3*alf) + endif + do 12 its=1,MAXIT + p1=1.d0 + p2=0.d0 + do 11 j=1,n + p3=p2 + p2=p1 + p1=((2*j-1+alf-z)*p2-(j-1+alf)*p3)/j +11 continue + pp=(n*p1-(n+alf)*p2)/z + z1=z + z=z1-p1/pp + if(abs(z-z1).le.EPS)goto 1 +12 continue + call utstop("too many iterations in gaulag") +1 x(i)=z + w(i)=-exp(gammln(alf+n)-gammln(float(n)))/(pp*n*p2) +13 continue + return + END +C (C) Copr. 1986-92 Numerical Recipes Software 4+1$!]. + + FUNCTION gammln(xx) + REAL gammln,xx + INTEGER j + DOUBLE PRECISION ser,stp,tmp,x,y,cof(6) + SAVE cof,stp + DATA cof,stp/76.18009172947146d0,-86.50532032941677d0, + *24.01409824083091d0,-1.231739572450155d0,.1208650973866179d-2, + *-.5395239384953d-5,2.5066282746310005d0/ + x=xx + y=x + tmp=x+5.5d0 + tmp=(x+0.5d0)*log(tmp)-tmp + ser=1.000000000190015d0 + do 11 j=1,6 + y=y+1.d0 + ser=ser+cof(j)/y +11 continue + gammln=tmp+log(stp*ser/x) + return + END +C (C) Copr. 1986-92 Numerical Recipes Software 4+1$!]. + + function polar(x,y) + + pi=3.1415927 + if(abs(x).gt.1.e-6)then + phi=atan(y/x) + if(x.lt.0.)phi=pi+phi + if(phi.lt.0)phi=2*pi+phi + else + phi=0.5*pi + if(y.lt.0)phi=phi+pi + endif + polar=phi + + end + + subroutine getJKNcentr + end diff --git a/modules/epos/epos-xan-lhc.f b/modules/epos/epos-xan-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..95de8c32158041e750253c1e58702ce69e507fa6 --- /dev/null +++ b/modules/epos/epos-xan-lhc.f @@ -0,0 +1,5515 @@ +c--------------------------------------------------------------------- + subroutine xiniall +c--------------------------------------------------------------------- + include 'epos.inc' + parameter (mxhis=500,mxcontr=500,mxidcd=60,mxtri=50,mxbin=405) + parameter (mypara=10,mxpara=20) + logical ilog,icnx,itrevt,idmod + double precision bin,bbin,zcbin,zbbin + common/bins/bin(mxbin,2,mxhis),zcbin(mxbin,2,mxhis) + $ ,bbin(mxbin,2,mxcontr),itrevt(mxhis),zbbin(mxbin,2,mxcontr) + $ ,nac(mxhis),ilog(mxhis),icnx(mxhis),xinc(mxhis),ncevt(mxhis) + $ ,sval(2,mxhis),valtri(mxtri,mxhis),ntrc(mxtri,mxhis) + $ ,xmin(mxhis),xmax(mxhis),nhis,noweak(mxhis) + $ ,ivar(2,mxhis),inorm(mxhis),nbin(mxhis),nidcod(mxhis) + $ ,idcod(mxidcd,mxhis),idmod(mxidcd,mxhis),ntri(mxhis) + $ ,itri(mxtri,mxhis),xmitri(mxtri,mxhis),xmatri(mxtri,mxhis) + $ ,xmitrp(mxtri,mxhis),xmatrp(mxtri,mxhis),xpara(mxpara,mxhis) + $ ,ypara(mypara,mxhis),lookcontr(mxhis) + $ ,lookcontrx(mxhis),ncontrall,icontrtyp(mxhis),nccevt(mxcontr) + double precision ebin,zebin + common/errbins/ebin(mxbin,2,mxhis/2),zebin(mxbin,2,mxhis/2), + $inoerr(mxhis),noerr(mxhis/2,2),noerrhis(mxhis/2),noerrall + + parameter (mxfra=5) + common/pfra/nfra,ifra(mxfra),ivfra(2,mxhis),itfra(mxtri,mxhis) + $ ,imofra(3,mxfra),iffra(mxfra),r1fra(3,mxfra),r2fra(3,mxfra) + $ ,emax(mxfra) + common/stavar/multc05,multy1,multc14,multyi,multc3,imulty1,multeb + & ,multc1,multc83,multc24,multc25,rapgap,ipairs1,xsi + parameter(mxxhis=150) + common/varhis/icorrtrig(0:mxxhis),ihardevent(0:mxxhis) + &,ijetfind1(0:mxxhis),ijetfind2(0:mxxhis),imux(0:mxxhis) + &,ifastjet(0:mxxhis),ijetevent(0:mxxhis),icaltrig(0:mxxhis) + + nhis=0 + nfra=0 + imulty1=0 + ipairs1=0 + do n=0,mxxhis + icorrtrig(n)=0 + ihardevent(n)=0 + ijetfind1(n)=0 + ijetfind2(n)=0 + ifastjet(n)=0 + ijetevent(n)=0 + imux(n)=0 + icaltrig(n)=0 + enddo + do n=1,mxhis + do m=1,mxpara + xpara(m,n)=0 + enddo + enddo + ncontrall=0 + noerrall=0 + + end + +c--------------------------------------------------------------------- + subroutine xini +c--------------------------------------------------------------------- +c called after beginhisto +c--------------------------------------------------------------------- + include 'epos.inc' + parameter (mxhis=500,mxcontr=500,mxidcd=60,mxtri=50,mxbin=405) + parameter (mypara=10,mxpara=20) + logical ilog,icnx,itrevt,idmod + double precision bin,bbin,zcbin,zbbin + common/bins/bin(mxbin,2,mxhis),zcbin(mxbin,2,mxhis) + $ ,bbin(mxbin,2,mxcontr),itrevt(mxhis),zbbin(mxbin,2,mxcontr) + $ ,nac(mxhis),ilog(mxhis),icnx(mxhis),xinc(mxhis),ncevt(mxhis) + $ ,sval(2,mxhis),valtri(mxtri,mxhis),ntrc(mxtri,mxhis) + $ ,xmin(mxhis),xmax(mxhis),nhis,noweak(mxhis) + $ ,ivar(2,mxhis),inorm(mxhis),nbin(mxhis),nidcod(mxhis) + $ ,idcod(mxidcd,mxhis),idmod(mxidcd,mxhis),ntri(mxhis) + $ ,itri(mxtri,mxhis),xmitri(mxtri,mxhis),xmatri(mxtri,mxhis) + $ ,xmitrp(mxtri,mxhis),xmatrp(mxtri,mxhis),xpara(mxpara,mxhis) + $ ,ypara(mypara,mxhis),lookcontr(mxhis) + $ ,lookcontrx(mxhis),ncontrall,icontrtyp(mxhis),nccevt(mxcontr) + double precision ebin,zebin + common/errbins/ebin(mxbin,2,mxhis/2),zebin(mxbin,2,mxhis/2), + $inoerr(mxhis),noerr(mxhis/2,2),noerrhis(mxhis/2),noerrall + common/stavar/multc05,multy1,multc14,multyi,multc3,imulty1,multeb + & ,multc1,multc83,multc24,multc25,rapgap,ipairs1,xsi + parameter(mxxhis=150) + common/varhis/icorrtrig(0:mxxhis),ihardevent(0:mxxhis) + &,ijetfind1(0:mxxhis),ijetfind2(0:mxxhis),imux(0:mxxhis) + &,ifastjet(0:mxxhis),ijetevent(0:mxxhis),icaltrig(0:mxxhis) + + parameter (mxfra=5) + common/pfra/nfra,ifra(mxfra),ivfra(2,mxhis),itfra(mxtri,mxhis) + $ ,imofra(3,mxfra),iffra(mxfra),r1fra(3,mxfra),r2fra(3,mxfra) + $ ,emax(mxfra) + character line*1000,cvar*6 + logical go + common/nl/noplin /cnnnhis/nnnhis + character*1000 cline + common/cjjj/jjj,cline + + call utpri('xini ',ish,ishini,5) + + i=1 + ! iapl=0 + ! nhis=0 + j=jjj !-1 + line=cline + ! nfra=1 + ! ifra(1)=iframe + iapl=0 + if(nfra.eq.0)then + nfra=1 + ifra(1)=iframe + endif + nhis=nhis+1 + nnnhis=nhis + if(nhis.gt.mxhis)stop'xini: mxhis too small. ' + noweak(nhis)=0 + ionoerr=0 +c newfra=0 + indfra=1 +c nepfra=0 + inpfra=1 + 1 call utword(line,i,j,0) + if(line(i:j).eq.'application')then !----------- + call utword(line,i,j,1) + if(line(i:j).eq.'analysis')then + !iapl=0 + !nhis=nhis+1 + !newfra=0 + !indfra=1 + !nepfra=0 + !inpfra=1 + else + iapl=1 + endif + elseif(line(i:j).eq.'input')then !----------- + call utword(line,i,j,0) + if(nopen.ge.0)then + nopen=nopen+1 + if(nopen.gt.9)stop'too many nested input commands' + open(unit=20+nopen,file=line(i:j),status='old') + if(iprmpt.eq.1)iprmpt=-1 + endif + elseif(line(i:j).eq.'runprogram')then !----------- + if(iapl.eq.0)then + else + goto 9999 + endif + elseif(line(i:j).eq.'frame'.or.line(i:j).eq.'frame+')then !------ + ifp=1 + if(line(i:j).eq.'frame+')ifp=2 + call utword(line,i,j,1) + if(line(i:j).eq.'total')then + nfp=iframe + elseif(line(i:j).eq.'nucleon-nucleon')then + nfp=11 + elseif(line(i:j).eq.'target')then + nfp=12 + elseif(line(i:j).eq.'gamma-nucleon')then + nfp=21 + elseif(line(i:j).eq.'lab')then + nfp=22 + elseif(line(i:j).eq.'breit')then + nfp=23 + elseif(line(i:j).eq.'thrust')then + nfp=33 + elseif(line(i:j).eq.'sphericity')then + nfp=32 + else + nfp=0 + call utstop("Wrong frame in xini !&") + endif + go=.true. + inl=0 + do l=1,nfra + if(ifra(l).eq.nfp)then + inl=l + go=.false. + endif + enddo + if (go) then + nfra=nfra+1 + inl=nfra + ifra(nfra)=nfp + endif + if(ifp.eq.1)then + indfra=inl +c newfra=nfp + ivfra(1,nhis)=indfra + ivfra(2,nhis)=indfra + else + inpfra=inl +c nepfra=nfp + endif + elseif(line(i:j).eq.'binning')then !----------- + call utword(line,i,j,1) + if(line(i:j).eq.'lin')then + iologb=0 + iocnxb=0 + elseif(line(i:j).eq.'log')then + iologb=1 + iocnxb=0 + elseif(line(i:j).eq.'clin')then + iologb=0 + iocnxb=1 + elseif(line(i:j).eq.'clog')then + iologb=1 + iocnxb=1 + else + print *, 'what the heck is ',line(i:j),' binning?' + print *, 'I will use the linear (lin) one' + endif + elseif(line(i:j).eq.'setm')then !----------- + if(iapl.eq.0) then + print *,"You should use histogram instead of setm, please" + stop + endif + elseif(line(i:j).eq.'set')then !----------- + call utword(line,i,j,1) + if(line(i:j).eq.'iologb')then + call utword(line,i,j,1) + read(line(i:j),*) iologb + elseif(line(i:j).eq.'iocnxb')then + call utword(line,i,j,1) + read(line(i:j),*) iocnxb + elseif(line(i:j).eq.'etacut')then + call utword(line,i,j,1) + read(line(i:j),*) etacut + elseif(line(i:j).eq.'nemsi')then + call utword(line,i,j,1) + read(line(i:j),*)nemsi + endif + elseif(line(i:j).eq.'xpara')then !----------- + call utword(line,i,j,1) + read(line(i:j),*)ipara + if(ipara.gt.mxpara)stop'mxpara too small. ' + call utword(line,i,j,1) + read(line(i:j),*)val + xpara(ipara,nhis)=val + elseif(line(i:j).eq.'xparas')then !----------- + call utword(line,i,j,1) + read(line(i:j),*)ipara + if(ipara.gt.mxpara)stop'mxpara too small.' + do ii=1,ipara + call utword(line,i,j,1) + read(line(i:j),*)val + xpara(ii,nhis)=val + enddo + elseif(line(i:j).eq.'echo')then !----------- + call utword(line,i,j,1) + if(line(i:j).eq.'on')iecho=1 + if(line(i:j).eq.'off')iecho=0 + if(line(i:j).ne.'on'.and.line(i:j).ne.'off') + * stop'invalid option' + elseif(line(i:j).eq.'noweak')then !----------- + noweak(nhis)=1 + elseif(line(i:j).eq.'histogram' + * .or.line(i:j).eq.'hi')then !----------- + nac(nhis)=1 + call utword(line,i,j,1) !xvaria + cvar=' ' + cvar=line(i:j) + call xtrans(cvar,inom,ifrnew,nhis) + if(inom.eq.-1)then + if(line(i:i).ge.'0'.and.line(i:i).le.'9')then + inom=298 + read(line(i:j),*) sval(1,nhis) + endif + endif + ivar(1,nhis)=inom + if(ifrnew.ne.0)then !check frame for e+e- event + go=.true. !shape variables + do l=1,nfra + if(ifra(l).eq.ifrnew)then + indfra=l + go=.false. !have it already + endif + enddo + if (go) then + nfra=nfra+1 + ifra(nfra)=ifrnew + indfra=nfra + endif + endif + call utword(line,i,j,1) !yvaria + cvar=' ' + cvar=line(i:j) + call xtrans(cvar,inom,ifrnew,nhis) + ivar(2,nhis)=inom + if(inom.eq.-1)then + if(line(i:i).ge.'0'.and.line(i:i).le.'9')then + inom=299 + read(line(i:j),*) sval(2,nhis) + endif + endif + if(inom.eq.-1)ivar(1,nhis)=inom + + ivfra(1,nhis)=indfra + ivfra(2,nhis)=indfra + + call utword(line,i,j,1) !normation + read(line(i:j),*) inorm(nhis) + + call utword(line,i,j,1) !xmin + if(line(i:j).eq.'egy')then + if(engy.gt.0)then + egy=engy + elseif(ecms.gt.0.)then + egy=ecms + elseif(elab.gt.0)then + call idmass(idproj,apj) + call idmass(idtarg,atg) + egy=sqrt( 2*elab*atg+atg**2+apj**2 ) + elseif(ekin.gt.0.)then + call idmass(idproj,apj) + call idmass(idtarg,atg) + egy=sqrt( 2*(ekin+apj)*atg+atg**2+apj**2 ) + elseif(pnll.gt.0.)then + call idmass(idproj,apj) + call idmass(idtarg,atg) + egy=sqrt( 2*sqrt(pnll**2+apj**2)*atg+atg**2+apj**2 ) + else + stop'pb in xini (1). ' + endif + xmin(nhis)=egy-0.5 + elseif(line(i:j).eq.'xp9')then + xmin(nhis)=xpara(9,nhis)-0.5 + else + read(line(i:j),*) xmin(nhis) + endif + + call utword(line,i,j,1) !xmax + if(line(i:j).eq.'egy')then + if(engy.gt.0)then + egy=engy + elseif(ecms.gt.0.)then + egy=ecms + elseif(elab.gt.0)then + call idmass(idproj,apj) + call idmass(idtarg,atg) + egy=sqrt( 2*elab*atg+atg**2+apj**2 ) + elseif(ekin.gt.0.)then + call idmass(idproj,apj) + call idmass(idtarg,atg) + egy=sqrt( 2*(ekin+apj)*atg+atg**2+apj**2 ) + elseif(pnll.gt.0.)then + call idmass(idproj,apj) + call idmass(idtarg,atg) + egy=sqrt( 2*sqrt(pnll**2+apj**2)*atg+atg**2+apj**2 ) + else + stop'pb in xini (2). ' + endif + xmax(nhis)=egy+0.5 + elseif(line(i:j).eq.'xp9')then + xmax(nhis)=xpara(9,nhis)+0.5 + else + read(line(i:j),*) xmax(nhis) + endif + + call utword(line,i,j,1) !nbin + read(line(i:j),*) nbin(nhis) + do l=1,nbin(nhis) + bin(l,nac(nhis),nhis)=0. + zcbin(l,nac(nhis),nhis)=0 + enddo + lookcontr(nhis)=0 + lookcontrx(nhis)=0 + inoerr(nhis)=0 + elseif(line(i:j).eq.'idcode')then !----------- + call utword(line,i,j,1) !idcode + if(line(i:i+2).eq.'995')stop'xini: idcode 995 not supported' + if(line(i:i+2).eq.'994')stop'xini: idcode 994 not supported' + nidcod(nhis)=nidcod(nhis)+1 + read(line(i:j),*) idcod(nidcod(nhis),nhis) + idmod(nidcod(nhis),nhis)=.false. + elseif(line(i:j).eq.'idcode+')then !----------- + stop'xini: idcode+ not supported' + call utword(line,i,j,1) !idcode + if(line(i:i+2).eq.'995')stop'xini: idcode 995 not supported' + if(line(i:i+2).eq.'994')stop'xini: idcode 994 not supported' + nidcod(nhis)=nidcod(nhis)+1 + read(line(i:j),*) idcod(nidcod(nhis),nhis) + idmod(nidcod(nhis),nhis)=.true. + elseif(line(i:j).eq.'trigger')then !----------- + call utword(line,i,j,1) + ntc=1 + imo=1 + ncontr=0 + icontrtyp(nhis)=0 + if(line(i:j).eq.'or'.or.line(i:j).eq.'contr')then + imo=2 + if(line(i:j).eq.'contr')imo=3 + call utword(line,i,j,1) + read(line(i:j),*)ztc + ntc=nint(ztc) + call utword(line,i,j,1) + if(imo.eq.3)then + ncontr=ntc + ncontrall=ncontrall+ncontr + if(ncontrall.gt.mxcontr)stop'xini: mxcontr too small. ' + if(ncontr.gt.mxcnt)stop'xini: mxcnt too small. ' + lookcontr(nhis)=ncontrall-ncontr+1 + lookcontrx(nhis)=ncontrall + do nb=1,nbin(nhis) + do nn=1,ncontr + bbin(nb,nac(nhis),lookcontr(nhis)-1+nn)=0.d0 + zbbin(nb,nac(nhis),lookcontr(nhis)-1+nn)=0.d0 + enddo + enddo + do nn=1,ncontr + nccevt(lookcontr(nhis)-1+nn)=0 + enddo + endif + endif + do n=1,ntc + if(n.ne.1)call utword(line,i,j,1) !trigger-name + cvar=' ' + ifp=1 + if(line(j:j).eq.'+')then + cvar=line(i:j-1) + ifp=2 + else + cvar=line(i:j) + ifp=1 + endif + call xtrans(cvar,inom,ifrnew,nhis) + if(inom.gt.0)then + ntri(nhis)=ntri(nhis)+1 + if(ntc.eq.1)then + ntrc(ntri(nhis),nhis)=1 + elseif(n.eq.1)then + ntrc(ntri(nhis),nhis)=2 + elseif(n.eq.ntc)then + ntrc(ntri(nhis),nhis)=3 + else + ntrc(ntri(nhis),nhis)=0 + endif + if(imo.eq.3)then + ntrc(ntri(nhis),nhis)=-1 + if(n.eq.1)then + icontrtyp(nhis)=1+inom/100 + else + if(1+inom/100.ne.icontrtyp(nhis)) + * stop'xini: type mismatch' + endif + endif + itri(ntri(nhis),nhis)=inom + if(ifp.eq.1)then + itfra(ntri(nhis),nhis)=indfra + else + itfra(ntri(nhis),nhis)=inpfra + endif + xmitrp(ntri(nhis),nhis)=100. + xmatrp(ntri(nhis),nhis)=100. + call utword(line,i,j,1) !-----------xmin---------- + if(line(i:j).eq.'inf')then + xmitri(ntri(nhis),nhis)=1e30 + elseif(line(i:j).eq.'-inf')then + xmitri(ntri(nhis),nhis)=-1e30 + elseif(line(i:j).eq.'A')then + xmitri(ntri(nhis),nhis)=maproj + elseif(line(i:j).eq.'A+1')then + xmitri(ntri(nhis),nhis)=maproj+1 + elseif(line(i:j).eq.'A+B')then + xmitri(ntri(nhis),nhis)=maproj+matarg + elseif(line(i:j).eq.'A+B+1')then + xmitri(ntri(nhis),nhis)=maproj+matarg+1 + elseif(line(i:j).eq.'lead')then !leading particle (neads Standard Variable) + xmitri(ntri(nhis),nhis)=-123456 + imulty1=1 + elseif(line(i:j).eq.'jet')then !jet from fastjet + xmitri(ntri(nhis),nhis)=nhis*100 + call actifastjet(nhis) + else + kk=0 + do k=i+1,j-1 + if(line(k:k).eq.'%')kk=k + enddo + if(kk.eq.0)then + read(line(i:j),*)xmitri(ntri(nhis),nhis) + else + read(line(i:kk-1),*)xmitrp(ntri(nhis),nhis) + read(line(kk+1:j),*)xmitri(ntri(nhis),nhis) + endif + endif + call utword(line,i,j,1) !-----------xmax------------ + if(line(i:j).eq.'inf')then + xmatri(ntri(nhis),nhis)=1e30 + elseif(line(i:j).eq.'-inf')then + xmatri(ntri(nhis),nhis)=-1e30 + elseif(line(i:j).eq.'A')then + xmatri(ntri(nhis),nhis)=maproj + elseif(line(i:j).eq.'A+1')then + xmatri(ntri(nhis),nhis)=maproj+1 + elseif(line(i:j).eq.'A+B')then + xmatri(ntri(nhis),nhis)=maproj+matarg + elseif(line(i:j).eq.'A+B+1')then + xmatri(ntri(nhis),nhis)=maproj+matarg+1 + elseif(line(i:j).eq.'lead')then !leading particle (neads Standard Variable) + xmatri(ntri(nhis),nhis)=-123456 + imulty1=1 + elseif(line(i:j).eq.'jet')then !jet form fastjet + xmatri(ntri(nhis),nhis)=nhis*100 + else + kk=0 + do k=i+1,j-1 + if(line(k:k).eq.'%')kk=k + enddo + if(kk.eq.0)then + read(line(i:j),*)xmatri(ntri(nhis),nhis) + xmatrp(ntri(nhis),nhis)=100. + else + read(line(i:kk-1),*)xmatrp(ntri(nhis),nhis) + read(line(kk+1:j),*)xmatri(ntri(nhis),nhis) + endif + endif + !---exchange min-max------------------ + if(xmitri(ntri(nhis),nhis).gt.xmatri(ntri(nhis),nhis))then + xmatri_save=xmatri(ntri(nhis),nhis) + xmatrp_save=xmatrp(ntri(nhis),nhis) + xmatri(ntri(nhis),nhis)=xmitri(ntri(nhis),nhis) + xmatrp(ntri(nhis),nhis)=xmitrp(ntri(nhis),nhis) + xmitri(ntri(nhis),nhis)=xmatri_save + xmitrp(ntri(nhis),nhis)=xmatrp_save + endif + !------------------------------------- + else + ivar(1,nhis)=-1 + call utword(line,i,j,1) !xmin + call utword(line,i,j,1) !xmax + endif + enddo + elseif(line(i:j).eq.'noerrorbut')then !----------- + ionoerr=ionoerr+1 + if(ionoerr.gt.2)stop'xini: not more than 2 noerrorbut ! ' + noerrall=noerrall+1 + if(noerrall.gt.mxhis/2)stop'xini: to many noerrorbut ' + + call utword(line,i,j,1) !variable-name + cvar=line(i:j) + call xtrans(cvar,inom,ifrnew,nhis) + if(inom.gt.0)then + if(inom.gt.100)then + write(*,*)'xini: noerrorbut can not be used with :',cvar + stop'xini: error with noerrorbut!' + endif + noerrhis(nhis)=noerrall-ionoerr+1 + noerr(noerrhis(nhis),ionoerr)=inom + do nb=1,nbin(nhis) + ebin(nb,nac(nhis),ionoerr-1+noerrhis(nhis))=0.d0 + zebin(nb,nac(nhis),ionoerr-1+noerrhis(nhis))=0.d0 + enddo + else + ionoerr=ionoerr-1 + noerrall=noerrall-1 + endif + inoerr(nhis)=ionoerr + elseif(line(i:j).eq.'write')then !----------- + call utword(line,i,j,1) + elseif(line(i:j).eq.'writearray')then !----------- + call utword(line,i,j,1) + iologb=0 + iocnxb=0 + elseif(line(i:j).eq.'writehisto')then !----------- + call utword(line,i,j,1) + iologb=0 + iocnxb=0 + elseif(line(i:j).eq.'endhisto' + . .or.line(i:j).eq.'eh')then !----------- + ilog(nhis)=.false. + icnx(nhis)=.false. + if(iologb.eq.1)ilog(nhis)=.true. + if(iocnxb.eq.1)icnx(nhis)=.true. + if(ilog(nhis))then + xinc(nhis)=1./log(xmax(nhis)/xmin(nhis))*nbin(nhis) + else + xinc(nhis)=float(nbin(nhis))/(xmax(nhis)-xmin(nhis)) + endif + iologb=0 + iocnxb=0 + jjj=j + cline=line + goto 9999 + endif + goto 1 + + 9999 continue + if(ish.ge.5)then + do n=1,nhis + write (ifch,*) n,': ',ivar(1,n),ivar(2,n) + $ ,'(',ivfra(1,n),ivfra(2,n) + $ ,')',inorm(n) + $ ,xmin(n),xmax(n),ilog(n),icnx(n) + $ ,nbin(n),(idcod(j,n),j=1,nidcod(n)) + $ ,' tri:',ntri(n),(itri(j,n),j=1,ntri(n)),'(' + $ ,(itfra(j,n),j=1,ntri(n)),')' + $ ,(xmitri(j,n),j=1,ntri(n)) ,(xmatri(j,n),j=1,ntri(n)) + enddo + write (ifch,*) (ifra(j),j=1,nfra) + endif + call utprix('xini ',ish,ishini,5) + return + end + + +c----------------------------------------------------------------------- + subroutine actifastjet(nhis) +c----------------------------------------------------------------------- + parameter(mxxhis=150) + common/varhis/icorrtrig(0:mxxhis),ihardevent(0:mxxhis) + &,ijetfind1(0:mxxhis),ijetfind2(0:mxxhis),imux(0:mxxhis) + &,ifastjet(0:mxxhis),ijetevent(0:mxxhis),icaltrig(0:mxxhis) + iok=0 + do i=1,ifastjet(0) + if(ifastjet(i).eq.nhis)iok=1 + enddo + if(iok.eq.0)then + ifastjet(0)=ifastjet(0)+1 + if(ifastjet(0).gt.mxxhis)stop'mxxhis too small' + ifastjet(ifastjet(0))=nhis + endif + end +c----------------------------------------------------------------------- + subroutine actijetevent(n) +c----------------------------------------------------------------------- + parameter(mxxhis=150) + common/varhis/icorrtrig(0:mxxhis),ihardevent(0:mxxhis) + &,ijetfind1(0:mxxhis),ijetfind2(0:mxxhis),imux(0:mxxhis) + &,ifastjet(0:mxxhis),ijetevent(0:mxxhis),icaltrig(0:mxxhis) + iok=0 + do i=1,ijetevent(0) + if(ijetevent(i).eq.n)iok=1 + enddo + if(iok.eq.0)then + ijetevent(0)=ijetevent(0)+1 + if(ijetevent(0).gt.mxxhis)stop'mxxhis too small' + ijetevent(ijetevent(0))=n + endif + end + + +c--------------------------------------------------------------------- + subroutine xana +c--------------------------------------------------------------------- + include 'epos.inc' + parameter (mxhis=500,mxcontr=500,mxidcd=60,mxtri=50,mxbin=405) + parameter (mypara=10,mxpara=20) + logical ilog,icnx,itrevt,idmod + double precision bin,bbin,zcbin,zbbin + common/bins/bin(mxbin,2,mxhis),zcbin(mxbin,2,mxhis) + $ ,bbin(mxbin,2,mxcontr),itrevt(mxhis),zbbin(mxbin,2,mxcontr) + $ ,nac(mxhis),ilog(mxhis),icnx(mxhis),xinc(mxhis),ncevt(mxhis) + $ ,sval(2,mxhis),valtri(mxtri,mxhis),ntrc(mxtri,mxhis) + $ ,xmin(mxhis),xmax(mxhis),nhis,noweak(mxhis) + $ ,ivar(2,mxhis),inorm(mxhis),nbin(mxhis),nidcod(mxhis) + $ ,idcod(mxidcd,mxhis),idmod(mxidcd,mxhis),ntri(mxhis) + $ ,itri(mxtri,mxhis),xmitri(mxtri,mxhis),xmatri(mxtri,mxhis) + $ ,xmitrp(mxtri,mxhis),xmatrp(mxtri,mxhis),xpara(mxpara,mxhis) + $ ,ypara(mypara,mxhis),lookcontr(mxhis) + $ ,lookcontrx(mxhis),ncontrall,icontrtyp(mxhis),nccevt(mxcontr) + double precision ebin,zebin + common/errbins/ebin(mxbin,2,mxhis/2),zebin(mxbin,2,mxhis/2), + $inoerr(mxhis),noerr(mxhis/2,2),noerrhis(mxhis/2),noerrall + + parameter (mxfra=5) + common/pfra/nfra,ifra(mxfra),ivfra(2,mxhis),itfra(mxtri,mxhis) + $ ,imofra(3,mxfra),iffra(mxfra),r1fra(3,mxfra),r2fra(3,mxfra) + $ ,emax(mxfra) + double precision bofra + common/dfra/bofra(5,mxfra) + parameter (ntim=1000) + common/cprt/pprt(5,ntim),q2prt(ntim),idaprt(2,ntim),idprt(ntim) + &,iorprt(ntim),jorprt(ntim),nprtj + + double precision pgampr,rgampr + common/cgampr/pgampr(5),rgampr(4) + + common/photrans/phoele(4),ebeam + + dimension ten(4,3) + logical go,goo(mxcnt),cont + + common/stavar/multc05,multy1,multc14,multyi,multc3,imulty1,multeb + & ,multc1,multc83,multc24,multc25,rapgap,ipairs1,xsi + parameter(mxxhis=150) + common/varhis/icorrtrig(0:mxxhis),ihardevent(0:mxxhis) + &,ijetfind1(0:mxxhis),ijetfind2(0:mxxhis),imux(0:mxxhis) + &,ifastjet(0:mxxhis),ijetevent(0:mxxhis),icaltrig(0:mxxhis) + common/cncntje/ncntje + + call utpri('xana ',ish,ishini,4) + + if(ish.ge.2)then + call alist('fill histograms&',0,0) + endif + + do n=1,nhis + do i=1,mypara + ypara(i,n)=0 + enddo + enddo + + + if(ish.ge.5)write(ifch,*)'frames ...' + + if(iappl.eq.6)then + if(mod(iolept/10,10).eq.1) call gakjet(1) + if(mod(iolept/100,10).eq.1) call gakjet(2) + endif + + do l=1,nfra + emax(l)=egyevt/2 + if(ifra(l).eq.12)emax(l)=sqrt(pnll**2+prom**2) + if(ifra(l).eq.iframe)then + if(iappl.eq.1.and.iframe.eq.22)emax(l)=ebeam + imofra(1,l)=0 + imofra(2,l)=0 + imofra(3,l)=0 + elseif(ifra(l).eq.11.or.ifra(l).eq.12)then + imofra(1,l)=0 + imofra(2,l)=0 + bofra(1,l)=0d0 + bofra(2,l)=0d0 + bofra(3,l)=dsinh(dble(yhaha)) + bofra(4,l)=dcosh(dble(yhaha)) + bofra(5,l)=1d0 + if(ifra(l).eq.11.and.iframe.eq.12)then + imofra(3,l)=1 ! target -> NN + elseif(ifra(l).eq.12.and.iframe.eq.11)then + imofra(3,l)=-1 ! NN -> target + else + imofra(3,l)=0 ! not known + endif + elseif(ifra(l).eq.21)then + if(iframe.ne.21)then + print *, 'invalid frame request' + print *, 'choose frame gamma-nucleon for event run' + stop'bye bye' + endif + elseif(ifra(l).eq.22)then + if(iappl.eq.1)emax(l)=ebeam + if(iframe.eq.21)then + imofra(1,l)=-1 !' trafo gN -> lab' + imofra(1,l)=0 + r1fra(1,l)=rgampr(1) + r1fra(2,l)=rgampr(2) + r1fra(3,l)=rgampr(3) + imofra(2,l)=0 + if(iappl.eq.1)then + imofra(3,l)=-2 + bofra(1,l)=dsinh(dble(yhaha)) !used for first boost in targ frame + bofra(2,l)=dcosh(dble(yhaha)) !here : pgampr(1)=pgampr(2)=0. + bofra(3,l)=pgampr(3) + bofra(4,l)=pgampr(4) + bofra(5,l)=pgampr(5) + else + imofra(3,l)=-1 + bofra(1,l)=pgampr(1) + bofra(2,l)=pgampr(2) + bofra(3,l)=pgampr(3) + bofra(4,l)=pgampr(4) + bofra(5,l)=pgampr(5) + endif + elseif(iframe.eq.22)then + ! nothing to do already gN-frame + else + print *, 'invalid frame request' + print *, 'choose frame gamma-nucleon or lab for event run' + stop'bye bye' + endif + elseif(ifra(l).eq.23)then + if(iframe.eq.21)then + imofra(1,l)=0 ! gN -> breit-frame + r1fra(1,l)=rgampr(1) + r1fra(2,l)=rgampr(2) + r1fra(3,l)=rgampr(3) + imofra(2,l)=0 + imofra(3,l)=1 + bofra(1,l)=0d0 + bofra(2,l)=0d0 + bofra(3,l)=rgampr(4) + bofra(4,l)=sqrt(rgampr(1)**2+rgampr(2)**2+rgampr(3)**2) + bofra(5,l)=sqrt( bofra(4,l)**2-rgampr(4)**2) + elseif(iframe.eq.23)then + ! nothing to do already breit-frame + else + print *, 'invalid frame request' + print *, 'choose frame gamma-nucleon or lab for event run' + stop'bye bye' + endif + elseif(ifra(l).eq.33.or.ifra(l).eq.36)then + if(ifra(l).eq.33)then + call gakthru(ten,2) + else + call gakthru(ten,3) + endif + if(ten(4,1).lt.0.)then + imofra(1,l)=0 + imofra(2,l)=0 + imofra(3,l)=0 + else + arox=ten(1,1) + aroy=ten(2,1) + aroz=ten(3,1) + brox=ten(1,2) + broy=ten(2,2) + broz=ten(3,2) + call utrota(1,arox,aroy,aroz,brox,broy,broz) + imofra(1,l)=1 + r1fra(1,l)=arox + r1fra(2,l)=aroy + r1fra(3,l)=aroz + imofra(2,l)=1 + r2fra(1,l)=brox + r2fra(2,l)=broy + r2fra(3,l)=broz + imofra(3,l)=0 !no boost + endif + bofra(1,l)=dble(ten(4,1)) !usually this is for boosting + bofra(2,l)=dble(ten(4,2)) !I abuse it to store the eigenvalues + bofra(3,l)=dble(ten(4,3)) ! + elseif(ifra(l).eq.32.or.ifra(l).eq.34.or.ifra(l).eq.35)then + if(ifra(l).eq.32)then + call gaksphe(ten,2.,2) + elseif(ifra(l).eq.34)then + call gaksphe(ten,1.,2) + else + call gaksphe(ten,2.,3) + endif + if(ten(4,1).lt.0.)then + imofra(1,l)=0 + imofra(2,l)=0 + imofra(3,l)=0 + else + arox=ten(1,1) + aroy=ten(2,1) + aroz=ten(3,1) + brox=ten(1,2) + broy=ten(2,2) + broz=ten(3,2) + call utrota(1,arox,aroy,aroz,brox,broy,broz) + imofra(1,l)=1 + r1fra(1,l)=arox + r1fra(2,l)=aroy + r1fra(3,l)=aroz + imofra(2,l)=1 + r2fra(1,l)=brox + r2fra(2,l)=broy + r2fra(3,l)=broz + imofra(3,l)=0 + endif + bofra(1,l)=dble(ten(4,1)) + bofra(2,l)=dble(ten(4,2)) + bofra(3,l)=dble(ten(4,3)) + endif + enddo + + do n=1,nhis + itrevt(n)=.false. + if(ivar(1,n).ge.100.and.ivar(1,n).le.199) sval(1,n)=0. + if(ivar(2,n).ge.100.and.ivar(2,n).le.199) sval(2,n)=0. + if(ivar(1,n).gt.300.and.ivar(1,n).lt.400)then + call xval(n,ivar(1,n),ivfra(1,n),0,x) !initializing of variables + endif + if(ivar(2,n).gt.300.and.ivar(2,n).lt.400)then + call xval(n,ivar(2,n),ivfra(2,n),0,y) ! + endif + do j=1,ntri(n) + valtri(j,n)=0. + enddo + do j=1,nbin(n) !copy bins + bin(j,3-nac(n),n)=bin(j,nac(n),n) + zcbin(j,3-nac(n),n)=zcbin(j,nac(n),n) + enddo + if(lookcontr(n).gt.0)then + do j=1,nbin(n) + do loo=lookcontr(n),lookcontrx(n) + bbin(j,3-nac(n),loo)=bbin(j,nac(n),loo) + zbbin(j,3-nac(n),loo)=zbbin(j,nac(n),loo) + enddo + enddo + endif + if(inoerr(n).gt.0)then + do j=1,nbin(n) + do nn=1,inoerr(n) + ebin(j,3-nac(n),nn-1+noerrhis(n))=ebin(j,nac(n), + & nn-1+noerrhis(n)) + zebin(j,3-nac(n),nn-1+noerrhis(n))=zebin(j,nac(n), + & nn-1+noerrhis(n)) + enddo + enddo + endif + enddo + + if(imulty1.eq.1)then + if(ish.ge.5)write(ifch,*)'Calculate standard variables ...' + call StandardVariables + endif + if(ipairs1.eq.1)then + if(ish.ge.5)write(ifch,*)'Calculate pair variables ...' + call PairVariables + endif + if(ish.ge.5)write(ifch,*)'Call corrtrig ...' + do n=1,icorrtrig(0) + call corrtrig(icorrtrig(n)) + enddo + if(ish.ge.5)write(ifch,*)'Call hardevent ...' + do n=1,ihardevent(0) + call hardevent(ihardevent(n)) + enddo + if(ish.ge.5)write(ifch,*)'Call mux ...' + do n=1,imux(0) + call mux(imux(n)) + enddo + if(ish.ge.5)write(ifch,*)'Call caltrig ...' + do n=1,icaltrig(0) + call caltrig(icaltrig(n)) + enddo + if(ish.ge.5)write(ifch,*)'Call jetfind ...' + do n=1,ijetfind1(0) + call jetfind(1,ijetfind1(n)) + enddo + do n=1,ijetfind2(0) + call jetfind(2,ijetfind2(n)) + enddo + if(ish.ge.5)write(ifch,*)'Call fastjet ...' + do n=1,ifastjet(0) + call fastjet(ifastjet(n)) + enddo +c don't change order here : jetevent should be called always after fastjet ! + if(ish.ge.5)write(ifch,*)'Call jetevent ...' + ncntje=0 + do n=1,ijetevent(0) + call jetevent(ijetevent(n)) + enddo + + +c...........................loop nptl................................... + ncontr=0 + if(ish.ge.5)write(ifch,*)'Loop nptl ...' + do j=1,nptl + if(iorptl(j).lt.0.or.(istptl(j).lt.100.and.istptl(j).gt.istmax)) + & goto 8 + if(ish.ge.5)write(ifch,*)'ptl :',j + call idchrg(idptl(j),ch) + do i=1,nfra + iffra(i)=0 !flag if frame calculated or not + enddo + do n=1,nhis + if(ivar(1,n).eq.-1.or.ivar(2,n).eq.-1)goto 9 + if(ivar(1,n).ge.200.and.ivar(2,n).ge.200)goto 9 !skip particle loop if event variables + +c...........check ids + go=nidcod(n).eq.0 + do i=1,nidcod(n) + if(istptl(j).eq.0.and.idcod(i,n).eq.10000)then !all final particle + go=.true. + elseif(istptl(j).eq.0.and.idcod(i,n).eq.9995)then !all particles but nuclei + if(abs(idptl(j)).lt.10000) go=.true. + elseif(istptl(j).eq.0.and.idcod(i,n).eq.9990)then !all hadrons + if((abs(idptl(j)).ge.100.or.abs(idptl(j)).eq.20) + $ .and.abs(idptl(j)).lt.10000) go=.true. + elseif(istptl(j).eq.0.and.idcod(i,n).eq.9985)then !neutral particles + if(abs(ch).lt.0.1.and.abs(idptl(j)).lt.10000) go=.true. + elseif(istptl(j).eq.0.and.idcod(i,n).eq.9980)then !charged particles + if(abs(ch).gt.0.1.and.abs(idptl(j)).lt.10000) go=.true. + elseif(istptl(j).eq.0.and.idcod(i,n).eq.9975)then !neutral hadrons + if(abs(ch).lt.0.1.and.(abs(idptl(j)).ge.100 + $ .or.abs(idptl(j)).eq.20).and.abs(idptl(j)).lt.10000) go=.true. + elseif(istptl(j).eq.0.and.idcod(i,n).eq.9970)then !charged hadrons + if(abs(ch).gt.0.1.and.abs(idptl(j)).ge.100 + $ .and.abs(idptl(j)).lt.10000) go=.true. + elseif(istptl(j).eq.0.and.idcod(i,n).eq.-9960)then !negative hadrons + if(ch.lt.-0.1.and.abs(idptl(j)).ge.100 + $ .and.abs(idptl(j)).lt.10000)go=.true. + elseif(istptl(j).eq.0.and.idcod(i,n).eq.9960)then !positive hadrons + if(ch.gt.0.1.and.abs(idptl(j)).ge.100 + $ .and.abs(idptl(j)).lt.10000)go=.true. + elseif((istptl(j).le.1.or.istptl(j).ge.10) + $ .and.ityptl(n).ne.61 + $ .and.idcod(i,n).eq.idptl(j))then + go=.true. + elseif(istptl(j).gt.100.and.idcod(i,n).eq.9999)then !jets from fastjet + go=.true. + endif + enddo + if(ish.ge.10)write(ifch,*)j,' id,ist',idptl(j),istptl(j),go + +c...........check weak decay + if(go)then + if(noweak(n).eq.1)then !do not consider weak decay products + if(iorptl(j).ne.0)then + idora=abs( idptl(iorptl(j)) ) + if( idora.eq.20 .or.idora.eq.2130 + & .or.idora.eq.2230 .or.idora.eq.1130 + & .or.idora.eq.2330 .or.idora.eq.1330 + & .or.idora.eq.3331 )go=.false. + ! print *, j,n, ' ', idptl(j),idora,go + endif + endif + endif + +c...........check triggers + if(go)then + if(ish.ge.7)write(ifch,*)' check triggers in histogram ',n + ncontr=0 + do i=1,ntri(n) + if(ish.ge.7)write(ifch,*)' trigger variable: ',itri(i,n) + if(itri(i,n).lt.100)then + call xval(n,itri(i,n),itfra(i,n),j,x) + if(ntrc(i,n).ne.-1)then + call triggercondition(i,n,x,go) + else + ncontr=ncontr+1 + goo(ncontr)=.true. + call triggercondition(i,n,x,goo(ncontr)) + if((ivar(1,n).gt.100.and.ivar(1,n).lt.200) + . .or.(ivar(2,n).gt.100.and.ivar(2,n).lt.200))then + print*,'!-----------------------------------------' + print*,'! 100-199 event variables can not be used' + print*,'! in connection with "trigger contr ..." ' + print*,'!-----------------------------------------' + stop'in xana (1). ' + endif + endif + elseif(itri(i,n).lt.200)then + if(ntrc(i,n).eq.-1)then + print*,'!-----------------------------------------' + print*,'! 100-199 event variables can not be used' + print*,'! in connection with "trigger contr ..." ' + print*,'!-----------------------------------------' + stop'in xana (2). ' + endif + call xval(n,itri(i,n),itfra(i,n),j,x) + valtri(i,n)=valtri(i,n)+x + endif + enddo + endif + +c............fill histogram + if(go)then + if(ish.ge.6)write(ifch,*)' fill histogram ' + & ,n,ivar(1,n),ivar(2,n),ivfra(2,n) + cont=.false. + if(ivar(1,n).lt.100.or.ivar(2,n).lt.100)then + if(ivar(2,n).lt.100)then + call xval(n,ivar(2,n),ivfra(2,n),j,y) + sval(2,n)=y + cont=.true. + endif + if(ivar(1,n).lt.100)then + call xval(n,ivar(1,n),ivfra(1,n),j,x) + if(x.ge.xmin(n).and.x.le.xmax(n))then + norm3=mod(inorm(n)/100,10) + if(norm3.eq.1)then + y=y*x + elseif(norm3.eq.2.and.ivar(1,n).eq.63.and.x.ne.0.)then + y=y/(x+pptl(5,j))/2/pi + elseif(norm3.eq.2.and.ivar(1,n).ne.63.and.x.ne.0.)then + y=y/x/2/pi + elseif(norm3.eq.4.and.x.ne.0.)then + y=y/x**1.5 + elseif(norm3.eq.5.and.x.ne.0.)then + y=y/x + elseif(norm3.eq.7.and.x.ne.0.)then + y=y/x/sqrt(x-pptl(5,j)) + endif + if(icnx(n))then + call fillhistoconex(n,x,y,ivfra(2,n),j) !for conex + else + if(ilog(n))then + nb=1+int(log(x/xmin(n))*xinc(n)) + else + nb=1+int((x-xmin(n))*xinc(n)) + endif + bin(nb,nac(n),n)=bin(nb,nac(n),n)+y + if(ncontr.gt.0)then !ptl trigger contr + do nn=1,ncontr + if(goo(nn))then + bbin(nb,nac(n),lookcontr(n)-1+nn)= + & bbin(nb,nac(n),lookcontr(n)-1+nn)+y + zbbin(nb,nac(n),lookcontr(n)-1+nn)= + & zbbin(nb,nac(n),lookcontr(n)-1+nn)+1 + endif + enddo + endif + if(inoerr(n).gt.0)then + do nn=1,inoerr(n) + call xval(n,noerr(noerrhis(n),nn),ivfra(2,n),j,y) + ebin(nb,nac(n),nn-1+noerrhis(n))= + & ebin(nb,nac(n),nn-1+noerrhis(n))+y + zebin(nb,nac(n),nn-1+noerrhis(n))= + & zebin(nb,nac(n),nn-1+noerrhis(n))+1 + enddo + endif + zcbin(nb,nac(n),n)=zcbin(nb,nac(n),n)+1 + endif + itrevt(n)=.true. + endif + endif + endif + if(ivar(1,n).gt.100.and.ivar(1,n).lt.200)then + call xval(n,ivar(1,n),ivfra(1,n),j,x) + sval(1,n)=sval(1,n)+x + endif + if(ivar(2,n).gt.100.and.ivar(2,n).lt.200)then + call xval(n,ivar(2,n),ivfra(2,n),j,y) + sval(2,n)=sval(2,n)+y + cont=.true. + endif + if(ivar(1,n).gt.300.and.ivar(1,n).lt.400)then + call xval(n,ivar(1,n),ivfra(1,n),j,x) + endif + if(ivar(2,n).gt.300.and.ivar(2,n).lt.400)then + call xval(n,ivar(2,n),ivfra(2,n),j,y) + cont=.true. + endif + if(ish.ge.6.and.cont)write (ifch,*) + * ' ---> histo n,x,y:',n,x,y + endif + 9 continue + enddo + 8 continue + enddo +c...........................end loop nptl........................... + + do n=1,nhis + if(ivar(1,n).eq.-1.or.ivar(2,n).eq.-1)goto 99 + +c........check event triggers + + if(ish.ge.7)write(ifch,*)' check event triggers in histogram ',n + go=.true. + ncontr=0 + do i=1,ntri(n) + if(itri(i,n).gt.100)then + if(itri(i,n).lt.200)then + x=valtri(i,n) + else + call xval(n,itri(i,n),itfra(i,n),0,x) + endif + if(ntrc(i,n).ne.-1)then + call triggercondition(i,n,x,go) + else + ncontr=ncontr+1 + goo(ncontr)=.true. + call triggercondition(i,n,x,goo(ncontr)) + endif + endif + enddo + +c........event variables > 200 + + if(go)then + if(ivar(1,n).gt.100)then + if(ivar(1,n).gt.200.and.ivar(1,n).lt.300)then + call xval(n,ivar(1,n),ivfra(1,n),0,x) + elseif(ivar(1,n).gt.300.and.ivar(1,n).lt.400)then + call xval(n,ivar(1,n),ivfra(1,n),nptl+1,x) + elseif(ivar(1,n).gt.100.and.ivar(1,n).lt.200)then + x=sval(1,n) + else + call xval(n,ivar(1,n),ivfra(1,n),0,x) + endif + if(ivar(2,n).gt.200.and.ivar(2,n).lt.300)then + call xval(n,ivar(2,n),ivfra(2,n),0,y) + elseif(ivar(2,n).gt.300.and.ivar(2,n).lt.400)then + call xval(n,ivar(2,n),ivfra(2,n),nptl+1,y) + elseif(ivar(2,n).gt.0.and.ivar(2,n).lt.200)then + y=sval(2,n) + else !inom>500 + call xval(n,ivar(2,n),ivfra(2,n),0,y) + endif +c The following doesn't work for ivar(2,n)<100, since particle number is not defined ! +c if(ivar(2,n).gt.200.and.ivar(2,n).lt.300)then +c call xval(n,ivar(2,n),ivfra(2,n),0,y) +c elseif(ivar(2,n).gt.300.and.ivar(2,n).lt.400)then +c call xval(n,ivar(2,n),ivfra(2,n),nptl+1,y) +c elseif(ivar(2,n).gt.100.and.ivar(2,n).lt.200)then +c y=sval(2,n) +c else +c call xval(n,ivar(2,n),ivfra(2,n),0,y) +c endif + if(mod(inorm(n)/100,10).eq.1)y=y*x + if(mod(inorm(n)/100,10).eq.2.and.x.ne.0.)y=y/x/2/pi + if(mod(inorm(n)/100,10).eq.4.and.x.ne.0.)y=y/x**1.5 + if(mod(inorm(n)/100,10).eq.5.and.x.ne.0.)y=y/x + sval(1,n)=x + sval(2,n)=y + if(ish.ge.6)write (ifch,*) 'histo n,x,y:',n,x,y + if(x.ge.xmin(n).and.x.le.xmax(n))then + if(ilog(n))then + nb=1+int(log(x/xmin(n))*xinc(n)) + else + nb=1+int((x-xmin(n))*xinc(n)) + endif + bin(nb,nac(n),n)=bin(nb,nac(n),n)+y + if(ncontr.gt.0)then + do nn=1,ncontr + if(goo(nn)) + & bbin(nb,nac(n),lookcontr(n)-1+nn)= + & bbin(nb,nac(n),lookcontr(n)-1+nn)+y + enddo + endif + zcbin(nb,nac(n),n)=zcbin(nb,nac(n),n)+1 + itrevt(n)=.true. + endif + endif + endif + +c........particle variables + + if(go)then + if(ivar(1,n).le.100)then + if(ncontr.gt.0)then !event trigger contr + do nb=1,nbin(n) + do nn=1,ncontr + if(goo(nn)) + & bbin(nb,nac(n),lookcontr(n)-1+nn)= + & bbin(nb,nac(n),lookcontr(n)-1+nn) + & +bin(nb,nac(n),n)-bin(nb,3-nac(n),n) + enddo + enddo + endif + endif + endif + +c............event ok (increase ncevt) or not (take copy) + + if(go)then + ncevt(n)=ncevt(n)+1 + if(ncontr.gt.0)then + do nn=1,ncontr + loo=lookcontr(n)-1+nn + if(goo(nn)) + & nccevt(loo)=nccevt(loo)+1 + enddo + endif + else + if(ish.ge.6)write (ifch,*) 'event rejected for histo',n + nac(n)=3-nac(n) + itrevt(n)=.false. + endif + + 99 continue + enddo + + call utprix('xana ',ish,ishini,4) + end + +c-------------------------------------------------------------------- + subroutine triggercondition(i,n,x,go) +c-------------------------------------------------------------------- +c ntrc is used to distinguish the different usage of trigger: +c +c trigger var xmin xmax +c ntrc=1 +c trigger or n var1 xmin1 xmax1 var2 xmin2 xmax2 ... varn xminn xmaxn +c 1 ntrc=2 +c 2 ntrc=0 +c ... +c n-1 ntrc=0 +c n ntrc=3 +c trigger contr n var1 xmin1 xmax1 var2 xmin2 xmax2 ... varn xminn xmaxn +c ntrc=-1 +c-------------------------------------------------------------------- + include 'epos.inc' + parameter (mxhis=500,mxcontr=500,mxidcd=60,mxtri=50,mxbin=405) + parameter (mypara=10,mxpara=20) + logical ilog,icnx,itrevt,idmod + double precision bin,bbin,zcbin,zbbin + common/bins/bin(mxbin,2,mxhis),zcbin(mxbin,2,mxhis) + $ ,bbin(mxbin,2,mxcontr),itrevt(mxhis),zbbin(mxbin,2,mxcontr) + $ ,nac(mxhis),ilog(mxhis),icnx(mxhis),xinc(mxhis),ncevt(mxhis) + $ ,sval(2,mxhis),valtri(mxtri,mxhis),ntrc(mxtri,mxhis) + $ ,xmin(mxhis),xmax(mxhis),nhis,noweak(mxhis) + $ ,ivar(2,mxhis),inorm(mxhis),nbin(mxhis),nidcod(mxhis) + $ ,idcod(mxidcd,mxhis),idmod(mxidcd,mxhis),ntri(mxhis) + $ ,itri(mxtri,mxhis),xmitri(mxtri,mxhis),xmatri(mxtri,mxhis) + $ ,xmitrp(mxtri,mxhis),xmatrp(mxtri,mxhis),xpara(mxpara,mxhis) + $ ,ypara(mypara,mxhis),lookcontr(mxhis) + $ ,lookcontrx(mxhis),ncontrall,icontrtyp(mxhis),nccevt(mxcontr) + double precision ebin,zebin + common/errbins/ebin(mxbin,2,mxhis/2),zebin(mxbin,2,mxhis/2), + $inoerr(mxhis),noerr(mxhis/2,2),noerrhis(mxhis/2),noerrall + logical go,gox,ok,goz + xmn=xmitri(i,n) + xmx=xmatri(i,n) + if(xmn.eq.-123456.and.xmx.eq.-123456)then !for leading part + xmn=float(idlead) + xmx=float(idlead) + endif + pmn=xmitrp(i,n) + pmx=xmatrp(i,n) + if(abs(ntrc(i,n)).eq.1)then + goz=.true. + if(pmn.gt.99.999.and.pmx.gt.99.999)then + if(x.lt.xmn.or.x.gt.xmx)goz=.false. + else + if(x.lt.xmn-0.5.or.x.gt.xmx+0.5)goz=.false. + ok=rangen().le.xmitrp(i,n)/100. + if(.not.ok.and.x.lt.xmn+0.5)goz=.false. + ok=rangen().le.xmatrp(i,n)/100. + if(.not.ok.and.x.gt.xmx-0.5)goz=.false. + endif + if(.not.goz)go=.false. + else + if(ntrc(i,n).eq.2)gox=.false. + goz=.true. + if(pmn.gt.99.999.and.pmx.gt.99.999)then + if(x.lt.xmn.or.x.gt.xmx)goz=.false. + else + if(x.lt.xmn-0.5.or.x.gt.xmx+0.5)goz=.false. + ok=rangen().le.xmitrp(i,n)/100. + if(.not.ok.and.x.lt.xmn+0.5)goz=.false. + ok=rangen().le.xmatrp(i,n)/100. + if(.not.ok.and.x.gt.xmx-0.5)goz=.false. + endif + if(goz)gox=.true. + if(ntrc(i,n).eq.3.and..not.gox)go=.false. + endif + if(ish.ge.9)write(ifch,*)'trigger conditions ' + & ,i,n,xmn,x,xmx,go + end + +c----------------------------------------------------------------------- + subroutine fillhistoconex(n,x,y,lf,j) !for conex +c----------------------------------------------------------------------- + include 'epos.inc' + parameter (mxhis=500,mxcontr=500,mxidcd=60,mxtri=50,mxbin=405) + parameter (mypara=10,mxpara=20) + logical ilog,icnx,itrevt,idmod + double precision bin,bbin,zcbin,zbbin + common/bins/bin(mxbin,2,mxhis),zcbin(mxbin,2,mxhis) + $ ,bbin(mxbin,2,mxcontr),itrevt(mxhis),zbbin(mxbin,2,mxcontr) + $ ,nac(mxhis),ilog(mxhis),icnx(mxhis),xinc(mxhis),ncevt(mxhis) + $ ,sval(2,mxhis),valtri(mxtri,mxhis),ntrc(mxtri,mxhis) + $ ,xmin(mxhis),xmax(mxhis),nhis,noweak(mxhis) + $ ,ivar(2,mxhis),inorm(mxhis),nbin(mxhis),nidcod(mxhis) + $ ,idcod(mxidcd,mxhis),idmod(mxidcd,mxhis),ntri(mxhis) + $ ,itri(mxtri,mxhis),xmitri(mxtri,mxhis),xmatri(mxtri,mxhis) + $ ,xmitrp(mxtri,mxhis),xmatrp(mxtri,mxhis),xpara(mxpara,mxhis) + $ ,ypara(mypara,mxhis),lookcontr(mxhis) + $ ,lookcontrx(mxhis),ncontrall,icontrtyp(mxhis),nccevt(mxcontr) + double precision ebin,zebin + common/errbins/ebin(mxbin,2,mxhis/2),zebin(mxbin,2,mxhis/2), + $inoerr(mxhis),noerr(mxhis/2,2),noerrhis(mxhis/2),noerrall + + if(.not.(mod(inorm(n),10).ne.4 + & .and.mod(inorm(n),10).ne.6 + & .and.mod(inorm(n)/100,10).ne.3))return + if(ilog(n))then + c=(xmax(n)/xmin(n))**(1./real(nbin(n))) + nde=nint(1./log10(c)) + nb=max(1,1+int(log10(x/xmin(n))*nde)) + xmb=xmin(n)*c**(nb-0.5) + if(x.gt.xmb.and.nb.lt.nbin(n))then + if(x.gt.xmax(n)) + & write(ifmt,*)'xana max ?',x,xmax(n),nb + nbx=1 + xmx=c*xmb + elseif(x.lt.xmb.and.nb.gt.1)then + if(x.lt.xmin(n))write(ifmt,*)'xana min ?',x,nb + nbx=-1 + xmx=xmb/c + else + nbx=0 + xmx=0. + endif + else + c=(xmax(n)-xmin(n))/real(nbin(n)) + nb=max(1,1+int((x-xmin(n))/c)) + xmb=xmin(n)+c*(nb-0.5) + if(x.gt.xmb)then + nbx=1 + xmx=c+xmb + elseif(x.lt.xmb)then + nbx=-1 + xmx=xmb-c + else + nbx=0 + xmx=0. + endif + endif + xc=(x-xmx)/(xmb-xmx) + xc=max(0.,min(1.,xc)) + bin(nb,nac(n),n)=bin(nb,nac(n),n)+xc*y + if(nbx.ne.0)bin(nb+nbx,nac(n),n) + & =bin(nb+nbx,nac(n),n)+(1.-xc)*y + zcbin(nb,nac(n),n)=zcbin(nb,nac(n),n)+1 + if(inoerr(n).gt.0)then + do nn=1,inoerr(n) + call xval(n,noerr(noerrhis(n),nn),lf,j,y2) + ebin(nb,nac(n),nn-1+noerrhis(n))= + & ebin(nb,nac(n),nn-1+noerrhis(n))+y2 + zebin(nb,nac(n),nn-1+noerrhis(n))= + & zebin(nb,nac(n),nn-1+noerrhis(n))+1 + enddo + endif + end + +c--------------------------------------------------------------------- + subroutine xhis(n) +c--------------------------------------------------------------------- + include 'epos.inc' + parameter (mxhis=500,mxcontr=500,mxidcd=60,mxtri=50,mxbin=405) + parameter (mypara=10,mxpara=20) + logical ilog,icnx,itrevt,idmod + double precision bin,bbin,zcbin,zbbin + common/bins/bin(mxbin,2,mxhis),zcbin(mxbin,2,mxhis) + $ ,bbin(mxbin,2,mxcontr),itrevt(mxhis),zbbin(mxbin,2,mxcontr) + $ ,nac(mxhis),ilog(mxhis),icnx(mxhis),xinc(mxhis),ncevt(mxhis) + $ ,sval(2,mxhis),valtri(mxtri,mxhis),ntrc(mxtri,mxhis) + $ ,xmin(mxhis),xmax(mxhis),nhis,noweak(mxhis) + $ ,ivar(2,mxhis),inorm(mxhis),nbin(mxhis),nidcod(mxhis) + $ ,idcod(mxidcd,mxhis),idmod(mxidcd,mxhis),ntri(mxhis) + $ ,itri(mxtri,mxhis),xmitri(mxtri,mxhis),xmatri(mxtri,mxhis) + $ ,xmitrp(mxtri,mxhis),xmatrp(mxtri,mxhis),xpara(mxpara,mxhis) + $ ,ypara(mypara,mxhis),lookcontr(mxhis) + $ ,lookcontrx(mxhis),ncontrall,icontrtyp(mxhis),nccevt(mxcontr) + double precision ebin,zebin + common/errbins/ebin(mxbin,2,mxhis/2),zebin(mxbin,2,mxhis/2), + $inoerr(mxhis),noerr(mxhis/2,2),noerrhis(mxhis/2),noerrall + dimension xx(mxbin) + + double precision histoweight + common/chiswei/histoweight + common/cyield/yield + common/csigma/sigma + double precision dcel + common/ems3/dcel,ad + common/geom/rmproj,rmtarg,bmax,bkmx + save cnormx + + if(ivar(1,n).eq.-1)then + nrbins=0 + goto 9999 + endif + +c.......here normalization....................................... +c see also "..........fill histogram" +c................................................................. +c the norm ( inorm(n) ) is a number hijk which normalizes to: +c +c k 0: * 1 +c 1: / number of events +c 2: / number of triggered events +c 4: / bin-counts +c 5: / bin sum +c 6: / number of summed bin-counts (yield=1.) +c 7: uses same normalization as one histo before +c +c j 0: * 1 +c 1: / bin-width +c 2: * sigma_total / bin-width +c 3: * sigma_diff / bin-width +c +c i 0: * 1 +c 1: y => y*x +c 2: y => y/x/2/pi (modified for mt0) +c 3: kno-scaling +c 4: y => y/x**1.5 +c 5: y => y/x +c 6: y => y*xi (for conex, xi=x of the bin) +c 7: y => y/x/(x-m) +c +c h 0: normal +c 1: accumulated +c +c................................................................. + + norm1=mod(inorm(n),10) + norm2=mod(inorm(n)/10,10) + norm3=mod(inorm(n)/100,10) + norm4=mod(inorm(n)/1000,10) + nctbin=0 + sumbin=0 + do l=1,nbin(n) + nctbin=nctbin+zcbin(l,nac(n),n) + sumbin=sumbin+bin(l,nac(n),n) + if(norm1.eq.4.and.zcbin(l,nac(n),n).ne.0d0)then + bin(l,nac(n),n)=bin(l,nac(n),n)/zcbin(l,nac(n),n) + if(lookcontr(n).gt.0)then + do loo=lookcontr(n),lookcontrx(n) + if(zbbin(l,nac(n),loo).ne.0.) + & bbin(l,nac(n),loo)=bbin(l,nac(n),loo) + & /zbbin(l,nac(n),loo) + enddo + endif + endif + if(ilog(n))then + xx(l)=xmin(n)*(xmax(n)/xmin(n))**((float(l)-.5)/nbin(n)) + else + xx(l)=(float(l)-0.5)*(xmax(n)-xmin(n))/nbin(n)+xmin(n) + endif + enddo + cnorm=1. + if(norm1.eq.1)cnorm=1./float(nevent) + if(norm1.eq.2)then + if(ncevt(n).ne.0)then + cnorm=1./float(ncevt(n)) + else + cnorm=0. + endif + endif + if(norm1.eq.5.and.sumbin.ne.0.)cnorm=1./sumbin + if(norm1.eq.6.and.nctbin.ne.0)cnorm=1./float(nctbin) + if(norm1.eq.7)cnorm=cnormx + cnormx=cnorm + if(ntevt.ne.0) + & sigma=10.*pi*bmax**2.*nevent/ntevt !total (untriggered) sigma + if(norm2.eq.3)then !differential (triggered) sigma + if(ntevt.ne.0) + & sigma=10.*pi*bmax**2.*ncevt(n)/ntevt + endif + if(norm3.eq.3)then !kno + first=0. + secnd=0. + do l=1,nbin(n) + if(nctbin.ne.0)first=first+xx(l)*zcbin(l,nac(n),n)/nctbin + if(nctbin.ne.0)secnd=secnd + $ +xx(l)**2*zcbin(l,nac(n),n)/nctbin + enddo + else + first=1. + endif + if(ilog(n))then + if(norm2.eq.2.or.norm2.eq.3) cnorm=cnorm*sigma + else + if(norm2.ge.1.and.norm2.le.3) cnorm=cnorm*xinc(n) + if(norm2.eq.2.or.norm2.eq.3) cnorm=cnorm*sigma + endif + do l=1,nbin(n) + bnorm=0. + if(ilog(n).and.norm2.ge.1.and.norm2.le.3)then + bnorm=1./(xmin(n)*exp(float(l)/xinc(n))*(1.-exp(-1./xinc(n)))) + bin(l,nac(n),n) = bin(l,nac(n),n) * bnorm + endif + bin(l,nac(n),n) = bin(l,nac(n),n) * cnorm + if(lookcontr(n).gt.0)then + if(ilog(n).and.norm2.ge.1.and.norm2.le.3)then + do loo=lookcontr(n),lookcontrx(n) + bbin(l,nac(n),loo)=bbin(l,nac(n),loo) * bnorm + enddo + endif + endif + enddo + f=first + nrbins=nbin(n) + nctbin=0 + yield=0. + shft=0 + if(nint(xpara(1,n)).eq.999963)shft=xpara(2,n) + do ii=1,nbin(n) + g=1 + if(norm3.eq.1.and.xx(ii).ne.0.)g=1./xx(ii) + if(norm3.eq.2)g=2*pi*(xx(ii)+shft) + if(norm3.eq.4)g=xx(ii)**1.5 + if(norm3.eq.5)g=xx(ii) + if(norm3.eq.7)g=0 + yield=yield+bin(ii,nac(n),n)/xinc(n)*hisfac*f*g + enddo + do l=1,nbin(n) + x=(xx(l)+xshift) !*xhfact + ar(l,1)=x/f + sigbin=0 + if(zcbin(l,nac(n),n).ne.0d0) + * sigbin=bin(l,nac(n),n)*hisfac*f/sqrt(zcbin(l,nac(n),n)) + if(norm4.eq.0.or.l.eq.1)then + ar(l,3)=bin(l,nac(n),n)*hisfac*f + if(lookcontr(n).gt.0)then + do loo=lookcontr(n),lookcontrx(n) + r=1 + if(norm1.eq.2.and.nccevt(loo).ne.0.) + * r=float(ncevt(n))/nccevt(loo) + lo=loo-lookcontr(n)+1 + ary(l,lo)=bbin(l,nac(n),loo)*hisfac*f*cnorm*r + if(zbbin(l,nac(n),loo).gt.0.)then + ardy(l,lo)=ary(l,lo)/sqrt(zbbin(l,nac(n),loo)) + else + ardy(l,lo)=0 + endif + if(norm1.eq.4)ardy(l,lo)=zbbin(l,nac(n),loo) + enddo + endif + if(norm3.eq.6)then !conex + ar(l,3)=ar(l,3)*xx(l) + endif + ar(l,4)=sigbin + else + ar(l,3)=ar(l-1,3)+bin(l,nac(n),n)*hisfac*f + ar(l,4)=sqrt(ar(l-1,4)**2+sigbin**2) + endif + if(inoerr(n).ge.1)then + if(zebin(l,nac(n),noerrhis(n)).gt.0.d0)then + ar(l,4)=ebin(l,nac(n),noerrhis(n))/zebin(l,nac(n),noerrhis(n)) + else + ar(l,4)=0. + endif + endif + if(inoerr(n).eq.2)then + if(zebin(l,nac(n),noerrhis(n)+1).gt.0.d0)then + ar(l,5)=ebin(l,nac(n),noerrhis(n)+1)/zebin(l,nac(n),noerrhis(n)+1) + else + ar(l,5)=0. + endif + endif + if(norm1.eq.4)ar(l,4)=zcbin(l,nac(n),n) + enddo + ionoerr=inoerr(n) + histoweight=dble(ncevt(n)) + if(norm1.eq.1)histoweight=dble(nevent) + if(norm1.eq.4)histoweight=0d0 + + 9999 hisfac=1. + xshift=0 + end + +c----------------------------------------------------------------------- + integer function nsdiff(insdif,now) +c----------------------------------------------------------------------- +c returns 1 if trigger condition for NSD fulfilled and 0 otherwise +c for UA1 (insdif=0) or UA5 (insdif=1) or CDF (insdif=2) or STAR (insdif=3,4) +C or BRAHMS (insdif=5) or NA61 (insdif=6) or CMS (insdif=7) +c or ATLAS (insdif=8) or ALICE (insdif=9, 10 and 11) +c or CMS hadron level (insdif=12) or CMS hadron level double sided (insdif=13) +c or LHCf hadron level (insdif=15) +c now ... noweak(histogram number) (obsolete) +c----------------------------------------------------------------------- + include 'epos.inc' + integer ncevt,nsdi(0:20) + logical cont + data ncevt/1/ + save nsdi,ncevt +c initialization for each event + if(ncevt.eq.nrevt)then + ncevt=ncevt+1 + do i=0,20 + nsdi(i)=-1 + enddo + endif + nsdiff=0 + if(insdif.ge.0)then + if(nsdi(insdif).lt.0)then + iii1=0 + iii2=0 + iii3=0 + ipos=0 + ineg=0 + do npts=1,nptl + if(istptl(npts).ne.0)goto 60 + cont= idptl(npts).ne.120 .and.idptl(npts).ne.-120 + * .and.idptl(npts).ne.130 .and.idptl(npts).ne.-130 + * .and.idptl(npts).ne.1120.and.idptl(npts).ne.-1120 + * .and.idptl(npts).ne.1130.and.idptl(npts).ne.-1130 + * .and.idptl(npts).ne.2230.and.idptl(npts).ne.-2230 + * .and.idptl(npts).ne.2330.and.idptl(npts).ne.-2330 + * .and.idptl(npts).ne.3331.and.idptl(npts).ne.-3331 + if(insdif.ne.7.and.insdif.lt.14)then + if(cont)goto 60 + endif +c just to avoid warning with gfortran when "now" is not used + nowdum=now +c if(now.eq.1)then !do not consider weak decay products +c if(iorptl(npts).ne.0)then +c idora=abs( idptl(iorptl(npts)) ) +c if( idora.eq.20 .or.idora.eq.2130 +c & .or.idora.eq.2230 .or.idora.eq.1130 +c & .or.idora.eq.2330 .or.idora.eq.1330 +c & .or.idora.eq.3331 )goto 60 +c endif +c endif + pz=pptl(3,npts) + pt=sqrt(pptl(2,npts)**2+pptl(1,npts)**2) + ppp=sqrt(pz**2+pt**2) + Etot=pptl(4,npts) + if(ppp.gt.abs(pz))then + yyy=.5*log((ppp+pz)/(ppp-pz)) + else + yyy=sign(100.,pz) + endif + if(insdif.eq.0)then + if(yyy.gt.1.5 .and. yyy.lt.5.5)iii1=1 + if(yyy.gt.-5.5 .and. yyy.lt.-1.5)iii2=1 + elseif(insdif.eq.1)then + if(yyy.gt.2. .and. yyy.lt.5.6)iii1=1 + if(yyy.gt.-5.6 .and. yyy.lt.-2.)iii2=1 + elseif(insdif.eq.2)then + if(yyy.gt.3.2 .and. yyy.lt.5.9)iii1=1 + if(yyy.gt.-5.9 .and. yyy.lt.-3.2)iii2=1 + if(yyy.gt.0. .and. yyy.lt.3.0)ipos=ipos+1 + if(yyy.gt.-3.0 .and. yyy.lt.0. )ineg=ineg+1 + elseif(insdif.eq.3)then + if(yyy.gt.-5.0 .and. yyy.lt.-3.3 )iii1=1 + if(yyy.gt. 3.3 .and. yyy.lt. 5.0 )iii2=1 + elseif(insdif.eq.4)then + if(yyy.gt.-5.0 .and. yyy.lt.-3.1 )iii1=1 + if(yyy.gt. 3.1 .and. yyy.lt. 5.0 )iii2=1 + elseif(insdif.eq.5)then + if(yyy.gt.-5.25 .and. yyy.lt.-3.26 )iii1=1 + if(yyy.gt. 3.26 .and. yyy.lt. 5.25 )iii2=1 + elseif(insdif.eq.6)then !NA61 trigger if NO charged particle with theta<5.26 mrad + if(pptl(3,npts).gt.0..and.yyy.lt.100.)then + theta=sqrt(pptl(1,npts)**2+pptl(2,npts)**2)/pptl(3,npts) + if(theta.lt.5.26e-3)iii1=1 + endif + elseif(insdif.eq.7)then !CMS NSD corrected using PYTHIA (2010) + if(yyy.gt.-5.2 .and. yyy.lt.-2.9 .and. Etot .gt.3.)iii1=1 + if(yyy.gt. 2.9 .and. yyy.lt. 5.2 .and. Etot .gt.3.)iii2=1 + if(yyy.gt. -2.5 .and. yyy.lt. 2.5 .and. pt .gt.0.2 .and. cont) + & iii3=1 + elseif(insdif.eq.8)then !ATLAS + if(yyy.gt.-2.5 .and. yyy.lt.2.5.and.pt.gt.0.5)iii1=1 + iii2=1 + elseif(insdif.eq.9)then !ALICE 900 GeV + if(yyy.gt.-3.7 .and. yyy.lt.-1.7 )iii1=1 + if(yyy.gt. 2.8 .and. yyy.lt. 5.1 )iii2=1 + elseif(insdif.eq.10)then !ALICE 2.36 TeV + if(yyy.gt.-2 .and. yyy.lt.2 )iii1=1 + iii2=1 + elseif(insdif.eq.11)then !ALICE Inel>0 + if(yyy.gt.-1 .and. yyy.lt.1 )iii1=1 + iii2=1 + elseif(insdif.eq.12)then !CMS hadron level NSD trigger (2011) + if(yyy.gt.-4.4 .and. yyy.lt.-3.9 )iii1=1 + if(yyy.gt. 3.9 .and. yyy.lt. 4.4 )iii2=1 + elseif(insdif.eq.13)then !CMS hadron level doubl sided trigger (2012) + if(yyy.gt.-5. .and. yyy.lt.-3. .and. Etot .gt. 3. )iii1=1 + if(yyy.gt. 3. .and. yyy.lt. 5. .and. Etot .gt. 3. )iii2=1 + elseif(insdif.eq.14)then !CMS hadron level single sided trigger (HF 2012) + if(yyy.gt.-4.9 .and. yyy.lt.-2.9 .and. Etot .gt. 5. )iii1=1 + if(yyy.gt. 2.9 .and. yyy.lt. 4.9 .and. Etot .gt. 5. )iii2=1 + elseif(insdif.eq.15)then !LHCf hadron level single sided trigger + emint=0. + if(idptl(npts).eq.10.or.abs(idptl(npts)).eq.20)emint=100. + if(abs(idptl(npts)).eq.1220.or.(abs(idptl(npts)).eq.2130)) + * emint=300. + if(yyy.lt.-7.935 .and. Etot .gt. emint )iii1=1 +c if(yyy.gt. 2.9 .and. yyy.lt. 4.9 .and. Etot .gt. 5. )iii2=1 + endif +60 continue + enddo + if(insdif.le.1)then + if(iii1.eq.1 .and. iii2.eq.1) nsdiff=1 + elseif(insdif.eq.2)then + if((iii1.eq.1 .and. iii2.eq.1) .and. + * ((ipos.ne.0 .and. ineg.ne.0) .and. ipos+ineg.ge.4)) nsdiff=1 + elseif(insdif.ge.14)then + if(iii1.eq.1 .or. iii2.eq.1) nsdiff=1 + elseif(insdif.eq.3.or.insdif.eq.4 + * .or.insdif.eq.5.or.insdif.eq.8.or.insdif.ge.9)then + if(iii1.eq.1 .and. iii2.eq.1) nsdiff=1 + elseif(insdif.eq.6)then + if(iii1.eq.0 .and. iii2.eq.0)then + nsdiff=1 + endif + elseif(insdif.eq.7)then + if(iii1.eq.1 .and. iii2.eq.1 .and.iii3.eq.1)then + nsdiff=1 + endif + endif + nsdi(insdif)=nsdiff + else + nsdiff=nsdi(insdif) + endif + else + stop'in nsdiff. argument of nsdiff not authorized. ' + endif + end + +c----------------------------------------------------------------------- + integer function isdiff(isdif) +c----------------------------------------------------------------------- +c returns 1 if trigger condition for single diff fulfilled and 0 otherwise +c for UA4 Mult distri (isdif=1) or UA4 xsection (isdif=2) +c or CDF SD (isdif=3) or CDF DPE (isdif=4) or CDF min bias (for DD) +c (isdif=5) +c----------------------------------------------------------------------- + include 'epos.inc' + isdiff=0 + if(isdif.ge.1)then + iii0=0 + iii1=0 + iii2=0 + iii3=0 + iii4=0 + Et1=0. + Et2=0. + do npts=1,nptl + if(istptl(npts).ne.0)goto 60 + if( abs(idptl(npts)).ne.120 + * .and.abs(idptl(npts)).ne.130 + * .and.abs(idptl(npts)).ne.1120 + * .and.abs(idptl(npts)).ne.1130 + * .and.abs(idptl(npts)).ne.2230 + * .and.abs(idptl(npts)).ne.2330 + * .and.abs(idptl(npts)).ne.3331)goto 60 + ppt=pptl(1,npts)**2+pptl(2,npts)**2 + ppp=sqrt(ppt+pptl(3,npts)**2) + ppt=sqrt(ppt) + yyy=0. + if(pptl(3,npts).ne.0..and.ppt.ne.0.)yyy=sign(1.,pptl(3,npts))* + * log((ppp+abs(pptl(3,npts)))/ppt) +c if(ppp.gt.abs(pptl(3,npts)))then +c yyy=.5*log((ppp+pptl(3,npts))/(ppp-pptl(3,npts))) +c else +c yyy=sign(100.,pptl(3,npts)) +c endif + if(isdif.le.2)yyy=-sign(1.,float(ilprtg))*yyy !trigger on antiproton (target : ilprt=-1) +c if(idptl(npts).eq.-1120)then + if(abs(pptl(3,npts)).gt.0.)then + theta=sign(1.,float(ilprtg))*ppt/pptl(3,npts) + if((isdif.le.2.and.theta.gt.2.5e-3.and.theta.lt.4.5e-3).or. + * (isdif.gt.2.and.theta.gt.0.2e-3.and.theta.lt.1.2e-3))then + iii0=iii0+1 +c write(ifch,*)'la', +c print *,'la',ilprtg,yyy,iii1,iii2 +c & ,npts,idptl(npts),ppt,pptl(3,npts),theta,ityptl(npts) + endif +c endif + endif + if(isdif.eq.1)then + if(yyy.gt.2.5 .and. yyy.lt.5.6)iii1=1 + elseif(isdif.eq.2)then + if(yyy.gt.3. .and. yyy.lt.5.6)iii1=1 + if(yyy.gt.-5.6 .and. yyy.lt.-4.4 )iii2=1 + elseif(isdif.eq.3)then + if(yyy.gt.2.4 .and. yyy.lt.5.9)iii1=1 + if(yyy.gt.-4.2 .and. yyy.lt.1.1)iii3=1 + if(yyy.gt.-5.9 .and. yyy.lt.-2.4)iii2=1 + if(yyy.gt.-1.1 .and. yyy.lt.4.2)iii4=1 + elseif(isdif.eq.4)then + if(ilprtg.eq.-1)then !antiproton = target + if(yyy.gt.2.4 .and. yyy.lt.5.9)iii1=1 + if(yyy.gt.-5.9 .and. yyy.lt.-3.2)iii2=iii2+1 + else !antiproton = projectile + if(yyy.gt.-5.9 .and. yyy.lt.-2.4)iii1=1 + if(yyy.gt. 3.2 .and. yyy.lt.5.9)iii2=iii2+1 + endif + elseif(isdif.eq.5)then + if(yyy.gt.3.2 .and. yyy.lt.5.9)iii1=1 + if(yyy.gt.-5.9 .and. yyy.lt.-3.2)iii2=1 + if(abs(yyy).lt.2.4)Et1=Et1+ppt + if(Et1.gt.0.2)iii3=1 + if(abs(yyy).gt.2.2 .and. abs(yyy).lt.4.2 )Et2=Et2+ppt + if(Et2.gt.1.)iii4=1 + endif +60 continue + enddo + if(isdif.eq.1)then + if(iii0.eq.1 .and. iii1.eq.1) isdiff=1 + elseif(isdif.eq.2)then + if(iii0.eq.1 .and. iii1.eq.1 .and. iii2.ne.1) isdiff=1 + elseif(isdif.eq.3)then + if( (iii1.ne.1 .and. iii3.eq.1) .or. + & (iii2.ne.1 .and. iii4.eq.1) ) isdiff=1 + elseif(isdif.eq.4)then + if(iii0.eq.1 .and. iii1.ne.1 .and. iii2.le.6) isdiff=1 +c if(isdiff.eq.1)then +c do npts=1,nptl +c if(istptl(npts).ne.0)goto 80 +c if( abs(idptl(npts)).ne.120 +c * .and.abs(idptl(npts)).ne.130 +c * .and.abs(idptl(npts)).ne.1120 +c * .and.abs(idptl(npts)).ne.1130 +c * .and.abs(idptl(npts)).ne.2230 +c * .and.abs(idptl(npts)).ne.2330 +c * .and.abs(idptl(npts)).ne.3331)goto 80 +c ppt=pptl(1,npts)**2+pptl(2,npts)**2 +c ppp=sqrt(ppt+pptl(3,npts)**2) +c ppt=sqrt(ppt) +c yyy=0. +c if(pptl(3,npts).ne.0..and.ppt.ne.0.)yyy=sign(1.,pptl(3,npts))* +c * log((ppp+abs(pptl(3,npts)))/ppt) +c print *,nrevt,yyy,idptl(npts),ityptl(npts) +c80 continue +c enddo +c print *,'dpe',iii0 +c endif + elseif(isdif.eq.5)then + if(iii1+iii2+iii3+iii4.eq.4) isdiff=1 + else + stop'in sdiff. argument of sdiff not authorized. ' + endif + endif + end + +c---------------------------------------------------------------------- + subroutine xtrans(cvar,inom,ifr,n) +c---------------------------------------------------------------------- + common/stavar/multc05,multy1,multc14,multyi,multc3,imulty1,multeb + & ,multc1,multc83,multc24,multc25,rapgap,ipairs1,xsi + parameter(mxxhis=150) + common/varhis/icorrtrig(0:mxxhis),ihardevent(0:mxxhis) + &,ijetfind1(0:mxxhis),ijetfind2(0:mxxhis),imux(0:mxxhis) + &,ifastjet(0:mxxhis),ijetevent(0:mxxhis),icaltrig(0:mxxhis) + + character*6 cvar + ifr=0 + if(cvar.eq.'numptl')then + inom=1 + elseif(cvar.eq.'npaptl')then + inom=2 + elseif(cvar.eq.'npmptl')then + inom=3 + elseif(cvar.eq.'ispptl')then + inom=4 + elseif(cvar.eq.'rapx')then + inom=5 + elseif(cvar.eq.'iptlfr')then + inom=6 + elseif(cvar.eq.'rinp')then + inom=7 + elseif(cvar.eq.'eco')then + inom=8 + elseif(cvar.eq.'tau')then + inom=9 + elseif(cvar.eq.'ctr')then + inom=10 + elseif(cvar.eq.'v2np')then + inom=11 + imulty1=1 !to switch on the calculation of "Standard variable" + elseif(cvar.eq.'absrap')then + inom=12 + elseif(cvar.eq.'rap')then + inom=13 + elseif(cvar.eq.'xp')then + inom=14 + elseif(cvar.eq.'xe')then + inom=15 + elseif(cvar.eq.'pt')then + inom=16 + elseif(cvar.eq.'p1a')then + inom=17 + elseif(cvar.eq.'p2a')then + inom=18 + elseif(cvar.eq.'xi')then + inom=19 + elseif(cvar.eq.'xf')then + inom=20 + elseif(cvar.eq.'t')then + inom=21 + elseif(cvar.eq.'rapmi')then + inom=22 + elseif(cvar.eq.'eta')then + inom=23 + elseif(cvar.eq.'theta')then + inom=24 + elseif(cvar.eq.'pt2')then + inom=25 + elseif(cvar.eq.'et')then + inom=26 + elseif(cvar.eq.'idptl')then + inom=27 + elseif(cvar.eq.'istptl')then + inom=28 + elseif(cvar.eq.'mass')then + inom=29 + elseif(cvar.eq.'idaptl')then + inom=30 + elseif(cvar.eq.'egy')then + inom=31 + elseif(cvar.eq.'rapwro')then + inom=32 + elseif(cvar.eq.'mt')then + inom=33 + elseif(cvar.eq.'pplus')then + inom=34 + elseif(cvar.eq.'pminus')then + inom=35 + elseif(cvar.eq.'p5')then + inom=36 + elseif(cvar.eq.'pa')then + inom=37 + elseif(cvar.eq.'sob')then + inom=38 + elseif(cvar.eq.'idpom')then + inom=39 + elseif(cvar.eq.'p3a')then + inom=40 + elseif(cvar.eq.'cmass')then + inom=41 + elseif(cvar.eq.'arappi')then + inom=42 + elseif(cvar.eq.'itsptl')then + inom=50 + elseif(cvar.eq.'ityptl')then + inom=51 + elseif(cvar.eq.'idoptl')then + inom=52 + elseif(cvar.eq.'iptl')then + inom=53 + elseif(cvar.eq.'index')then + inom=54 + elseif(cvar.eq.'p1')then + inom=55 + elseif(cvar.eq.'p2')then + inom=56 + elseif(cvar.eq.'p3')then + inom=57 + elseif(cvar.eq.'p4')then + inom=58 + elseif(cvar.eq.'xg')then + inom=59 + elseif(cvar.eq.'ek')then + inom=60 + elseif(cvar.eq.'beta')then + inom=61 + elseif(cvar.eq.'mt0')then + inom=63 + elseif(cvar.eq.'qsqptl')then + inom=64 + elseif(cvar.eq.'xelab')then + inom=65 + elseif(cvar.eq.'hgtc05')then + inom=66 + imulty1=1 !to switch on the calculation of "Standard variable" + elseif(cvar.eq.'hadtyp')then + inom=67 + imulty1=1 + elseif(cvar.eq.'hgtc1')then + inom=68 + imulty1=1 + elseif(cvar.eq.'x4')then + inom=69 + elseif(cvar.eq.'npn')then + inom=70 + elseif(cvar.eq.'routp')then + inom=71 + elseif(cvar.eq.'hgtc3')then + inom=72 + imulty1=1 + elseif(cvar.eq.'mu14')then + inom=73 + imulty1=1 + elseif(cvar.eq.'delphi')then + inom=74 + iok=0 + !------------------------------------------------------------ + !icorrtrig stores the histogram numbers of those histograms which + !use the delphi variable (and therfore require a call corrtrig + !------------------------------------------------------------ + do i=1,icorrtrig(0) + if(icorrtrig(i).eq.n)iok=1 + enddo + if(iok.eq.0)then + icorrtrig(0)=icorrtrig(0)+1 + if(icorrtrig(0).gt.mxxhis)stop'mxxhis too small' + icorrtrig(icorrtrig(0))=n + endif + elseif(cvar.eq.'v2')then + inom=75 + elseif(cvar.eq.'pt4')then + inom=76 + elseif(cvar.eq.'rin')then + inom=77 + elseif(cvar.eq.'theh1p')then + inom=78 + elseif(cvar.eq.'theh1t')then + inom=79 + elseif(cvar.eq.'phi')then + inom=80 + elseif(cvar.eq.'isoft')then + inom=81 + elseif(cvar.eq.'mux')then + inom=82 + imux(0)=imux(0)+1 + imux(imux(0))=n + elseif(cvar.eq.'v4')then + inom=83 + elseif(cvar.eq.'x3')then + inom=84 + elseif(cvar.eq.'jorptl')then + inom=85 + elseif(cvar.eq.'ptlead')then + inom=86 + iok=0 + !------------------------------------------------------------ + !icorrtrig stores the histogram numbers of those histograms which + !use the ptlead variable (and therfore require a call corrtrig + !------------------------------------------------------------ + do i=1,icorrtrig(0) + if(icorrtrig(i).eq.n)iok=1 + enddo + if(iok.eq.0)then + icorrtrig(0)=icorrtrig(0)+1 + if(icorrtrig(0).gt.mxxhis)stop'mxxhis too small' + icorrtrig(icorrtrig(0))=n + endif + elseif(cvar.eq.'mu25')then + inom=87 + imulty1=1 + elseif(cvar.eq.'pai')then + inom=88 + ipairs1=1 + elseif(cvar.eq.'co2')then + inom=89 + ipairs1=1 + elseif(cvar.eq.'co3')then + inom=90 + ipairs1=1 + elseif(cvar.eq.'rad')then + inom=91 + elseif(cvar.eq.'abseta')then + inom=92 + elseif(cvar.eq.'phiexp')then + inom=93 + elseif(cvar.eq.'mu24')then + inom=94 + imulty1=1 + elseif(cvar.eq.'mulevt')then + inom=101 + elseif(cvar.eq.'etevt')then + inom=102 + elseif(cvar.eq.'enevt')then + inom=103 + elseif(cvar.eq.'ev6evt')then + inom=104 + elseif(cvar.eq.'xenevt')then + inom=105 + elseif(cvar.eq.'netevt')then + inom=106 + elseif(cvar.eq.'ptevt')then + inom=107 + elseif(cvar.eq.'pmxevt')then + inom=108 + elseif(cvar.eq.'numevt')then + inom=201 + elseif(cvar.eq.'egyevt')then + inom=202 + elseif(cvar.eq.'bimevt')then + inom=203 + elseif(cvar.eq.'xbjevt')then + inom=204 + elseif(cvar.eq.'qsqevt')then + inom=205 + elseif(cvar.eq.'yevt')then + inom=206 + elseif(cvar.eq.'eloevt')then + inom=207 + elseif(cvar.eq.'nd1evt')then + inom=208 + elseif(cvar.eq.'nd2evt')then + inom=209 + elseif(cvar.eq.'theevt')then + inom=210 + elseif(cvar.eq.'nspevt')then + inom=211 + elseif(cvar.eq.'nhpevt')then + inom=212 + elseif(cvar.eq.'sigtot')then + inom=213 + elseif(cvar.eq.'sigela')then + inom=214 + elseif(cvar.eq.'sloela')then + inom=215 + elseif(cvar.eq.'nrgevt')then + inom=216 + elseif(cvar.eq.'qevt')then + inom=217 + elseif(cvar.eq.'qtlevt')then + inom=218 + elseif(cvar.eq.'nd0evt')then + inom=219 + elseif(cvar.eq.'threvt')then + inom=220 + ifr=33 !set thrust-frame + elseif(cvar.eq.'omtevt')then + inom=221 + ifr=33 !set thrust-frame + elseif(cvar.eq.'tmaevt')then + inom=222 + ifr=33 !set thrust-frame + elseif(cvar.eq.'tmievt')then + inom=223 + ifr=33 !set thrust-frame + elseif(cvar.eq.'oblevt')then + inom=224 + ifr=33 !set thrust-frame + elseif(cvar.eq.'sphevt')then + inom=230 + ifr=32 !set sph-frame + elseif(cvar.eq.'aplevt')then + inom=231 + ifr=32 !set sph-frame + elseif(cvar.eq.'cpaevt')then + inom=232 + ifr=34 !set sph2-frame + elseif(cvar.eq.'dpaevt')then + inom=233 + ifr=34 !set sph2-frame + elseif(cvar.eq.'npoevt')then + inom=234 + elseif(cvar.eq.'npnevt')then + inom=235 + elseif(cvar.eq.'ikoevt')then + inom=236 + elseif(cvar.eq.'iktevt')then + inom=237 + elseif(cvar.eq.'npxevt')then + inom=238 + elseif(cvar.eq.'nd6evt')then + inom=239 + elseif(cvar.eq.'mu1evt')then + inom=240 + imulty1=1 + elseif(cvar.eq.'muievt')then + inom=241 + imulty1=1 + elseif(cvar.eq.'hgtevt')then + inom=242 + imulty1=1 + elseif(cvar.eq.'difevt')then + inom=243 + elseif(cvar.eq.'dixevt')then + inom=244 + elseif(cvar.eq.'nd7evt')then + inom=245 + elseif(cvar.eq.'nd8evt')then + inom=246 + elseif(cvar.eq.'nd9evt')then + inom=247 + elseif(cvar.eq.'ndaevt')then + inom=248 + elseif(cvar.eq.'ndbevt')then + inom=249 + elseif(cvar.eq.'qinevt')then + inom=250 + elseif(cvar.eq.'qfievt')then + inom=251 + elseif(cvar.eq.'einevt')then + inom=252 + elseif(cvar.eq.'efievt')then + inom=253 + elseif(cvar.eq.'pinevt')then + inom=254 + elseif(cvar.eq.'pfievt')then + inom=255 + elseif(cvar.eq.'pxfevt')then ! leading proton xf in cms + inom=256 + elseif(cvar.eq.'pi+xf')then ! pi+xf: pi+ yield at cms xf>0.01 + inom=257 + elseif(cvar.eq.'pi-xf')then ! pi-xf: pi- yield at cms xf>0.01 + inom=258 + elseif(cvar.eq.'sigcut')then + inom=260 + elseif(cvar.eq.'keu')then + inom=261 + elseif(cvar.eq.'ked')then + inom=262 + elseif(cvar.eq.'kes')then + inom=263 + elseif(cvar.eq.'kolevt')then + inom=265 + elseif(cvar.eq.'sigsd')then + inom=266 + elseif(cvar.eq.'nglevt')then + inom=267 + elseif(cvar.eq.'kppevt')then ! collision numbers per participant + inom=268 + elseif(cvar.eq.'npievt')then ! pion + multiplicity per event + inom=269 + elseif(cvar.eq.'np2evt')then ! pion + multiplicity per participant + inom=270 + elseif(cvar.eq.'sigdif'.or.cvar.eq.'sigdifr')then + inom=271 + elseif(cvar.eq.'koievt')then + inom=272 + elseif(cvar.eq.'ineevt')then + inom=273 + elseif(cvar.eq.'elaevt')then + inom=274 + elseif(cvar.eq.'itgevt')then + inom=275 + iok=0 + do i=1,icorrtrig(0) + if(icorrtrig(i).eq.n)iok=1 + enddo + if(iok.eq.0)then + icorrtrig(0)=icorrtrig(0)+1 + if(icorrtrig(0).gt.mxxhis)stop'mxxhis too small' + icorrtrig(icorrtrig(0))=n + endif + elseif(cvar.eq.'hrdevt')then + inom=276 + iok=0 + do i=1,ihardevent(0) + if(ihardevent(i).eq.n)iok=1 + enddo + if(iok.eq.0)then + ihardevent(0)=ihardevent(0)+1 + if(ihardevent(0).gt.mxxhis)stop'mxxhis too small' + ihardevent(ihardevent(0))=n + endif + elseif(cvar(2:6).eq.'j1evt'.or.cvar(2:6).eq.'j2evt')then + iok=0 + do i=1,ijetfind1(0) + if(ijetfind1(i).eq.n)iok=1 + enddo + if(iok.eq.0)then + ijetfind1(0)=ijetfind1(0)+1 + if(ijetfind1(0).gt.mxxhis)stop'mxxhis too small' + ijetfind1(ijetfind1(0))=n + endif + if(cvar.eq.'ej1evt')inom=277 + if(cvar.eq.'pj1evt')inom=278 + if(cvar(2:6).eq.'j2evt')then + iok=0 + do i=1,ijetfind2(0) + if(ijetfind2(i).eq.n)iok=1 + enddo + if(iok.eq.0)then + ijetfind2(0)=ijetfind2(0)+1 + if(ijetfind2(0).gt.mxxhis)stop'mxxhis too small' + ijetfind2(ijetfind2(0))=n + endif + if(cvar.eq.'ej2evt')inom=279 + if(cvar.eq.'pj2evt')inom=280 + endif + elseif(cvar.eq.'zppevt')then + inom=281 + elseif(cvar.eq.'zptevt')then + inom=282 + elseif(cvar.eq.'***not used***')then + inom=283 + elseif(cvar.eq.'nd3evt')then + inom=284 + elseif(cvar.eq.'nd4evt')then + inom=285 + elseif(cvar.eq.'mubevt')then + inom=286 + imulty1=1 + elseif(cvar.eq.'nd5evt')then + inom=287 + elseif(cvar.eq.'ekievt')then + inom=288 + elseif(cvar.eq.'sd1evt')then + inom=289 + elseif(cvar.eq.'sd2evt')then + inom=290 + elseif(cvar.eq.'mdevt')then + inom=291 + imulty1=1 !to switch on the calculation of "Standard variable" + elseif(cvar.eq.'m2devt')then + inom=292 + imulty1=1 + elseif(cvar.eq.'tdevt')then + inom=293 + imulty1=1 + elseif(cvar.eq.'ndpevt')then + inom=294 + elseif(cvar.eq.'rapgap')then + inom=295 + imulty1=1 + elseif(cvar.eq.'ng1evt')then + inom=296 + elseif(cvar.eq.'r21evt')then + inom=297 + elseif(cvar.eq.'aimevt')then + inom=301 + elseif(cvar.eq.'wjbevt')then + inom=302 + elseif(cvar.eq.'njbevt')then + inom=303 + elseif(cvar.eq.'djbevt')then + inom=304 + elseif(cvar.eq.'tjbevt')then + inom=305 + elseif(cvar.eq.'hjmevt')then + inom=306 + elseif(cvar.eq.'ljmevt')then + inom=307 + elseif(cvar.eq.'djmevt')then + inom=308 + elseif(cvar.eq.'ybal')then + inom=310 + elseif(cvar.eq.'yabal')then + inom=310 + elseif(cvar.eq.'sigine')then + inom=312 + elseif(cvar.eq.'sigiaa')then + inom=313 + elseif(cvar.eq.'alpdsf')then + inom=314 + elseif(cvar.eq.'alpdsh')then + inom=315 + elseif(cvar.eq.'betdsf')then + inom=316 + elseif(cvar.eq.'betdsh')then + inom=317 + elseif(cvar.eq.'rexdip')then + inom=318 + elseif(cvar.eq.'rexdit')then + inom=319 + elseif(cvar.eq.'m14evt')then + inom=320 + imulty1=1 + elseif(cvar.eq.'ht3evt')then + inom=321 + elseif(cvar.eq.'sigiex')then + inom=322 + elseif(cvar.eq.'sigdex')then + inom=323 + elseif(cvar.eq.'sigsex')then + inom=324 + elseif(cvar.eq.'ekievt')then + inom=325 + elseif(cvar.eq.'sigcaa')then + inom=326 + elseif(cvar.eq.'sigtaa')then + inom=327 + elseif(cvar.eq.'xkappa')then + inom=328 + elseif(cvar.eq.'gamdsf')then + inom=329 + elseif(cvar.eq.'gamdsh')then + inom=330 + elseif(cvar.eq.'deldsf')then + inom=331 + elseif(cvar.eq.'deldsh')then + inom=332 + elseif(cvar.eq.'nd6evt')then + inom=333 + elseif(cvar.eq.'muxevt')then + inom=334 + imux(0)=imux(0)+1 + imux(imux(0))=n + elseif(cvar.eq.'typevt')then + inom=335 + elseif(cvar.eq.'m25evt')then + inom=339 + imulty1=1 + elseif(cvar.eq.'segevt')then + inom=340 + elseif(cvar.eq.'ielevt')then + inom=341 + elseif(cvar.eq.'mc1evt')then + inom=342 + imulty1=1 + elseif(cvar.eq.'sdcdf')then + inom=343 + elseif(cvar.eq.'dpecdf')then + inom=344 + elseif(cvar.eq.'ddcdf')then + inom=345 + elseif(cvar.eq.'phievt')then + inom=346 + elseif(cvar.eq.'ndcevt')then + inom=347 + elseif(cvar.eq.'jetevt')then + inom=348 + call actijetevent(n) + call actifastjet(n) + elseif(cvar.eq.'epszer')then + inom=349 + elseif(cvar.eq.'xsievt')then + inom=350 + imulty1=1 + elseif(cvar.eq.'xsicms')then + inom=351 + elseif(cvar.eq.'calevt')then + inom=352 + icaltrig(0)=icaltrig(0)+1 + icaltrig(icaltrig(0))=n + elseif(cvar.eq.'fgpevt')then + inom=353 + icaltrig(0)=icaltrig(0)+1 + icaltrig(icaltrig(0))=n + elseif(cvar.eq.'bgpevt')then + inom=354 + icaltrig(0)=icaltrig(0)+1 + icaltrig(icaltrig(0))=n + elseif(cvar.eq.'gapevt')then + inom=355 + icaltrig(0)=icaltrig(0)+1 + icaltrig(icaltrig(0))=n + elseif(cvar.eq.'sigdd')then + inom=356 + elseif(cvar.eq.'ajtevt')then + inom=357 + call actijetevent(n) + call actifastjet(n) + elseif(cvar.eq.'fjtevt')then + inom=358 + call actijetevent(n) + call actifastjet(n) + elseif(cvar.eq.'pjtevt')then + inom=359 + call actijetevent(n) + call actifastjet(n) + elseif(cvar.eq.'styevt')then + inom=360 ! moved from 357 + elseif(cvar.eq.'ndsevt')then + inom=361 ! moved from 358 + elseif(cvar.eq.'m24evt')then + inom=362 ! moved from 359 + imulty1=1 + elseif(cvar.eq.'ndhevt')then + inom=363 ! moved from 360 + elseif(cvar.eq.'ndfevt')then + inom=364 + elseif(cvar.eq.'ox1evt')then + inom=501 + elseif(cvar.eq.'ox2evt')then + inom=502 + elseif(cvar.eq.'ox3evt')then + inom=503 + elseif(cvar.eq.'ox4evt')then + inom=504 + elseif(cvar.eq.'eglevt')then ! eccentricity + inom=505 + elseif(cvar.eq.'fglevt')then ! eccentricity_part + inom=506 + elseif(cvar.eq.'rglevt')then ! ratio ng2 / ng1 + inom=507 + elseif(cvar.eq.'sglevt')then ! area S + inom=508 + elseif(cvar.eq.'ptrevt')then + inom=509 + elseif(cvar.eq.'rr2evt')then + inom=510 + imulty1=1 !to switch on the calculation of "Standard variable" + elseif(cvar.eq.'perevt')then + inom=511 + elseif(cvar.eq.'paievt')then + inom=512 + ipairs1=1 + elseif(cvar.eq.'co2evt')then + inom=513 + ipairs1=1 + elseif(cvar.eq.'co3evt')then + inom=514 + ipairs1=1 + elseif(cvar.eq.'nh1evt')then + inom=515 + elseif(cvar.eq.'nh2evt')then + inom=516 + elseif(cvar.eq.'nh3evt')then + inom=517 + elseif(cvar.eq.'gbyevt')then + inom=518 + elseif(cvar.eq.'icyevt')then + inom=519 + elseif(cvar.eq.'xp9evt')then + inom=520 + elseif(cvar.eq.'hlxevt')then + inom=521 + else + print *,' ' + print *,' xtrans: unknown variable ',cvar + print *,' ' +c inom=-1 + stop + endif + end + +c---------------------------------------------------------------------- + subroutine xval(n,inom,lf,j,x) +c---------------------------------------------------------------------- +c n ...... histogram index +c inom ... variable index +c 1-100 particle variables +c 101-200 accumulative event variables +c > 200 other event variables +c lf ..... frame index +c particle index (used for particle variables) +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incems' + common/cshatpr/shatpr(npommx,kollmx) + common/stavar/multc05,multy1,multc14,multyi,multc3,imulty1,multeb + & ,multc1,multc83,multc24,multc25,rapgap,ipairs1,xsi + parameter(mxxhis=150) + common/varhis/icorrtrig(0:mxxhis),ihardevent(0:mxxhis) + &,ijetfind1(0:mxxhis),ijetfind2(0:mxxhis),imux(0:mxxhis) + &,ifastjet(0:mxxhis),ijetevent(0:mxxhis),icaltrig(0:mxxhis) + common/zeus2/qtl /cgbyjmax/gbyjmax + + parameter (ntim=1000) + common/cprt/pprt(5,ntim),q2prt(ntim),idaprt(2,ntim),idprt(ntim) + &,iorprt(ntim),jorprt(ntim),nprtj + + common/cxyzt/xptl(mxptl),yptl(mxptl),zptl(mxptl),tptl(mxptl) + *,optl(mxptl),uptl(mxptl),sptl(mxptl),rptl(mxptl,3) + common/cpairs/paievt,co2evt,co3evt + + parameter (mxhis=500,mxcontr=500,mxidcd=60,mxtri=50,mxbin=405) + parameter (mypara=10,mxpara=20) + logical ilog,icnx,itrevt,idmod + double precision bin,bbin,zcbin,zbbin + common/bins/bin(mxbin,2,mxhis),zcbin(mxbin,2,mxhis) + $ ,bbin(mxbin,2,mxcontr),itrevt(mxhis),zbbin(mxbin,2,mxcontr) + $ ,nac(mxhis),ilog(mxhis),icnx(mxhis),xinc(mxhis),ncevt(mxhis) + $ ,sval(2,mxhis),valtri(mxtri,mxhis),ntrc(mxtri,mxhis) + $ ,xmin(mxhis),xmax(mxhis),nhis,noweak(mxhis) + $ ,ivar(2,mxhis),inorm(mxhis),nbin(mxhis),nidcod(mxhis) + $ ,idcod(mxidcd,mxhis),idmod(mxidcd,mxhis),ntri(mxhis) + $ ,itri(mxtri,mxhis),xmitri(mxtri,mxhis),xmatri(mxtri,mxhis) + $ ,xmitrp(mxtri,mxhis),xmatrp(mxtri,mxhis),xpara(mxpara,mxhis) + $ ,ypara(mypara,mxhis),lookcontr(mxhis) + $ ,lookcontrx(mxhis),ncontrall,icontrtyp(mxhis),nccevt(mxcontr) + double precision ebin,zebin + common/errbins/ebin(mxbin,2,mxhis/2),zebin(mxbin,2,mxhis/2), + $inoerr(mxhis),noerr(mxhis/2,2),noerrhis(mxhis/2),noerrall + parameter (mxfra=5) + common/pfra/nfra,ifra(mxfra),ivfra(2,mxhis),itfra(mxtri,mxhis) + $ ,imofra(3,mxfra),iffra(mxfra),r1fra(3,mxfra),r2fra(3,mxfra) + $ ,emax(mxfra) + common/cphi2/phi2pos,phi2neg + common/cen/ncentr + parameter(nbkbin=100) + common /kfitd/ xkappafit(nclegy,nclha,nclha,nbkbin),xkappa,bkbin + parameter (mxpaih=8) + common/cpairs2/paih(mxpaih,40),co2h(mxpaih,40),co3h(mxpaih,40) + . ,ipaih(mxpaih,40),ico2h(mxpaih,40),ico3h(mxpaih,40) + . ,maxpt,delpt + + double precision bofra,bofra1,bofra2,bofra3,bofra4,bofra5 + common/dfra/bofra(5,mxfra) + dimension p(5,mxfra),aimuni(10,mxhis),xor(5,mxfra) + common/cranphi/ranphi /cicentrality/icentrality + save p,aimuni,xor + phinll=phievt+ranphi + if(phinll.lt.-pi)phinll=phinll+2*pi + if(phinll.gt.pi)phinll=phinll-2*pi + if(iffra(lf).eq.0.and.j.ne.0)then + do l=1,5 + p(l,lf)=pptl(l,j) + enddo + do l=1,4 + xor(l,lf)=xorptl(l,j) + enddo + if(imofra(1,lf).ne.0)then + call utrota(imofra(1,lf),r1fra(1,lf),r1fra(2,lf),r1fra(3,lf) + $ ,p(1,lf),p(2,lf),p(3,lf)) + call utrota(imofra(1,lf),r1fra(1,lf),r1fra(2,lf),r1fra(3,lf) + $ ,xor(1,lf),xor(2,lf),xor(3,lf)) + endif + if(imofra(2,lf).ne.0)then !the x-z exchanged is ok !! + call utrota(imofra(2,lf),r2fra(3,lf),r2fra(2,lf),r2fra(1,lf) + $ ,p(3,lf),p(2,lf),p(1,lf)) + call utrota(imofra(2,lf),r2fra(3,lf),r2fra(2,lf),r2fra(1,lf) + $ ,xor(3,lf),xor(2,lf),xor(1,lf)) + endif + if(imofra(3,lf).ne.0)then + imof3=sign(1,imofra(3,lf)) + if(abs(imofra(3,lf)).gt.1)then + bofra1=0d0 + bofra2=0d0 + bofra5=1d0 + call utlob5(imof3*yhaha + $ ,p(1,lf),p(2,lf),p(3,lf),p(4,lf),p(5,lf)) + bofra3=bofra(1,lf) + bofra4=bofra(2,lf) + call utlob4(imof3,bofra1,bofra2,bofra3,bofra4,bofra5 + $ ,xor(1,lf),xor(2,lf),xor(3,lf),xor(4,lf)) + bofra3=bofra(3,lf) + bofra4=bofra(4,lf) + bofra5=bofra(5,lf) + else + bofra1=bofra(1,lf) + bofra2=bofra(2,lf) + bofra3=bofra(3,lf) + bofra4=bofra(4,lf) + bofra5=bofra(5,lf) + endif + call utlob4(imof3,bofra1,bofra2,bofra3,bofra4,bofra5 + $ ,p(1,lf),p(2,lf),p(3,lf),p(4,lf)) + call utlob4(imof3,bofra1,bofra2,bofra3,bofra4,bofra5 + $ ,xor(1,lf),xor(2,lf),xor(3,lf),xor(4,lf)) + endif + iffra(lf)=1 + endif + +c--------------------------------- 1 - 100 ---------------------------- + if(inom.eq.1)then + x=1. + elseif(inom.eq.2)then + x=isign(1,idptl(j)) + elseif(inom.eq.3)then + chrg=0 + if(iabs(idptl(j)).le.9999 + $ .and.mod(iabs(idptl(j)),10).le.1) + $ call idchrg(idptl(j),chrg) + if(chrg.eq.0.)then + x=0 + else + x=int(sign(1.,chrg)) + endif + elseif(inom.eq.4)then + iad=abs(idptl(j)) + jspin=mod(iad,10) + x=0. + if (iad.ge.100.and.iad.lt.1000) x=1./(1.+2.*jspin) + if (iad.ge.1000.and.iad.lt.9999) x=1./(2.+2*jspin) + elseif(inom.eq.5)then !'rapx' !st-rap for string segments only !!!!!!!!!! + x=dezptl(j) + elseif(inom.eq.6)then !'iptlfr' + x=0 + if(j.ge.minfra.and.j.le.maxfra)x=1 + elseif(inom.eq.7)then !'rinp' + aa=cos(phinll) + bb=sin(phinll) + x=xptl(j)*aa+yptl(j)*bb + elseif(inom.eq.8)then !'eco' !engy in comoving frame + x=0 + amt=p(5,lf)**2+p(1,lf)**2+p(2,lf)**2 + if(amt.gt.0..and.p(4,lf)+abs(p(3,lf)).gt.0.d0)then + amt=sqrt(amt) + rap=sign(1.,p(3,lf))*alog((p(4,lf)+abs(p(3,lf)))/amt) + rapx=dezptl(j) + x=amt*cosh(rap-rapx) + endif + elseif(inom.eq.9)then !'tau' + x=-999999 + !if(iorptl(j).ne.0)then + ! jo=iorptl(j) + dt=xorptl(4,j) !-xorptl(4,jo) + dz=xorptl(3,j) !-xorptl(3,jo) + x2=dt**2-dz**2 + if(x2.gt.0.)x=sqrt(x2) + !endif + elseif(inom.eq.10)then !'ctr' + x=ctrevt + elseif(inom.eq.11)then !'v2np' + phi=polar( p(1,lf) , p(2,lf) ) + pt=sqrt(p(2,lf)**2+p(1,lf)**2) + eta=0 + if(p(3,lf).ne.0..and.pt.ne.0.)eta=sign(1.,p(3,lf))* + * alog((sqrt(p(3,lf)**2+pt**2)+abs(p(3,lf)))/pt) + if(eta.gt.0)then + phi2=phi2neg + else + phi2=phi2pos + endif + x=cos(2*(phi-phi2)) + elseif(inom.eq.12)then !'absrap' + amt=p(5,lf)**2+p(1,lf)**2+p(2,lf)**2 + if(amt.gt.0..and.p(4,lf)+abs(p(3,lf)).gt.0.d0)then + amt=sqrt(amt) + x=alog((p(4,lf)+abs(p(3,lf)))/amt) + else + x=0. ! + endif + elseif(inom.eq.13)then !'rap' + amt=p(5,lf)**2+p(1,lf)**2+p(2,lf)**2 + if(amt.gt.0..and.p(4,lf)+abs(p(3,lf)).gt.0.d0)then !not correct if particles off-shell +c if(amt.gt.0..and.p(4,lf)+p(3,lf).gt.0.d0)then !not correct and assymetric if particles off-shell + amt=sqrt(amt) + x=sign(1.,p(3,lf))*log((p(4,lf)+abs(p(3,lf)))/amt) !not correct if particles off-shell +c x=alog((p(4,lf)+p(3,lf))/amt) !not correct and assymetric if particles off-shell +c x=0.5*alog((p(4,lf)+p(3,lf))/(p(4,lf)-p(3,lf))) !always correct but numerically unstable +c if(abs(x).lt.0.05.and.idptl(j).eq.120) +c & write(ifch,*)'pion epo',p(4,lf),p(3,lf),amt,x + else + x=0. ! + endif + elseif(inom.eq.14)then !'xp' + x=sqrt(p(3,lf)**2+p(2,lf)**2+p(1,lf)**2)/emax(lf) + elseif(inom.eq.15)then !'xe' + x=min(1.,p(4,lf)/emax(lf)) + elseif(inom.eq.16)then !'pt' + x=sqrt(p(2,lf)**2+p(1,lf)**2) + elseif(inom.eq.17)then + x=abs(p(1,lf)) + elseif(inom.eq.18)then + x=abs(p(2,lf)) + elseif(inom.eq.19)then + x=-log(sqrt(p(3,lf)**2+p(2,lf)**2+p(1,lf)**2)/emax(lf)) + elseif(inom.eq.20)then !'xf' + m=mod(ifra(lf)/10,10) + if(m.eq.1.or.noebin.lt.0)then +c pmax=sqrt((engy/2)**2-prom*2) + pmax=pnullx !??????????????????? + if(mod(ifra(lf),10).eq.2)pmax=pnll + x=p(3,lf)/pmax + else + x=p(3,lf)/emax(lf) + endif +c if(x.gt.0.95.and.idptl(j).eq.1220)then +c write(ifch,'(a,d25.15)')'ici !!!!!!!!!',seedc +c stop +c endif + elseif(inom.eq.21)then +c pmax=pmxevt +c pmax=sqrt((engy/2)**2-prom*2) + pmax=pnullx !??????????????????? + if(mod(ifra(lf),10).eq.2)pmax=pnll + x=-(amproj**2-2.*sqrt(amproj**2+pmax**2)*p(4,lf) + * +2.*abs(pmax*p(3,lf))+p(5,lf)**2) + elseif(inom.eq.22)then + amt=sqrt(p(5,lf)**2+p(1,lf)**2+p(2,lf)**2) + if(amt.ne.0.)then + x=-sign(1.,p(3,lf))*alog((p(4,lf)+abs(p(3,lf)))/amt) + else + x=0. ! + endif + elseif(inom.eq.23)then !'eta' + pt=sqrt(p(2,lf)**2+p(1,lf)**2) + if(p(3,lf).eq.0.)then + x=0. + elseif(pt.ne.0.)then + x=sign(1.,p(3,lf))* + * alog((sqrt(p(3,lf)**2+pt**2)+abs(p(3,lf)))/pt) + else + x=sign(1000.,p(3,lf)) + endif + elseif(inom.eq.24)then !'theta (deg)' + pt=sqrt(p(2,lf)**2+p(1,lf)**2) + x=90 + if(p(3,lf).ne.0.)x=atan(pt/p(3,lf))/pi*180. + if(x.lt.0.)x=180.+x + elseif(inom.eq.25)then !'pt2' + x=p(2,lf)**2+p(1,lf)**2 + elseif(inom.eq.26)then !'et' + pt=sqrt(p(2,lf)**2+p(1,lf)**2) + x=0 + eef=p(4,lf) +c if(idptl(j).ge.1000)eef=eef-prom +c if(idptl(j).le.-1000)eef=eef+prom + p2=p(3,lf)**2+p(2,lf)**2+p(1,lf)**2 + if(p2.ne.0.)x=eef*pt/sqrt(p2) + elseif(inom.eq.27)then !'idptl' + x=idptl(j) + elseif(inom.eq.28)then !istptl + x=istptl(j) + elseif(inom.eq.29)then !mass + x=p(5,lf) + if(istptl(j).le.1)call idmass(idptl(j),x) + elseif(inom.eq.30)then !idaptl + x=abs(idptl(j)) + elseif(inom.eq.31)then !egy + x=egyevt + elseif(inom.eq.32)then !arapwro + x=0 + pt2=p(2,lf)**2+p(1,lf)**2 + if(p(3,lf).ne.0.)x=sign(1.,p(3,lf))* + * alog((sqrt(p(3,lf)**2+pt2+.13957**2)+abs(p(3,lf))) + * /sqrt(pt2+.13957**2)) + elseif(inom.eq.33)then !'mt' + x=sqrt(p(2,lf)**2+p(1,lf)**2+p(5,lf)**2) + elseif(inom.eq.34)then !'pplus' + x=sign(1.,p(3,lf)) * (p(4,lf)+abs(p(3,lf))) + elseif(inom.eq.35)then !'pminus' + x=sign(1.,p(3,lf)) * (p(4,lf)-abs(p(3,lf))) + elseif(inom.eq.36)then !'p5' (mass) + x=p(5,lf) + elseif(inom.eq.37)then !pa + x=sqrt(p(1,lf)**2+p(2,lf)**2+p(3,lf)**2) + elseif(inom.eq.38)then !'pa' + if(p(1,lf)**2+p(2,lf)**2+p(3,lf)**2.ne.0) + * x=egyevt**2/sqrt(p(1,lf)**2+p(2,lf)**2+p(3,lf)**2)*p(4,lf) + elseif(inom.eq.39)then !idpom + x=idptl(j)/1000000 + elseif(inom.eq.40)then !p3a + x=abs(p(3,lf)) + elseif(inom.eq.41)then + cm2=p(4,lf)**2-p(3,lf)**2-p(2,lf)**2-p(1,lf)**2 !cmass + x=sign(sqrt(abs(cm2)),cm2) + elseif(inom.eq.42)then !arappi + x=0 + pt2=p(2,lf)**2+p(1,lf)**2 + if(p(3,lf).ne.0.) + * x=alog((sqrt(p(3,lf)**2+pt2+.13957**2)+abs(p(3,lf))) + * /sqrt(pt2+.13957**2)) + elseif(inom.eq.50)then + x=itsptl(j) + elseif(inom.eq.51)then + x=ityptl(j) + elseif(inom.eq.52)then !'idoptl' + x=0. + if(iorptl(j).ne.0) x=idptl(iorptl(j)) + elseif(inom.eq.53)then + x=j + elseif(inom.eq.54)then !'sloela' + call idflav(idptl(j),ifl1,ifl2,ifl3,jspin,indx) + x=indx + elseif(inom.eq.55)then !'p1' + x=p(1,lf) + elseif(inom.eq.56)then !'p2' + x=p(2,lf) + elseif(inom.eq.57)then !'p3' + x=p(3,lf) + elseif(inom.eq.58)then !'p4' + x=p(4,lf) + elseif(inom.eq.59)then !E/p_max +c pmax=sqrt((engy/2)**2-prom*2) + pmax=pnullx !??????????????????? + if(mod(ifra(lf),10).eq.2)pmax=pnll + x=p(4,lf)/pmax + elseif(inom.eq.60)then !'ek' + x=p(4,lf)-p(5,lf) + elseif(inom.eq.61)then !'beta' + x=p(3,lf)/p(4,lf) + elseif(inom.eq.63)then !'mt0' + x=sqrt(p(2,lf)**2+p(1,lf)**2+p(5,lf)**2)-p(5,lf) + elseif(inom.eq.64)then !qsqptl + x=qsqptl(j) + elseif(inom.eq.65)then !xelab=Elab/Eolab + x=p(4,lf)/(ecms**2/2/prom-prom) + if(x.gt.0.9999999) x=.9999999 + elseif(inom.eq.66)then !'hgtc05' ... charged ptl mult |[c]|<0.5 + x=multc05 + elseif(inom.eq.67)then !'hadtyp' ... primary (1) or secondary (2) hadron + if(j.le.nbdky)then + x=1 + else + x=2 + endif + elseif(inom.eq.68)then !'hgtc1' + x=multc1 + elseif(inom.eq.69)then !'x4' + x=xor(4,lf) + elseif(inom.eq.70)then !'npn' + x=npjevt+ntgevt + elseif(inom.eq.71)then !'routp' + cc=-sin(phinll) + dd=cos(phinll) + x=xptl(j)*cc+yptl(j)*dd + elseif(inom.eq.72)then !'hgtc3' ... charged ptl mult |eta|<3.15 /6.3 + x=multc3/6.3 + elseif(inom.eq.73)then !'mu14' ... charged ptl mult |eta|<1 pt>.4 + x=multc14 + elseif(inom.eq.74)then !'delphi' ... azimuthhal correlation + x=10000. + pt=sqrt(p(1,lf)**2+p(2,lf)**2) + + if(nint(ypara(1,n)).ne.0.and.j.ne.nint(ypara(1,n)).and. + $ pt.gt.0)then + phi=sign(1.,p(2,lf))*acos(p(1,lf)/pt) + x=phi-ypara(2,n) + phiz= ypara(3,n) + if (x.lt.(-2+phiz)*pi)then + x=x+4*pi + elseif(x.lt.(0+phiz)*pi)then + x=x+2*pi + elseif(x.gt.(4+phiz)*pi)then + x=x-4*pi + elseif(x.gt.(2+phiz)*pi)then + x=x-2*pi + endif + endif + elseif(inom.eq.75)then !'v2' +c if(iranphi.ne.1)stop'\n\n ERROR 29062010b \n\n' + aa=cos(phinll) + bb=sin(phinll) + cc=-sin(phinll) + dd=cos(phinll) + px=p(1,lf)*aa+p(2,lf)*bb + py=p(1,lf)*cc+p(2,lf)*dd + pt2=p(2,lf)**2+p(1,lf)**2 + x=0 + if(pt2.gt.0.)x=(px**2-py**2)/pt2 + elseif(inom.eq.76)then !'pt4' + x=(p(2,lf)**2+p(1,lf)**2)**2 + elseif(inom.eq.77)then !'rin' + x=rinptl(j) + elseif(inom.eq.78)then !'theta for H1 (rad) for (proj side)' + pt=sqrt(p(2,lf)**2+p(1,lf)**2) + p1=p(1,lf) + p2=p(2,lf) + p3=p(3,lf) + p4=p(4,lf) + p5=p(5,lf) + if(abs(p3).gt.1e-5)then +c put the particle in the projectile frame + call utlob5(yhaha,p1,p2,p3,p4,p5) +c put the particle in a frame where the projectile (proton) has 820 GeV (HERA) + call utlob4(-1,0d0,0d0,819.99946d0,820.d0,0.938d0,p1,p2,p3,p4) + x=atan(pt/p3) + if(x.lt.0.)x=pi+x + else + x=0.5*pi + endif + elseif(inom.eq.79)then !'theta for H1 (rad) (for target side)' + pt=sqrt(p(2,lf)**2+p(1,lf)**2) + p1=p(1,lf) + p2=p(2,lf) + p3=p(3,lf) + p4=p(4,lf) + p5=p(5,lf) + if(abs(p3).gt.1e-5)then +c put the particle in the projectile frame + call utlob5(-yhaha,p1,p2,p3,p4,p5) +c put the particle in a frame where the projectile (proton) has 820 GeV (HERA) + call utlob4(-1,0d0,0d0,-819.99946d0,820d0,0.938d0,p1,p2,p3,p4) + x=atan(pt/p3) + if(x.gt.0.)x=pi-x + else + x=0.5*pi + endif + elseif(inom.eq.80)then !'phi' + x=1000 + pt=sqrt(p(1,lf)**2+p(2,lf)**2) + if(pt.gt.0.)then + phi=sign(1.,p(2,lf))*acos(p(1,lf)/pt) + x=phi-phinll + endif + if(x.lt.-pi)x=x+2*pi + if(x.gt.pi)x=x-2*pi + elseif(inom.eq.81)then !'isoft' + x=0 + it=ityptl(j) + if(it.ge.20.and.it.le.29)x=1 + if(it.ge.40.and.it.le.60)x=1 + elseif(inom.eq.82)then !'mux' ... charged ptl mult + x= ypara(1,n) + elseif(inom.eq.83)then !'v4' + aa=cos(phinll) + bb=sin(phinll) + cc=-sin(phinll) + dd=cos(phinll) + px=p(1,lf)*aa+p(2,lf)*bb + py=p(1,lf)*cc+p(2,lf)*dd + pt2=p(2,lf)**2+p(1,lf)**2 + x=0 + if(pt2.gt.0.)x=px**2/pt2 !cos**2 + x=8*x**2-8*x+1 + elseif(inom.eq.84)then !'x3' + x=xor(3,lf) + elseif(inom.eq.85)then !jorptl + x=jorptl(j) + elseif(inom.eq.86)then !'ptlead' ... pt of particle with higher pt + x=0. + if(nint(ypara(1,n)).ne.0)x=ypara(4,n) + elseif(inom.eq.87)then !'mu25' ... charged ptl mult |eta|<2.5 pt>.5 + x=multc25 + elseif(inom.eq.88)then !'pai' + x=0 + if(bimevt.gt.xpara(1,n).and.bimevt.lt.xpara(2,n))then + ida=abs(idptl(j)) + ian=abs(idptl(j)) + idn= idptl(j) + pt=sqrt(p(2,lf)**2+p(1,lf)**2) + ipt=pt/delpt+1 + if(ipt.ge.1.and.ipt.le.maxpt)then + iid=0 + if(ida.eq.120)iid=1 + if(ida.eq.1120)iid=2 + if(ida.eq.130)iid=3 + if(ida.eq.1130)iid=4 + if(idn.eq.20)iid=5 + if(ian.eq.2130)iid=6 + if(ian.eq.2330)iid=7 + if(ian.eq.3331)iid=8 + if(iid.ne.0)then + if(ipaih(iid,ipt).eq.0)then + x=paih(iid,ipt) + ipaih(iid,ipt)=1 + endif + endif + endif + endif + elseif(inom.eq.89)then !'co2' + x=0 + if(bimevt.gt.xpara(1,n).and.bimevt.lt.xpara(2,n))then + ida=abs(idptl(j)) + ian=abs(idptl(j)) + idn= idptl(j) + pt=sqrt(p(2,lf)**2+p(1,lf)**2) + ipt=pt/delpt+1 + if(ipt.ge.1.and.ipt.le.maxpt)then + iid=0 + if(ida.eq.120)iid=1 + if(ida.eq.1120)iid=2 + if(ida.eq.130)iid=3 + if(ida.eq.1130)iid=4 + if(idn.eq.20)iid=5 + if(ian.eq.2130)iid=6 + if(ian.eq.2330)iid=7 + if(ian.eq.3331)iid=8 + if(iid.ne.0)then + if(ico2h(iid,ipt).eq.0)then + x=co2h(iid,ipt) + ico2h(iid,ipt)=1 + endif + endif + endif + endif + elseif(inom.eq.90)then !'co3' + x=0 + if(bimevt.gt.xpara(1,n).and.bimevt.lt.xpara(2,n))then + ida=abs(idptl(j)) + ian=abs(idptl(j)) + idn= idptl(j) + pt=sqrt(p(2,lf)**2+p(1,lf)**2) + ipt=pt/delpt+1 + if(ipt.ge.1.and.ipt.le.maxpt)then + iid=0 + if(ida.eq.120)iid=1 + if(ida.eq.1120)iid=2 + if(ida.eq.130)iid=3 + if(ida.eq.1130)iid=4 + if(idn.eq.20)iid=5 + if(ian.eq.2130)iid=6 + if(ian.eq.2330)iid=7 + if(ian.eq.3331)iid=8 + if(iid.ne.0)then + if(ico3h(iid,ipt).eq.0)then + x=co3h(iid,ipt) + ico3h(iid,ipt)=1 + endif + endif + endif + endif + elseif(inom.eq.91)then !'rad' + x=0.001 !unit is fm ! + x1=xor(1,lf) + x2=xor(2,lf) + xd=dble(x1)**2+dble(x2)**2 + if(xd.gt.0.d0.and.xd.eq.xd)x=sqrt(xd) + elseif(inom.eq.92)then !'abseta' + pt=sqrt(p(2,lf)**2+p(1,lf)**2) + if(p(3,lf).eq.0.)then + x=0. + elseif(pt.ne.0.)then + x=sign(1.,p(3,lf))* + * alog((sqrt(p(3,lf)**2+pt**2)+abs(p(3,lf)))/pt) + else + x=sign(1000.,p(3,lf)) + endif +c pp=sqrt(p(2,lf)**2+p(1,lf)**2+p(3,lf)**2) +c x=0 +c if(pp-p(3,lf).gt.0..and.pp+p(3,lf).gt.0.)x= +c * 0.5*log((pp+p(3,lf))/(pp-p(3,lf))) + x=abs(x) + elseif(inom.eq.93)then !'phiexp' + x=1000 + pt=sqrt(p(1,lf)**2+p(2,lf)**2) + if(pt.gt.0.)x=sign(1.,p(2,lf))*acos(p(1,lf)/pt) + if(x.lt.-pi)x=x+2*pi + if(x.gt.pi)x=x-2*pi + elseif(inom.eq.94)then !'mu24' ... charged ptl mult |eta|<2.4 (CMS) + x=multc24 + +c--------------------------------- 101 - 200 ---------------------------- + + elseif(inom.eq.101)then !mulevt + x=1. + elseif(inom.eq.102)then !'etevt' + x=0 + if(istptl(j).eq.0)then + eef=p(4,lf) + if(maproj.gt.1.or.matarg.gt.1)then + if(idptl(j).ge.1000)eef=eef-prom + if(idptl(j).le.-1000)eef=eef+prom + endif + pp=sqrt(p(1,lf)**2+p(2,lf)**2+p(3,lf)**2) + if(pp.ne.0.)x=eef*sqrt(p(1,lf)**2+p(2,lf)**2)/pp + if(x.ne.x)then + write(ifch,*)x,eef,p(1,lf),p(2,lf),p(3,lf),pp,prom,idptl(j),j + call alist('xan&',1,nptl) + stop 'probleme dans xan' + endif + endif + elseif(inom.eq.103)then + x=p(4,lf)/1000. + elseif(inom.eq.104)then !'ev6evt' + x=0 + if(istptl(j).eq.0)then + pt=sqrt(p(2,lf)**2+p(1,lf)**2) + eta=0 + if(p(3,lf).ne.0..and.pt.ne.0.)eta=sign(1.,p(3,lf))* + * alog((sqrt(p(3,lf)**2+pt**2)+abs(p(3,lf)))/pt) + if(pt.eq.0.)eta=sign(1e5,p(3,lf)) + if(eta.gt.6.0)then + eef=p(4,lf) + if(idptl(j).ge.1000)eef=eef-prom + if(idptl(j).le.-1000)eef=eef+prom + pp=sqrt(p(1,lf)**2+p(2,lf)**2+p(3,lf)**2) + if(pp.ne.0.)x=0.001*eef + endif + endif + elseif(inom.eq.105)then + !etot=maproj*emax(lf)+matarg*0.94 !nur richtig fur target frame!!!!! + etot=maproj*emax(lf)+matarg*emax(lf) + x=p(4,lf)/etot + elseif(inom.eq.106)then + x=isign(1,idptl(j)) + elseif(inom.eq.107)then !'ptevt' + x=sqrt(p(2,lf)**2+p(1,lf)**2) + elseif(inom.eq.108)then !'pmxevt' + x=pmxevt + +c--------------------------------- > 200 ---------------------------- + + elseif(inom.eq.201)then + x=1. + elseif(inom.eq.202)then + x=egyevt + elseif(inom.eq.203)then + x=bimevt + elseif(inom.eq.204)then !'xbjevt' + x=xbjevt + elseif(inom.eq.205)then !'qsqevt' + x=qsqevt + elseif(inom.eq.206)then !'yevt' + x=qsqevt/xbjevt/ecms**2 + elseif(inom.eq.207)then !'eloevt' +c x=qsqevt/4./elepti+elepti*(1.-qsqevt/xbjevt/ecms**2) + x=elepto + elseif(inom.eq.208)then !nd1evt + x=nsdiff(1,noweak(n)) + elseif(inom.eq.209)then !'nd2evt' + x=nsdiff(2,noweak(n)) + elseif(inom.eq.210)then !'theevt' +c eloevt=qsqevt/4./elepti+elepti*(1.-qsqevt/xbjevt/ecms**2) +c x=acos(1-qsqevt/2./elepti/eloevt)/pi*180. + x=acos(1-qsqevt/2./elepti/elepto)/pi*180. + elseif(inom.eq.211)then !'nspevt' + x=0 + do i=1,nptl + if((istptl(i).eq.30.or.istptl(i).eq.31) + & .and.int(idptl(i)/1000000).eq.1)x=x+1 + enddo + elseif(inom.eq.212)then !'nhpevt' + x=0 + do i=1,nptl + if((istptl(i).eq.30.or.istptl(i).eq.31) + & .and.int(idptl(i)/1000000).eq.3)x=x+1 + enddo + elseif(inom.eq.213)then !'sigtot' + x=sigtot + elseif(inom.eq.214)then !'sigela' + x=sigela + elseif(inom.eq.215)then !'sloela' + x=sloela + elseif(inom.eq.216)then !'nrgevt' + x=0 + do i=1,nptl + if(istptl(i).eq.31.and.int(idptl(i)/10000).eq.2)x=x+1 + enddo + elseif(inom.eq.217)then !qevt + x=sqrt(qsqevt) + elseif(inom.eq.218)then !qevt + if(iappl.eq.8)then + x=qtl + else + x=pprt(1,5) + endif + elseif(inom.eq.219)then !'nd0evt' UA1 + x=nsdiff(0,noweak(n)) + elseif(inom.eq.220)then!------------------------------------------ + x=sngl(bofra(1,lf)) !thrust + elseif(inom.eq.221)then + x=1.-sngl(bofra(1,lf)) !1-thrust + elseif(inom.eq.222)then + x=sngl(bofra(2,lf)) !major + elseif(inom.eq.223)then + x=sngl(bofra(3,lf)) !minor + elseif(inom.eq.224)then + x=sngl(bofra(2,lf)-bofra(3,lf)) !oblateness + elseif(inom.eq.230)then!------------------------------------------ + x=1.5*(1.-sngl(bofra(1,lf))) !spherecity + elseif(inom.eq.231)then + x=1.5*sngl(bofra(3,lf)) !aplanarity + elseif(inom.eq.232)then + x=3.*sngl(bofra(1,lf)*bofra(2,lf)+bofra(1,lf)*bofra(3,lf) + & +bofra(2,lf)*bofra(3,lf)) !c-parameter + elseif(inom.eq.233)then + x=27.*sngl(bofra(1,lf)*bofra(2,lf)*bofra(3,lf)) !d-parameter + elseif(inom.eq.234)then !npoevt + x=0 + do i=1,nptl + if(istptl(i).eq.30.or.istptl(i).eq.31)x=x+1 + enddo + elseif(inom.eq.235)then !npnevt + x=npjevt+ntgevt !npnevt + elseif(inom.eq.236)then !ikoevt + x=ikoevt + elseif(inom.eq.237)then !iktevt +c x=zkotest + elseif(inom.eq.238)then !npxevt ... nr of pomerons, including absorbed + x=0 + do i=1,nptl + if(istptl(i).eq.30.or.istptl(i).eq.31)x=x+1 + if(mod(abs(idptl(i)),100).eq.94)x=x+0.5 + enddo + elseif(inom.eq.239)then !'nd6evt' + x=nsdiff(6,noweak(n)) + elseif(inom.eq.240)then !mu1evt ... charged ptl multipl for central rap + x=multy1 + elseif(inom.eq.241)then !muievt ... charged ptl multipl + x=multyi + elseif(inom.eq.242)then !hgtevt ... charged ptl multipl for central eta + x=multc05 + elseif(inom.eq.243)then !difevt + npom=0 + do i=1,nptl + if(istptl(i).eq.30.or.istptl(i).eq.31)npom=npom+1 + enddo + x=0 + if(npom.eq.0)x=1 + elseif(inom.eq.244)then !dixevt + zpom=0 + do i=1,nptl + if(istptl(i).eq.30.or.istptl(i).eq.31)zpom=zpom+1 + if(mod(abs(idptl(i)),100).eq.94)zpom=zpom+0.5 + enddo + x=0 + if(abs(zpom).lt.0.001)x=1 + elseif(inom.eq.245)then !'nd7evt' CMS NSD + x=nsdiff(7,noweak(n)) + elseif(inom.eq.246)then !'nd8evt' ATLAS + x=nsdiff(8,noweak(n)) + elseif(inom.eq.247)then !'nd9evt' ALICE 900 GeV + x=nsdiff(9,noweak(n)) + elseif(inom.eq.248)then !'ndaevt' ALICE 2.36 TeV + x=nsdiff(10,noweak(n)) + elseif(inom.eq.249)then !'ndbevt' ALICE Inel > 0 + x=nsdiff(11,noweak(n)) + elseif(inom.eq.250)then + if(iappl.eq.8)then !mass in + x=-pptl(5,6) + else + x=pprt(5,3) + endif + elseif(inom.eq.251)then + if(iappl.eq.8)then !mass out + x=pptl(5,7) + else + x=pprt(5,2) + endif + elseif(inom.eq.252)then + if(iappl.eq.8)then + x=-pptl(4,6) + else + x=pprt(4,2) + endif + elseif(inom.eq.253)then + if(iappl.eq.8)then + x=pptl(4,7) + else + x=pprt(4,3) + endif + elseif(inom.eq.254)then + if(iappl.eq.8)then + x=abs(pptl(3,6)) + else + x=abs(pprt(3,2)) + endif + elseif(inom.eq.255)then + if(iappl.eq.8)then + x=abs(pptl(3,7)) + do l=1,5 + p(l,lf)=pptl(l,7) + enddo + if(imofra(1,lf).ne.0)then + call utrota(imofra(1,lf),r1fra(1,lf),r1fra(2,lf),r1fra(3,lf) + $ ,p(1,lf),p(2,lf),p(3,lf)) + endif + if(imofra(2,lf).ne.0)then !the x-z exchanged is ok !! + call utrota(imofra(2,lf),r2fra(3,lf),r2fra(2,lf),r2fra(1,lf) + $ ,p(3,lf),p(2,lf),p(1,lf)) + endif + if(imofra(3,lf).ne.0)then + call utlob4(imofra(3,lf),bofra(1,lf),bofra(2,lf) + $ ,bofra(3,lf) ,bofra(4,lf),bofra(5,lf) + $ ,p(1,lf),p(2,lf),p(3,lf),p(4,lf)) + endif + x=abs(p(3,lf)) + else + x=abs(pprt(3,3)) + endif + elseif(inom.eq.256)then !pxfevt: leading proton xf in cms + x=-2 +c pmax=sqrt((ecms/2.)**2-prom**2) + pmax=pnullx !??????????????????? + do i=1,nptl + if(idptl(i).eq.1120.and.istptl(i).eq.0)then + if(iframe.eq.11)then + pz=pptl(3,i) + else + amt=sqrt(prom**2+pptl(1,i)**2+pptl(2,i)**2) + rap=alog((pptl(4,i)+pptl(3,i))/amt) + & -alog((sqrt(pnll**2+ecms**2)+pnll)/ecms) + pz=amt*sinh(rap) + endif + x=max(x,pz/pmax) + endif + enddo + elseif(inom.eq.257)then ! pi+xf: pi+ yield at cms xf>0.01 + x=0. +c pmax=sqrt((ecms/2)**2-prom*2) + pmax=pnullx !??????????????????? + do i=1,nptl + if(idptl(i).eq.120.and.istptl(i).eq.0)then + if(iframe.eq.11)then + pz=pptl(3,i) + else + amt=sqrt(pptl(5,i)**2+pptl(1,i)**2+pptl(2,i)**2) + rap=alog((pptl(4,i)+pptl(3,i))/amt) + & -alog((sqrt(pnll**2+ecms**2)+pnll)/ecms) + pz=amt*sinh(rap) + endif + if(pz/pmax.gt.0.01)x=x+1. + endif + enddo + elseif(inom.eq.258)then ! pi-xf: pi- yield at cms xf>0.01 + x=0. +c pmax=sqrt((ecms/2)**2-prom*2) + pmax=pnullx !??????????????????? + do i=1,nptl + if(idptl(i).eq.-120.and.istptl(i).eq.0)then + if(iframe.eq.11)then + pz=pptl(3,i) + else + amt=sqrt(pptl(5,i)**2+pptl(1,i)**2+pptl(2,i)**2) + rap=alog((pptl(4,i)+pptl(3,i))/amt) + & -alog((sqrt(pnll**2+ecms**2)+pnll)/ecms) + pz=amt*sinh(rap) + endif + if(pz/pmax.gt.0.01)x=x+1. + endif + enddo + elseif(inom.eq.260)then!------------------------------ + x=sigcut + elseif(inom.eq.261)then + x=keu + elseif(inom.eq.262)then + x=ked + elseif(inom.eq.263)then + x=kes + elseif(inom.eq.265)then + x=kolevt + elseif(inom.eq.266)then + x=sigsd + elseif(inom.eq.267)then + x=nglevt + elseif(inom.eq.268)then ! kppevt : collision number per participant + x=kolevt/float(npjevt+ntgevt) + elseif(inom.eq.269)then ! npievt : pion + multi per event + x=0 + do i=1,nptl + if(idptl(i).eq.120)x=x+1 + enddo + elseif(inom.eq.270)then ! np2evt : pion + multi per event + x=0 + do i=1,nptl + if(idptl(i).eq.120)x=x+1 + enddo + x=x/float(npjevt+ntgevt) + elseif(inom.eq.271)then + x=sigdif + elseif(inom.eq.272)then !number of inelastic collisions per event + x=koievt + elseif(inom.eq.273)then ! inelasticity (energy loss of leading particle) + x=0. + do i=maproj+matarg+1,nptl + if(istptl(i).eq.0)then + if((((abs(idptl(i)).gt.1000.and.abs(idptl(i)).lt.10000) + * .and.idproj.gt.1000).or.(iabs(idptl(i)).gt.100 + * .and.idproj.lt.1000)).and.pptl(4,i) + * .gt.x.and.pptl(3,i).gt.0.)x=pptl(4,i) + endif + enddo + Eini=pptl(4,1) + if(Eini.gt.0.)x=(Eini-x)/Eini + elseif(inom.eq.274)then ! elasticity (energy of leading particle) + x=0. + do i=maproj+matarg+1,nptl + if(istptl(i).eq.0)then + if((((abs(idptl(i)).gt.1000.and.abs(idptl(i)).lt.10000) + * .and.idproj.gt.1000).or.(iabs(idptl(i)).gt.100 + * .and.idproj.lt.1000)).and.pptl(4,i) + * .gt.x.and.pptl(3,i).gt.0.)x=pptl(4,i) + endif + enddo + Eini=pptl(4,1) + if(Eini.gt.0.)x=x/Eini + elseif(inom.eq.275)then !'itgevt' + x=0 + if(nint(ypara(1,n)).ne.0)x=1 + elseif(inom.eq.276)then !'hrdevt' ...... 1 = hard event + x=0 + if(nint(ypara(1,n)).ne.0)x=1 + elseif(inom.eq.277)then !'ej1evt' .... et of jet 1 + x=0 + if(nint(ypara(1,n)).ne.0) + & x=ypara(2,n) + elseif(inom.eq.278)then !'pj1evt' .... phi of jet 1 + x=1000 + if(nint(ypara(1,n)).ne.0) + & x=ypara(4,n) + elseif(inom.eq.279)then !'ej2evt' .... et of jet 2 + x=0 + if(nint(ypara(6,n)).ne.0) + & x=ypara(7,n) + elseif(inom.eq.280)then !'pj2evt' .... delta_phi of jet 2 1 + x=1000 + if(nint(ypara(6,n)).ne.0)then + x=ypara(9,n)-ypara(4,n) + if(x.lt.-2.5*pi)then + x=x+4*pi + elseif(x.lt.-0.5*pi)then + x=x+2*pi + elseif(x.gt.3.5*pi)then + x=x-4*pi + elseif(x.gt.1.5*pi)then + x=x-2*pi + endif + endif + elseif(inom.eq.281)then !'zppevt' + x=zppevt + elseif(inom.eq.282)then !'zptevt' + x=zptevt + elseif(inom.eq.283)then + stop '**********not used*********' + elseif(inom.eq.284)then !'nd3evt' + x=nsdiff(3,noweak(n)) + elseif(inom.eq.285)then !'nd4evt' + x=nsdiff(4,noweak(n)) + elseif(inom.eq.286)then !'mubevt' + x=multeb + elseif(inom.eq.287)then !'nd5evt' + x=nsdiff(5,noweak(n)) + elseif(inom.eq.288)then + x=ekievt + elseif(inom.eq.289)then !'diffmevt' + x=isdiff(1) + elseif(inom.eq.290)then !'diffxevt' + x=isdiff(2) + elseif(inom.eq.291.or.inom.eq.292)then ! mass of produced system (inelasticity of leading particle ) + x=0. + i=idlead + if(i.gt.0)then + pmax=pnullx + if(mod(ifra(lf),10).eq.2)pmax=pnll + x=abs(pptl(3,i)/pmax) + x=(1.-x)*engy*engy + if(inom.eq.291.and.x.gt.0.)x=sqrt(x) +c write(ifch,*)'ici',i,idptl(i),x,abs(pptl(3,i)/pmax) + endif + elseif(inom.eq.293)then ! tdevt : -t of leading particle + x=0. + i=idlead + if(i.gt.0)then + pmax=pnullx + if(mod(ifra(lf),10).eq.2)pmax=pnll +c xxx=(amproj**2-2.*sqrt(amproj**2+pmax**2)*pptl(4,i) +c * +2.*abs(pmax*pptl(4,i))+pptl(5,i)**2) + ppt=sqrt(pptl(1,i)**2+pptl(2,i)**2) + if(abs(pptl(3,i)).gt.0.)then + theta=atan(ppt/pptl(3,i)) + else + theta=pi/2. + endif + x=abs(pptl(3,i)/pmax) +c -t definition of UA4 (Phys Lett B136,217) + x=pptl(5,i)**2*(1.-x)**2/x+2*x*pmax*pmax*(1.-cos(theta)) +c write(*,*)'ici',i,idptl(i),theta,x,xxx + endif + elseif(inom.eq.294)then !'ndpevt' pomeron from diffraction + x=0 + do i=1,nptl + if((istptl(i).eq.30.or.istptl(i).eq.31) + & .and.mod(ityptl(i),10).eq.5)x=x+1 + enddo + elseif(inom.eq.295)then !'rapgap' rapidity gap + x=rapgap + elseif(inom.eq.296)then !'ng1evt' + x=ng1evt + elseif(inom.eq.297)then !'r21evt' + x=0 + if(ng1evt.ne.0)x=ng2evt/float(ng1evt) + elseif(inom.eq.298)then + x=sval(1,n) + elseif(inom.eq.299)then + x=sval(2,n) + elseif(inom.eq.301)then !--------------------------------------------- + if(j.eq.0)then !initialize + do l=1,4 + aimuni(l,n)=0. + enddo + elseif(j.gt.nptl)then !final calculation + am2=aimuni(4,n)**2-aimuni(3,n)**2 + $ -aimuni(2,n)**2-aimuni(1,n)**2 + x=sign(sqrt(abs(am2)),am2) +c print *, x + else !routine work + do l=1,4 + aimuni(l,n)=aimuni(l,n)+p(l,lf) + enddo +c print *, j,(p(l,lf),l=1,5) + endif + elseif(inom.ge.302.and.inom.le.305)then !----------------------- + if(j.eq.0)then !initialize + do l=1,4 + aimuni(l,n)=0. + enddo + elseif(j.gt.nptl)then !final calculation + if(inom.eq.302) x=max(aimuni(1,n)/2/(aimuni(2,n)+aimuni(4,n)) + $ ,aimuni(3,n)/2/(aimuni(2,n)+aimuni(4,n))) + if(inom.eq.303) x=min(aimuni(1,n)/2/(aimuni(2,n)+aimuni(4,n)) + $ ,aimuni(3,n)/2/(aimuni(2,n)+aimuni(4,n))) + if(inom.eq.304) x=abs(aimuni(1,n)/2/(aimuni(2,n)+aimuni(4,n)) + $ -aimuni(3,n)/2/(aimuni(2,n)+aimuni(4,n))) + if(inom.eq.305) x=aimuni(1,n)/2/(aimuni(2,n)+aimuni(4,n)) + $ +aimuni(3,n)/2/(aimuni(2,n)+aimuni(4,n)) + else !routine work + l=0 + if(p(3,lf).lt.0.)l=2 + aimuni(1+l,n)=aimuni(1+l,n)+sqrt(p(1,lf)**2+p(2,lf)**2) + aimuni(2+l,n)=aimuni(2+l,n) + $ +sqrt(p(1,lf)**2+p(2,lf)**2+p(3,lf)**2) + + endif + elseif(inom.eq.306.or.inom.eq.307.or.inom.eq.308)then !--------- + if(j.eq.0)then !initialize + do ll=1,8 + aimuni(ll,n)=0. + enddo + elseif(j.gt.nptl)then !final calculation + am2a=aimuni(4,n)**2-aimuni(3,n)**2 + $ -aimuni(2,n)**2-aimuni(1,n)**2 + am2b=aimuni(8,n)**2-aimuni(7,n)**2 + $ -aimuni(6,n)**2-aimuni(5,n)**2 + if(inom.eq.306)x=(max(0.,am2a,am2b))/engy**2 + if(inom.eq.307)x=(max(0.,min(am2a,am2b)))/engy**2 + if(inom.eq.308)x=(abs(am2a-am2b))/engy**2 + else !routine work + ll=0 + if(p(3,lf).lt.0.)ll=4 + do l=1,4 + aimuni(l+ll,n)=aimuni(l+ll,n)+p(l,lf) + enddo + endif + elseif (inom.eq.310.or.inom.eq.311) then !--------- + if(j.eq.0)then !initialize + aimuni(1,n)=0 + aimuni(2,n)=0 + do i=1,nptl +c charge=0. + if(istptl(i).eq.0) then + if (idptl(i).eq.idcod(1,n)) aimuni(1,n)=aimuni(1,n)+1. + if (idptl(i).eq.idcod(2,n)) aimuni(2,n)=aimuni(2,n)+1. + endif + enddo + elseif(j.gt.nptl)then !final calculation + if(aimuni(1,n).eq.0.or.aimuni(2,n).eq.0) then + ncevt(n)=ncevt(n)-1 + endif + x=xmin(n)-100. + do i=1,nbin(n) + zcbin(i,nac(n),n)=abs(zcbin(i,nac(n),n)) + enddo + else !routine work + if( istptl(j).eq.0 + $ .and. aimuni(1,n).ne.0. .and. aimuni(2,n).ne.0. ) then + id1=idptl(j) + if(id1.eq.idcod(1,n) .or. id1.eq.idcod(2,n)) then + y1=sign(1.,pptl(3,j))*alog((pptl(4,j)+abs(pptl(3,j))) + * /sqrt(pptl(5,j)**2+pptl(1,j)**2+pptl(2,j)**2)) + do i=1,nptl + if(i.eq.j .or. istptl(i).ne.0) goto 124 + id2=idptl(i) + if(id2.eq.idcod(1,n) .or. id2.eq.idcod(2,n)) then + y2=sign(1.,pptl(3,i))*alog((pptl(4,i)+abs(pptl(3,i))) + * /sqrt(pptl(5,i)**2+pptl(1,i)**2+pptl(2,i)**2)) + dy=(y2-y1) + if(inom.eq.311) dy=abs(dy) + ib=1+int((dy-xmin(n))*xinc(n)) + if(dy.ge.xmin(n).and.dy.le.xmax(n)) then + if( id1.eq.idcod(1,n) ) then + if( id2.eq.idcod(2,n) ) then + bin(ib,nac(n),n)=bin(ib,nac(n),n)+.5/aimuni(2,n) + zcbin(ib,nac(n),n)=zcbin(ib,nac(n),n)+1 + else + bin(ib,nac(n),n)=bin(ib,nac(n),n)-.5/aimuni(1,n) + zcbin(ib,nac(n),n)=zcbin(ib,nac(n),n)-1 + endif + else !id1 is idcod(2,n) + if(id2.eq.idcod(1,n)) then + bin(ib,nac(n),n)=bin(ib,nac(n),n)+.5/aimuni(1,n) + zcbin(ib,nac(n),n)=zcbin(ib,nac(n),n)+1 + else + bin(ib,nac(n),n)=bin(ib,nac(n),n)-.5/aimuni(2,n) + zcbin(ib,nac(n),n)=zcbin(ib,nac(n),n)-1 + endif + endif + endif + endif + 124 continue + enddo + endif + endif + endif + elseif (inom.eq.312) then !--------- + x=sigine + elseif (inom.eq.313) then !--------- + x=sigineaa + elseif (inom.eq.314) then !--------- + x=alpD(idxD0,iclpro,icltar) + elseif (inom.eq.315) then !--------- + x=alpD(1,iclpro,icltar) + elseif (inom.eq.316) then !--------- + x=betD(idxD0,iclpro,icltar) + if(x.lt.0.)x=-10.*x + elseif (inom.eq.317) then !--------- + x=betD(1,iclpro,icltar) + elseif (inom.eq.318) then !--------- + x=rexdif(iclpro) + elseif (inom.eq.319) then !--------- + x=rexdif(icltar) + elseif(inom.eq.320)then !m14evt ... multipl |eta|<1, pt>0.4 + x=multc14 + elseif(inom.eq.321)then !ht3evt ... height |eta|<3.15 + x=multc3/6.3 + elseif (inom.eq.322) then !--------- + x=sigineex + elseif (inom.eq.323) then !--------- + x=sigdifex + elseif (inom.eq.324) then !--------- + x=sigsdex + elseif (inom.eq.325) then !--------- + x=ekin + elseif (inom.eq.326) then !--------- + x=sigcutaa + elseif (inom.eq.327) then !--------- + x=sigtotaa + elseif (inom.eq.328) then !--------- + x=xkappafit(iclegy,iclpro,icltar,1) + elseif (inom.eq.329) then !--------- + x=gamD(idxD0,iclpro,icltar) + elseif (inom.eq.330) then !--------- + x=gamD(1,iclpro,icltar) + elseif (inom.eq.331) then !--------- + x=delD(idxD0,iclpro,icltar) + elseif (inom.eq.332) then !--------- + x=delD(1,iclpro,icltar) + elseif(inom.eq.333)then !'nd6evt' + x=nsdiff(6,noweak(n)) + elseif(inom.eq.334)then !'muxevt' ... multipl + x= ypara(1,n) + elseif(inom.eq.335)then + x=abs(nint(typevt)) !ND(1), DD(2), or SD(3) + elseif(inom.eq.339)then !m25evt ... multipl |eta|<2.5, pt>0.5 + x=multc25 + elseif(inom.eq.340)then !'segevt' ... segment multiplicity +c x=segevt + elseif(inom.eq.341)then !'ielevt' + x=nsdiff(11,noweak(n)) + elseif(inom.eq.342)then !'mc1evt' charged particle + x=multc1 ! mult for |eta|<1 + elseif(inom.eq.343)then !CDF SD trigger 'sdcdf' + x=isdiff(3) + elseif(inom.eq.344)then !CDF DPE trigger 'dpecdf' + x=isdiff(4) + elseif(inom.eq.345)then !CDF DD trigger 'ddcdf' + x=isdiff(5) + elseif(inom.eq.346)then !'phievt' + x=phievt + elseif(inom.eq.347)then !'ndcevt' CMS hadron level NSD (2011) + x=nsdiff(12,noweak(n)) + elseif(inom.eq.348)then !'jetevt' ...... 1 = jet event + x=0 + if(nint(ypara(1,n)).ne.0)x=1 + elseif(inom.eq.349)then !'epszero (Z for pp)' + x=epszero + elseif(inom.eq.350)then !xsievt: xsi = (M_X^2/s) +c (where M_X = sqrt{ (sum E)^2 - (sum vec-p)^2 } with sum E and sum vec-p +c being resp. the sum of the energies and the sum of the 3-momenta of the +c generated particles in the event, excluding the proton with the largest +c laboratory momentum) + x=xsi +cc xsievt: xsi = 1-xF_leading +c x=-2 +cc pmax=sqrt((ecms/2.)**2-prom**2) +c pmax=pnullx !??????????????????? +c do i=1,nptl +c if(abs(idptl(i)).gt.100.and.istptl(i).eq.0)then +c if(iframe.eq.11)then +c pz=pptl(3,i) +c else +c amt=sqrt(prom**2+pptl(1,i)**2+pptl(2,i)**2) +c rap=alog((pptl(4,i)+pptl(3,i))/amt) +c & -alog((sqrt(pnll**2+ecms**2)+pnll)/ecms) +c pz=amt*sinh(rap) +c endif +c x=max(x,abs(pz/pmax)) +c endif +c enddo +c x=max(0.,1.-x) + elseif(inom.eq.351)then !xsicms: CMS determination of xsi=M2_X/s + !using xsi=Sum [(E+pz)_i/sqrt(s)] where i runs on every reconstructed particles (= |eta|<4.9 charged + neutral) + x=-2 +c pmax=sqrt((ecms/2.)**2-prom**2) + pmax=pnullx !??????????????????? + Ef=0. + Eb=0. + Pf=0. + Pb=0. + Esum=0. + Psum=0. + do i=1,nptl + if(istptl(i).eq.0)then + pt=sqrt(pptl(2,i)**2+pptl(1,i)**2) + pz=pptl(3,i) + eta=0. + if(abs(pz).gt.0..and.pt.gt.0.)eta=sign(1.,pz)* + * log((sqrt(pz**2+pt**2)+abs(pz))/pt) + if(pt.eq.0.)eta=sign(1e5,pz) + if(eta.ge.4.9)then + Ef=Ef+pptl(4,i) + Pf=Pf+pptl(3,i) + elseif(eta.le.-4.9)then + Eb=Eb+pptl(4,i) + Pb=Pb+pptl(3,i) + else + Esum=Esum+pptl(4,i) + Psum=Psum+pptl(3,i) + endif +c write(ifch,*)'ici',i,eta,Ef,Eb,Esum,Psum,Ef-Pf,Eb+Pb + endif + enddo + if(Ef.ge.Eb)then + x=Esum+Psum+Eb+Pb + else + x=Esum-Psum+Ef-Pf + endif + x=max(0.,x/ecms) +c write(ifmt,*)'ici',x,min(Esum-Psum,Esum+Psum)/ecms + elseif(inom.eq.352)then !'calevt' ...... energy in eta range + x= ypara(1,n) + elseif(inom.eq.353)then !'fgpevt' ...... max forward rapidity gap in eta range + x= ypara(2,n) + elseif(inom.eq.354)then !'bgpevt' ...... max backward rapidity gap in eta range + x= ypara(3,n) + elseif(inom.eq.355)then !'gapevt' ...... max backward rapidity gap in eta range + x= ypara(4,n) + elseif(inom.eq.356)then + x=sigdd + elseif(inom.eq.357)then !'ajtevt' + x=-9999 + if(nint(ypara(1,n)).ne.0)x=ypara(2,n) + elseif(inom.eq.358)then !'fjtevt' + x=-9999 + if(nint(ypara(1,n)).ne.0)x=ypara(3,n) + elseif(inom.eq.359)then !'pjtevt' + x=-9999 + if(nint(ypara(1,n)).ne.0)x=ypara(4,n) + elseif(inom.eq.360)then + x=nint(typevt) !ND(1), DD(2), or SD(3) with fusion < 0 + elseif(inom.eq.361)then !'ndsevt' CMS hadron level double sided trigger (2012) + x=nsdiff(13,noweak(n)) + elseif(inom.eq.362)then !m24evt ... multipl |eta|<2.4 (CMS) + x=multc24 + elseif(inom.eq.363)then !'ndhevt' CMS hadron level single sided trigger (HF 2012) + x=nsdiff(14,noweak(n)) + elseif(inom.eq.364)then !'ndfevt' LHCf trigger + x=nsdiff(15,noweak(n)) + elseif (inom.eq.501) then !--------- + x=sval(1,1) + elseif (inom.eq.502) then !--------- + x=sval(1,2) + elseif (inom.eq.503) then !--------- + x=sval(1,3) + elseif (inom.eq.504) then !--------- + x=sval(1,4) + elseif(inom.eq.505)then !'eglevt' eccentricity + x=eglevt + elseif(inom.eq.506)then !'fglevt' eccentricity_part + x=fglevt + elseif(inom.eq.507)then !'rglevt' ratio ng2 / ng1 + x=0 + if(ng1evt.ne.0) + . x=ng2evt/float(ng1evt) + elseif(inom.eq.508)then !'sglevt' area S + x=sglevt + elseif(inom.eq.509)then !'ptrevt' + x=0 + do i=maproj+matarg+1,minfra + if(istptl(i).eq.25)then + pt=sqrt(pptl(1,i)**2+pptl(2,i)**2) + x=max(x,pt) + endif + enddo + elseif(inom.eq.510)then !'rr2evt' + x=cos(2*(phi2neg-phi2pos)) + !write(ifmt,*)'+++++ rr2evt +++++ ',x,phi2neg,phi2pos + elseif(inom.eq.511)then !'perevt' + call getJKNcentr + x=(ncentr-0.5)*5 + elseif(inom.eq.512)then !'paievt' + x=paievt + elseif(inom.eq.513)then !'co2evt' + x=co2evt + elseif(inom.eq.514)then !'co3evt' + x=co3evt + elseif(inom.eq.515)then !'nh1evt' + x=0 + do i=maproj+matarg+1,minfra + if(istptl(i).eq.25)then + pt=sqrt(pptl(1,i)**2+pptl(2,i)**2) + if(pt.gt.10)x=x+1 + endif + enddo + elseif(inom.eq.516)then !'nh2evt' + x=0 + do i=maproj+matarg+1,minfra + if(istptl(i).eq.25)then + pt=sqrt(pptl(1,i)**2+pptl(2,i)**2) + if(pt.gt.20)x=x+1 + endif + enddo + elseif(inom.eq.517)then !'nh3evt' + x=0 + do i=maproj+matarg+1,minfra + if(istptl(i).eq.25)then + pt=sqrt(pptl(1,i)**2+pptl(2,i)**2) + if(pt.gt.50)x=x+1 + endif + enddo + elseif(inom.eq.518)then !'gbyevt' + x=gbyjmax + elseif(inom.eq.519)then !'icyevt' +c call getncenthy + if(ncenthy.ne.20)stop'\n\n ERROR 28072011d\n\n' + f=(1-(icentrality-0.5)*0.05) + x=f * 100 + elseif(inom.eq.520)then !'xp9evt' + x=xpara(9,n) + elseif(inom.eq.521)then !'hlxevt' + xi=xpara(9,n) + x=helix(xi) + endif !--------------------------------------- + end + +c---------------------------------------------------------------------- + subroutine mux(n) +c---------------------------------------------------------------------- + ! input + ! n = histogram number + ! xpara(1,n) ... etamin + ! xpara(2,n) ... etamax + ! xpara(3,n) ... ptmin + ! xpara(4,n) ... ptmax + ! xpara(5,n) ... factor + ! xpara(6,n) ... divisor + ! xpara(7,n) ... absolute value of eta (1) + ! xpara(8,n) ... take into account leptons (1) + ! + ! output + ! ypara(1,n) ... multiplicity + !-------------------------------------------------------------- + include 'epos.inc' + parameter (mxhis=500,mxcontr=500,mxidcd=60,mxtri=50,mxbin=405) + parameter (mypara=10,mxpara=20) + logical ilog,icnx,itrevt,idmod + double precision bin,bbin,zcbin,zbbin + common/bins/bin(mxbin,2,mxhis),zcbin(mxbin,2,mxhis) + $ ,bbin(mxbin,2,mxcontr),itrevt(mxhis),zbbin(mxbin,2,mxcontr) + $ ,nac(mxhis),ilog(mxhis),icnx(mxhis),xinc(mxhis),ncevt(mxhis) + $ ,sval(2,mxhis),valtri(mxtri,mxhis),ntrc(mxtri,mxhis) + $ ,xmin(mxhis),xmax(mxhis),nhis,noweak(mxhis) + $ ,ivar(2,mxhis),inorm(mxhis),nbin(mxhis),nidcod(mxhis) + $ ,idcod(mxidcd,mxhis),idmod(mxidcd,mxhis),ntri(mxhis) + $ ,itri(mxtri,mxhis),xmitri(mxtri,mxhis),xmatri(mxtri,mxhis) + $ ,xmitrp(mxtri,mxhis),xmatrp(mxtri,mxhis),xpara(mxpara,mxhis) + $ ,ypara(mypara,mxhis),lookcontr(mxhis) + $ ,lookcontrx(mxhis),ncontrall,icontrtyp(mxhis),nccevt(mxcontr) + mul=0 + do i=maproj+matarg+1,nptl + if(istptl(i).eq.0)then + pt=pptl(1,i)**2+pptl(2,i)**2 +c if(pt.gt.1.)then +c ypara(1,n)=0 +c return +c endif + pp=sqrt(pptl(1,i)**2+pptl(2,i)**2+pptl(3,i)**2) + if(pt.gt.0.)then + pt=sqrt(pt) + eta=sign(1.,pptl(3,i))*alog((pp+abs(pptl(3,i)))/pt) + else + eta=1000. + endif + if(xpara(7,n).ge.1.)eta=abs(eta) + idmin=100 + if(xpara(8,n).ge.1.)idmin=0 + if(abs(idptl(i)).ge.idmin + $ .and.abs(idptl(i)).lt.10000)then + call idchrg(idptl(i),ch) + if(abs(ch).gt.0.1)then + if( eta.ge.xpara(1,n) + * .and.eta.le.xpara(2,n) + * .and.pt .gt.xpara(3,n) + * .and.pt .lt.xpara(4,n) )mul=mul+1 + endif + endif + endif + enddo + ypara(1,n)=mul*xpara(5,n)/xpara(6,n) + !print*,'+++++++',n,mul + !. ,xpara(1,n),xpara(2,n),xpara(3,n) + !. ,xpara(4,n),xpara(5,n),xpara(6,n) + end + +c---------------------------------------------------------------------- + function helix(xi) +c---------------------------------------------------------------------- + include 'epos.inc' + parameter (maxpv=20000) + real phixx(maxpv),etaxx(maxpv),ptxx(maxpv) + helix=0 + ii=0 + do i=maproj+matarg+1,nptl + if(istptl(i).eq.0)then + px=pptl(1,i) + py=pptl(2,i) + pt=pptl(1,i)**2+pptl(2,i)**2 + if(pt.gt.0.)then + pt=sqrt(pt) + theta=atan(pt/pptl(3,i)) + if(theta.lt.0.)theta=theta+pi + eta=-log(tan(theta*0.5)) + else + eta=1000. + endif + if(abs(eta).lt.2.5)then + call idchrg(idptl(i),ch) + if(abs(ch).gt.0.1.and.pt.gt.0.100)then + ii=ii+1 + if(ii.gt.maxpv)then + write(ifmt,*) + . '***** ERROR: PairVariables: arrays too small' + stop'\n\n PairVariables: arrays too small \n\n' + endif + phixx(ii)=polar(px,py) + etaxx(ii)=eta + ptxx(ii)=pt + !print*,'+++++',ii,pt,idptl(i) + endif + endif + endif + enddo + if(ii.gt.0)then + do m=1,ii + do n=1,ii + if(n.ne.m)then + d=xi*(etaxx(m)-etaxx(n))-(phixx(m)-phixx(n)) + helix=helix+cos(d) + endif + enddo + enddo + helix=helix/ii + endif + !print*,'helix',ii,xi,helix + end + +c---------------------------------------------------------------------- + subroutine PairVariables +c---------------------------------------------------------------------- + include 'epos.inc' + parameter (maxpv=20000) + real phixx(maxpv),etaxx(maxpv),ptxx(maxpv) + integer idxx(maxpv) + common/cpairs/paievt,co2evt,co3evt + parameter (mxpaih=8) + common/cpairs2/paih(mxpaih,40),co2h(mxpaih,40),co3h(mxpaih,40) + . ,ipaih(mxpaih,40),ico2h(mxpaih,40),ico3h(mxpaih,40) + . ,maxpt,delpt + maxpt=40 + delpt=8./maxpt + do j=1,maxpt + do i=1,mxpaih + ipaih(i,j)=0 + ico2h(i,j)=0 + ico3h(i,j)=0 + paih(i,j)=0. + co2h(i,j)=0. + co3h(i,j)=0. + enddo + enddo + paievt=0 + co2evt=0 + co3evt=0 + ii=0 + do i=maproj+matarg+1,nptl + if(istptl(i).eq.0)then + px=pptl(1,i) + py=pptl(2,i) + pt=pptl(1,i)**2+pptl(2,i)**2 + if(pt.gt.0.)then + pt=sqrt(pt) + theta=atan(pt/pptl(3,i)) + if(theta.lt.0.)theta=theta+pi + eta=-log(tan(theta*0.5)) + else + eta=1000. + endif + if(abs(eta).lt.1.0)then + call idchrg(idptl(i),ch) + !if(abs(ch).gt.0.1)then + ii=ii+1 + if(ii.gt.maxpv)then + write(ifmt,*) + . '***** ERROR: PairVariables: arrays too small' + stop'\n\n PairVariables: arrays too small \n\n' + endif + phixx(ii)=polar(px,py) + etaxx(ii)=eta + ptxx(ii)=pt + idxx(ii)=idptl(i) + !print*,'+++++',ii,pt,idxx(ii) + !endif + endif + endif + enddo + do m=1,ii + do n=1,ii + if( (etaxx(m).lt.-0.5 .and. etaxx(n).gt.0.5) + . .or. (etaxx(n).lt.-0.5 .and. etaxx(m).gt.0.5) )then + if(abs(etaxx(m)-etaxx(n)).lt.0.999) + . stop'\n\n ERROR 04112011\n\n' + !m.ne.n automatic in this case + paievt=paievt+1 + co2mn=cos(2*(phixx(m)-phixx(n))) + co3mn=cos(3*(phixx(m)-phixx(n))) + call idchrg(idxx(m),chm) + call idchrg(idxx(n),chn) + if(abs(chm).gt.0.1.and.abs(chn).gt.0.1)then + co2evt=co2evt+co2mn + co3evt=co3evt+co3mn + endif + !iam=abs(idxx(m)) + !im=ptxx(m)/delpt+1 + ian=abs(idxx(n)) + idn= idxx(n) + in=ptxx(n)/delpt+1 + if(in.ge.1.and.in.le.maxpt)then + iid=0 + if(ian.eq.120)iid=1 + if(ian.eq.1120)iid=2 + if(ian.eq.130)iid=3 + if(ian.eq.1130)iid=4 + if(idn.eq.20)iid=5 + if(ian.eq.2130)iid=6 + if(ian.eq.2330)iid=7 + if(ian.eq.3331)iid=8 + if(iid.ne.0)then + paih(iid,in)=paih(iid,in)+1 + co2h(iid,in)=co2h(iid,in)+co2mn + co3h(iid,in)=co3h(iid,in)+co3mn + !print*,'+++hadron++',in, idxx(n),ptxx(n) + endif + endif + endif + enddo + enddo + !print*,'+++++ pairs +++++',ii,paievt,co2evt,co3evt + sum1=0 + sum2=0 + sum3=0 + do j=1,min(20,maxpt) + !write(*,'(a,i5,2(f7.0,2f7.3,3x))') '+++++++',j, + !. paih(1,j),co2h(1,j),co3h(1,j),paih(2,j),co2h(2,j),co3h(2,j) + sum1=sum1+paih(1,j)+paih(2,j)+paih(3,j)+paih(4,j) + sum2=sum2+co2h(1,j)+co2h(2,j)+co2h(3,j)+co2h(4,j) + sum3=sum3+co3h(1,j)+co3h(2,j)+co3h(3,j)+co3h(4,j) + enddo + !print*,'+++++ sum +++++ ',sum1,sum2,sum3 + end + +c---------------------------------------------------------------------- + subroutine StandardVariables +c---------------------------------------------------------------------- + include 'epos.inc' + common/stavar/multc05,multy1,multc14,multyi,multc3,imulty1,multeb + & ,multc1,multc83,multc24,multc25,rapgap,ipairs1,xsi + parameter(mxxhis=150) + common/varhis/icorrtrig(0:mxxhis),ihardevent(0:mxxhis) + &,ijetfind1(0:mxxhis),ijetfind2(0:mxxhis),imux(0:mxxhis) + &,ifastjet(0:mxxhis),ijetevent(0:mxxhis),icaltrig(0:mxxhis) + logical CDF + common/cphi2/phi2pos,phi2neg + double precision sumE,sumP(4) + + Emax=0. + Pmax=0. + multy1=0 + multc05=0 + multc14=0 + multc24=0 + multc25=0 + multc1=0 + multyi=0 + multc3=0 + multeb=0 + multc83=0 + rapgap=0. + etamn=-1000. + etamx=1000. + avcos2p=0 + avsin2p=0 + avcos2n=0 + avsin2n=0 + sumE=0d0 + sumP(1)=0d0 + sumP(2)=0d0 + sumP(3)=0d0 + sumP(4)=0d0 + imax=0 + + do i=maproj+matarg+1,nptl + if(istptl(i).eq.0)then + amt=pptl(5,i)**2+pptl(1,i)**2+pptl(2,i)**2 + px=pptl(1,i) + py=pptl(2,i) + pt=pptl(1,i)**2+pptl(2,i)**2 + pp=sqrt(pptl(1,i)**2+pptl(2,i)**2+pptl(3,i)**2) + et=sqrt(pptl(1,i)**2+pptl(2,i)**2+pptl(5,i)**2) + if(amt.gt.0..and.pptl(4,i).gt.0.)then + amt=sqrt(amt) + rap=sign(1.,pptl(3,i))*alog((pptl(4,i)+abs(pptl(3,i)))/amt) + else + rap=1000. + endif + if(pt.gt.0.)then + pt=sqrt(pt) + theta=atan(pt/pptl(3,i)) + if(theta.lt.0.)theta=theta+pi + et=sin(theta)*pptl(4,i) + eta=-log(tan(theta*0.5)) + else + eta=1000. + endif + if(eta.gt.3.2.and.eta.lt.4.8)then + a=polar(px,py) + avcos2p=avcos2p+cos(2*a) + avsin2p=avsin2p+sin(2*a) + elseif(eta.lt.-3.2.and.eta.gt.-4.8)then + a=polar(px,py) + avcos2n=avcos2n+cos(2*a) + avsin2n=avsin2n+sin(2*a) + endif + sumE=sumE+dble(pptl(4,i)) + sumP(1)=sumP(1)+dble(pptl(1,i)) + sumP(2)=sumP(2)+dble(pptl(2,i)) + sumP(3)=sumP(3)+dble(pptl(3,i)) + if(idptl(i).eq.idproj.and.pp.gt.Pmax)then + imax=i + Pmax=pp + endif + if(abs(idptl(i)).ge.100 + $ .and.abs(idptl(i)).lt.10000)then + call idchrg(idptl(i),ch) + CDF=.false. + if(abs(ch).gt.0.1)then +c---multyi---charged ptl multipl + multyi=multyi+1 +c---multy1---charged ptl multipl for central rap + if(abs(rap).le.1.)multy1=multy1+1 + if(abs(eta).le.0.5)multc05=multc05+1 + if(abs(eta).le.1.and.pt.gt.0.4)multc14=multc14+1 + if(abs(eta).le.0.8.and.pt.gt.0.3 + * .and.pt.lt.4.)multc83=multc83+1 + if(abs(eta).lt.2.4)multc24=multc24+1 + if(abs(eta).le.2.5.and.pt.gt.0.5)multc25=multc25+1 + if(abs(eta).le.1)multc1=multc1+1 + if(abs(rap).le.3.15)multc3=multc3+1 +c---multeb---charged ptl multipl for back rap + if(eta.gt.-3.8.and.eta.lt.-2.8)multeb=multeb+1 + if(abs(eta).lt.1.2.and.pt.gt.0.3)then + CDF=.true. !CDF CTC acceptance + elseif(abs(eta).gt.3.2.and.abs(eta).lt.5.9)then + CDF=.true. !CDF BBC acceptance + endif + endif + if(abs(eta).lt.2.4.and.et.gt.0.2)then + CDF=.true. !CDF central and plug calorimeters acceptance + elseif(abs(eta).gt.2.2.and.abs(eta).lt.4.2.and.et.gt.1.)then + CDF=.true. !CDF forward calorimeters acceptance + endif + if(CDF)then + if(eta.le.0)etamn=max(etamn,eta) + if(eta.ge.0)etamx=min(etamx,eta) + endif + endif + if(ilprtg.eq.1)then + if((((abs(idptl(i)).gt.1000.and.abs(idptl(i)).lt.10000) + * .and.abs(idproj).gt.1000).or.(iabs(idptl(i)).gt.100 + * .and.abs(idproj).lt.1000)).and.pptl(4,i) + * .gt.Emax.and.pptl(3,i).gt.0.)then + Emax=pptl(4,i) + idlead=i + endif + else + if(abs(idptl(i)).gt.1000.and.abs(idptl(i)).lt.10000 + * .and.pptl(4,i).gt.Emax.and.pptl(3,i).lt.0.)then + Emax=pptl(4,i) + idlead=i + endif + endif + endif + enddo + if(imax.gt.0)then + sumE=sumE-dble(pptl(4,imax)) + sumP(1)=sumP(1)-dble(pptl(1,imax)) + sumP(2)=sumP(2)-dble(pptl(2,imax)) + sumP(3)=sumP(3)-dble(pptl(3,imax)) + endif + sumP(4)=sqrt(sumP(1)**2+sumP(2)**2+sumP(3)**2) + xsi=sngl((sumE+sumP(4))*(sumE-sumP(4))/dble(engy)**2) + rapgap=etamx-etamn + if(rapgap.gt.100)rapgap=-1. !not defined + phi2pos=polar(avcos2p,avsin2p)/2. + phi2neg=polar(avcos2n,avsin2n)/2. + !write(ifmt,*)'+++++ phi2pos phi2neg +++++ ' + !. ,phi2pos, phi2neg + end + +c---------------------------------------------------------------------- + subroutine jetfind(m,n) +c---------------------------------------------------------------------- +c m = 1 ou 2 (two different definitions) +c n = histogram +c input(jet definition): +c xpara(1,n) ... output (m=1) (0=et, 1=pt) +c xpara(2,n) ... etamin (m=1) +c xpara(3,n) ... etamax (m=1) +c xpara(4,n) ... rmax (m=1) (rmax defining the cone) +c xpara(5,n) ... ichd (m=1) (1=charged, 0=all) +c xpara(6,n) ... output (m=2) (0=et, 1=pt) +c xpara(7,n) ... etamin (m=2) +c xpara(8,n) ... etamax (m=2) +c xpara(9,n) ... rmax (m=2) +c xpara(10,n) .. ichd (m=2) +c output (jet properties): +c ypara(1,n) ... 1 (found) or 0 if not (m=1) +c ypara(2,n) ... et or pt (m=1) +c ypara(3,n) ... eta of center (m=1) +c ypara(4,n) ... phi of center (m=1) +c ypara(5,n) +c ypara(6,n) ... 1 (found) or 0 if not (m=2) +c ypara(7,n) ... et or pt (m=2) +c ypara(8,n) ... eta of center (m=2) +c ypara(9,n) ... phi of center (m=2) +c ypara(10,n) +c---------------------------------------------------------------------- + + include 'epos.inc' + parameter (mxhis=500,mxcontr=500,mxidcd=60,mxtri=50,mxbin=405) + parameter (mypara=10,mxpara=20) + logical ilog,icnx,itrevt,idmod + parameter (mxval=5) + real ptx(mxval),lst(mxval),etax(mxval),phix(mxval) + double precision bin,bbin,zcbin,zbbin + common/bins/bin(mxbin,2,mxhis),zcbin(mxbin,2,mxhis) + $ ,bbin(mxbin,2,mxcontr),itrevt(mxhis),zbbin(mxbin,2,mxcontr) + $ ,nac(mxhis),ilog(mxhis),icnx(mxhis),xinc(mxhis),ncevt(mxhis) + $ ,sval(2,mxhis),valtri(mxtri,mxhis),ntrc(mxtri,mxhis) + $ ,xmin(mxhis),xmax(mxhis),nhis,noweak(mxhis) + $ ,ivar(2,mxhis),inorm(mxhis),nbin(mxhis),nidcod(mxhis) + $ ,idcod(mxidcd,mxhis),idmod(mxidcd,mxhis),ntri(mxhis) + $ ,itri(mxtri,mxhis),xmitri(mxtri,mxhis),xmatri(mxtri,mxhis) + $ ,xmitrp(mxtri,mxhis),xmatrp(mxtri,mxhis),xpara(mxpara,mxhis) + $ ,ypara(mypara,mxhis),lookcontr(mxhis) + $ ,lookcontrx(mxhis),ncontrall,icontrtyp(mxhis),nccevt(mxcontr) + + if(m.ne.1.and.m.ne.2)stop'jetfind: value of m not valid. ' + + ipt = nint(xpara(1+5*(m-1),n)) + etamin= xpara(2+5*(m-1),n) + etamax= xpara(3+5*(m-1),n) + rmax = xpara(4+5*(m-1),n) + ichd = nint(xpara(5+5*(m-1),n)) + + ifound=0 + do l=1,mxval + ptx(l)=0 + lst(l)=0 + etax(l)=0 + phix(l)=0 + enddo + +ctp060829 pp1=0 +ctp060829 pp2=0 +ctp060829 pp3=0 + + do i=maproj+matarg+1,nptl + iok=0 + if(istptl(i).eq.0.and.abs(idptl(i)).lt.10000)iok=1 + if(iok.eq.1)call idchrg(idptl(i),ch) + if(ichd.eq.1.and.nint(ch).eq.0)iok=0 + if(iok.eq.1)then + p1=pptl(1,i) + p2=pptl(2,i) + p3=pptl(3,i) + pt=sqrt(p1**2+p2**2) + if(pt.gt.0)then + eta=sign(1.,p3)*alog((sqrt(p3**2+pt**2)+abs(p3))/pt) + phi=sign(1.,p2)*acos(p1/pt) + else + eta=10000 + phi=0 + endif + do k=1,mxval + iok=1 + if(m.eq.2)then + dphi=phi-ypara(4,n) + if(dphi.lt.-pi)dphi=dphi+2*pi + if(dphi.gt. pi)dphi=dphi-2*pi + if(abs(dphi).lt.pi/2)iok=0 + endif + if(iok.eq.1.and.pt.gt.ptx(k) + & .and.eta.le.etamax.and.eta.ge.etamin)then + do l=mxval,k+1,-1 + ptx(l)=ptx(l-1) + lst(l)=lst(l-1) + etax(l)=etax(l-1) + phix(l)=phix(l-1) + enddo + ptx(k)=pt + lst(k)=i + etax(k)=eta + phix(k)=phi + goto2 + endif + enddo + 2 continue + endif + enddo + + kk=0 + etx=0 + + do k=1,mxval + if(lst(k).ne.0)then + + ifound=1 + et=0 + etaxx=etax(k) + phixx=phix(k) + do j=maproj+matarg+1,nptl + iok=0 + if(istptl(j).eq.0.and.abs(idptl(j)).lt.10000)iok=1 + if(iok.eq.1)call idchrg(idptl(j),ch) + if(ichd.eq.1.and.nint(ch).eq.0)iok=0 + if(iok.eq.1)then + p1=pptl(1,j) + p2=pptl(2,j) + p3=pptl(3,j) + pt=sqrt(p1**2+p2**2) + am=pptl(5,j) + if(pt.gt.0)then + eta=sign(1.,p3)*alog((sqrt(p3**2+pt**2)+abs(p3))/pt) + phi=sign(1.,p2)*acos(p1/pt) + else + eta=-10000 + phi=0 + endif + if(eta.le.etamax.and.eta.ge.etamin)then + deta=eta-etaxx + dphi=phi-phixx + if(dphi.lt.-pi)dphi=dphi+2*pi + if(dphi.gt. pi)dphi=dphi-2*pi + if(deta**2+dphi**2.lt.rmax**2)then + if(ipt.eq.0)then !output is et + et=et+sqrt(pt**2+am**2) + else !output is pt + et=et+pt + endif + endif + endif + endif + enddo + if(et.gt.etx)then + etx=et + kk=k + endif + + endif + enddo + + ypara(1+5*(m-1),n)=ifound + ypara(2+5*(m-1),n)=etx + if(kk.gt.0)then + ypara(3+5*(m-1),n)=etax(kk) + ypara(4+5*(m-1),n)=phix(kk) + endif + return + end + +c---------------------------------------------------------------------- + subroutine fastjet(n) +c---------------------------------------------------------------------- +c n = histogram (to define istptl=100*n of id=9999) +c input: +c xpara(1,n) ... algorithm 1.0=kt, 0.0=Cam/Aachen, -1.0 = anti-kt +c xpara(2,n) ... rapmin for particles used to define jet +c xpara(3,n) ... rapmax for particles used to define jet +c xpara(4,n) ... rmax rmax defining the cone +c xpara(5,n) ... ichd 1=charged, 0=all +c xpara(10,n) .. iorap 0 = rap, >0 = eta +c xpara(12,n) .. ptcheck pt threshhold for checks (default 1e30) +c output: +c new particles (jets four momentum) in particle list triggered +c by : trigger istptl jet jet +c can be used as usual particle to plot pt, phi, etc ... +c---------------------------------------------------------------------- + + include 'epos.inc' + parameter (mxhis=500,mxcontr=500,mxidcd=60,mxtri=50,mxbin=405) + parameter (mypara=10,mxpara=20) + parameter (mxval=10000) + parameter (mxxeta=120,mxxphi=63) + double precision p(4,mxval), rmax, algo,jets(4,mxval) + double precision pav(mxval) + integer jarray1(mxval),jarray2(mxval) + integer iphimtx(mxval),ietamtx(mxval),npmtx(mxxeta,mxxphi) + common/cjcheck/jcheck + logical ilog,icnx,itrevt,idmod + double precision bin,bbin,zcbin,zbbin + real amtx(mxxeta,mxxphi),bmtx(mxxeta,mxxphi) + common/bins/bin(mxbin,2,mxhis),zcbin(mxbin,2,mxhis) + $ ,bbin(mxbin,2,mxcontr),itrevt(mxhis),zbbin(mxbin,2,mxcontr) + $ ,nac(mxhis),ilog(mxhis),icnx(mxhis),xinc(mxhis),ncevt(mxhis) + $ ,sval(2,mxhis),valtri(mxtri,mxhis),ntrc(mxtri,mxhis) + $ ,xmin(mxhis),xmax(mxhis),nhis,noweak(mxhis) + $ ,ivar(2,mxhis),inorm(mxhis),nbin(mxhis),nidcod(mxhis) + $ ,idcod(mxidcd,mxhis),idmod(mxidcd,mxhis),ntri(mxhis) + $ ,itri(mxtri,mxhis),xmitri(mxtri,mxhis),xmatri(mxtri,mxhis) + $ ,xmitrp(mxtri,mxhis),xmatrp(mxtri,mxhis),xpara(mxpara,mxhis) + $ ,ypara(mypara,mxhis),lookcontr(mxhis) + $ ,lookcontrx(mxhis),ncontrall,icontrtyp(mxhis),nccevt(mxcontr) + data ncntfj/0/ + save ncntfj + ncntfj=ncntfj+1 + ptcheck=1e30 + jcheck=0 + kcheck=0 + + algo = dble(xpara(1,n)) + rapmin= xpara(2,n) + rapmax= xpara(3,n) + rmax = dble(xpara(4,n)) + ichd = nint(xpara(5,n)) + iorap = nint(xpara(10,n)) + if(xpara(12,n).gt.1e-5)ptcheck=xpara(12,n) + + mxphi=0 + mxeta=0 + mxphi=63 + if(mxphi.gt.mxxphi)stop'\n\n ERROR 04062012a \n\n' + phimax=2*3.1415927 + delphi=phimax/mxphi + mxeta=iorap + if(mxeta.gt.mxxeta)stop'\n\n ERROR 04062012b \n\n' + etamin=rapmin + etamax=rapmax + deleta=1 + if(mxeta.gt.0)deleta=(etamax-etamin)/mxeta + do np=1,mxval + p(4,np)=0 + enddo + do ieta=1,mxeta + do iphi=1,mxphi + amtx(ieta,iphi)=0 + enddo + enddo + do ieta=1,mxeta + do iphi=1,mxphi + bmtx(ieta,iphi)=0 + enddo + enddo + + do i=maproj+matarg+1,nptl + if(istptl(i).eq.25)then + p1=pptl(1,i) + p2=pptl(2,i) + pt2=p2**2+p1**2 + if(pt2.gt.ptcheck**2)then + jcheck=1 + goto 76 + endif + endif + enddo + 76 continue + + nj=0 + npart=0 + nchi=0 + do i=maproj+matarg+1,nptl +c print*,'fastjet ',iorptl(i),jorptl(i),' ',i,' ' +c . ,idptl(i),istptl(i),ityptl(i),' ' +c . ,sqrt(pptl(1,i)**2+pptl(2,i)**2) + if(istptl(i).eq.0.and.abs(idptl(i)).lt.10000)then + call idchrg(idptl(i),ch) + if(nint(ch).ne.0.or.ichd.eq.0)then + p1=pptl(1,i) + p2=pptl(2,i) + p3=pptl(3,i) + p4=pptl(4,i) + p5=pptl(5,i) + amt=p5**2+p1**2+p2**2 + pt=p2**2+p1**2 + if(iorap.eq.0)then !rap + rap=0. + if(amt.gt.0..and.p4+abs(p3).gt.0.)then + amt=sqrt(amt) + rap=sign(1.,p3)*log((p4+abs(p3))/amt) !not correct if particles off-shell +c rap=0.5*log((p4+p3)/(p4-p3)) !always correct but numerically unstable + endif + elseif(iorap.gt.0)then !eta + rap=0 + if(sqrt(p3**2+pt)+abs(p3).gt.0..and.pt.gt.0.)then + pt=sqrt(pt) + rap=sign(1.,p3)* + . alog((sqrt(p3**2+pt**2)+abs(p3))/pt) + endif + endif + if(rap.ge.rapmin.and.rap.le.rapmax)then !particle used for jet + if(iorap.gt.1)then + eta=rap + ieta=1+(eta-etamin)/deleta + phi=polar( p1 , p2 ) + iphi=1+phi/delphi + if(ieta.ge.1.and.ieta.le.mxeta + . .and.iphi.ge.1.and.iphi.le.mxphi)then + theta=polar(p3,pt) + theta2=2*atan(exp(-eta)) + et=p4*sin(theta) + bmtx(ieta,iphi)=bmtx(ieta,iphi)+et + !print*,'++++ theta1/2 et1/2',theta,theta2,et,pt + !+++++++++++++++++++++++++check+++++++++++++++++++++++++++++++ + if(jcheck.eq.1)then + if(ityptl(i).eq.30)then + iori=iorptl(i) + 77 continue + if(iori.gt.0)then + if(istptl(iori).eq.1)then + !print*,' ',i,iori,iorptl(iori) + iori=iorptl(iori) + goto 77 + endif + if(istptl(iori).ne.29) + . stop'\n\n ERROR 05062012a\n\n' + i1parton=iorptl(iori) + i25=i1parton + 78 i25=i25-1 + if(i25.eq.1)stop'\n\n ERROR 05062012b\n\n' + if(istptl(i25).ne.25)goto 78 + if(istptl(i25-1).ne.25) + . stop'\n\n ERROR 05062012c\n\n' + if(iorptl(i25-1).ne.iorptl(i1parton) + . .and.iorptl(i25-1).ne.0) + . stop'\n\n ERROR 05062012d\n\n' + pt1=sqrt(pptl(1,i25)**2+pptl(2,i25)**2) + pt2=sqrt(pptl(1,i25-1)**2+pptl(2,i25-1)**2) + if(pt1.gt.ptcheck.or.pt2.gt.ptcheck)then + nchi=nchi+1 + !print*,'++++',i,iori,i1parton,iorptl(i1parton) + !. ,i25,pt1,pt2,eta + amtx(ieta,iphi)=amtx(ieta,iphi)+et + endif + endif + endif + endif + !+++++++++++++++++++++++++check+++++++++++++++++++++++++++++++ + endif + else + npart=npart+1 + if(npart.gt.mxval)then + write(ifmt,*) + . 'Too many particles (mxval) for Fastjet ! skip ...' + return + endif + p(1,npart)=dble(p1) + p(2,npart)=dble(p2) + p(3,npart)=dble(p3) + p(4,npart)=dble(p4) + endif + endif + endif + endif + enddo + + !++++++++++++++++++++++++++++check++++++++++++++++++++++++++++++++++++ + if(jcheck.eq.1)then + if(iorap.gt.1.and.nchi.gt.0)then +c call oo2bin(-4, mxxeta,mxxphi,amtx,mxeta,etamin,etamax +c . ,mxphi,0.,phimax,'#eta ','#phi ','E_{T} for ' +c . ,'hadrons from hardest process ') +c call oo2bin(-4, mxxeta,mxxphi,bmtx,mxeta,etamin,etamax +c . ,mxphi,0.,phimax,'#eta ','#phi ','E_{T} for ' +c . ,'all final hadrons ') + endif + endif + !+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ + + if(iorap.gt.1)then + npart=0 + do iphi=1,mxphi + do ieta=1,mxeta + npmtx(ieta,iphi)=0 + et=bmtx(ieta,iphi) + if(et.gt.0.001)then + npart=npart+1 + npmtx(ieta,iphi)=npart + iphimtx(npart)=iphi + ietamtx(npart)=ieta + phi= (iphi-0.5)*delphi + eta=etamin+(ieta-0.5)*deleta + p(1,npart)=et*cos(phi) + p(2,npart)=et*sin(phi) + p(3,npart)=et*sinh(eta) + p(4,npart)=et*cosh(eta) + endif + enddo + enddo + endif + + !++++++++++++++++++++++++++++check++++++++++++++++++++++++++++++++++++ + if(jcheck.eq.1)then + do ieta=1,mxeta + do iphi=1,mxphi + amtx(ieta,iphi)=0 + bmtx(ieta,iphi)=0 + enddo + enddo + k25p=0 + ihitp=0 + i25=0 + do i=maproj+matarg+1,nptl + ihit=0 + k25=0 + if(istptl(i).eq.25)then + k25=1 + p1=pptl(1,i) + p2=pptl(2,i) + p3=pptl(3,i) + pt=p2**2+p1**2 + if(pt.gt.ptcheck**2.or.ihitp.eq.1)then + if(k25p.eq.1.and.ihitp.eq.0)then + nj=nj+1 + ptp=sqrt(ptp) + phi=polar( p1p , p2p ) + eta + . =sign(1.,p3p)*alog((sqrt(p3p**2+ptp**2)+abs(p3p))/ptp) + print*,'ist25 partons: i pt phi eta =' + . ,i-1,ptp, phi, eta + ieta=1+(eta-etamin)/deleta + iphi=1+phi/delphi + amtx(ieta,iphi)=amtx(ieta,iphi)+ptp + endif + nj=nj+1 + pt=sqrt(pt) + phi=polar( p1 , p2 ) + eta=sign(1.,p3)*alog((sqrt(p3**2+pt**2)+abs(p3))/pt) + print*,'ist25 partons: i pt phi eta =',i,pt, phi, eta + ieta=1+(eta-etamin)/deleta + iphi=1+phi/delphi + amtx(ieta,iphi)=amtx(ieta,iphi)+pt + ihit=1 + if(k25p.eq.1)then + i25=i + ior25=iorptl(i25) + ii=i25 + 79 ii=ii+1 + if(istptl(ii).ne.21.or.iorptl(ii).ne.ior25) + . stop'\n\n ERROR 10062012 \n\n' + !print*,iorptl(ii),ii,istptl(ii) + p1=pptl(1,ii) + p2=pptl(2,ii) + p3=pptl(3,ii) + pt=p2**2+p1**2 + pt=sqrt(pt) + phi=polar( p1 , p2 ) + eta=sign(1.,p3)*alog((sqrt(p3**2+pt**2)+abs(p3))/pt) + ieta=1+(eta-etamin)/deleta + iphi=1+phi/delphi + if(ieta.ge.1.and.ieta.le.mxeta + . .and.iphi.ge.1.and.iphi.le.mxphi) + . bmtx(ieta,iphi)=bmtx(ieta,iphi)+pt + if(istptl(ii+1).eq.21.and.iorptl(ii+1).eq.ior25)goto 79 + !print*,iorptl(ii+1),ii+1,istptl(ii+1) + endif + endif + p1p=p1 + p2p=p2 + p3p=p3 + ptp=pt + endif + k25p=k25 + ihitp=ihit + enddo + if(iorap.gt.1.and.nj.gt.0)then +c call oo2bin(-4, mxxeta,mxxphi,amtx,mxeta,etamin,etamax +c . ,mxphi,0.,phimax,'#eta ','#phi ','E_{T} for ' +c . ,'direct partons from hardest process') +c call oo2bin(-4, mxxeta,mxxphi,bmtx,mxeta,etamin,etamax +c . ,mxphi,0.,phimax,'#eta ','#phi ','E_{T} for ' +c . ,'final partons from hardest process ') + endif + endif + !+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ + + if(npart.le.0)goto 1001 !return + + do ieta=1,mxeta + do iphi=1,mxphi + amtx(ieta,iphi)=0 + bmtx(ieta,iphi)=0 + enddo + enddo + + !run the clustering with a pp generalised-kt + !sequential recombination alg + ipri=1 + if(ncntfj.gt.1)ipri=0 + if(ipri.eq.1)write(ifmt,'(a,$)')'fastjet:' + if(ipri.eq.1)write(ifmt,*)npart,' particles' + !$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$ + call fastjetppgenkt(p,npart,rmax,algo,jets,njets, + & jarray1,jarray2,ipri) + !$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$ + + if(njets.le.0)goto 1001 !return + if(.not.(iorap.gt.1))goto 1002 + + iconp=0 + do i=1,njets + iprx=jcheck + if(i.gt.0)iprx=0 !!!!!!!!!!!!! + p1=sngl(jets(1,i)) !jet px momentum + p2=sngl(jets(2,i)) !jet py momentum + p3=sngl(jets(3,i)) !jet pz momentum + pt=sqrt(p2**2+p1**2) + phi=polar( p1 , p2 ) + eta=sign(1.,p3)*alog((sqrt(p3**2+pt**2)+abs(p3))/pt) + if(iprx.eq.1)write(ifmt,'(a,i4,3f7.2,$)') + . ' +++jet i pt, phi, eta',i,pt, phi, eta + if(iprx.eq.1)write(ifmt,'(i7,a,$)'),jarray1(i)-iconp,' ' + p1su=0 + p2su=0 + etsu=0 + etmx=0 + do ij=iconp+1,jarray1(i) + nco=jarray1(i)-iconp + nij=jarray2(ij) + et=sqrt(p(1,nij)**2+p(2,nij)**2) + etsu=etsu+et + etmx=max(etmx,et) + !write(ifmt,'(f6.1,$)')et + p1su=p1su+p(1,nij) + p2su=p2su+p(2,nij) + enddo + ptxx=sqrt(p1su**2+p2su**2) + if(abs(pt-ptxx).gt.1e-4)then + print*,'pt ptxx diff',pt,ptxx,abs(pt-ptxx) + stop'\n\n ERROR 10062012b \n\n' + endif + dd=etmx/etsu*nco + if(iprx.eq.1)write(ifmt,*)' ',dd + if(dd.gt.5)then + do ij=iconp+1,jarray1(i) + nij=jarray2(ij) + et=sqrt(p(1,nij)**2+p(2,nij)**2) + iphi=iphimtx(nij) + ieta=ietamtx(nij) + if(iprx.eq.1)print*,'+++++',i,ieta,iphi,et + bmtx(ieta,iphi)=1. + enddo + endif + iconp=jarray1(i) + enddo + !++++++++++++++++++++++++++++check++++++++++++++++++++++++++++++ +c if(jcheck.eq.1.and.kcheck.eq.1) +c .call oo2bin(-4, mxxeta,mxxphi,bmtx,mxeta,etamin,etamax +c . ,mxphi,0.,phimax,'#eta ','#phi ',' ' +c . ,'excluded towers (D>5) ') + !+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ + + do ieta=1,mxeta + avpt=0 + do iphi=1,mxphi + np=npmtx(ieta,iphi) + if(np.gt.0)then + p1=p(1,np) + p2=p(2,np) + p3=p(3,np) + p4=p(4,np) + pt=sqrt(p2**2+p1**2) + if(nint(bmtx(ieta,iphi)).ne.1)then + avpt=avpt+pt + else + !if(jcheck.eq.1)write(ifmt,*)'excl',ieta,iphi,pt + endif + endif + enddo + avpt=avpt/mxphi + do iphi=1,mxphi + np=npmtx(ieta,iphi) + if(np.gt.0)then + pav(np)=avpt + amtx(ieta,iphi)=pav(np) + endif + enddo + enddo + !++++++++++++++++++++++++++++check++++++++++++++++++++++++++++++ + !if(jcheck.eq.1) + !.call oo2bin(-4, mxxeta,mxxphi,amtx,mxeta,etamin,etamax + !. ,mxphi,0.,phimax,'#eta ','#phi ',' ' + !. ,'average pt (excl D>5) ') + !+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ + + iconp=0 + do i=1,njets + p1nsu=0 + p2nsu=0 + p3nsu=0 + do ij=iconp+1,jarray1(i) + nij=jarray2(ij) + p1=p(1,nij) + p2=p(2,nij) + p3=p(3,nij) + pt=sqrt(p2**2+p1**2) + ptav=pav(nij) + ptnew=pt-ptav + iphi=iphimtx(nij) + ieta=ietamtx(nij) + phi= (iphi-0.5)*delphi + eta=etamin+(ieta-0.5)*deleta + p1n=ptnew*cos(phi) + p2n=ptnew*sin(phi) + p3n=ptnew*sinh(eta) + p4n=abs(ptnew)*cosh(eta) + p1nsu=p1nsu+p1n + p2nsu=p2nsu+p2n + p3nsu=p3nsu+p3n + enddo + p1=p1nsu + p2=p2nsu + p3=p3nsu + p4=sqrt(p1**2+p2**2+p3**2) + pt=sqrt(p2**2+p1**2) + phi=polar( p1 , p2 ) + eta=sign(1.,p3)*alog((sqrt(p3**2+pt**2)+abs(p3))/pt) + imark=0 + if(pt.gt.25)then + do ij=iconp+1,jarray1(i) + nij=jarray2(ij) + iphi=iphimtx(nij) + ieta=ietamtx(nij) + bmtx(ieta,iphi)=1. + enddo + imark=999999 + endif + !if(jcheck.eq.1.and.i.le.18)then + !print*,phi,' ',eta,' ',pt,' ',imark + !endif + iconp=jarray1(i) + enddo + !++++++++++++++++++++++++++++check++++++++++++++++++++++++++++++ +c if(jcheck.eq.1.and.kcheck.eq.1) +c .call oo2bin(-4, mxxeta,mxxphi,bmtx,mxeta,etamin,etamax +c . ,mxphi,0.,phimax,'#eta ','#phi ',' ' +c . ,'excluded towers (D>5 & pt>25) ') + !+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ + + do ieta=1,mxeta + do iphi=1,mxphi + amtx(ieta,iphi)=0 + enddo + enddo + + do ieta=1,mxeta + avpt=0 + do iphi=1,mxphi + np=npmtx(ieta,iphi) + if(np.gt.0)then + p1=p(1,np) + p2=p(2,np) + p3=p(3,np) + p4=p(4,np) + pt=sqrt(p2**2+p1**2) + if(nint(bmtx(ieta,iphi)).ne.1)then + avpt=avpt+pt + else + !if(jcheck.eq.1)write(ifmt,*)'excl',ieta,iphi,pt + endif + endif + enddo + avpt=avpt/mxphi + do iphi=1,mxphi + np=npmtx(ieta,iphi) + if(np.gt.0)then + pav(np)=avpt + amtx(ieta,iphi)=pav(np) + endif + enddo + enddo + !++++++++++++++++++++++++++++check++++++++++++++++++++++++++++++ + !if(jcheck.eq.1) + !.call oo2bin(-4, mxxeta,mxxphi,amtx,mxeta,etamin,etamax + !. ,mxphi,0.,phimax,'#eta ','#phi ',' ' + !. ,'average pt (excl D>5 & pt>25) ') + !+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ + + do ieta=1,mxeta + do iphi=1,mxphi + amtx(ieta,iphi)=0 + enddo + enddo + + nptl0=nptl+1 + iconp=0 + do i=1,njets + p1j=sngl(jets(1,i)) !jet px momentum + p2j=sngl(jets(2,i)) !jet py momentum + p3j=sngl(jets(3,i)) !jet pz momentum + p4j=sngl(jets(4,i)) !jet E momentum + ptj=sqrt(p2j**2+p1j**2) + phij=polar( p1j , p2j ) + etaj=sign(1.,p3j)*alog((sqrt(p3j**2+ptj**2)+abs(p3j))/ptj) + p1su=0 + p2su=0 + p3su=0 + p1nsu=0 + p2nsu=0 + p3nsu=0 + do ij=iconp+1,jarray1(i) + nij=jarray2(ij) + p1=p(1,nij) + p2=p(2,nij) + p3=p(3,nij) + p1su=p1su+p1 + p2su=p2su+p2 + p3su=p3su+p3 + pt=sqrt(p2**2+p1**2) + ptav=pav(nij) + ptnew=pt-ptav + iphi=iphimtx(nij) + ieta=ietamtx(nij) + phi= (iphi-0.5)*delphi + eta=etamin+(ieta-0.5)*deleta + p1n=ptnew*cos(phi) + p2n=ptnew*sin(phi) + p3n=ptnew*sinh(eta) + p4n=abs(ptnew)*cosh(eta) + p1nsu=p1nsu+p1n + p2nsu=p2nsu+p2n + p3nsu=p3nsu+p3n + !if(jcheck.eq.1.and.i.le.5)print*,phi,eta,pt,ptnew + enddo + p1=p1nsu + p2=p2nsu + p3=p3nsu + p4=sqrt(p1**2+p2**2+p3**2) + pt=sqrt(p2**2+p1**2) + nptl=nptl+1 + istptl(nptl)=100*n !used for trigger + idptl(nptl)=9999 !jet ID + pptl(1,nptl)=p1 + pptl(2,nptl)=p2 + pptl(3,nptl)=p3 + pptl(4,nptl)=p4 + pptl(5,nptl)=sqrt(p1**2+p2**2) + phi=polar( p1 , p2 ) + eta=sign(1.,p3)*alog((sqrt(p3**2+pt**2)+abs(p3))/pt) + ieta=1+(eta-etamin)/deleta + iphi=1+phi/delphi + if(jcheck.eq.1.and.i.le.10)then + !print*,i,p1su-p1j,p2su-p2j,p3su-p3j + !print*,i,p1j,p1nsu,' ',p2j,p2nsu,' ',p3j,p3nsu + !print*,phij,phi,' ',etaj,eta,' ',ptj,pt + !print*,phi,' ',eta,' ',pt + endif + if(ieta.ge.1.and.ieta.le.mxeta + . .and.iphi.ge.1.and.iphi.le.mxphi) + . amtx(ieta,iphi)=amtx(ieta,iphi)+pt + iconp=jarray1(i) + enddo + !++++++++++++++++++++++++++++check++++++++++++++++++++++++++++++ + !if(jcheck.eq.1) + !.call oo2bin(-4, mxxeta,mxxphi,amtx,mxeta,etamin,etamax + !. ,mxphi,0.,phimax,'#eta ','#phi ','E_{T} for ' + !. ,'jets ') + !+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ + + do ieta=1,mxeta + do iphi=1,mxphi + amtx(ieta,iphi)=0 + enddo + enddo + + do np=nptl0,nptl-1 + nmax=np + do mp=np+1,nptl + if(pptl(5,mp).gt.pptl(5,nmax))nmax=mp + enddo + if(nmax.gt.np)then + p1xx=pptl(1,nmax) + p2xx=pptl(2,nmax) + p3xx=pptl(3,nmax) + p4xx=pptl(4,nmax) + p5xx=pptl(5,nmax) + do mp=nmax-1,np,-1 + pptl(1,mp+1)=pptl(1,mp) + pptl(2,mp+1)=pptl(2,mp) + pptl(3,mp+1)=pptl(3,mp) + pptl(4,mp+1)=pptl(4,mp) + pptl(5,mp+1)=pptl(5,mp) + enddo + pptl(1,np)=p1xx + pptl(2,np)=p2xx + pptl(3,np)=p3xx + pptl(4,np)=p4xx + pptl(5,np)=p5xx + endif + if(jcheck.eq.1.and.np-nptl0+1.le.10)then + p1=pptl(1,np) + p2=pptl(2,np) + p3=pptl(3,np) + pt=pptl(5,np) + phi=polar( p1 , p2 ) + eta=sign(1.,p3)*alog((sqrt(p3**2+pt**2)+abs(p3))/pt) + if(np-nptl0+1.le.10) + . print*,phi,' ',eta,' ',pt + ieta=1+(eta-etamin)/deleta + iphi=1+phi/delphi + if(ieta.ge.1.and.ieta.le.mxeta + . .and.iphi.ge.1.and.iphi.le.mxphi) + . amtx(ieta,iphi)=amtx(ieta,iphi)+pt + endif + enddo + !++++++++++++++++++++++++++++check++++++++++++++++++++++++++++++ +c if(jcheck.eq.1) +c .call oo2bin(-4, mxxeta,mxxphi,amtx,mxeta,etamin,etamax +c . ,mxphi,0.,phimax,'#eta ','#phi ','E_{T} for ' +c . ,'jets ') + !+++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++++ + + if(ish.ge.5)call alist('list after fastjet&',nptl0,nptl) + return + + 1002 nptl0=nptl+1 + do i=1,njets + p1=sngl(jets(1,i)) !jet px momentum + p2=sngl(jets(2,i)) !jet py momentum + p3=sngl(jets(3,i)) !jet pz momentum + p4=sngl(jets(4,i)) !jet E momentum + pt=sqrt(p2**2+p1**2) + nptl=nptl+1 + istptl(nptl)=100*n !used for trigger + idptl(nptl)=9999 !jet ID + pptl(1,nptl)=p1 + pptl(2,nptl)=p2 + pptl(3,nptl)=p3 + pptl(4,nptl)=p4 + pptl(5,nptl)=sqrt(p1**2+p2**2) + phi=polar( p1 , p2 ) + eta=sign(1.,p3)*alog((sqrt(p3**2+pt**2)+abs(p3))/pt) + ieta=1+(eta-etamin)/deleta + iphi=1+phi/delphi + enddo + if(ish.ge.5)call alist('list after fastjet&',nptl0,nptl) + return + + 1001 continue + return + end + + +c---------------------------------------------------------------------- + subroutine jetevent(n) +c---------------------------------------------------------------------- +c uses jets found with fastjet (MANDATORY: activate fastjet BEFORE) +c input: +c n = histogram +c xpara(6,n) ... pt_min +c xpara(7,n) ... njet (number of jets required) +c xpara(8,n) ... delta_phi (0, not used, >0 uses delta_phi-pi (-0 if <0) +c xpara(9,n) ... pt_min_first if >0.001 +c xpara(11,n) .. pt_max_first if >0.001 +c output: +c ypara(1,n) ... 1 or 0 (valid event or not) +c ypara(2,n) ... ajt (Asymmetry parameter A_j) +c ypara(3,n) ... fjt (DeltaPhi) +c ypara(4,n) ... pjt (ptSubleading/ptLeading) +c---------------------------------------------------------------------- + + include 'epos.inc' + parameter (mxhis=500,mxcontr=500,mxidcd=60,mxtri=50,mxbin=405) + parameter (mypara=10,mxpara=20) + common/cjcheck/jcheck + logical ilog,icnx,itrevt,idmod + double precision bin,bbin,zcbin,zbbin + common/bins/bin(mxbin,2,mxhis),zcbin(mxbin,2,mxhis) + $ ,bbin(mxbin,2,mxcontr),itrevt(mxhis),zbbin(mxbin,2,mxcontr) + $ ,nac(mxhis),ilog(mxhis),icnx(mxhis),xinc(mxhis),ncevt(mxhis) + $ ,sval(2,mxhis),valtri(mxtri,mxhis),ntrc(mxtri,mxhis) + $ ,xmin(mxhis),xmax(mxhis),nhis,noweak(mxhis) + $ ,ivar(2,mxhis),inorm(mxhis),nbin(mxhis),nidcod(mxhis) + $ ,idcod(mxidcd,mxhis),idmod(mxidcd,mxhis),ntri(mxhis) + $ ,itri(mxtri,mxhis),xmitri(mxtri,mxhis),xmatri(mxtri,mxhis) + $ ,xmitrp(mxtri,mxhis),xmatrp(mxtri,mxhis),xpara(mxpara,mxhis) + $ ,ypara(mypara,mxhis),lookcontr(mxhis) + $ ,lookcontrx(mxhis),ncontrall,icontrtyp(mxhis),nccevt(mxcontr) + dimension inumj(10000) + common/cncntje/ncntje + ncntje=ncntje+1 + + ypara(1,n)=0 + njet=nint(xpara(7,n)) + numj=0 + ! count the number of jets with Et>Et_min in the event + do i=maproj+matarg+1,nptl + if(istptl(i).eq.100*n)then + if(pptl(5,i).ge.xpara(6,n))then + if(numj.eq.0.and.xpara(9,n).gt.0.001)then + if(pptl(5,i).lt.xpara(9,n))goto 999 + endif + if(numj.eq.0.and.xpara(11,n).gt.0.001)then + if(pptl(5,i).gt.xpara(11,n))goto 999 + endif + numj=numj+1 + if(numj.le.10000)then + !save position of jet in particle list + inumj(numj)=i + else + write(ifmt,*) + . "Too many jets in jetevent, last are skipped!" + endif + endif + endif + enddo + !write(ifch,*)"jetevent",numj,abs(xpara(8,n)),inumj(1),inumj(2) + !if enough jets, analyse them + if(numj.lt.njet)goto 999 + j=inumj(1) !fastjet provides jet list ordered in pt + px=pptl(1,j) + py=pptl(2,j) + pt1=pptl(5,j) + phi1=polar(px,py) + j=inumj(2) + px=pptl(1,j) + py=pptl(2,j) + pt2=pptl(5,j) + phi2=polar(px,py) + if(abs(xpara(8,n)).gt.0.001)then + phi0=pi + if(xpara(8,n).lt.0.)phi0=0. + if(abs(abs(phi1-phi2)-phi0).gt.abs(xpara(8,n)))goto 999 + endif + ypara(1,n)=1 !valid event + ajt=0 + if(pt1+pt2.gt.0.)then + ajt=(pt1-pt2)/(pt1+pt2) + endif + ypara(2,n)=ajt + fjt=abs(phi1-phi2) + if(fjt.gt.3.14159)fjt=2*3.14159-fjt + ypara(3,n)=fjt + pjt=0 + if(pt1.gt.0.)pjt=pt2/pt1 + ypara(4,n)=pjt + iprije=0 + if(ncntje.eq.1.and.iprije.eq.1) + . write(ifmt,'(a,2f8.2,3x,3f7.2)') + . ' +++pair pt1 pt2 ajt fjt pjt =',pt1,pt2,ajt,fjt,pjt + return + 999 continue + end + +c---------------------------------------------------------------------- + subroutine hardevent(n) +c---------------------------------------------------------------------- +c n = histogram +c input(jet event conditions): +c xpara(2,n) ... pt1 +c xpara(3,n) ... pt2 +c xpara(4,n) ... absetamax +c xpara(5,n) ... rmax (r=sqrt(deltaeta**2+deltaphi**2)) +c xpara(6,n) ... Et_min +c output (jet event found or not): +c ypara(1,n) ... 1 (found) or 0 if not +c---------------------------------------------------------------------- + + include 'epos.inc' + parameter (mxhis=500,mxcontr=500,mxidcd=60,mxtri=50,mxbin=405) + parameter (mypara=10,mxpara=20) + logical ilog,icnx,itrevt,idmod + double precision bin,bbin,zcbin,zbbin + common/bins/bin(mxbin,2,mxhis),zcbin(mxbin,2,mxhis) + $ ,bbin(mxbin,2,mxcontr),itrevt(mxhis),zbbin(mxbin,2,mxcontr) + $ ,nac(mxhis),ilog(mxhis),icnx(mxhis),xinc(mxhis),ncevt(mxhis) + $ ,sval(2,mxhis),valtri(mxtri,mxhis),ntrc(mxtri,mxhis) + $ ,xmin(mxhis),xmax(mxhis),nhis,noweak(mxhis) + $ ,ivar(2,mxhis),inorm(mxhis),nbin(mxhis),nidcod(mxhis) + $ ,idcod(mxidcd,mxhis),idmod(mxidcd,mxhis),ntri(mxhis) + $ ,itri(mxtri,mxhis),xmitri(mxtri,mxhis),xmatri(mxtri,mxhis) + $ ,xmitrp(mxtri,mxhis),xmatrp(mxtri,mxhis),xpara(mxpara,mxhis) + $ ,ypara(mypara,mxhis),lookcontr(mxhis) + $ ,lookcontrx(mxhis),ncontrall,icontrtyp(mxhis),nccevt(mxcontr) + + ypara(1,n)=0 + do i=maproj+matarg+1,nptl + if(abs(idptl(i)).ge.100.and.abs(idptl(i)).lt.10000. + $ and.istptl(i).eq.0)then + call idchrg(idptl(i),ch) + if(abs(ch).gt.0.1)then + p1=pptl(1,i) + p2=pptl(2,i) + p3=pptl(3,i) + pt=sqrt(p1**2+p2**2) + if(pt.gt.0)then + eta=sign(1.,p3)*alog((sqrt(p3**2+pt**2)+abs(p3))/pt) + phi=sign(1.,p2)*acos(p1/pt) + else + eta=10000 + phi=0 + endif + if(pt.ge.xpara(2,n).and.abs(eta).lt.xpara(4,n))then + et1=pptl(4,i)*pt/sqrt(p3**2+pt**2) + do j=maproj+matarg+1,nptl + if(j.ne.i + $ .and.abs(idptl(j)).ge.100.and.abs(idptl(j)).lt.10000. + $ .and.istptl(j).eq.0)then + call idchrg(idptl(j),ch) + if(abs(ch).gt.0.1.and.abs(idptl(j)).ge.100 + $ .and.abs(idptl(j)).lt.10000.and.istptl(j).eq.0)then + p1=pptl(1,j) + p2=pptl(2,j) + p3=pptl(3,j) + pt=sqrt(p1**2+p2**2) + if(pt.gt.0)then + etax=sign(1.,p3)*alog((sqrt(p3**2+pt**2)+abs(p3))/pt) + phix=sign(1.,p2)*acos(p1/pt) + else + etax=-10000 + phix=0 + endif + if(pt.ge.xpara(3,n).and.abs(etax).lt.xpara(4,n))then + deta=eta-etax + dphi=phi-phix + if(dphi.lt.-pi)dphi=dphi+2*pi + if(dphi.gt. pi)dphi=dphi-2*pi + if(deta**2+dphi**2.lt.xpara(5,n)**2)then + et2=pptl(4,j)*pt/sqrt(p3**2+pt**2) + if(et1+et2.gt.xpara(6,n))then + ypara(1,n)=1 + goto1 + endif + endif + endif + endif + endif + enddo + endif + endif + endif + enddo + + 1 continue + return + end + +c---------------------------------------------------------------------- + subroutine corrtrig(n) +c---------------------------------------------------------------------- +c n = histogram +c input(trigger conditions): +c xpara(1,n) ... mode (0,1) +c xpara(2,n) ... ptmin +c xpara(3,n) ... ptmax +c xpara(4,n) ... etamin +c xpara(5,n) ... etamax +c xpara(6,n) ... +c xpara(7,n) ... +c output (triggered particle (the one with highest pt if there are several)): +c ypara(1,n) ... iptl or 0 if no particle found +c ypara(2,n) ... phi of particle +c ypara(3,n) ... phi_null +c ypara(4,n) ... pt lead +c---------------------------------------------------------------------- + + include 'epos.inc' + parameter (mxhis=500,mxcontr=500,mxidcd=60,mxtri=50,mxbin=405) + parameter (mypara=10,mxpara=20) + logical ilog,icnx,itrevt,idmod + double precision bin,bbin,zcbin,zbbin + common/bins/bin(mxbin,2,mxhis),zcbin(mxbin,2,mxhis) + $ ,bbin(mxbin,2,mxcontr),itrevt(mxhis),zbbin(mxbin,2,mxcontr) + $ ,nac(mxhis),ilog(mxhis),icnx(mxhis),xinc(mxhis),ncevt(mxhis) + $ ,sval(2,mxhis),valtri(mxtri,mxhis),ntrc(mxtri,mxhis) + $ ,xmin(mxhis),xmax(mxhis),nhis,noweak(mxhis) + $ ,ivar(2,mxhis),inorm(mxhis),nbin(mxhis),nidcod(mxhis) + $ ,idcod(mxidcd,mxhis),idmod(mxidcd,mxhis),ntri(mxhis) + $ ,itri(mxtri,mxhis),xmitri(mxtri,mxhis),xmatri(mxtri,mxhis) + $ ,xmitrp(mxtri,mxhis),xmatrp(mxtri,mxhis),xpara(mxpara,mxhis) + $ ,ypara(mypara,mxhis),lookcontr(mxhis) + $ ,lookcontrx(mxhis),ncontrall,icontrtyp(mxhis),nccevt(mxcontr) + + pt0=xpara(2,n) + + do i=maproj+matarg+1,nptl + if(abs(idptl(i)).ge.100.and.abs(idptl(i)).lt.10000. + $ and.istptl(i).eq.0)then + call idchrg(idptl(i),ch) + if(abs(ch).gt.0.1)then + p1=pptl(1,i) + p2=pptl(2,i) + p3=pptl(3,i) + pt=sqrt(p1**2+p2**2) + pt=max(pt,1e-20) + eta=sign(1.,p3)*alog((sqrt(p3**2+pt**2)+abs(p3))/pt) + phi=sign(1.,p2)*acos(p1/pt) + if(pt.ge.pt0.and.pt.le.xpara(3,n).and.eta.gt.xpara(4,n) + $ .and.eta.lt.xpara(5,n))then + pt0=pt + ypara(1,n)=i + ypara(2,n)=phi + ypara(4,n)=pt + endif + endif + endif + enddo + ypara(3,n)=-0.5 + if(nint(xpara(1,n)).eq.1)ypara(3,n)=0.0 + + return + end + +c---------------------------------------------------------------------- + subroutine caltrig(n) +c---------------------------------------------------------------------- +c n = histogram +c input(trigger conditions): +c xpara(1,n) ... mode (0,1,2) (one eta side, 2 eta side independently or, +c 2 eta side simultaneously) +c xpara(2,n) ... etamin +c xpara(3,n) ... etamax +c xpara(4,n) ... 0 all or 1 charged or 2 charged + photons +c xpara(5,n) ... ptmin +c xpara(6,n) ... ptmax +c output (triggered energy): +c ypara(1,n) ... max E for a particle in eta range (per side) +c---------------------------------------------------------------------- + + include 'epos.inc' + parameter (mxhis=500,mxcontr=500,mxidcd=60,mxtri=50,mxbin=405) + parameter (mypara=10,mxpara=20) + logical ilog,icnx,itrevt,idmod + double precision bin,bbin,zcbin,zbbin + common/bins/bin(mxbin,2,mxhis),zcbin(mxbin,2,mxhis) + $ ,bbin(mxbin,2,mxcontr),itrevt(mxhis),zbbin(mxbin,2,mxcontr) + $ ,nac(mxhis),ilog(mxhis),icnx(mxhis),xinc(mxhis),ncevt(mxhis) + $ ,sval(2,mxhis),valtri(mxtri,mxhis),ntrc(mxtri,mxhis) + $ ,xmin(mxhis),xmax(mxhis),nhis,noweak(mxhis) + $ ,ivar(2,mxhis),inorm(mxhis),nbin(mxhis),nidcod(mxhis) + $ ,idcod(mxidcd,mxhis),idmod(mxidcd,mxhis),ntri(mxhis) + $ ,itri(mxtri,mxhis),xmitri(mxtri,mxhis),xmatri(mxtri,mxhis) + $ ,xmitrp(mxtri,mxhis),xmatrp(mxtri,mxhis),xpara(mxpara,mxhis) + $ ,ypara(mypara,mxhis),lookcontr(mxhis) + $ ,lookcontrx(mxhis),ncontrall,icontrtyp(mxhis),nccevt(mxcontr) + logical cont + double precision Eforw,Eback + + mode=nint(xpara(1,n)) + etamin=xpara(2,n) + etamax=xpara(3,n) + ptmin=xpara(5,n) + ptmax=xpara(6,n) + ichrd=nint(xpara(4,n)) + Eforw=0.d0 + Eback=0.d0 + etaf=1000. + etab=1000. + + do i=maproj+matarg+1,nptl + if(istptl(i).eq.0)then + call idchrg(idptl(i),ch) + if(ichrd.ge.1)then + cont=abs(ch).gt.0.1.or.(idptl(i).eq.10.and.ichrd.eq.2) + else + cont=.true. + endif + if(cont)then + p1=pptl(1,i) + p2=pptl(2,i) + p3=pptl(3,i) + pt=sqrt(p1**2+p2**2) + pt=max(pt,1e-20) + if(pt.gt.ptmin.and.pt.lt.ptmax)then + eta=sign(1.,p3)*alog((sqrt(p3**2+pt**2)+abs(p3))/pt) +c phi=sign(1.,p2)*acos(p1/pt) + if(eta.gt.etamin.and.eta.lt.etamax) + * Eforw=max(Eforw,dble(pptl(4,i))) + if(eta.lt.-etamin.and.eta.gt.-etamax) + * Eback=max(Eback,dble(pptl(4,i))) + if(eta.le.etamax)etaf=min(etaf,etamax-eta) + if(eta.ge.etamin)etab=min(etab,eta-etamin) + endif + endif + endif + enddo + if(mode.eq.0)then + ypara(1,n)=sngl(Eforw) + elseif(mode.eq.1)then + ypara(1,n)=sngl(max(Eforw,Eback)) + elseif(mode.eq.2)then + ypara(1,n)=sngl(min(Eforw,Eback)) + endif + ypara(2,n)=etaf + ypara(3,n)=etab + ypara(4,n)=max(etab,etaf) +c if(typevt.eq.3)print *,mode, ypara(1,n),Eforw,Eback,etaf,etab +c print *,typevt,mode, ypara(1,n),Eforw,Eback,etaf,etab + + + return + end + +c---------------------------------------------------------------------- diff --git a/modules/epos/epos-xpr-lhc.f b/modules/epos/epos-xpr-lhc.f new file mode 100644 index 0000000000000000000000000000000000000000..eebbf64aab29c7c8aaf1f6ad154e63a283c236b1 --- /dev/null +++ b/modules/epos/epos-xpr-lhc.f @@ -0,0 +1,5992 @@ +c---------------------------------------------------------------------- + double precision function xDfit(zz,i1,i2,s,xp,xm,b) +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + include 'epos.incsem' + + + + xDfit=0.d0 + do i=max(0,i1),i2 + call GfunPar(zz,zz,1,i,b,s,alp,bet,betp,epsp,epst,epss,gamv) + if(i1.ge.0)then + corp=alppar-epsp + cort=alppar-epst + cors=-epss + else + corp=alppar + cort=alppar + cors=0. + endif +c write(ifch,*)'xdfit',i,zz,b,s,alp,bet,betp,epsp,epst,epss + xDfit=xDfit+dble(alp*xp**(bet+corp)*xm**(betp+cort)*s**cors) + enddo + return + end + + +c---------------------------------------------------------------------- + subroutine xFitD1 +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + double precision x,y,Dsoftshval,om51p,xminr,tmp,xtmp,xDfit + character chenergy*12 + + nptg=50 !number of point for the graphs + iii=nint(xpar1) + biniDf=xpar2 !value of biniDf (impact parameter) + y=dble(xpar3) !value of y (rapidity) + xtmp=xmaxDf + xmaxDf=dexp(-2.d0*y) + zz=xpar7 + + chenergy='E= ' + if (engy.ge.10000.) then + write(chenergy(4:8),'(I5)')int(engy) + ke=10 + elseif (engy.ge.1000.) then + write(chenergy(4:7),'(I4)')int(engy) + ke=9 + elseif (engy.ge.100.) then + write(chenergy(4:6),'(I3)')int(engy) + ke=8 + elseif (engy.ge.10.) then + write(chenergy(4:5),'(I2)')int(engy) + ke=7 + else + write(chenergy(4:4),'(I1)')int(engy) + ke=6 + endif + chenergy(ke:ke+2)='GeV' + + xminr=1.d0/dble(engy**2) !value of xminr for plotting the function + + if(iii/10.eq.1)then !................................................... + + write(ifhi,'(a)')'!----------------------------------------------' + write(ifhi,'(a)')'! D exact all (blue) ' + write(ifhi,'(a)')'!----------------------------------------------' + + write(ifhi,'(a)')'openhisto name DExact-'//chenergy(4:ke-2) + write(ifhi,'(a)') 'htyp lbu' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange .01 auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,a)') 'text 0.65 0.9 "exact" ' + write(ifhi,'(3a)') 'text 0.05 0.9 "',chenergy,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.8 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.7 "y=',y,'"' + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + tmp=Dsoftshval(real(x)*smaxDf,x,y,biniDf,0) + write(ifhi,*) x,tmp + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + + write(ifhi,'(a)')'!----------------------------------------------' + write(ifhi,'(a)')'! D exact soft (red dot) ' + write(ifhi,'(a)')'!----------------------------------------------' + + write(ifhi,'(a)')'openhisto name DExactSoft-'//chenergy(4:ke-2) + write(ifhi,'(a)') 'htyp lra' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange .01 auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(3a)') 'text 0.05 0.9 "',chenergy,'"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.8 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + write(ifhi,*) x,2.d0*om51p(real(x)*smaxDf,x,y,biniDf,0) + & /(x**dble(-alppar)*dble(chad(iclpro)*chad(icltar))) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! D exact sea-sea (yellow-dot) ' + write(ifhi,'(a)')'!---------------------------------------------' + + write(ifhi,'(a)')'openhisto name DExactSemi-'//chenergy(4:ke-2) + write(ifhi,'(a)') 'htyp lya' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange .01 auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(3a)') 'text 0.05 0.9 "',chenergy,'"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.8 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + tmp=2.d0*om51p(real(x)*smaxDf,x,y,biniDf,1) + & /(x**dble(-alppar)*dble(chad(iclpro)*chad(icltar))) + write(ifhi,*) x,tmp + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! D exact semi (blue dot) ' + write(ifhi,'(a)')'!---------------------------------------------' + + write(ifhi,'(a)')'openhisto name DExactVal-'//chenergy(4:ke-2) + write(ifhi,'(a)') 'htyp lba' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange .01 auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(3a)') 'text 0.05 0.9 "',chenergy,'"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.8 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + tmp=2.d0*(om51p(real(x)*smaxDf,x,y,biniDf,2) + & +om51p(real(x)*smaxDf,x,y,biniDf,1) + & +om51p(real(x)*smaxDf,x,y,biniDf,3) + & +om51p(real(x)*smaxDf,x,y,biniDf,4)) + & /(x**dble(-alppar)*dble(chad(iclpro)*chad(icltar))) + write(ifhi,*) x,tmp + enddo + + write(ifhi,'(a)') ' endarray' + + if(iii.eq.11)then + write(ifhi,'(a)') 'closehisto plot 0-' + else + write(ifhi,'(a)') 'closehisto plot 0' + endif + + endif !................................................................ + if(mod(iii,10).eq.1)then !............................................. + + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! D exact all (blue) ' + write(ifhi,'(a)')'!---------------------------------------------' + + write(ifhi,'(a)')'openhisto name DExact-'//chenergy(4:ke-2) + write(ifhi,'(a)') 'htyp lbu' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange .01 auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,a)') 'text 0.65 0.9 "exact+fit" ' + write(ifhi,'(3a)') 'text 0.05 0.9 "',chenergy,'"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.8 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + tmp=Dsoftshval(real(x)*smaxDf,x,y,biniDf,0) + write(ifhi,*) x,tmp + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! D exact all (green) ' + write(ifhi,'(a)')'!---------------------------------------------' + + write(ifhi,'(a)')'openhisto name DExact-f-'//chenergy(4:ke-2) + write(ifhi,'(a)') 'htyp lga' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange .01 auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,a)') 'text 0.65 0.9 "exact+fit" ' + write(ifhi,'(3a)') 'text 0.05 0.9 "',chenergy,'"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.8 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + tmp=Dsoftshval(real(x)*smaxDf,x,y,biniDf,-1) + write(ifhi,*) x,tmp + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! fit soft (red dot) ' + write(ifhi,'(a)')'!---------------------------------------------' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lro' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange .01 auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(3a)') 'text 0.05 0.9 "',chenergy,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.8 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.7 "y=',y,'"' + write(ifhi,'(a)') 'array 2' + + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + xp=sqrt(real(x))*exp(real(y)) + xm=sqrt(real(x))*exp(-real(y)) + tmp=xDfit(zz,0,0,smaxDf,xp,xm,biniDf) + write(ifhi,*) x,tmp + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! fit semi (blue dot) ' + write(ifhi,'(a)')'!---------------------------------------------' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lbo' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange .01 auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,,s,b)" ' + write(ifhi,'(3a)') 'text 0.05 0.9 "',chenergy,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.8 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.7 "y=',y,'"' + write(ifhi,'(a)') 'array 2' + + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + xp=sqrt(real(x))*exp(real(y)) + xm=sqrt(real(x))*exp(-real(y)) + tmp=xDfit(zz,1,1,smaxDf,xp,xm,biniDf) + write(ifhi,*) x,tmp + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! fit all (red) ' + write(ifhi,'(a)')'!---------------------------------------------' + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange .01 auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,,s,b)" ' + write(ifhi,'(3a)') 'text 0.05 0.9 "',chenergy,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.8 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.05 0.7 "y=',y,'"' + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + xp=sqrt(real(x))*exp(real(y)) + xm=sqrt(real(x))*exp(-real(y)) + tmp=xDfit(zz,0,1,smaxDf,xp,xm,biniDf) + write(ifhi,*) x,tmp + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + endif !............................................................... + + xmaxDf=xtmp + + end + +c---------------------------------------------------------------------- + subroutine xFitD2 +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + + double precision x,om51p,xDfit,z(0:200),xminr,y,xtmp,om,om5,om51 +c & ,omYuncut,omNpuncut + character chenergy*12,chf*3,texte*15,textb*17,texty*17 + + nptg=30 !number of point for the graphs + biniDf=xpar2 !value of biniDf (impact parameter) + y=dble(xpar3) !value of y (rapidity) + jj1=nint(xpar4) + jj2=nint(xpar5) + if(jj1.ne.1.and.jj1.ne.2)jj1=3 + if(jj2.ne.1.and.jj2.ne.2)jj2=3 + zz=xpar7 + xtmp=xmaxDf + xmaxDf=dexp(-2.d0*y) + + chenergy='E= ' + if (engy.ge.10000.) then + write(chenergy(4:8),'(I5)')int(engy) + ke=10 + elseif (engy.ge.1000.) then + write(chenergy(4:7),'(I4)')int(engy) + ke=9 + elseif (engy.ge.100.) then + write(chenergy(4:6),'(I3)')int(engy) + ke=8 + elseif (engy.ge.10.) then + write(chenergy(4:5),'(I2)')int(engy) + ke=7 + else + write(chenergy(4:4),'(I1)')int(engy) + ke=6 + endif + chenergy(ke:ke+2)='GeV' + + xminr=1.d0/dble(engy**2) !value of xminr for plotting the function + + do jj=jj1,jj2 + + if(jj.eq.1)chf=' D' + if(jj.eq.2)chf=' G' + if(jj.eq.3)chf='FFG' + texte='text 0.05 0.9 "' + textb='text 0.05 0.8 "b=' + texty='text 0.05 0.7 "y=' + if(jj.eq.2)texty='text 0.15 0.7 "y=' + if(jj.eq.3)texte='text 0.05 0.3 "' + if(jj.eq.3)textb='text 0.05 0.2 "b=' + if(jj.eq.3)texty='text 0.05 0.1 "y=' + + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! '//chf//' exact all (green) ' + write(ifhi,'(a)')'!---------------------------------------------' + + write(ifhi,'(a)')'openhisto name '//chf//'ExaI-'//chenergy(4:ke-2) + write(ifhi,'(a)') 'htyp lga' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis '//chf//'(x+,x-,s,b)" ' + write(ifhi,'(a,a)') 'text 0.65 0.9 "exact+fit" ' + write(ifhi,'(3a)') texte,chenergy,'"' + write(ifhi,'(a,f5.2,a)') textb,biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') texty,y,'"' + write(ifhi,'(a)') 'array 2' + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + xp=sqrt(real(x))*exp(real(y)) + xm=sqrt(real(x))*exp(-real(y)) + om=0 + do j=0,4 + om=om+om51p(engy**2*real(x),x,y,biniDf,j) + enddo + om=2.d0*om + if(jj.eq.1)om=om/(x**dble(-alppar)) + if(jj.eq.3)om=om + & *(1-xm)**alplea(icltar)*(1-xp)**alplea(iclpro) + write(ifhi,*) x,om + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! '//chf//' exact all +diff (blue) ' + write(ifhi,'(a)')'!---------------------------------------------' + + write(ifhi,'(a)')'openhisto name '//chf//'ExaD-'//chenergy(4:ke-2) + write(ifhi,'(a)') 'htyp lbu' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis '//chf//'(x+,x-,s,b)" ' + write(ifhi,'(3a)') texte,chenergy,'"' + write(ifhi,'(a,f5.2,a)') textb,biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') texty,y,'"' + write(ifhi,'(a)') 'array 2' + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + xp=sqrt(real(x))*exp(real(y)) + xm=sqrt(real(x))*exp(-real(y)) + om=0 + do j=0,4 + om=om+om51p(engy**2*real(x),x,y,biniDf,j) + enddo + om5=om51(x,y,biniDf,5,5) + om=2.d0*(om+om5) + if(jj.eq.1)om=om/(x**dble(-alppar)) + if(jj.eq.3)om=om + & *(1-xm)**alplea(icltar)*(1-xp)**alplea(iclpro) + write(ifhi,*) x,om + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! '//chf//' param all (red) ' + write(ifhi,'(a)')'!---------------------------------------------' + + write(ifhi,'(a)')'openhisto name '//chf//'Par-'//chenergy(4:ke-2) + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis '//chf//'(x+,x-,s,b)" ' + write(ifhi,'(3a)') texte,chenergy,'"' + write(ifhi,'(a,f5.2,a)') textb,biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') texty,y,'"' + write(ifhi,'(a)') 'array 2' + imax=idxD1 + if(iomega.eq.2)imax=1 + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + xp=sqrt(real(x))*exp(real(y)) + xm=sqrt(real(x))*exp(-real(y)) + z(i)=xDfit(zz,0,imax,engy**2,xp,xm,biniDf) + if(jj.ge.2)z(i)=z(i)*(x**dble(-alppar)) + if(jj.eq.3)z(i)=z(i) + & *(1-xm)**alplea(icltar)*(1-xp)**alplea(iclpro) + write(ifhi,*) x,z(i) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)')'!---------------------------------------------' + write(ifhi,'(a)')'! '//chf//' param all (yellow) ' + write(ifhi,'(a)')'!---------------------------------------------' + + write(ifhi,'(a)')'openhisto name '//chf//'Scr-'//chenergy(4:ke-2) + write(ifhi,'(a)') 'htyp lyi' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis '//chf//'(x+,x-,s,b)" ' + write(ifhi,'(3a)') texte,chenergy,'"' + write(ifhi,'(a,f5.2,a)') textb,biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') texty,y,'"' + write(ifhi,'(a)') 'array 2' + imax=idxD1 + if(iomega.eq.2)imax=1 + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + xp=sqrt(real(x))*exp(real(y)) + xm=sqrt(real(x))*exp(-real(y)) + z(i)=xDfit(zz,-1,imax,engy**2,xp,xm,biniDf) + if(jj.ge.2)z(i)=z(i)*(x**dble(-alppar)) + if(jj.eq.3)z(i)=z(i) + & *(1-xm)**alplea(icltar)*(1-xp)**alplea(iclpro) + write(ifhi,*) x,z(i) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + enddo + + xmaxDf=xtmp + + end + +c---------------------------------------------------------------------- + subroutine xbExaD +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + + double precision x,y,Dsoftshval,om51p,z,xDfit!,omNpuncut + + + nptg=50 !number of point for the graphs + bmax=xpar2 + bmax=max(0.1,bmax) + !value max of b (impact parameter) + y=dble(xpar3) !value of y (rapidity) + x=dble(xpar4) + zz=xpar7 + if(x.eq.0.d0)x=1.d0 + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DExactb-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DExactb-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DExactb-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DExactb-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DExactb-',int(engy) + endif + write(ifhi,'(a)') 'htyp lbu' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax + write(ifhi,'(a)') 'yrange .00001 auto' +c write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + z=Dsoftshval(real(x)*smaxDf,x,y,b,0) + write(ifhi,*) b,z + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DParamb-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DParamb-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DParamb-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DParamb-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DParamb-',int(engy) + endif + write(ifhi,'(a)') 'htyp lrd' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax +c write(ifhi,'(a)') 'yrange -.01 auto' + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + imax=idxD1 + if(iomega.eq.2)imax=1 + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + z=xDfit(zz,0,imax,smaxDf, + & real(dsqrt(x)*dexp(y)),real(dsqrt(x)*dexp(-y)),b) + write(ifhi,*) b,z + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DExactSoftb-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DExactSoftb-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DExactSoftb-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DExactSoftb-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DExactSoftb-',int(engy) + endif + write(ifhi,'(a)') 'htyp pfc' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax +c write(ifhi,'(a)') 'yrange -.01 auto' + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + z=2.d0*om51p(real(x)*smaxDf,x,y,b,0) + & /(x**dble(-alppar)*dble(chad(iclpro)*chad(icltar))) + write(ifhi,*) b,z + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DExactSemib-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DExactSemib-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DExactSemib-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DExactSemib-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DExactSemib-',int(engy) + endif + write(ifhi,'(a)') 'htyp pft' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax +c write(ifhi,'(a)') 'yrange -.01 auto' + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + z=2.d0*om51p(real(x)*smaxDf,x,y,b,1) + & /(x**dble(-alppar)*dble(chad(iclpro)*chad(icltar))) + write(ifhi,*) b,z + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DExactValb-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DExactValb-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DExactValb-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DExactValb-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DExactValb-',int(engy) + endif + write(ifhi,'(a)') 'htyp pfs' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax +c write(ifhi,'(a)') 'yrange -.01 auto' + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + z=2.d0*(om51p(real(x)*smaxDf,x,y,b,2)+ + & om51p(real(x)*smaxDf,x,y,b,3)+om51p(real(x)*smaxDf,x,y,b,4)) + & /(x**dble(-alppar)*dble(chad(iclpro)*chad(icltar))) + write(ifhi,*) b,z + enddo + + write(ifhi,'(a)') ' endarray' + + write(ifhi,'(a)') 'closehisto plot 0' + + + end + + +c---------------------------------------------------------------------- + subroutine xbnExaD +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + + double precision x,y,Dsoftshval,z,xDfit,Dint + + + + nptg=50 !number of point for the graphs + bmax=xpar2 + bmax=max(0.1,bmax) + y=dble(xpar2) !value of y (rapidity) + x=dble(xpar3) + zz=xpar7 + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DExactbn-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DExactbn-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DExactbn-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DExactbn-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DExactbn-',int(engy) + endif + write(ifhi,'(a)') 'htyp lbu' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax +c write(ifhi,'(a)') 'yrange -.01 auto' + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + Dint=Dsoftshval(real(x)*smaxDf,x,y,0.,0) + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + z=Dsoftshval(real(x)*smaxDf,x,y,b,0)/Dint + write(ifhi,*) b,z + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DParambn-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DParambn-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DParambn-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DParambn-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DParambn-',int(engy) + endif + write(ifhi,'(a)') 'htyp lrd' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax +c write(ifhi,'(a)') 'yrange -.01 auto' + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + imax=idxD1 + if(iomega.eq.2)imax=1 + + + Dint=xDfit(zz,0,imax,engy**2, + & real(dsqrt(x)*dexp(y)),real(dsqrt(x)*dexp(-y)),0.) + + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + z=xDfit(zz,0,imax,engy**2, + & real(dsqrt(x)*dexp(y)),real(dsqrt(x)*dexp(-y)),b) + + write(ifhi,*) b,z/Dint + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DEfitb-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DEfitb-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DEfitb-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DEfitb-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DEfitb-',int(engy) + endif + write(ifhi,'(a)') 'htyp pfc' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax +c write(ifhi,'(a)') 'yrange -.01 auto' + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + sig2=sigma2(x,2) + if(sig2.le.0.) sig2=1.e+10 + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + write(ifhi,*) b,exp(-b**2/sig2) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DEfitbnSoft-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DEfitbnSoft-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DEfitbnSoft-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DEfitbnSoft-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DEfitbnSoft-',int(engy) + endif + write(ifhi,'(a)') 'htyp pft' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax +c write(ifhi,'(a)') 'yrange -.01 auto' + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + sig2=sigma2(x,0) + if(sig2.le.0.) sig2=1.e+10 + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + write(ifhi,*) b,exp(-b**2/sig2) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DEfitbnSh-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DEfitbnSh-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DEfitbnSh-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DEfitbnSh-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DEfitbnSh-',int(engy) + endif + write(ifhi,'(a)') 'htyp poc' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax +c write(ifhi,'(a)') 'yrange -.01 auto' + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + sig2=sigma2(x,1) + if(sig2.le.0.) sig2=1.e+10 + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + write(ifhi,*) b,exp(-b**2/sig2) + enddo + + write(ifhi,'(a)') ' endarray' + + write(ifhi,'(a)') 'closehisto plot 0' + + end + +c---------------------------------------------------------------------- + subroutine xbnParD +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + + double precision x,y,Dsoftshval,z,xDfit + + + + nptg=50 !number of point for the graphs + bmax=xpar2 !value max of b (impact parameter) + bmax=max(0.1,bmax) + y=dble(xpar3) !value of y (rapidity) + x=dble(xpar4) + zz=xpar7 + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DExactbn-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DExactbn-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DExactbn-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DExactbn-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DExactbn-',int(engy) + endif + write(ifhi,'(a)') 'htyp lbu' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax +c write(ifhi,'(a)') 'yrange -.01 auto' + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + Dint=Dsoftshval(real(x)*smaxDf,x,y,0.,0) + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + z=Dsoftshval(real(x)*smaxDf,x,y,b,0)/Dint + write(ifhi,*) b,z + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DParambn-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DParambn-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DParambn-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DParambn-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DParambn-',int(engy) + endif + write(ifhi,'(a)') 'htyp lrd' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax +c write(ifhi,'(a)') 'yrange -.01 auto' + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + Dint=xDfit(zz,0,1,smaxDf, + & real(dsqrt(x)*dexp(y)),real(dsqrt(x)*dexp(-y)),0.) + + imax=idxD1 + if(iomega.eq.2)imax=1 + + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + z=xDfit(zz,0,imax,smaxDf, + & real(dsqrt(x)*dexp(y)),real(dsqrt(x)*dexp(-y)),b) + + write(ifhi,*) b,z/Dint + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DEfitb-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DEfitb-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DEfitb-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DEfitb-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DEfitb-',int(engy) + endif + write(ifhi,'(a)') 'htyp pfc' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax +c write(ifhi,'(a)') 'yrange -.01 auto' + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + sig2=sigma2(x,2) + if(sig2.le.0.) sig2=1.e+10 + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + write(ifhi,*) b,exp(-b**2/sig2) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DEintb-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DEintb-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DEintb-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DEintb-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DEintb-',int(engy) + endif + write(ifhi,'(a)') 'htyp pft' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax +c write(ifhi,'(a)') 'yrange -.01 auto' + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + sig2=sigma1i(x) + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + write(ifhi,*) b,exp(-b**2/sig2) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DPfitb-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DPfitb-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DPfitb-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DPfitb-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DPfitb-',int(engy) + endif + write(ifhi,'(a)') 'htyp poc' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax +c write(ifhi,'(a)') 'yrange -.01 auto' + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + sig2=xsigmafit(x) + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + write(ifhi,*) b,exp(-b**2/sig2) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + + + end + +c---------------------------------------------------------------------- + subroutine xbParD +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + + double precision x,om5s,xDfit,z(0:200),y +c & ,omYuncut,omNpuncut,omYcut + + nptg=50 !number of point for the graphs + x=dble(xpar4) !value of biniDf (impact parameter) + y=dble(xpar3) !value of y (rapidity) + if(x.gt.dexp(-2.d0*y))x=x*dexp(-2.d0*y) + zz=xpar7 + + bmax=xpar2 + bmax=max(0.1,bmax) + t=1. +c iqqN=0 +c iqq=int(xpar7) + iqq1=-1 + iqq2=-1 + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DbParam-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DbParam-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DbParam-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DbParam-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DbParam-',int(engy) + endif + write(ifhi,'(a)') 'htyp lbu' + if(xpar5.eq.0.)then + write(ifhi,'(a)') 'xmod lin ymod lin' + else + write(ifhi,'(a)') 'xmod lin ymod log' + endif + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + xp=sqrt(real(x))*exp(real(y)) + xm=sqrt(real(x))*exp(-real(y)) + imax=idxD1 + if(iomega.eq.2)imax=1 + + if(xpar6.eq.1.)t=real(xDfit(zz,0,imax,smaxDf,xp,xm,0.)) + if(abs(t).lt.1.d-8)t=1. + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + z(i)=xDfit(zz,0,imax,smaxDf,xp,xm,b)/dble(t) + write(ifhi,*) b,z(i) + enddo + + write(ifhi,'(a)') ' endarray' + + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DbParamI-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DbParamI-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DbParamI-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DbParamI-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DbParamI-',int(engy) + endif + write(ifhi,'(a)') 'htyp lga' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax + write(ifhi,'(a)') 'yrange .01 auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + if(xpar6.eq.1.)t=(alpDs(idxD0,iclegy,iclpro,icltar) + & *(smaxDf*real(x))**betDs(idxD0,iclegy,iclpro,icltar) + & +alpDs(1,iclegy,iclpro,icltar) + & *(smaxDf*real(x))**betDs(1,iclegy,iclpro,icltar)) + & /real(idxD0+1) + if(abs(t).lt.1.d-8)t=1. + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + tmp=(alpDs(idxD0,iclegy,iclpro,icltar)/t + & *(smaxDf*real(x))**(betDs(idxD0,iclegy,iclpro,icltar) + & +gamDs(idxD0,iclegy,iclpro,icltar)*b**2.) + & *exp(-b**2./delDs(idxD0,iclegy,iclpro,icltar)) + & +alpDs(1,iclegy,iclpro,icltar)/t + & *(smaxDf*real(x))**(betDs(1,iclegy,iclpro,icltar) + & +gamDs(1,iclegy,iclpro,icltar)*b**2.) + & *exp(-b**2./delDs(1,iclegy,iclpro,icltar))) + & /real(idxD0+1) + write(ifhi,*) b,tmp + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DbExaI-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DbExaI-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DbExaI-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DbExaI-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DbExaI-',int(engy) + endif + write(ifhi,'(a)') 'htyp poc' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-bmax,bmax + write(ifhi,'(a)') 'yrange .01 auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "y=',y,'"' + endif + write(ifhi,'(a)') 'array 2' + + if(xpar6.eq.1.)t=2*real(om5s(real(x)*smaxDf,x,0.d0,0.,iqq1,iqq2) + & /(x**dble(-alppar)*dble(chad(iclpro)*chad(icltar)))) + if(abs(t).lt.1.d-8)t=1. + nptg=nptg/2 + do i=0,nptg + b=-bmax+2.*real(i)/real(nptg)*bmax + tmp=2*real(om5s(real(x)*smaxDf,x,y,b,iqq1,iqq2) + & /(x**dble(-alppar)*dble(chad(iclpro)*chad(icltar))))/t + write(ifhi,*) b,tmp + enddo + + write(ifhi,'(a)') ' endarray' + + write(ifhi,'(a)') 'closehisto plot 0' + + end + +c---------------------------------------------------------------------- + subroutine xGexaJ +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + include 'epos.incpar' + + parameter(nptg=50) !number of point for the graphs + double precision x(0:nptg),omJ1(0:nptg),xtmp,w(0:nptg),corfa + double precision z(0:nptg),om5J!,omYuncut,omYuncutJ + double precision xminr,y,t,omJ2(0:nptg),omJ3(0:nptg),omJ4(0:nptg) + &,omJ5(0:nptg)!,omJ6(0:nptg),omJ7(0:nptg) + + + kollsave=koll !koll modified in zzfz + koll=1 + biniDf=xpar2 !value of biniDf (impact parameter) + y=dble(xpar3) + t=1.d0 + xtmp=xmaxDf + xmaxDf=exp(-2.d0*y) + + xminr=1.d0/dble(engy**2) !value of xminr for plotting the function + + nnnmax=1 + if(iscreen.ne.0)nnnmax=2 + iscreensave=iscreen + + do nnn=1,nnnmax + + if(nnn.eq.2)then + iscreen=0 + corfa=0d0 + zzp=0. + zzt=0. + elseif(iscreen.ne.0)then + call zzfz(zzp,zzt,kollth,biniDf) + koll=kollth + rs=r2had(iclpro)+r2had(icltar)+slopom*log(engy*engy) + rpom=4.*.0389*rs + b2x=epscrp*rpom + zzini=epscrw*fscra(engy/egyscr)*exp(-biniDf*biniDf/2./b2x) + zzini=min(zzini,epscrx) !saturation + zzp=zzini+zzp + zzt=zzini+zzt + if(gfactor.lt.0.)then + corfa=dble(abs(gfactor)*(zzp+zzt)) + else + corfa=0d0 + endif + else + corfa=0d0 + zzp=0. + zzt=0. + endif + + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name GIexa-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name GIexa-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name GIexa-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name GIexa-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name GIexa-',int(engy) + endif + write(ifhi,'(a)') 'htyp lru' + if(xpar5.eq.0.)then + write(ifhi,'(a)') 'xmod log ymod log' + else + write(ifhi,'(a)') 'xmod log ymod lin' + endif + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + x(0)=xminr + do i=0,nptg + if (i.ne.0) x(i)=x(0)*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + z(i)=0.d0 + omJ1(i)=om5J(zzp,zzt,x(i),y,biniDf,0) + omJ2(i)=om5J(zzp,zzt,x(i),y,biniDf,1) + omJ3(i)=om5J(zzp,zzt,x(i),y,biniDf,2) + omJ3(i)=omJ3(i)+om5J(zz,zz,x(i),y,biniDf,3) + omJ4(i)=om5J(zzp,zzt,x(i),y,biniDf,4) + omJ5(i)=om5J(zzp,zzt,x(i),y,biniDf,5) + z(i)=omJ1(i)+omJ2(i)+omJ3(i)+omJ4(i)+omJ5(i) + w(i)=om5J(zzp,zzt,x(i),y,biniDf,-1) + if(xpar6.eq.0)t=z(i)/w(i) + if(xpar6.eq.1)t=z(i) + write(ifhi,*) x(i),z(i)/t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c************************************************************************* + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name GIsoft-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name GIsoft-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name GIsoft-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name GIsoft-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name GIsoft-',int(engy) + endif + write(ifhi,'(a)') 'htyp lba' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + if(xpar6.eq.0)t=z(i)/w(i) + if(xpar6.eq.1)t=z(i) + gfa=1. + if(omJ2(i).gt.0)gfa=exp(-max(0d0,corfa + & *(1d0-sqrt(dble(xggfit)*omJ1(i)/omJ2(i))))) + write(ifhi,*) x(i),omJ1(i)*gfa/t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c************************************************************************* + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name GIgg-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name GIgg-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name GIgg-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name GIgg-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name GIgg-',int(engy) + endif + write(ifhi,'(a)') 'htyp lra' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + if(xpar6.eq.0)t=z(i)/w(i) + if(xpar6.eq.1)t=z(i) + gfa=1. + if(omJ2(i).gt.0)gfa=exp(-max(0d0,corfa + & *(1d0-sqrt(dble(xggfit)*omJ1(i)/omJ2(i))))) + write(ifhi,*) x(i),(omJ2(i)+(1.-gfa)*omJ1(i))/t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c************************************************************************* + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name GIgq-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name GIgq-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name GIgq-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name GIgq-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name GIgq-',int(engy) + endif + write(ifhi,'(a)') 'htyp lga' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + if(xpar6.eq.0)t=z(i)/w(i) + if(xpar6.eq.1)t=z(i) + write(ifhi,*) x(i),omJ3(i)/t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c************************************************************************* + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name GIqq-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name GIqq-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name GIqq-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name GIqq-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name GIqq-',int(engy) + endif + write(ifhi,'(a)') 'htyp lya' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + if(xpar6.eq.0)t=z(i)/w(i) + if(xpar6.eq.1)t=z(i) + write(ifhi,*) x(i),omJ4(i)/t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c************************************************************************* + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name GIdif-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name GIdif-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name GIdif-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name GIdif-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name GIdif-',int(engy) + endif + write(ifhi,'(a)') 'htyp lfa' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + if(xpar6.eq.0)t=z(i)/w(i) + if(xpar6.eq.1)t=z(i) + write(ifhi,*) x(i),omJ5(i)/t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c************************************************************************* + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name GItot-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name GItot-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name GItot-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name GItot-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name GItot-',int(engy) + endif + write(ifhi,'(a)') 'htyp pfc' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + if(xpar6.eq.0)t=z(i)/w(i) + if(xpar6.eq.1)t=z(i) + write(ifhi,*) x(i),(omJ1(i)+omJ2(i)+omJ3(i)+omJ4(i)+omJ5(i)) + & /t + enddo + + write(ifhi,'(a)') ' endarray' + + write(ifhi,'(a)') 'closehisto plot 0' + + if(nnn.eq.2)iscreen=iscreensave + + enddo + + xmaxDf=xtmp + koll=kollsave + + end + + + +c---------------------------------------------------------------------- + subroutine xsParD +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + + double precision x,xminr,y,om5s,xtmp,z +c & ,t,omYuncut + + nptg=50 !number of point for the graphs + biniDf=xpar2 !value of biniDf (impact parameter) + y=dble(xpar3) !value of y (rapidity) + xtmp=xmaxDf + xmaxDf=dexp(-2.d0*y) + call Class('xsParD ') + iqq1=-1 + iqq2=-1 +c iqqN=0 + + xminr=dble(egylow/engy)**2.d0 !value of xminr for plotting the function + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DParamI-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DParamI-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DParamI-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DParamI-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DParamI-',int(engy) + endif + write(ifhi,'(a)') 'htyp lga' + if(xpar5.eq.0.)then + write(ifhi,'(a)') 'xmod log ymod log' + else + write(ifhi,'(a)') 'xmod log ymod lin' + endif + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + egy=sqrt(real(x))*engy + iclegy=1+int((log(egy)-log(egylow))/log(egyfac)) + write(ifhi,*) x,(alpDs(idxD0,iclegy,iclpro,icltar) + & *(smaxDf*real(x))**(betDs(idxD0,iclegy,iclpro,icltar) + & +gamDs(idxD0,iclegy,iclpro,icltar)*biniDf**2.) + & *exp(-biniDf**2./delDs(idxD0,iclegy,iclpro,icltar)) + & +alpDs(1,iclegy,iclpro,icltar) + & *(smaxDf*real(x))**(betDs(1,iclegy,iclpro,icltar) + & +gamDs(1,iclegy,iclpro,icltar)*biniDf**2.) + & *exp(-biniDf**2./delDs(1,iclegy,iclpro,icltar))) + & /real(idxD0+1) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DExaI-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DExaI-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DExaI-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DExaI-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DExaI-',int(engy) + endif + write(ifhi,'(a)') 'htyp poc' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange .01 auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + nptg=nptg/2 + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + egy=sqrt(real(x))*engy + iclegy=1+int((log(egy)-log(egylow))/log(egyfac)) + z=2d0*om5s(real(x)*smaxDf,1.d0,0.d0,biniDf,iqq1,iqq2) + & /dble(chad(iclpro)*chad(icltar)) + write(ifhi,*) x,z + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + xmaxDf=xtmp + + end + +c---------------------------------------------------------------------- + subroutine xyParD +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + + double precision x,om5s,xDfit,z(0:200),ymax,y,t +c & ,omYuncut,omNpuncut + + nptg=50 !number of point for the graphs + biniDf=xpar2 !value of biniDf (impact parameter) + + x=dble(xpar4) + if(x.le.1.d-20)x=1.d0/dble(engy) + ymax=-.5d0*dlog(x) + zz=xpar7 + iqq1=-1 + iqq2=-1 +c iqqN=0 + + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DyParam-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DyParam-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DyParam-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DyParam-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DyParam-',int(engy) + endif + write(ifhi,'(a)') 'htyp lbu' + if(xpar5.eq.0.)then + write(ifhi,'(a)') 'xmod lin ymod lin' + else + write(ifhi,'(a)') 'xmod lin ymod log' + endif + write(ifhi,'(a,2e11.3)')'xrange ',-ymax-1.d0,ymax+1.d0 + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis y"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "x=',x,'"' + endif + write(ifhi,'(a)') 'array 2' + + imax=idxD1 + if(iomega.eq.2)imax=1 + + do i=0,nptg + y=-ymax+(ymax+ymax)*(dble(i)/dble(nptg)) + xp=sqrt(real(x))*exp(real(y)) + xm=sqrt(real(x))*exp(-real(y)) + z(i)=xDfit(zz,0,imax,engy**2,xp,xm,biniDf) + write(ifhi,*) y,z(i) + enddo + + write(ifhi,'(a)') ' endarray' + + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DyParamI-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DyParamI-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DyParamI-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DyParamI-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DyParamI-',int(engy) + endif + write(ifhi,'(a)') 'htyp lga' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange ',-ymax-1.d0,ymax+1.d0 + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis y"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "x=',x,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + y=-ymax+(ymax+ymax)*(dble(i)/dble(nptg)) + xp=sqrt(real(x))*exp(real(y)) + xm=sqrt(real(x))*exp(-real(y)) + write(ifhi,*) y,(alpDs(idxD0,iclegy,iclpro,icltar) + & *smaxDf**(betDs(idxD0,iclegy,iclpro,icltar) + & +gamDs(idxD0,iclegy,iclpro,icltar)*biniDf**2.) + & *xp**(betDps(idxD0,iclegy,iclpro,icltar) + & +gamDs(idxD0,iclegy,iclpro,icltar)*biniDf**2.) + & *xm**(betDpps(idxD0,iclegy,iclpro,icltar) + & +gamDs(idxD0,iclegy,iclpro,icltar)*biniDf**2.) + & *exp(-biniDf**2./delDs(idxD0,iclegy,iclpro,icltar)) + & +alpDs(1,iclegy,iclpro,icltar) + & *smaxDf**(betDs(1,iclegy,iclpro,icltar) + & +gamDs(1,iclegy,iclpro,icltar)*biniDf**2.) + & *xp**(betDps(1,iclegy,iclpro,icltar) + & +gamDs(1,iclegy,iclpro,icltar)*biniDf**2.) + & *xm**(betDpps(1,iclegy,iclpro,icltar) + & +gamDs(1,iclegy,iclpro,icltar)*biniDf**2.) + & *exp(-biniDf**2./delDs(1,iclegy,iclpro,icltar))) + & /real(idxD0+1) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name DyExaI-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name DyExaI-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name DyExaI-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name DyExaI-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name DyExaI-',int(engy) + endif + write(ifhi,'(a)') 'htyp poc' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange ',-ymax-1.d0,ymax+1.d0 + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis y"' + write(ifhi,'(a,a)') 'text 0 0 "yaxis D(x+,x-,s,b)" ' + write(ifhi,'(a,e8.2,a)') 'text 0.1 0.9 "E=',engy,' GeV"' + if (xpar8.eq.1.) then + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.7 "x=',x,'"' + endif + write(ifhi,'(a)') 'array 2' + + nptg=nptg/2 + do i=0,nptg + y=-ymax+(ymax+ymax)*(dble(i)/dble(nptg)) + t=2*om5s(real(x)*smaxDf,x,y,biniDf,iqq1,iqq2) + & /(x**dble(-alppar)*dble(chad(iclpro)*chad(icltar))) + write(ifhi,*) y,t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + end + +c---------------------------------------------------------------------- + subroutine xParSigma +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + + double precision x,w(0:200),z(0:200),xminr,t + + nptg=20 !number of point for the graphs + + xminr=1.d0/dble(engy**2) !value of xminr for plotting the function + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name SigmaReel-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name SigmaReel-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name SigmaReel-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name SigmaReel-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name SigmaReel-',int(engy) + endif + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,1. + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis [s]^2!(X)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.05 0.75 "Emax=',engy,' GeV"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + X=xminr + if (i.ne.0) X=X*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + z(i)=dble(sigma2(X,2)) + if(z(i).le.0.) z(i)=0.d0 + write(ifhi,'(2e14.6)') X,z(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name SigmaParam-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name SigmaParam-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name SigmaParam-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name SigmaParam-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name SigmaParam-',int(engy) + endif + write(ifhi,'(a)') 'htyp pfc' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,1. + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis [s]^2!?param!(X)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.05 0.75 "Emax=',engy,' GeV"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + X=xminr + if (i.ne.0) X=X*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + w(i)=dble(xsigmafit(X)) + write(ifhi,'(2e14.6)') X,w(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name SigmaInt-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name SigmaInt-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name SigmaInt-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name SigmaInt-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name SigmaInt-',int(engy) + endif + write(ifhi,'(a)') 'htyp lba' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,1. + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis [s]^2!?Int!(X)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.05 0.75 "Emax=',engy,' GeV"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + X=xminr + if (i.ne.0) X=X*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + t=dble(sigma1i(X)) + write(ifhi,'(2e14.6)') X,t + enddo + + write(ifhi,'(a)') ' endarray' + + if(xpar8.eq.1)then + write(ifhi,'(a)') 'closehisto plot 0-' + + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name SigmaReelSoft-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name SigmaReelSoft-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name SigmaReelSoft-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name SigmaReelSoft-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name SigmaReelSoft-',int(engy) + endif + write(ifhi,'(a)') 'htyp pft' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,1. + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis [s]^2!(X)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.05 0.75 "Emax=',engy,' GeV"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + X=xminr + if (i.ne.0) X=X*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + t=dble(sigma2(X,0)) + if(t.gt.0.) write(ifhi,'(2e14.6)') X,t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name SigmaReelSh-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name SigmaReelSh-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name SigmaReelSh-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name SigmaReelSh-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name SigmaReelSh-',int(engy) + endif + write(ifhi,'(a)') 'htyp pot' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,1. + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis [s]^2!(X)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.05 0.75 "Emax=',engy,' GeV"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + X=xminr + if (i.ne.0) X=X*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + t=dble(sigma2(X,1)) + if(t.gt.0.)write(ifhi,'(2e14.6)') X,t + enddo + + write(ifhi,'(a)') ' endarray' + + write(ifhi,'(a)') 'closehisto plot 0-' + +c********************************************************************** + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lya' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,1. + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis [s]^2!(X)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.05 0.75 "Emax=',engy,' GeV"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + X=xminr + if (i.ne.0) X=X*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + t=1.d0/dble(-gamD(0,iclpro,icltar)*log(X*smaxDf) + & +1./delD(0,iclpro,icltar)) + if(t.gt.0.)write(ifhi,'(2e14.6)') X,t + enddo + + write(ifhi,'(a)') ' endarray' + + + write(ifhi,'(a)') 'closehisto plot 0-' + +c********************************************************************** + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lyo' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,1. + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis [s]^2!(X)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.05 0.75 "Emax=',engy,' GeV"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + X=xminr + if (i.ne.0) X=X*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + t=1.d0/dble(-gamD(1,iclpro,icltar)*log(X*smaxDf) + * +1./delD(1,iclpro,icltar)) + if(t.gt.0.)write(ifhi,'(2e14.6)') X,t + enddo + + write(ifhi,'(a)') ' endarray' + + endif + + + write(ifhi,'(a)') 'closehisto plot 0' + +c********************************************************************** +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name SigmaDiff-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name SigmaDiff-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name SigmaDiff-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name SigmaDiff-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name SigmaDiff-',int(engy) + endif + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,1. + write(ifhi,'(a,2e11.3)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis [D][s]/[s]"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.05 0.9 "Emax=',engy,' GeV"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + X=xminr + if (i.ne.0) X=X*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + t=0.d0 + if(w(i).gt.0.d0)t=(z(i)-w(i))/w(i) + if(abs(t).gt.0.15d0) t=dsign(0.15d0,t) + write(ifhi,'(2e14.6)') X,t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + end + +c---------------------------------------------------------------------- + subroutine xParGauss +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + + double precision x,om5s,xDfit,y,enh,t!,omNpuncut + + nptg=50 !number of point for the graphs + x=dble(xpar4) !value of x (energy) + y=dble(xpar2) !value of rapidity + zz=xpar7 + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name GaussExact-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name GaussExact-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name GaussExact-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name GaussExact-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name GaussExact-',int(engy) + endif + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',0.,bmaxDf + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a)') 'text 0 0 "yaxis b*D(x+,x-,s,b)"' +c if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.6 0.9 "E=',engy,' GeV"' + write(ifhi,'(a,f5.2,a)') 'text 0.6 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.6 0.7 "y=',y,'"' +c endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + b=bmaxDf*(real(i)/real(nptg)) + enh=0.d0 + t=dble(b)*(2*om5s(real(x)*smaxDf,x,y,b,-1,-1) + & +enh) + & /(x**dble(-alppar)*dble(chad(iclpro)*chad(icltar))) + write(ifhi,*) b,t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name GaussParam-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name GaussParam-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name GaussParam-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name GaussParam-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name GaussParam-',int(engy) + endif + write(ifhi,'(a)') 'htyp pfc' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',0.,bmaxDf + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a)') 'text 0 0 "yaxis b*D(x+,x-,s,b)"' +c if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.6 0.9 "E=',engy,' GeV"' + write(ifhi,'(a,f5.2,a)') 'text 0.6 0.8 "x=',x,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.6 0.7 "y=',y,'"' +c endif + write(ifhi,'(a)') 'array 2' + + imax=idxD1 + if(iomega.eq.2)imax=1 + + do i=0,nptg + b=bmaxDf*(real(i)/real(nptg)) + xp=sqrt(real(x))*exp(real(y)) + xm=sqrt(real(x))*exp(-real(y)) + t=xDfit(zz,0,imax,engy**2,xp,xm,b) + write(ifhi,'(2e14.6)') b,dble(b)*t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + end + + + +c---------------------------------------------------------------------- + subroutine xParOmega1 +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + + double precision x,w(0:200),z(0:200) + double precision yp,om1,xminr,Dsoftshval,t + + nptg=50 !number of point for the graphs + biniDf=xpar2 !value of biniDf (impact parameter) + yp=xpar3 !value of yp (rapidity) + xminr=1.d0/dble(engy**2) !value of xminr for plotting the function + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name Om1Exact-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name Om1Exact-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name Om1Exact-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name Om1Exact-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name Om1Exact-',int(engy) + endif + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis [h](x,0,b)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + w(i)=Dsoftshval(real(x)*engy**2,x,0.d0,biniDf,0) + & *(x**dble(-alppar)*dble(chad(iclpro)*chad(icltar))) + write(ifhi,*) x,w(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name om5param-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name om5param-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name om5param-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name om5param-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name om5param-',int(engy) + endif + write(ifhi,'(a)') 'htyp pfc' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1!(x,0,b)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + z(i)=om1(x,yp,biniDf) + write(ifhi,*) x,z(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + +c********************************************************************** +c********************************************************************** + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name Om1Diff-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name Om1Diff-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name Om1Diff-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name Om1Diff-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name Om1Diff-',int(engy) + endif + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a,2e11.3)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis X"' + write(ifhi,'(a)') 'text 0 0 "yaxis ([w]?1!-[h])/[h]"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + t=z(i)!(z(i)-w(i)) +c if(abs(w(i)).gt.0.)t=t/w(i) +c if(abs(t).gt.0.15d0) t=dsign(0.15d0,t) + write(ifhi,*) x,t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + + end + +c---------------------------------------------------------------------- + subroutine xEpsilon(iii) +c---------------------------------------------------------------------- +c iii: modus (0,1,2) +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + include 'epos.incpar' + + parameter(nxeps=20,nyeps=32) + common/cxeps1/w(0:nxeps,nyeps),y1(nyeps),y2(nyeps) + common/cxeps2/db,b1,b2 + common/geom/rmproj,rmtarg,bmax,bkmx + character ch*3 + common /psar34/ rrr,rrrm + common /psar41/ rrrp,rrrmp + external pprzz,pttzz + + b1=0.03 + b2=bkmx*1.2 + db=(b2-b1)/nyeps + + if(iii.eq.0)then + + do j=0,nxeps + do k=1,nyeps + w(j,k)=0 + enddo + enddo + + elseif(iii.eq.2)then + + + do nj=1,14 + y1(nj)=1e+20 + y2(nj)=1e-20 + do k=1,nyeps + if(w(0,k).ne.0)then + y1(nj)=min(y1(nj),w(nj,k)/w(0,k)) + y2(nj)=max(y2(nj),w(nj,k)/w(0,k)) + endif + enddo + if(y1(nj).ge.0)then + y1(nj)=max(y1(nj)*.2,1e-4) + else + y1(nj)=y1(nj)*2. + endif + y2(nj)=min(y2(nj)*5,1e4) + enddo + y2(13)=max(y2(13),y2(14)) + y2(14)=max(y2(13),y2(14)) + y2(1)=max(y2(1),y2(2)) + y2(2)=max(y2(1),y2(2)) + y2(5)=max(y2(5),y2(6)) + y2(6)=max(y2(5),y2(6)) + y2(7)=y2(5) + y2(8)=y2(5) + y2(9)=max(y2(9),y2(10)) + y2(10)=max(y2(9),y2(10)) + y2(11)=y2(9) + y2(12)=y2(9) + do nj=1,14 + if(nj.le.9)write(ifhi,'(a,i1)')'openhisto name xEps',nj + if(nj.gt.9)write(ifhi,'(a,i2)')'openhisto name xEps',nj + ch='lin' + if(nj.eq.7.or.nj.eq.11)ch='lyo' + if(nj.eq.8.or.nj.eq.12)ch='lgo' + write(ifhi,'(a)') 'htyp '//ch//' xmod lin' + if(y1(nj).ge.0.)then + write(ifhi,'(a)') 'ymod log' + else + write(ifhi,'(a)') 'ymod lin' + endif + write(ifhi,'(a,e9.2)')'xrange 0 ',b2 + if(nj.eq.1.or.nj.eq.3.or.nj.eq.5.or.nj.eq.9)then + write(ifhi,'(a,2e9.2)') 'yrange ',min(y1(nj),y1(nj+1)) + * ,max(y2(nj),y2(nj+1)) + else + write(ifhi,'(a,2e9.2)') 'yrange ',y1(nj),y2(nj) + endif + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + if(nj.eq.1) write(ifhi,'(a)')'txt "yaxis [e]?GP/T!(b)"' + if(nj.eq.1) write(ifhi,'(a)')'txt "title soft pro soft tar"' + if(nj.eq.3) write(ifhi,'(a)')'txt "yaxis [e]?G!(b)"' + if(nj.eq.3) write(ifhi,'(a)')'txt "title diff"' +c if(nj.eq.3) write(ifhi,'(a)')'txt "title soft semi"' + if(nj.eq.5) write(ifhi,'(a)')'txt "yaxis [b]?eff!(b)"' + if(nj.eq.5) write(ifhi,'(a)')'txt "title soft pro soft tar"' + if(nj.eq.9) write(ifhi,'(a)')'txt "yaxis [b]?eff!(b)"' + if(nj.eq.9) write(ifhi,'(a)')'txt "title semi pro semi tar"' + if(nj.eq.13)write(ifhi,'(a)')'txt "yaxis Z?P/T!"' + write(ifhi,'(a)') 'array 2' + do k=1,nyeps + b=b1+(k-0.5)*db + y=0 + if(w(0,k).ne.0)y=w(nj,k)/w(0,k) + write(ifhi,'(2e11.3)')b,y + enddo + write(ifhi,'(a)') ' endarray' + if(nj.eq.2.or.nj.eq.4.or.nj.eq.8.or.nj.eq.12.or.nj.eq.14 + & .or.nj.eq.16)then + write(ifhi,'(a)') 'closehisto plot 0' + else + write(ifhi,'(a)') 'closehisto plot 0-' + endif + enddo + !----15-16-17--- + write(ifhi,'(a)') 'openhisto name xEps15' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'xrange 0 10' + write(ifhi,'(a)') 'text 0 0 "xaxis b?0!"' + write(ifhi,'(a)') 'txt "yaxis Z?P/T!(b?0!)"' + write(ifhi,'(a)') 'array 2' + do k=1,10 + b=(k-0.5) + y=0 + if(w(17,k).ne.0)y=w(15,k)/w(17,k) + write(ifhi,'(2e11.3)')b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto name xEps16' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a)') 'xrange 0 10' + write(ifhi,'(a)') 'text 0 0 "xaxis b?0!"' + write(ifhi,'(a)') 'txt "yaxis Z?P/T!(b?0!)"' + write(ifhi,'(a)') 'array 2' + do k=1,10 + b=(k-0.5) + y=0 + if(w(17,k).ne.0)y=w(16,k)/w(17,k) + write(ifhi,'(2e11.3)')b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + !----18-19-20--- + kk=2 + do k=3,32 + if(w(18,k).ne.0)kk=k + enddo + xmx=(kk-1)/31.*0.1*maproj*matarg + write(ifhi,'(a)') 'openhisto name xEps18' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a,f10.2)') 'xrange 0 ',xmx + write(ifhi,'(a)') 'text 0 0 "xaxis n?Gl!"' + write(ifhi,'(a)') 'txt "yaxis Z?P/T!(n?Gl!)"' + write(ifhi,'(a)') 'array 2' + do k=1,32 + x=(k-1.)*0.1*maproj*matarg/(nyeps-1.) + y=0 + if(w(20,k).ne.0)y=w(18,k)/w(20,k) + write(ifhi,'(2e11.3)')x,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto name xEps19' + write(ifhi,'(a)') 'htyp lin xmod lin ymod lin' + write(ifhi,'(a,f10.2)') 'xrange 0 ',xmx + write(ifhi,'(a)') 'text 0 0 "xaxis n?Gl!"' + write(ifhi,'(a)') 'txt "yaxis Z?P/T!(n?Gl!)"' + write(ifhi,'(a)') 'array 2' + do k=1,32 + x=(k-1.)*0.1*maproj*matarg/(nyeps-1.) + y=0 + if(w(20,k).ne.0)y=w(19,k)/w(20,k) + write(ifhi,'(2e11.3)')x,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + endif + + end + +c---------------------------------------------------------------------- + subroutine xZnucTheo +c---------------------------------------------------------------------- +c Theoretical mean Z as a function of impact parameter between proj and targ +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incems' + include 'epos.incpar' + + common/geom/rmproj,rmtarg,bmax,bkmx + common /psar34/ rrr,rrrm + common /psar41/ rrrp,rrrmp + external pprzz,pttzz + + + rs=r2had(iclpro)+r2had(icltar)+slopom*log(engy**2) + bglaub2=4.*.0389*rs + b2x=epscrp*bglaub2 + zzini=epscrw*fscra(engy/egyscr) + + if(maproj.gt.1)then + rrrp=radnuc(maproj)/difnuc(maproj) + rrrmp=rrrp+log(9.) + endif + if(matarg.gt.1)then + rrr=radnuc(matarg)/difnuc(matarg) + rrrm=rrr+log(9.) + endif + + write(ifhi,'(a)') 'openhisto name xZTheo' + write(ifhi,'(a)') 'htyp lyi xmod lin ymod lin' + write(ifhi,'(a)') 'xrange 0 10' + write(ifhi,'(a)') '- text 0 0 "xaxis b?0!"' + write(ifhi,'(a)') '+ txt "yaxis Z?P!(b?0!)"' + write(ifhi,'(a)') '+ txt "yaxis Z?T!(b?0!)"' + write(ifhi,'(a)') 'array -3' + do k=1,10 + b=(k-0.5) + call zzfz(zzp,zzt,kollth,b) + zz=min(epscrw,zzini*exp(-b*b/2./b2x)) + write(ifhi,'(2e11.3)')b,zz+zzp,zz+zzt + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto' + write(ifhi,'(a)') ' plot -htyp lyi xZTheo+1-', + & ' plot -htyp lga xZTheo+2' + + end + +c---------------------------------------------------------------------- + subroutine xParOmegaN +c---------------------------------------------------------------------- +c xpar1=engy +c xpar2=b +c xpar4=xremnant +c xpar5: 0=log scale (x dep of om) 1=lin scale (b dep of om) +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + include 'epos.incsem' + include 'epos.incems' + double precision x,w(0:200),z(0:200),xminr,t,ghh + *,xprem,omGam,Womint,Gammapp,WomGamint,omGamk +c *,yp,SomY,omYuncut,y,xtmp + + nptg=30 !number of point for the graphs + biniDf=xpar2 !value of biniDf (impact parameter) + xprem=dble(xpar4) !value of x remnant + bmax=3. + xminr=1.d0/dble(engy**2) !value of xminr for plotting the function + +c********************************************************************** + + do i=0,3 + b=bmax*(real(i)/real(3)) + z(i)=1.d0 +c if(xpar5.eq.0.)z(i)=Gammapp(engy**2.,b,1) + enddo + + write(ifhi,'(a)') 'openhisto name Womint-1' + write(ifhi,'(a)') 'htyp lru' + if(xpar5.eq.0.)then + write(ifhi,'(a)') 'xmod lin ymod log' + else + write(ifhi,'(a)') 'xmod lin ymod lin' + endif + write(ifhi,'(a,2e11.3)')'xrange',0.,bmax + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?int!(s,b)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + + ierr=0 + ghh=0.d0 + do i=0,3 + b=bmax*(real(i)/real(3)) + w(i)=Womint(engy**2.,b) + if(b.eq.biniDf)then + write(*,*)'Womint(',b,',1)=',w(i) + ghh=ghh+w(i) + endif + if(w(i).lt.0.d0.and.ierr.eq.0.and.xpar5.eq.0.)then + write(*,*)'Warning Womint(1)<0 =',w(i) + w(i)=-w(i) + ierr=1 + elseif(w(i).lt.0.d0.and.xpar5.eq.0.)then + w(i)=-w(i) + elseif(w(i).ge.0.d0.and.ierr.eq.1.and.xpar5.eq.0.)then + ierr=0 + write(*,*)'Warning Womint(1)>0 =',w(i) + endif + write(ifhi,*) b,w(i)/z(i) + enddo + + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c********************************************************************** + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp pfc' + if(xpar5.eq.0.)then + write(ifhi,'(a)') 'xmod lin ymod log' + else + write(ifhi,'(a)') 'xmod lin ymod lin' + endif + write(ifhi,'(a,2e11.3)')'xrange',0.,bmax + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis b"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?int!(s,b)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + b=bmax*(real(i)/real(nptg)) + z(i)=1.d0 + if(xpar5.eq.0.)then + z(i)=z(i)+dabs(WomGamint(b)) + endif + enddo + ierr=0 + do i=0,nptg + b=bmax*(real(i)/real(nptg)) + w(i)=WomGamint(b) + if(w(i).lt.0.d0.and.ierr.eq.0.and.xpar5.eq.0.)then + write(*,*)'Warning WomGamint(1)<0 =',w(i) + w(i)=-w(i) + ierr=1 + elseif(w(i).lt.0.d0.and.xpar5.eq.0.)then + w(i)=-w(i) + elseif(w(i).ge.0.d0.and.ierr.eq.1.and.xpar5.eq.0.)then + ierr=0 + write(*,*)'Warning WomGamint(1)>0 =',w(i) + endif + write(ifhi,*) b,w(i)/z(i) + enddo + + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + t=Gammapp(engy**2.,biniDf,1) + write(*,*)'--> gamma(',biniDf,')=',ghh,t + +c********************************************************************** +c********************************************************************** + do k=1,koll + bk(k)=biniDf + enddo + call GfunPark(0) + call integom1(0) + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name xOmNG-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name xOmNG-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name xOmNG-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name xOmNG-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name xOmNG-',int(engy) + endif + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x-"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?NPi!(x+rem,x-rem,b)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.85 "x+?rem!=',xprem,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + t=dabs(omGam(xprem,x,biniDf)) + write(ifhi,*) x,t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + if (engy.ge.10.) then + if (engy.ge.100.) then + if (engy.ge.1000.) then + if (engy.ge.10000.) then + write(ifhi,'(a,I5)') 'openhisto name xOmNG-',int(engy) + else + write(ifhi,'(a,I4)') 'openhisto name xOmNG-',int(engy) + endif + else + write(ifhi,'(a,I3)') 'openhisto name xOmNG-',int(engy) + endif + else + write(ifhi,'(a,I2)') 'openhisto name xOmNG-',int(engy) + endif + else + write(ifhi,'(a,I1)') 'openhisto name xOmNG-',int(engy) + endif + write(ifhi,'(a)') 'htyp pfc' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x-"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?NPi!(x+rem,x-rem,b)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.85 "x+?rem!=',xprem,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + t=dabs(omGamk(1,xprem,x)) + write(ifhi,*) x,t + enddo + + write(ifhi,'(a)') ' endarray' + + write(ifhi,'(a)') 'closehisto plot 0' + + end + +c---------------------------------------------------------------------- + subroutine xParGampp +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + + double precision Gammapp,GammaGauss,sg,sgmc,Znorm,Zn,t + * ,w(0:200),z(0:200)!,GammaMC + + nptg=2 !number of point for the graphs + biniDf=xpar2 !value of biniDf (impact parameter) + + +c************************************************** + + if (biniDf.lt.1.) then + k=int(10.*biniDf) + write(ifhi,'(a,I1)') 'openhisto name Gamma-b0.',k + else + write(ifhi,'(a,f3.1)')'openhisto name Gamma-b',biniDf + endif + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',0.,real(nptg) + write(ifhi,'(a,2e11.3)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis m"' + write(ifhi,'(a)') 'text 0 0 "yaxis [g]?h1h2!"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + sg=0.d0 + do i=0,nptg + w(i)=Gammapp(engy**2.,biniDf,i) + sg=sg+w(i) + write(ifhi,*) i,w(i) + write(*,*) 'G12',i,w(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + if (biniDf.lt.1.) then + k=int(10.*biniDf) + write(ifhi,'(a,I1)') 'openhisto name GammaMC-b0.',k + else + write(ifhi,'(a,f3.1)')'openhisto name GammaMC-b',biniDf + endif + write(ifhi,'(a)') 'htyp pfc' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',0.,real(nptg) + write(ifhi,'(a,2e11.3)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis m"' + write(ifhi,'(a)') 'text 0 0 "yaxis [g]?h1h2!"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + sgmc=0.d0 + do i=0,nptg + z(i)=GammaGauss(engy**2.,biniDf,i) + sgmc=sgmc+z(i) + write(ifhi,*) i,z(i) + write(*,*) 'G12gauss',i,z(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + +c********************************************************************** +c********************************************************************** + Zn=Znorm(engy**2,biniDf) + + write(ifhi,'(a)') 'openhisto name GammaDiff' + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',0.,real(nptg) + write(ifhi,'(a,2e11.3)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis m"' + write(ifhi,'(a)') 'text 0 0 "yaxis (G-GMC)/G"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.1 0.8 "b=',biniDf,' fm"' + endif + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "[S]?Guncut!=',sg,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.8 "[S]?Gcut!=',sgmc,'"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.7 "Z=',Zn,'"' + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + if(w(i).ne.0d0) t=(z(i)-w(i))/w(i) +c if(abs(t).gt.0.5d0) t=dsign(0.5d0,t) + write(ifhi,*) i,t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + end + +c---------------------------------------------------------------------- + subroutine xParPomInc +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + + double precision x,PomIncExact,PomIncUnit,xminr,xm,t + * ,w(0:200),z(0:200) + + nptg=10 !number of point for the graphs + biniDf=xpar2 !value of biniDf (impact parameter) + xm=dble(xpar4) !value of biniDf (impact parameter) + xminr=1.d0/dble(engy**2) !value of xminr for plotting the function + + +c********************* red = PomIncXExact ***************************** + + if (biniDf.lt.1.) then + k=int(10.*biniDf) + write(ifhi,'(a,I1)') 'openhisto name PomIncExact-b0.',k + else + write(ifhi,'(a,f3.1)')'openhisto name PomIncExact-b',biniDf + endif + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a,2e11.3)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x+"' + write(ifhi,'(a)') 'text 0 0 "yaxis dn?Pom!/dx+/dx-"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.8 "x-=',xm,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) + w(i)=PomIncExact(dsqrt(x),dsqrt(x),biniDf) + write(ifhi,*) x,w(i) + write(*,*) 'Xe',i,w(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + + +c************************* dot = PomIncXUnit ************************** +c nptg=50 !number of point for the graphs + + if (biniDf.lt.1.) then + k=int(10.*biniDf) + write(ifhi,'(a,I1)') 'openhisto name PomIncUnit-b0.',k + else + write(ifhi,'(a,f3.1)')'openhisto name PomIncUnit-b',biniDf + endif + write(ifhi,'(a)') 'htyp pfc' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a,2e11.3)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis dn?Pom!/dx+/dx-"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.8 "x-=',xm,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) + z(i)=PomIncUnit(dsqrt(x),dsqrt(x),biniDf) + write(ifhi,*) x,z(i) + write(*,*) 'Xu',i,z(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + +c********************************************************************** +c********************************************************************** + + write(ifhi,'(a)') 'openhisto name PomIncDiff' + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a,2e11.3)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis ([w]?5!-G)/G"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.8 "x-=',xm,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) + t=0.d0 + if(w(i).ne.0d0) t=(z(i)-w(i))/w(i) +c if(abs(t).gt.0.5d0) t=dsign(0.5d0,t) + write(ifhi,*) x,t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + end + +c---------------------------------------------------------------------- + subroutine xParPomIncX +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + + double precision x,PomIncXExact,PomIncXUnit,xminr,y + + nptg=20 !number of point for the graphs + biniDf=xpar2 !value of biniDf (impact parameter) + xminr=1.d0/dble(engy**2) !value of xminr for plotting the function + + +c********************* red = PomIncXExact ***************************** + + if (biniDf.lt.1.) then + k=int(10.*biniDf) + write(ifhi,'(a,I1)') 'openhisto name PomIncXExact-b0.',k + else + write(ifhi,'(a,f3.1)')'openhisto name PomIncXExact-b',biniDf + endif + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a,2e11.3)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis dn?Pom!/dx(x,b)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c.......x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) + y=PomIncXExact(x,biniDf) + write(ifhi,*) x,y +c write(*,*) 'Xe',i + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + + +c************************* dot = PomIncXUnit ************************** +c nptg=50 !number of point for the graphs + + if (biniDf.lt.1.) then + k=int(10.*biniDf) + write(ifhi,'(a,I1)') 'openhisto name PomIncXUnit-b0.',k + else + write(ifhi,'(a,f3.1)')'openhisto name PomIncXUnit-b',biniDf + endif + write(ifhi,'(a)') 'htyp pfc' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a,2e11.3)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis dn?Pom!/dx(x,b)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c.......x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) + write(ifhi,*) x,PomIncXUnit(x,biniDf) + write(*,*) 'Xu',i + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + end + +c---------------------------------------------------------------------- + subroutine xParPomIncXI +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + + double precision x,xminr + double precision PomIncXIExact,PomIncXIUnit + + nptg=20 !number of point for the graphs + xminr=1.d0/dble(engy**2) !value of xminr for plotting the function + +c*********************red = PomIncXIExact ***************************** + + write(ifhi,'(a)') 'openhisto name PomIncXIExact' + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis d[s]?Pom!/dx(x)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c.......x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) + write(ifhi,*) x,PomIncXIExact(x) +c.......write(*,*) 'XIe',i + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c***************************dot = PomIncXIUnit ************************ +c.....nptg=50 !number of point for the graphs + + write(ifhi,'(a)') 'openhisto name PomIncXIUnit' + write(ifhi,'(a)') 'htyp pfc' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis d[s]?Pom!/dx(x)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c.......x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) + write(ifhi,*) x,PomIncXIUnit(x) + write(*,*) 'XIu',i + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + end + +c---------------------------------------------------------------------- + subroutine xParPomIncP +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + + double precision x,PomIncPUnit,xminr + double precision PomIncPExact + + nptg=30 !number of point for the graphs + biniDf=xpar1 !value of biniDf (impact parameter) + xminr=1.d0/dble(engy**2) !value of xminr for plotting the function + +c*********************red = PomIncPExact ***************************** + + if (biniDf.lt.1.) then + k=int(10.*biniDf) + write(ifhi,'(a,I1)') 'openhisto name PomIncPExact-b0.',k + else + write(ifhi,'(a,f3.1)')'openhisto name PomIncPExact-b',biniDf + endif + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'text 0 0 "xaxis x+"' + write(ifhi,'(a)') 'text 0 0 "yaxis dn?Pom!/dx+(x+,b)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + write(ifhi,*) x,PomIncPExact(x,biniDf) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c**************************dot = PomIncPUnit ************************** +c.....nptg=50 !number of point for the graphs + + if (biniDf.lt.1.) then + k=int(10.*biniDf) + write(ifhi,'(a,I1)') 'openhisto name PomIncPUnit-b0.',k + else + write(ifhi,'(a,f3.1)')'openhisto name PomIncPUnit-b',biniDf + endif + write(ifhi,'(a)') 'htyp pfc' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'text 0 0 "xaxis x+"' + write(ifhi,'(a)') 'text 0 0 "yaxis dn?Pom!/dx+(x+,b)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + write(*,*) 'Pu',i + write(ifhi,*) x,PomIncPUnit(x,biniDf) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + end + +c---------------------------------------------------------------------- + subroutine xParPomIncPI +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + + double precision x,xminr + double precision PomIncPIExact,PomIncPIUnit + + nptg=50 !number of point for the graphs + xminr=1.d0/dble(engy**2) !value of xminr for plotting the function + +c*********************red = PomIncPIExact ***************************** +c.....nptg=100 !number of point for the graphs + + write(ifhi,'(a)') 'openhisto name PomIncPIExact' + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'text 0 0 "xaxis x+"' + write(ifhi,'(a)') 'text 0 0 "yaxis d[s]?Pom!/dx+(x+)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + write(ifhi,*) x,PomIncPIExact(x) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c***************************dot = PomIncPIUnit ************************ +c.....nptg=10 !number of point for the graphs + + write(ifhi,'(a)') 'openhisto name PomIncPIUnit' + write(ifhi,'(a)') 'htyp pfc' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'text 0 0 "xaxis x+"' + write(ifhi,'(a)') 'text 0 0 "yaxis n?Pom!/dx+(x+)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + write(ifhi,*) x,PomIncPIUnit(x) + write(*,*) 'PIu',i + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + end + +c---------------------------------------------------------------------- + subroutine xParPomIncM +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + + double precision x,xminr,PomIncMUnit,PomIncMExact + + nptg=50 !number of point for the graphs + biniDf=xpar1 !value of biniDf (impact parameter) + xminr=1.d0/dble(engy**2) !value of xminr for plotting the function + +c**********************red = PomIncMExact ***************************** + + if (biniDf.lt.1.) then + k=int(10.*biniDf) + write(ifhi,'(a,I1)') 'openhisto name PomIncMExact-b0.',k + else + write(ifhi,'(a,f3.1)')'openhisto name PomIncMExact-b',biniDf + endif + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'text 0 0 "xaxis x-"' + write(ifhi,'(a)') 'text 0 0 "yaxis dn?Pom!/dx-(x-,b)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + write(ifhi,*) x,PomIncMExact(x,biniDf) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c**************************dot = PomIncMUnit ************************** +c.....nptg=100 !number of point for the graphs + + if (biniDf.lt.1.) then + k=int(10.*biniDf) + write(ifhi,'(a,I1)') 'openhisto name PomIncMUnit-b0.',k + else + write(ifhi,'(a,f3.1)')'openhisto name PomIncMUnit-b',biniDf + endif + write(ifhi,'(a)') 'htyp pfc' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'text 0 0 "xaxis x-"' + write(ifhi,'(a)') 'text 0 0 "yaxis dn?Pom!/dx-(x-,b)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + write(ifhi,*) x,PomIncMUnit(x,biniDf) + write(*,*) 'Mu',i + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + end + +c---------------------------------------------------------------------- + subroutine xParPomIncMI +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + + double precision x,xminr + double precision PomIncMIExact,PomIncMIUnit + + nptg=30 !number of point for the graphs + xminr=1.d0/dble(engy**2) !value of xminr for plotting the function + +c*********************red = PomIncMIExact ***************************** +c.....nptg=100 !number of point for the graphs + + write(ifhi,'(a)') 'openhisto name PomIncMIExact' + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'text 0 0 "xaxis x-"' + write(ifhi,'(a)') 'text 0 0 "yaxis d[s]?Pom!/dx-(x-)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + write(ifhi,*) x,PomIncMIExact(x) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c***************************dot = PomIncMIUnit ************************ +c.....nptg=100 !number of point for the graphs + + write(ifhi,'(a)') 'openhisto name PomIncMIUnit' + write(ifhi,'(a)') 'htyp pfc' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'text 0 0 "xaxis x-"' + write(ifhi,'(a)') 'text 0 0 "yaxis d[s]?Pom!/dx-(x-)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + write(ifhi,*) x,PomIncMIUnit(x) + write(*,*) 'MIu',i + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + end + +c---------------------------------------------------------------------- + subroutine xParPomIncJ +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + common/geom/rmproj,rmtarg,bmax,bkmx + parameter(nbib=48) + + double precision PomIncJExact,PomIncJUnit + + + b1=0 + b2=bkmx*1.2 + db=(b2-b1)/nbib + +c*************************red = PomIncJExact ************************** + + write(ifhi,'(a)') 'openhisto name PomIncJExact' + write(ifhi,'(a)') 'htyp lru xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis n?Pom!(b)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)')'text 0.5 0.8 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + do k=1,nbib + b=b1+(k-0.5)*db + write(ifhi,*)b,PomIncJExact(b) + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c****************************dot = PomIncJUnit *********************** + + write(ifhi,'(a)') 'openhisto name PomIncJUnit' + write(ifhi,'(a)') 'htyp pfc xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis n?Pom!(b)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)')'text 0.5 0.8 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + do k=1,nbib + b=b1+(k-0.5)*db + write(ifhi,*)b,PomIncJUnit(b) + write(*,*) 'Ju',k + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + + end + +c---------------------------------------------------------------------- + subroutine xParPhi1 +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + include 'epos.incpar' + double precision x,xminr,y + double precision PhiExpo + double precision PhiExact + + nptg=30 !number of point for the graphs + biniDf=xpar2 !value of biniDf (impact parameter) + xminr=1.d0/dble(engy**2) !value of xminr for plotting the function + zz=xpar7 + +c************************* red = PhiMExact *************************** + + write(ifhi,'(a)') 'openhisto name Phi1Exact' + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'txt "yaxis [F](x)/x^[a]!"' + write(ifhi,'(a,i4,a,f4.1,a)') + * 'txt "title E=',nint(engy),' b=',biniDf,'"' + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) + y=0.d0 + if(engy**2..lt.5.e06) + & y=Phiexact(zz,zz,.5,dsqrt(x),dsqrt(x),engy**2,biniDf) + & *dsqrt(x)**dble(-alplea(iclpro)) + & *dsqrt(x)**dble(-alplea(icltar)) + write(ifhi,*)x,y + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c********************** blue = PhiMExpo ****************************** + + write(ifhi,'(a)') 'openhisto name Phi1Expo' + write(ifhi,'(a)') 'htyp lba' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a,2e11.3)')'yrange auto auto' + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) + y=Phiexpo(zz,zz,.5,dsqrt(x),dsqrt(x),engy**2,biniDf) + & *dsqrt(x)**dble(-alplea(iclpro)) + & *dsqrt(x)**dble(-alplea(icltar)) + write(ifhi,*) x,y + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + end + + +cc---------------------------------------------------------------------- +c subroutine xParPhi2 +cc---------------------------------------------------------------------- +c +c include 'epos.inc' +c include 'epos.incems' +c include 'epos.incsem' +c include 'epos.incpar' +c double precision x,xminr,xm,y,u(0:100),v(0:100),w(0:100)!,z +c double precision PhiExpo,omGam,PhiExpoK +c double precision PhiExact +c +c nptg=30 !number of point for the graphs +c biniDf=xpar2 !value of biniDf (impact parameter) +c xminr=1.d-3 !/dble(engy**2) !value of xminr for plotting the function +c xm=dble(xpar4) +c +cc************************* yellow = PhiMExact *************************** +c +c write(ifhi,'(a)') 'openhisto name Phi1Exact' +c write(ifhi,'(a)') 'htyp lru' +c write(ifhi,'(a)') 'xmod lin ymod lin' +c write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf +c write(ifhi,'(a)') 'yrange auto auto' +c write(ifhi,'(a)') 'text 0 0 "xaxis x+"' +c write(ifhi,'(a)') 'txt "yaxis [F](x)/x^[a]!"' +c write(ifhi,'(a,i4,a,f4.1,a)') +c * 'txt "title E=',nint(engy),' b=',biniDf,'"' +c write(ifhi,'(a)') 'array 2' +c +c do i=0,nptg +c ! x=xminr +c ! if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) +c y=0.d0 +c if(engy**2..lt.5.e06) +c & y=Phiexact(0.,0.,1.,dsqrt(x),dsqrt(x),engy**2,biniDf) +c ! & *dsqrt(x)**dble(-alplea(iclpro)) +c ! & *dsqrt(x)**dble(-alplea(icltar)) +c write(ifhi,*)x,y +c enddo +c +c write(ifhi,'(a)') ' endarray' +c write(ifhi,'(a)') 'closehisto plot 0-' +c +cc********************** blue = PhiMExpo ****************************** +c +c write(ifhi,'(a)') 'openhisto name Phi1Expo' +c write(ifhi,'(a)') 'htyp lbu' +c write(ifhi,'(a)') 'xmod lin ymod lin' +c write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf +c write(ifhi,'(a,2e11.3)')'yrange auto auto' +c write(ifhi,'(a)') 'array 2' +c +c do i=0,nptg +c ! x=xminr +c ! if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) +c y=Phiexpo(0.,0.,1.,dsqrt(x),dsqrt(x),engy**2,biniDf) +c ! & *dsqrt(x)**dble(-alplea(iclpro)) +c ! & *dsqrt(x)**dble(-alplea(icltar)) +c write(ifhi,*) x,y +c enddo +c +c write(ifhi,'(a)') ' endarray' +c write(ifhi,'(a)') 'closehisto plot 0-' +c +cc********************************************************************** +cc********************************************************************** +c do k=1,koll +c bk(k)=biniDf +c enddo +c call GfunPark(0) +c call integom1(0) +c +cc********************* points = PhiExpoK********************************* +c +c if (biniDf.lt.1.) then +c k=int(10.*biniDf) +c write(ifhi,'(a,I1)') 'openhisto name PhiExpok-b0.',k +c else +c write(ifhi,'(a,f3.1)') 'openhisto name PhiExpok-b',biniDf +c endif +c write(ifhi,'(a)') 'htyp pfc' +c write(ifhi,'(a)') 'xmod log ymod lin' +c write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf +c write(ifhi,'(a,2e11.3)')'yrange auto auto' +c write(ifhi,'(a)') 'text 0 0 "xaxis x"' +c write(ifhi,'(a)') 'text 0 0.1 "yaxis [F](x+,x-)/x^[a]?remn!!"' +c if (xpar8.eq.1.) then +c write(ifhi,'(a,e7.2,a)')'text 0.1 0.9 "s=',engy**2,' GeV^2!"' +c write(ifhi,'(a,f5.2,a)')'text 0.5 0.9 "b=',biniDf,' fm"' +c endif +c write(ifhi,'(a)') 'array 2' +c +c do i=0,nptg +c x=xminr +c if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c y=PhiExpoK(1,dsqrt(x),dsqrt(x)) +c write(ifhi,*) x,y +c enddo +c +c write(ifhi,'(a)') ' endarray' +c write(ifhi,'(a)') 'closehisto plot 0' +c +cc************************* red = PhiMExact*omGam ************************ +c +c write(ifhi,'(a)') 'openhisto name GPhiExact' +c write(ifhi,'(a)') 'htyp lru' +c if(xpar5.eq.0.)then +c write(ifhi,'(a)') 'xmod lin ymod lin' +c else +c write(ifhi,'(a)') 'xmod log ymod log' +c endif +c write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf +c write(ifhi,'(a)') 'yrange auto auto' +c write(ifhi,'(a)') 'text 0 0 "xaxis x+"' +c write(ifhi,'(a,a)') 'text 0 0.1 "yaxis G(x+,x-)*[F]' +c *,'(x+,x-)/x^[a]?remn!!"' +c if (xpar8.eq.1.) then +c write(ifhi,'(a,e7.2,a)')'text 0.1 0.2 "s=',engy**2,' GeV^2!"' +c write(ifhi,'(a,f5.2,a)')'text 0.1 0.1 "b=',biniDf,' fm"' +c write(ifhi,'(a,f5.2,a)')'text 0.1 0.3 "x-=',xm,'"' +c endif +c write(ifhi,'(a)') 'array 2' +c +c do i=0,nptg +c x=xminr +c if(xpar5.ne.0.)then +c if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c else +c x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) +c endif +cc z=1.d0-dsqrt(x) +c v(i)=0.d0 +c if(engy**2..lt.5.e06) +c * v(i)=Phiexact(0.,0.,1.,1.d0-x,1.d0-xm,engy**2,biniDf) +cc * v(i)=Phiexact(0.,0.,1.,z,z,engy**2,biniDf) +c u(i)=omGam(x,xm,biniDf) +cc u(i)=omGam(dsqrt(x),dsqrt(x),biniDf) +c y=u(i)*v(i) +c if(xpar5.ne.0.)y=dabs(y) +c write(ifhi,*)x,y +c enddo +c +c write(ifhi,'(a)') ' endarray' +c write(ifhi,'(a)') 'closehisto plot 0-' +c +cc************************* red = PhiMExpo*omGam ************************ +c +c write(ifhi,'(a)') 'openhisto name GPhiExpo' +c write(ifhi,'(a)') 'htyp lba' +c if(xpar5.eq.0.)then +c write(ifhi,'(a)') 'xmod lin ymod lin' +c else +c write(ifhi,'(a)') 'xmod log ymod log' +c endif +c write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf +c write(ifhi,'(a)') 'yrange auto auto' +c write(ifhi,'(a)') 'text 0 0 "xaxis x+"' +c write(ifhi,'(a,a)') +c * 'text 0 0.1 "yaxis G(x+,x-)*[F]?' +c * ,'(1-x+,1-x-)/x^[a]?remn!!"' +c if (xpar8.eq.1.) then +c write(ifhi,'(a,e7.2,a)')'text 0.1 0.9 "s=',engy**2,' GeV^2!"' +c write(ifhi,'(a,f5.2,a)')'text 0.1 0.8 "b=',biniDf,' fm"' +c write(ifhi,'(a,f5.2,a)')'text 0.1 0.7 "x-=',xm,'"' +c endif +c write(ifhi,'(a)') 'array 2' +c +c do i=0,nptg +c x=xminr +c if(xpar5.ne.0.)then +c if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c else +c x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) +c endif +cc z=1.d0-dsqrt(x) +cc w(i)=Phiexpo(0.,0.,1.,z,z,engy**2,biniDf) +c w(i)=Phiexpo(0.,0.,1.,1.d0-x,1.d0-xm,engy**2,biniDf) +c y=u(i)*w(i) +c if(xpar5.ne.0.)y=dabs(y) +c write(ifhi,*)x,y +c enddo +c +c write(ifhi,'(a)') ' endarray' +c if(xpar5.ne.0.)then +c write(ifhi,'(a)') 'closehisto plot 0-' +c +cc************************* green = omGam ************************ +c +c write(ifhi,'(a)') 'openhisto name GM' +c write(ifhi,'(a)') 'htyp lgo' +c write(ifhi,'(a)') 'array 2' +c +c do i=0,nptg +c x=xminr +c if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c write(ifhi,*)x,dabs(u(i)) +c enddo +c +c write(ifhi,'(a)') ' endarray' +c write(ifhi,'(a)') 'closehisto plot 0-' +c +cc************************* circle = PhiMExact ************************ +c +c write(ifhi,'(a)') 'openhisto name PhiExact' +c write(ifhi,'(a)') 'htyp poc' +c write(ifhi,'(a)') 'array 2' +c +c do i=0,nptg +c x=xminr +c if(xpar5.ne.0.)then +c if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c else +c x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) +c endif +c y=v(i) +c if(xpar5.ne.0.)y=dabs(y) +c write(ifhi,*)x,y +c enddo +c +c write(ifhi,'(a)') ' endarray' +c write(ifhi,'(a)') 'closehisto plot 0-' +c +cc************************* triangle = PhiMExpo ************************ +c +c write(ifhi,'(a)') 'openhisto name PhiExpo' +c write(ifhi,'(a)') 'htyp pot' +c write(ifhi,'(a)') 'array 2' +c +c do i=0,nptg +c x=xminr +c if(xpar5.ne.0.)then +c if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c else +c x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) +c endif +c y=w(i) +c if(xpar5.ne.0.)y=dabs(y) +c write(ifhi,*)x,y +c enddo +c +c write(ifhi,'(a)') ' endarray' +c endif +c write(ifhi,'(a)') 'closehisto plot 0' +c +c end +c + +c---------------------------------------------------------------------- + subroutine xParPhi +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incems' + include 'epos.incsem' + include 'epos.incpar' + double precision x,xminr,y,z(0:200)!,Zn,Znorm + double precision PhiExpo,PhiExact,PhiExpoK + + + nptg=10 !number of point for the graphs + biniDf=xpar2 !value of biniDf (impact parameter) + xminr=max(1.d-6,1.d0/dble(engy**2)) !value of xminr for plotting the function + zz=xpar7 + +c********************** full-red = PhiExact *************************** + + if (biniDf.lt.1.) then + k=int(10.*biniDf) + write(ifhi,'(a,I1)') 'openhisto name PhiExact-b0.',k + else + write(ifhi,'(a,f3.1)') 'openhisto name PhiExact-b',biniDf + endif + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis x"' + write(ifhi,'(a)') 'text 0 0 "yaxis [F](x)/x^[a]"' + write(ifhi,'(a,i4,a,f4.1,a)') + * 'txt "title E=',nint(engy),' b=',biniDf,'"' + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + !x=xminr + !if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) + y=Phiexact(zz,zz,1.,dsqrt(x),dsqrt(x),engy**2,biniDf) + & *dsqrt(x)**dble(-alplea(iclpro)) + & *dsqrt(x)**dble(-alplea(icltar)) + write(ifhi,*)x,y + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c******************** blue = PhiExpo *************************** + + if (biniDf.lt.1.) then + k=int(10.*biniDf) + write(ifhi,'(a,I1)') 'openhisto name PhiExpo-b0.',k + else + write(ifhi,'(a,f3.1)') 'openhisto name PhiExpo-b',biniDf + endif + write(ifhi,'(a)') 'htyp lbu' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a,2e11.3)')'yrange auto auto' + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + !x=xminr + !if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) + z(i)=Phiexpo(zz,zz,1.,dsqrt(x),dsqrt(x),engy**2,biniDf) + & *dsqrt(x)**dble(-alplea(iclpro)) + & *dsqrt(x)**dble(-alplea(icltar)) + write(ifhi,*) x,z(i) + enddo + + write(ifhi,'(a)') ' endarray' +c write(ifhi,'(a)') 'closehisto plot 0-' +c +cc*********************yellow = PhiUnit********************************* +c +c if (biniDf.lt.1.) then +c k=int(10.*biniDf) +c write(ifhi,'(a,I1)') 'openhisto name PhiUnit-b0.',k +c else +c write(ifhi,'(a,f3.1)') 'openhisto name PhiUnit-b',biniDf +c endif +c write(ifhi,'(a)') 'htyp lyu' +c write(ifhi,'(a)') 'xmod lin ymod lin' +c write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf +c write(ifhi,'(a,2e11.3)')'yrange auto auto' +c write(ifhi,'(a)') 'array 2' +c +c Zn=Znorm(engy**2,biniDf) +c +c do i=0,nptg +c !x=xminr +c !if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) +c write(ifhi,*) x,z(i)/Zn +c enddo +c +c write(ifhi,'(a)') ' endarray' + + if(koll.ge.1)then + + write(ifhi,'(a)') 'closehisto plot 0-' + +c********************************************************************** +c********************************************************************** + do k=1,koll + bk(k)=biniDf + enddo + call GfunPark(0) + call integom1(0) + + +c*********************green = PhiExpoK********************************* + + if (biniDf.lt.1.) then + k=int(10.*biniDf) + write(ifhi,'(a,I1)') 'openhisto name PhiExpok-b0.',k + else + write(ifhi,'(a,f3.1)') 'openhisto name PhiExpok-b',biniDf + endif + write(ifhi,'(a)') 'htyp lga' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a,2e11.3)')'yrange auto auto' + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + !x=xminr + !if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) + x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) + z(i)=PhiExpoK(1,dsqrt(x),dsqrt(x)) + write(ifhi,*) x,z(i) + enddo + + write(ifhi,'(a)') ' endarray' + endif + write(ifhi,'(a)') 'closehisto plot 0' + +c + end + +c---------------------------------------------------------------------- + subroutine xParH +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + parameter(idxD2=8) + double precision GbetUni,GbetpUni,HbetUni,HbetpUni,HalpUni + common/DGamUni/GbetUni( idxD0:idxD2),HbetUni( idxD0:idxD2), + & GbetpUni(idxD0:idxD2),HbetpUni(idxD0:idxD2), + & HalpUni(idxD0:idxD2) + double precision x,xminr,y,xm,utgam2 + double precision Hrst + + nptg=20 !number of point for the graphs + biniDf=xpar2 !value of biniDf (impact parameter) + xm=dble(xpar4) !value of xminus +c.....xminr=0.d0 !value of xminr for plotting the function + xminr=1.d0/dble(engy**2) !value of xminr for plotting the function + + imax=idxD1 + if(iomega.eq.2)imax=1 + do i=idxDmin,imax + call Gfunpar(0.,0.,1,i,biniDf,smaxDf,alpx,betx,betpx,epsp,epst + & ,epss,gamv) + enddo + call GfomPar(biniDf,smaxDf) + imax0=idxD1 + if(iomega.eq.2)imax0=1 + imax1=idxD2 + if(iomega.eq.2)imax1=imax1-1 + do i=idxDmin,imax0 + GbetUni(i)=utgam2(betUni(i,1)+1.d0) + GbetpUni(i)=utgam2(betpUni(i,1)+1.d0) + HbetUni(i)=utgam2(GbetUni(i)) + HbetpUni(i)=utgam2(GbetpUni(i)) + HalpUni(i)=alpUni(i,1)*dble(chad(iclpro)*chad(icltar)) + enddo + do i=0,1 + HbetUni(imax0+1+i)=betUni(i,1)+1.d0+betfom + HbetUni(imax0+3+i)=betUni(i,1)+1.d0 + HbetUni(imax0+5+i)=betUni(i,1)+1.d0+betfom + HbetpUni(imax0+1+i)=betpUni(i,1)+1.d0 + HbetpUni(imax0+3+i)=betpUni(i,1)+1.d0+betfom + HbetpUni(imax0+5+i)=betpUni(i,1)+1.d0+betfom + GbetUni(imax0+1+i)=utgam2(HbetUni(imax0+1+i)) + GbetUni(imax0+3+i)=utgam2(HbetUni(imax0+3+i)) + GbetUni(imax0+5+i)=utgam2(HbetUni(imax0+5+i)) + GbetpUni(imax0+1+i)=utgam2(HbetpUni(imax0+1+i)) + GbetpUni(imax0+3+i)=utgam2(HbetpUni(imax0+3+i)) + GbetpUni(imax0+5+i)=utgam2(HbetpUni(imax0+5+i)) + HalpUni(imax0+1+i)=zztUni*alpUni(i,1) + HalpUni(imax0+3+i)=zzpUni*alpUni(i,1) + HalpUni(imax0+5+i)=zzpUni*zztUni*alpUni(i,1) + enddo + +c*********************** red = Hrst ********************************* + + write(ifhi,'(a)') 'openhisto name Hrst' + write(ifhi,'(a)') 'htyp lru' + write(ifhi,'(a)') 'xmod log ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') + * 'text 0 0 "yaxis H?2!(x+,x-)"' + write(ifhi,'(a)') 'text 0 0 "xaxis x+"' + write(ifhi,'(a)') + * 'text 0 0 "yaxis H?2!(x+,x-)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)')'text 0.1 0.2 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)')'text 0.1 0.1 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)')'text 0.1 0.3 "x-=',xm,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminr + if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +c.......x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) + y=Hrst(smaxDf,biniDf,dsqrt(x),dsqrt(x)) + write(ifhi,*)x,y + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + end + + + + +cc---------------------------------------------------------------------- +c subroutine xParHPhiIntnew +cc---------------------------------------------------------------------- +c +c include 'epos.inc' +c include 'epos.incsem' +c include 'epos.incems' +c include 'epos.incpar' +c double precision x,xminr,xm,y +c double precision PhiExact,omGam +cc double precision PhiExpo +c +c nptg=30 !number of point for the graphs +c biniDf=xpar2 !value of biniDf (impact parameter) +c xm=dble(xpar4) !value of xminus +cc.....xminr=0.d0 !value of xminr for plotting the function +c xminr=1.d-3 !/dble(engy**2) !value of xminr for plotting the function +cc************************* black = PhiExact *************************** +c +c write(ifhi,'(a)') 'openhisto name Phi1Exact' +c write(ifhi,'(a)') 'htyp lru' +c if(xpar5.eq.0.)then +c write(ifhi,'(a)') 'xmod lin ymod lin' +c else +c write(ifhi,'(a)') 'xmod log ymod lin' +c endif +c write(ifhi,'(a,2e11.3)')'xrange',xminr,xmaxDf +c write(ifhi,'(a)') 'yrange auto auto' +c write(ifhi,'(a)') 'text 0 0 "xaxis x+"' +c write(ifhi,'(a)') +c * 'text 0 0.1 "yaxis [F]?(x+,x-)/x^[a]?remn!!"' +c if (xpar8.eq.1.) then +c write(ifhi,'(a,e7.2,a)')'text 0.1 0.2 "s=',engy**2,' GeV^2!"' +c write(ifhi,'(a,f5.2,a)')'text 0.1 0.1 "b=',biniDf,' fm"' +c write(ifhi,'(a,f5.2,a)')'text 0.1 0.3 "x-=',xm,'"' +c endif +c write(ifhi,'(a)') 'array 2' +c +c do i=0,nptg +c x=xminr +c if (i.ne.0) x=x*(xmaxDf/xminr)**(dble(i)/dble(nptg)) +cc.......x=xminr+(xmaxDf-xminr)*(dble(i)/dble(nptg)) +c y=Phiexact(0.,0.,1.,dsqrt(x),dsqrt(x),engy**2,biniDf) +c & *omGam(dsqrt(x),dsqrt(x),biniDf) +c write(ifhi,*)x,y +c enddo +c +c write(ifhi,'(a)') ' endarray' +c write(ifhi,'(a)') 'closehisto plot 0' +c +c end +c +c---------------------------------------------------------------------- + subroutine xParHPhiInt +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + double precision y,HPhiInt + common/geom/rmproj,rmtarg,bmax,bkmx + parameter(nbib=32) + + +c************************ dotted = gauss integration ****************** + + b1=0 + b2=max(abs(bkmx),3.)*1.2 + db=(b2-b1)/nbib + + write(ifhi,'(a)') 'openhisto name HPhiExpoInt' + write(ifhi,'(a)') 'htyp pfc xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis Int(H[F]?pp!)(s,b)"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)')'text 0.5 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + imax=idxD1 + if(iomega.eq.2)imax=1 + do k=1,nbib + b=b1+(k-0.5)*db + do i=idxDmin,imax + call Gfunpar(0.,0.,1,i,b,smaxDf,alpx,betx,betpx,epsp,epst,epss + & ,gamv) + call Gfunpar(0.,0.,2,i,b,smaxDf,alpx,betx,betpx,epsp,epst,epss + & ,gamv) + enddo + y=HPhiInt(smaxDf,b) + write(ifhi,*)b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + end + +c---------------------------------------------------------------------- + subroutine xParZ +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incpar' + double precision Znorm,y + common/geom/rmproj,rmtarg,bmax,bkmx + parameter(nbib=12) + + b1=0 + b2=max(abs(bkmx),3.)*1.2 + db=(b2-b1)/nbib + +c************************full-red = Znorm ***************************** + + write(ifhi,'(a)') 'openhisto name Znorm' + write(ifhi,'(a)') 'htyp lru xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis Z(s,b) "' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)')'text 0.1 0.1 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' +c y=Znorm(engy**2,xpar2) + do k=1,nbib + b=b1+(k-0.5)*db + y=Znorm(smaxDf,b) + write(ifhi,*)b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + write(ifhi,'(a)') 'openhisto name un' + write(ifhi,'(a)') 'htyp lba xmod lin ymod lin' + write(ifhi,'(a)') 'array 2' + do k=1,nbib + b=b1+(k-0.5)*db + y=1 + write(ifhi,*)b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + + end + +c---------------------------------------------------------------------- + subroutine xParPro +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + double precision PhiExact,PhiExpo,y,om1intb,om1intbc,om1intgc + &,om1intbi!,PhiUnit + common/geom/rmproj,rmtarg,bmax,bkmx + parameter(nbib=12) + + b1=0 + b2=max(abs(bkmx),3.)*1.2 + db=(b2-b1)/nbib + zz=xpar7 + +c********************* full-red = 1-PhiExact ************************** + + write(ifhi,'(a)') 'openhisto name 1-PhiExact' + write(ifhi,'(a)') 'htyp lru xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis 1-[F]?pp!(1,1) "' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)')'text 0.5 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + do k=1,nbib + b=b1+(k-0.5)*db + y=1.d0-Phiexact(zz,zz,1.,1.d0,1.d0,engy**2,b) + write(ifhi,*)b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c************************** blue-dashed = 1-PhiExpo ******************* + + write(ifhi,'(a)') 'openhisto name 1-PhiExpo' + write(ifhi,'(a)') 'htyp lba xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis 1-[F]?pp!(1,1) "' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)')'text 0.5 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + do k=1,nbib + b=b1+(k-0.5)*db + y=1.d0-Phiexpo(zz,zz,1.,1.d0,1.d0,engy**2,b) + write(ifhi,*)b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + write(ifhi,'(a)') 'openhisto' + write(ifhi,'(a)') 'htyp lga xmod lin ymod lin' + write(ifhi,'(a)') 'array 2' + do k=1,nbib + b=b1+(k-0.5)*db + y=1 + write(ifhi,*)b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + +c****************************** red = om1intbc ******************** + + write(ifhi,'(a)') 'openhisto name om1intbc' + write(ifhi,'(a)') 'htyp lru xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1bc!(b) "' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)')'text 0.5 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + + do k=1,nbib + b=b1+(k-0.5)*db + y=om1intbc(b) + write(ifhi,*)b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c************************* blue dashed = om1intb ******************** + + write(ifhi,'(a)') 'openhisto name om1intb' + write(ifhi,'(a)') 'htyp lba xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1b!(b) "' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)')'text 0.5 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + + do k=1,nbib + b=b1+(k-0.5)*db + y=om1intb(b) + write(ifhi,*)b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c****************************** green dot = om1intgc ******************** + + write(ifhi,'(a)') 'openhisto name om1intgc' + write(ifhi,'(a)') 'htyp lgo xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1gc!(b) "' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)')'text 0.5 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + + do k=1,nbib + b=b1+(k-0.5)*db + y=om1intgc(b) + write(ifhi,*)b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + +c****************************** red = om1intbi(0) ******************** + + write(ifhi,'(a)') 'openhisto name om1intbc' + write(ifhi,'(a)') 'htyp lru xmod lin ymod log' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1bc!(b) "' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)')'text 0.5 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + + do k=1,nbib + b=b1+(k-0.5)*db + y=om1intbi(b,0) + write(ifhi,*)b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c************************* blue dashed = om1intbi(1) ******************** + + write(ifhi,'(a)') 'openhisto name om1intb' + write(ifhi,'(a)') 'htyp lba xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1b!(b) "' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)')'text 0.5 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + + do k=1,nbib + b=b1+(k-0.5)*db + y=om1intbi(b,1) + write(ifhi,*)b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c****************************** green dot = om1intbi(2) ******************** + + write(ifhi,'(a)') 'openhisto name om1intgc' + write(ifhi,'(a)') 'htyp lgo xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1gc!(b) "' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)')'text 0.5 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + + do k=1,nbib + b=b1+(k-0.5)*db + y=om1intbi(b,2) + write(ifhi,*)b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + + + end + +c---------------------------------------------------------------------- + subroutine xParPro1 +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + double precision PhiExact,PhiExpo,y + common/geom/rmproj,rmtarg,bmax,bkmx + parameter(nbib=12) + + b1=0 + b2=max(abs(bkmx),3.)*1.2 + db=(b2-b1)/nbib + zz=xpar7 + +c********************* full-red = 1-PhiExact ************************** + + write(ifhi,'(a)') 'openhisto name 1-PhiExact' + write(ifhi,'(a)') 'htyp lru xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis 1-[F]?pp!(1,1) "' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)')'text 0.5 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + do k=1,nbib + b=b1+(k-0.5)*db + y=1.d0-Phiexact(zz,zz,.5,1.d0,1.d0,engy**2,b) + write(ifhi,*)b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + +c************************** blue-dashed = 1-PhiExpo ******************* + + write(ifhi,'(a)') 'openhisto name 1-PhiExpo' + write(ifhi,'(a)') 'htyp lba xmod lin ymod lin' + write(ifhi,'(a)') 'text 0 0 "xaxis impact parameter b (fm)"' + write(ifhi,'(a)') 'text 0 0 "yaxis 1-[F]?pp!(1,1) "' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)')'text 0.5 0.9 "s=',engy**2,' GeV^2!"' + endif + write(ifhi,'(a)') 'array 2' + do k=1,nbib + b=b1+(k-0.5)*db + y=1.d0-Phiexpo(zz,zz,.5,1.d0,1.d0,engy**2,b) + write(ifhi,*)b,y + enddo + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + + + + end + +c---------------------------------------------------------------------- + subroutine xParGam +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incsem' + include 'epos.incpar' + dimension bet(idxD0:idxD1) + double precision utgam2,xgammag2!,xrem + dimension ip(idxD0:idxD1),imax(idxD0:idxD1) + + nptg=50 !number of point for the graphs + b=xpar2 + gamp=xpar6 + zmax=6. +c xrem=dble(xpar4) + if(idxD0.ne.0.or.idxD1.ne.2) stop "Check xPargam" + + do i=idxD0,idxD1 + imax(i)=4 + bet(i)=0 + enddo + nmax=idxD1 + imax(idxD0)=int(zmax) + imax(1)=imax(idxD0) + imax(2)=imax(idxD0) + + do i=idxD0,nmax + gam=gamD(i,iclpro,icltar)*b**2 + bet(i)=gam+betDp(i,iclpro,icltar)-alppar+1. + enddo + write(ifhi,'(a)') 'openhisto name gExact' + write(ifhi,'(a)') 'htyp pfs' + write(ifhi,'(a)') 'xmod lin ymod log' + write(ifhi,'(a,2e11.3)')'xrange',0.,zmax + write(ifhi,'(a)') 'yrange auto auto' +c write(ifhi,'(a)')'yrange 1.e-10 2' + write(ifhi,'(a)') 'text 0 0 "xaxis z"' + write(ifhi,'(a)') 'text 0 0 "yaxis g(z) "' + write(ifhi,'(a)') 'array 2' + + do ip0=0,imax(0) + ip(0)=ip0 + do ip1=0,imax(1) + ip(1)=ip1 + do ip2=0,imax(2) + ip(2)=ip2 + t=0. + do i=idxD0,nmax + t=t+real(ip(i))*bet(i) + enddo + write(ifhi,'(2e14.6)')t,utgam2(dble(alplea(2))+1.D0) + & /utgam2(dble(alplea(2))+1.D0+dble(t)) + enddo + enddo + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + write(ifhi,'(a)') 'openhisto name gExpo' + write(ifhi,'(a)') 'htyp lbu' + write(ifhi,'(a)') 'xmod lin ymod log' + write(ifhi,'(a,2e11.3)')'xrange',0.,zmax + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis z"' + write(ifhi,'(a)') 'text 0 0 "yaxis g(z)"' + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + t=zmax*(real(i)/real(nptg)) + write(ifhi,'(2e14.6)') t,dexp(-dble(t)) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + +c********************************************************************** + + + + write(ifhi,'(a)') 'openhisto name gPower' + write(ifhi,'(a)') 'htyp poc' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',0.,zmax + write(ifhi,'(a)') 'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis t"' + write(ifhi,'(2a)') 'text 0 0 ', + & '"yaxis [P][G](1+[a]?L!)/[G](1+[a]?L!+[b])"' + write(ifhi,'(a)') 'array 2' + + do ip0=0,imax(0) + ip(0)=ip0 + do ip1=0,imax(1) + ip(1)=ip1 + do ip2=0,imax(2) + ip(2)=ip2 +c$$$ do ip3=0,imax(3) +c$$$ ip(3)=ip3 + t=0. + do i=idxD0,nmax + t=t+real(ip(i))*bet(i) + enddo + write(ifhi,'(2e14.6)')t,xgammag2(iclpro,bet,ip,gamp) +c$$$ enddo + enddo + enddo + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + end + +c---------------------------------------------------------------------- + subroutine xParOmega1xy +c---------------------------------------------------------------------- +c xpar2=b +c xpar4=xh +c xpar3=y +c xpar7 : nucl coef +c xpar8 : 2=xp/xm instead of xh/yp +c---------------------------------------------------------------------- + include 'epos.incems' + include 'epos.incsem' + include 'epos.inc' + include 'epos.incpar' + ! double precision om1x,om1y + double precision x,ranhis(0:51),y,ymax,xh + &,om1xpk,om1xmk,t,om1xk,om1yk,xpr1,xmr1!,xp,xm,xmin,xmax + common /psar7/ delx,alam3p,gam3p + + nptg=50 !number of point for the graphs + biniDf=xpar2 !value of biniDf (impact paramter) + xh=0.99d0 + xpr1=1.d0 + xmr1=1.d0 + if(xpar4.lt.1..and.xpar4.gt.0.)then + xh=dble(xpar4**2) !value of x + xpr1=dble(xpar4) + xmr1=dble(xpar4) + endif + do i=0,51 + ranhis(i)=0.d0 + enddo +c$$$ xp=dsqrt(xh)*dble(exp(xpar3)) !y=xpar3 +c$$$ xm=1.d0 +c$$$ if(xp.ne.0.d0)xm=xh/xp + + + + if(koll.eq.0)then + + call xhistomran1(ranhis,biniDf) + + stop'om1x not defined' + + + write(ifhi,'(a)') 'openhisto name Om1x' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminDf,xmaxDf + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis X"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1x!"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminDf + if (i.ne.0) x=x*(xmaxDf/xminDf)**(dble(i)/dble(nptg)) +c.......x=xminDf+(xmaxDf-xminDf)*(dble(i)/dble(nptg)) + write(ifhi,*) x, 0 !om1x(x,biniDf) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto name Om1xRan' + write(ifhi,'(a)') 'htyp his' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminDf,xmaxDf + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis X"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1x! random"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,51 + x=xminDf + if (i.ne.0) x=x*(xmaxDf/xminDf)**((dble(i)+.5d0)/51.d0) +c.......x=xminDf+(xmaxDf-xminDf)*((dble(i)+.5d0)/51.d0) + write(ifhi,*) x,ranhis(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + x=xh + ymax=-.5D0*dlog(x) + do i=0,51 + ranhis(i)=0.d0 + enddo + call xhistomran2(ranhis,x,biniDf) + + stop'om1y not defined' + + write(ifhi,'(a)') 'openhisto name Om1y' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-ymax-1.d0,ymax+1.d0 + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis Y"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1y!"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + y=-ymax+(2.d0*ymax)*(dble(i)/dble(nptg)) + write(ifhi,*) y, 0 !om1y(x,y,biniDf) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto name Om1yRan' + write(ifhi,'(a)') 'htyp his' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-ymax-1.d0,ymax+1.d0 + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis Y"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1y! random"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,50 + y=-ymax+(2.d0*ymax)*(dble(i)/50.d0) + write(ifhi,*) y,ranhis(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + +c********************************************************************** + + else + + do k=1,koll + bk(k)=biniDf + enddo + call GfunPark(0) + call integom1(0) + + if(xpar8.eq.2.)then + + call xhistomran8(ranhis,xpr1,xmr1) + + + write(ifhi,'(a)') 'openhisto name Om1xp' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminDf,xmaxDf + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis X+"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1x+!"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminDf + if (i.ne.0) x=x*(xmaxDf/xminDf)**(dble(i)/dble(nptg)) +c.......x=xminDf+(xmaxDf-xminDf)*(dble(i)/dble(nptg)) + t=om1xpk(x,xpr1,1) + write(ifhi,*) x,t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto name Om1xpRan' + write(ifhi,'(a)') 'htyp his' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminDf,xmaxDf + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis X+"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1x+! random"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,51 + x=xminDf + if (i.ne.0) x=x*(xmaxDf/xminDf)**(dble(i)/dble(nptg)) +c.......x=xminDf+(xmaxDf-xminDf)*((dble(i)+.5d0)/51.d0) + write(ifhi,*) x,ranhis(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + do i=0,51 + ranhis(i)=0.d0 + enddo + + call xhistomran9(ranhis,xh,xpr1,xmr1) + + + write(ifhi,'(a)') 'openhisto name Om1xm' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminDf,xmaxDf + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis X-"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1x-!"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.8 "x+=',xh,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminDf + if (i.ne.0) x=x*(xmaxDf/xminDf)**(dble(i)/dble(nptg)) +c.......x=xminDf+(xmaxDf-xminDf)*(dble(i)/dble(nptg)) + t=om1xmk(xh,x,xpr1,xmr1,1) + write(ifhi,*) x,t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto name Om1xmRan' + write(ifhi,'(a)') 'htyp his' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminDf,xmaxDf + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis X-"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1x-! random"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.8 "x+=',xh,'"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,51 + x=xminDf + if (i.ne.0) x=x*(xmaxDf/xminDf)**(dble(i)/dble(nptg)) +c.......x=xminDf+(xmaxDf-xminDf)*((dble(i)+.5d0)/51.d0) + write(ifhi,*) x,ranhis(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + +c********************************************************************** + else + + call xhistomran10(ranhis) + + + write(ifhi,'(a)') 'openhisto name Om1xk' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminDf,xmaxDf + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis X"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1x!"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + x=xminDf + if (i.ne.0) x=x*(xmaxDf/xminDf)**(dble(i)/dble(nptg)) +c.......x=xminDf+(xmaxDf-xminDf)*(dble(i)/dble(nptg)) + t=om1xk(x,1) + write(ifhi,*) x,t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto name Om1xpRan' + write(ifhi,'(a)') 'htyp his' + write(ifhi,'(a)') 'xmod log ymod log' + write(ifhi,'(a,2e11.3)')'xrange',xminDf,xmaxDf + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis X+"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1x+! random"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,51 + x=xminDf + if (i.ne.0) x=x*(xmaxDf/xminDf)**(dble(i)/dble(nptg)) +c.......x=xminDf+(xmaxDf-xminDf)*((dble(i)+.5d0)/51.d0) + write(ifhi,*) x,ranhis(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + ymax=-.5D0*dlog(xh) + do i=0,51 + ranhis(i)=0.d0 + enddo + + call xhistomran11(ranhis,xh) + + + + write(ifhi,'(a)') 'openhisto name Om1yk' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-ymax-1.d0,ymax+1.d0 + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis Y"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1y!"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,nptg + y=-ymax+(2.d0*ymax)*(dble(i)/dble(nptg)) + t=om1yk(xh,y,1) + write(ifhi,*) y,t + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + write(ifhi,'(a)') 'openhisto name Om1yRan' + write(ifhi,'(a)') 'htyp his' + write(ifhi,'(a)') 'xmod lin ymod lin' + write(ifhi,'(a,2e11.3)')'xrange',-ymax-1.d0,ymax+1.d0 + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis Y"' + write(ifhi,'(a)') 'text 0 0 "yaxis [w]?1y! random"' + if (xpar8.eq.1.) then + write(ifhi,'(a,e7.2,a)') 'text 0.1 0.9 "s=',engy**2,' GeV^2!"' + write(ifhi,'(a,f5.2,a)') 'text 0.5 0.9 "b=',biniDf,' fm"' + endif + write(ifhi,'(a)') 'array 2' + + do i=0,50 + y=-ymax+(2.d0*ymax)*(dble(i)/50.d0) + write(ifhi,*) y,ranhis(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0' + + + endif + + endif + + return + end + +c---------------------------------------------------------------------- + subroutine xRanPt +c---------------------------------------------------------------------- +c xpar2=xcut +c---------------------------------------------------------------------- + include 'epos.inc' + parameter (nptg1=501) !number of point for the graphs + double precision ranhis(0:nptg1) + common /cranpt/conv + + nptg=nptg1-1 + xcut=xpar2 !value of biniDf (impact paramter) + xfact=xpar3 + xadd=xpar4 + xmax=10. + conv=10./float(nptg) + if(xcut.le.0.)xcut=float(nptg) + if(xfact.le.0.)xfact=1. + do i=0,nptg1 + ranhis(i)=0.d0 + enddo +c$$$ xp=dsqrt(xh)*dble(exp(xpar3)) !y=xpar3 +c$$$ xm=1.d0 +c$$$ if(xp.ne.0.d0)xm=xh/xp + + if(xpar1.ge.1.)then + + call xranptg(ranhis,xcut,xfact,xadd) + + + + write(ifhi,'(a)') 'openhisto name ranpt' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod lin ymod log' + write(ifhi,'(a,2e11.3)')'xrange',0.,min(xmax,xfact*xcut+xadd+1.) + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis pt"' + write(ifhi,'(a)') 'text 0 0 "yaxis P"' + write(ifhi,'(a)') 'array 2' + + + do i=0,nptg + x=float(i)*conv + write(ifhi,*) x,ranhis(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + endif + + if(xpar1.ge.2.)then + + call xranpte(ranhis,xcut,xfact,xadd) + + + + write(ifhi,'(a)') 'openhisto name ranpt' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod lin ymod log' + write(ifhi,'(a,2e11.3)')'xrange',0.,min(xmax,xfact*xcut+xadd+1.) + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis pt"' + write(ifhi,'(a)') 'text 0 0 "yaxis P"' + write(ifhi,'(a)') 'array 2' + + + do i=0,nptg + x=float(i)*conv + write(ifhi,*) x,ranhis(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + + endif + + if(xpar1.ge.3.)then + + call xranpts(ranhis,xcut,xfact,xadd) + + + + write(ifhi,'(a)') 'openhisto name ranpt' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod lin ymod log' + write(ifhi,'(a,2e11.3)')'xrange',0.,min(xmax,xfact*xcut+xadd+1.) + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis pt"' + write(ifhi,'(a)') 'text 0 0 "yaxis P"' + write(ifhi,'(a)') 'array 2' + + + do i=0,nptg + x=float(i)*conv + write(ifhi,*) x,ranhis(i) + enddo + + write(ifhi,'(a)') ' endarray' + write(ifhi,'(a)') 'closehisto plot 0-' + + endif + + call xranptc(ranhis,xcut,xfact,xadd) + + + + write(ifhi,'(a)') 'openhisto name ranpt' + write(ifhi,'(a)') 'htyp lin' + write(ifhi,'(a)') 'xmod lin ymod log' + if(xpar1.ge.1)then + write(ifhi,'(a,2e11.3)')'xrange',0.,min(xmax,xfact*xcut+xadd+1.) + else + write(ifhi,'(a,2e11.3)')'xrange',0.,1. + endif + write(ifhi,'(a)')'yrange auto auto' + write(ifhi,'(a)') 'text 0 0 "xaxis pt"' + write(ifhi,'(a)') 'text 0 0 "yaxis P"' + write(ifhi,'(a)') 'array 2' + + + do i=0,nptg + x=float(i)*conv + write(ifhi,*) x,ranhis(i) + enddo + + write(ifhi,'(a)') ' endarray' + + + return + end + +c---------------------------------------------------------------------- + + double precision function xgammag2(iclrem,bet,ip,gamp) + +c---------------------------------------------------------------------- + include 'epos.inc' + include 'epos.incsem' + double precision utgam2 + dimension bet(idxD0:idxD1),ip(idxD0:idxD1) + + xgammag2=1.d0 + + imax=idxD1 + + do i=idxD0,imax + if(ip(i).ne.0) xgammag2=xgammag2 + & *(utgam2(dble(alplea(iclrem))+1.d0+dble(gamp)) + & /(max(0.d0,dble(int(gamp+0.5))+1)) + & /utgam2(dble(alplea(iclrem)+bet(i)+gamp)+1.D0)) + & **dble(ip(i)) + enddo + + return + end + +c---------------------------------------------------------------------- + + function xsigmafit(x) + +c---------------------------------------------------------------------- + + include 'epos.inc' + include 'epos.incpar' + double precision x,xDfit,sfsh,varifit,range,sig2 + double precision bf(maxdataDf),Db(maxdataDf) + external varifit + + + sig2=bmaxDf/2. + range=sig2 + xp=real(dsqrt(x)) + xm=xp + zz=xpar7 + + + sfsh=xDfit(zz,0,1,smaxDf,xp,xm,0.) + if(dabs(sfsh).ge.1.d-5)then + do i=0,nptf-1 + bf(i+1)=dble(-bmaxDf+real(i)*2.*bmaxDf/real(nptf-1)) + Db(i+1)=xDfit(zz,0,1,smaxDf,xp,xm,real(bf(i+1)))/sfsh + enddo + +c.....Fit of D(X,b) between -bmaxDf and bmaxDf + call minfit(varifit,bf,Db,nptf,sig2,range) + + xsigmafit=real(sig2) + else + xsigmafit=0. + endif + + + return + end + + +c---------------------------------------------------------------------- + + subroutine xhistomran1(histo,b) + +c---------------------------------------------------------------------- +c.....Make Histogram of om1xr +c---------------------------------------------------------------------- + + include 'epos.incpar' + + double precision histo(0:51),x,x1 !,om1xr + integer*4 n + + + n=100000 + do i=0,51 + histo(i)=0.d0 + enddo + do 111 j=1,n + if(mod(j,10000).eq.0)write(*,*)"x1",j,b + x=0 !om1xr(b) + stop'om1xr(b) not defined' + if(x.lt.xminDf)goto 111 +c.........Exponential + k=int((-dlog(x)/dlog(xminDf)+1.d0)*51.d0) +c.........Linear +c.........k=int(x*50.d0) + histo(k)=histo(k)+1.d0 + 111 continue + do i=0,51 + +c.......Exponential + + x=xminDf + x1=xminDf + x=x**(1.d0-dble(i)/51.d0) + x1=x1**(1.d0-dble(i+1)/51.d0) + if(i.eq.51)then + x1=1.d0 + x=0.d0 + endif + histo(i)=histo(i)/dble(n)/(x1-x) + +c.......Linear +c histo(i)=histo(i)/dble(n)*51.d0 + enddo + + return + end + + +c---------------------------------------------------------------------- + + subroutine xhistomran2(histo,xh,b) + +c---------------------------------------------------------------------- +c.....Make Histogram of om1yr +c---------------------------------------------------------------------- + + double precision histo(0:51),x,xh,dx,ymax !,om1yr + integer*4 n + + ymax=-.5D0*dlog(xh) + dx=ymax/25.d0 + + n=100000 + do i=0,50 + histo(i)=0.d0 + enddo + do j=1,n + if(mod(j,10000).eq.0)write(*,*)"y1",j,b + x= 0 ! om1yr(xh,b) + stop'om1yr(xh,b) not defined' + k=int((x/ymax+1.d0)*25.d0) +c.......write(*,*)x,k + histo(k)=histo(k)+1.d0 + enddo + do i=0,50 + histo(i)=histo(i)/dble(n)/dx + enddo + + return + end + + +cc---------------------------------------------------------------------- +c +c subroutine xhistomran6(histo,bx,by,bmax,del) +c +cc---------------------------------------------------------------------- +cc.....Make Histogram of b1 (impact parameter of vertex in Y and X) +cc---------------------------------------------------------------------- +c +c double precision histo(0:51),dx +c integer*4 n +c +c n=100000 +c dx=dble(bmax)/50.d0 +c do i=0,50 +c histo(i)=0.d0 +c enddo +c do j=1,n +c if(mod(j,10000).eq.0)write(*,*)"b1",j +c z=rangen() +c zp=rangen() +c bb1x=(bx+sqrt(-del*log(z))*cos(2.*3.14*zp))/2. +c bb1y=(by+sqrt(-del*log(z))*sin(2.*3.14*zp))/2. +c x=sqrt((bx-bb1x)*(bx-bb1x)+(by-bb1y)*(by-bb1y)) +c k=int(x/bmax*50.) +c if(k.le.50)then +c histo(k)=histo(k)+1.d0 +c else +c histo(51)=histo(51)+1.d0 +c endif +c enddo +c do i=0,50 +c histo(i)=histo(i)/dble(n)/dx +c enddo +c +c return +c end +c + +c---------------------------------------------------------------------- + + subroutine xhistomran8(histo,xpr,xmr) + +c---------------------------------------------------------------------- +c.....Make Histogram of om1xprk +c---------------------------------------------------------------------- + + include 'epos.incpar' + + double precision histo(0:51),x,x1,om1xprk,xpr,xmr + integer*4 n + + + n=100000 + do i=0,51 + histo(i)=0.d0 + enddo + do 111 j=1,n + if(mod(j,10000).eq.0)write(*,*)"x+",j,xmr + x=om1xprk(1,xpr,xminDf,1) + if(x.lt.xminDf)goto 111 +c.........Exponential + k=int((-dlog(x)/dlog(xminDf)+1.d0)*51.d0) +c.........Linear +c.........k=int(x*50.d0) + histo(k)=histo(k)+1.d0 + 111 continue + do i=0,51 + +c.......Exponential + + x=xminDf + x1=xminDf + x=x**(1.d0-dble(i)/51.d0) + x1=x1**(1.d0-dble(i+1)/51.d0) + if(i.eq.51)then + x1=1.d0 + x=0.d0 + endif + histo(i)=histo(i)/dble(n)/(x1-x)*xpr + +c.......Linear +c histo(i)=histo(i)/dble(n)*51.d0 + enddo + + return + end + +c---------------------------------------------------------------------- + + subroutine xhistomran9(histo,xp,xpr,xmr) + +c---------------------------------------------------------------------- +c.....Make Histogram of om1xmrk +c---------------------------------------------------------------------- + + include 'epos.incpar' + + double precision histo(0:51),x,x1,om1xmrk,xp,xpr,xmr + integer*4 n + + + n=100000 + do i=0,51 + histo(i)=0.d0 + enddo + do 111 j=1,n + if(mod(j,10000).eq.0)write(*,*)"x-",j + x=om1xmrk(1,xp,xpr,xminDf,1) + if(x.lt.xminDf)goto 111 +c.........Exponential + k=int((-dlog(x)/dlog(xminDf)+1.d0)*51.d0) +c.........Linear +c.........k=int(x*50.d0) + histo(k)=histo(k)+1.d0 + 111 continue + do i=0,51 + +c.......Exponential + + x=xminDf + x1=xminDf + x=x**(1.d0-dble(i)/51.d0) + x1=x1**(1.d0-dble(i+1)/51.d0) + if(i.eq.51)then + x1=1.d0 + x=0.d0 + endif + histo(i)=histo(i)/dble(n)/(x1-x)*xmr + +c.......Linear +c histo(i)=histo(i)/dble(n)*51.d0 + enddo + + return + end + +c---------------------------------------------------------------------- + + subroutine xhistomran10(histo) + +c---------------------------------------------------------------------- +c.....Make Histogram of om1xrk +c---------------------------------------------------------------------- + + include 'epos.incpar' + + double precision histo(0:51),x,x1,om1xrk + integer*4 n + + + n=100000 + do i=0,51 + histo(i)=0.d0 + enddo + do 111 j=1,n + if(mod(j,10000).eq.0)write(*,*)"xk",j + x=om1xrk(1) + if(x.lt.xminDf)goto 111 +c.........Exponential + k=int((-dlog(x)/dlog(xminDf)+1.d0)*51.d0) +c.........Linear +c.........k=int(x*50.d0) + histo(k)=histo(k)+1.d0 + 111 continue + do i=0,51 + +c.......Exponential + + x=xminDf + x1=xminDf + x=x**(1.d0-dble(i)/51.d0) + x1=x1**(1.d0-dble(i+1)/51.d0) + if(i.eq.51)then + x1=1.d0 + x=0.d0 + endif + histo(i)=histo(i)/dble(n)/(x1-x) + +c.......Linear +c histo(i)=histo(i)/dble(n)*51.d0 + enddo + + return + end + + +c---------------------------------------------------------------------- + + subroutine xhistomran11(histo,xh) + +c---------------------------------------------------------------------- +c.....Make Histogram of om1yrk +c---------------------------------------------------------------------- + + double precision histo(0:51),x,xh,dx,om1yrk,ymax + integer*4 n + + ymax=-.5D0*dlog(xh) + dx=ymax/25.d0 + + n=100000 + do i=0,50 + histo(i)=0.d0 + enddo + do j=1,n + if(mod(j,10000).eq.0)write(*,*)"yk",j + x=om1yrk(xh) + k=int((x/ymax+1.d0)*25.d0) +c.......write(*,*)x,k + histo(k)=histo(k)+1.d0 + enddo + do i=0,50 + histo(i)=histo(i)/dble(n)/dx + enddo + + return + end + +c---------------------------------------------------------------------- + + subroutine xranptg(histo,xcut,xfact,xadd) + +c---------------------------------------------------------------------- +c.....Make Histogram of random distribution +c---------------------------------------------------------------------- + + include 'epos.incpar' + + parameter (nptg1=501) !number of point for the graphs + common /cranpt/conv + double precision histo(0:nptg1) + integer*4 n + + + n=100000 + do i=0,nptg1 + histo(i)=0.d0 + enddo + do j=1,n + if(mod(j,10000).eq.0)write(*,*)"ptg",j +c .........exp(-x**2) + 12 x=sqrt(-log(rangen())/(3.1415927/4.)) !gauss + + if(xcut.gt.0.)then + if(rangen().lt.x/xcut)goto 12 + endif + x=x*xfact+xadd +c.........Exponential +c k=int((-dlog(x)/dlog(xminDf)+1.d0)*51.d0) +c.........Linear + k=int(x/conv) + k=min(k,nptg1) + histo(k)=histo(k)+1.d0 + enddo + do i=0,nptg1 + +c.......Exponential + +c x=xminDf +c x1=xminDf +c x=x**(1.d0-dble(i)/51.d0) +c x1=x1**(1.d0-dble(i+1)/51.d0) +c if(i.eq.51)then +c x1=1.d0 +c x=0.d0 +c endif +c histo(i)=histo(i)/dble(n)/(x1-x) + +c.......Linear + histo(i)=histo(i)/dble(n)*float(nptg1) + enddo + + return + end + +c---------------------------------------------------------------------- + + subroutine xranpte(histo,xcut,xfact,xadd) + +c---------------------------------------------------------------------- +c.....Make Histogram of random distribution +c---------------------------------------------------------------------- + + include 'epos.incpar' + + parameter (nptg1=501) !number of point for the graphs + common /cranpt/conv + double precision histo(0:nptg1) + integer*4 n + + + n=100000 + do i=0,nptg1 + histo(i)=0.d0 + enddo + do j=1,n + if(mod(j,10000).eq.0)write(*,*)"pte",j +c .........exp(-x) + 12 xmx=50 + r=2. + x=0. + do while (r.gt.1.) + 11 x=sqrt(exp(rangen()*log(1+xmx**2))-1) + if(x.eq.0.)goto11 + r=rangen() / ( exp(-x)*(1+x**2) ) + enddo + x=x/2. + + if(xcut.gt.0.)then + if(rangen().lt.x/xcut)goto 12 + endif + x=x*xfact+xadd +c.........Exponential +c k=int((-dlog(x)/dlog(xminDf)+1.d0)*51.d0) +c.........Linear + k=int(x/conv) + k=min(k,nptg1) + histo(k)=histo(k)+1.d0 + enddo + do i=0,nptg1 + +c.......Exponential + +c x=xminDf +c x1=xminDf +c x=x**(1.d0-dble(i)/51.d0) +c x1=x1**(1.d0-dble(i+1)/51.d0) +c if(i.eq.51)then +c x1=1.d0 +c x=0.d0 +c endif +c histo(i)=histo(i)/dble(n)/(x1-x) + +c.......Linear + histo(i)=histo(i)/dble(n)*float(nptg1) + enddo + + return + end + +c---------------------------------------------------------------------- + + subroutine xranpts(histo,xcut,xfact,xadd) + +c---------------------------------------------------------------------- +c.....Make Histogram of random distribution +c---------------------------------------------------------------------- + + include 'epos.incpar' + + parameter (nptg1=501) !number of point for the graphs + common /cranpt/conv + double precision histo(0:nptg1) + integer*4 n + + + n=100000 + do i=0,nptg1 + histo(i)=0.d0 + enddo + do j=1,n + if(mod(j,10000).eq.0)write(*,*)"pts",j +c .........exp(-sqrt(x)) + 12 xmx=500 + r=2. + x=0. + do while (r.gt.1.) + x=sqrt(exp(rangen()*log(1+xmx**2))-1) + r=rangen() / ( exp(-sqrt(x))*(1+x**2)/5. ) + enddo + x=x/20. + + if(xcut.gt.0.)then + if(rangen().lt.x/xcut)goto 12 + endif + x=x*xfact+xadd +c.........Exponential +c k=int((-dlog(x)/dlog(xminDf)+1.d0)*51.d0) +c.........Linear + k=int(x/conv) + k=min(k,nptg1) + histo(k)=histo(k)+1.d0 + enddo + do i=0,nptg1 + +c.......Exponential + +c x=xminDf +c x1=xminDf +c x=x**(1.d0-dble(i)/51.d0) +c x1=x1**(1.d0-dble(i+1)/51.d0) +c if(i.eq.51)then +c x1=1.d0 +c x=0.d0 +c endif +c histo(i)=histo(i)/dble(n)/(x1-x) + +c.......Linear + histo(i)=histo(i)/dble(n)*float(nptg1) + enddo + + return + end + +c---------------------------------------------------------------------- + + subroutine xranptc(histo,xcut,xfact,xadd) + +c---------------------------------------------------------------------- +c.....Make Histogram of random distribution +c---------------------------------------------------------------------- + + include 'epos.incpar' + + parameter (nptg1=501) !number of point for the graphs + common /cranpt/conv + double precision histo(0:nptg1) + integer*4 n + + + n=100000 + do i=0,nptg1 + histo(i)=0.d0 + enddo + do j=1,n + if(mod(j,10000).eq.0)write(*,*)"ptc",j + + x=ranptcut(xcut)*xfact+xadd +c.........Exponential +c k=int((-dlog(x)/dlog(xminDf)+1.d0)*51.d0) +c.........Linear + k=int(x/conv) + k=min(k,nptg1) + histo(k)=histo(k)+1.d0 + enddo + do i=0,nptg1 + +c.......Exponential + +c x=xminDf +c x1=xminDf +c x=x**(1.d0-dble(i)/51.d0) +c x1=x1**(1.d0-dble(i+1)/51.d0) +c if(i.eq.51)then +c x1=1.d0 +c x=0.d0 +c endif +c histo(i)=histo(i)/dble(n)/(x1-x) + +c.......Linear + histo(i)=histo(i)/dble(n)*float(nptg1) + enddo + + return + end + + + diff --git a/modules/epos/epos.cpp b/modules/epos/epos.cpp new file mode 100644 index 0000000000000000000000000000000000000000..757fba685e75c91973bc3401f21f29a30ab22965 --- /dev/null +++ b/modules/epos/epos.cpp @@ -0,0 +1,14 @@ +#include <epos.hpp> + +namespace epos { + + // this is needed as linker object, but it is not needed to do anything + void ranfini_(double&, int&, int&) {} + + // this is needed as linker object, but it is not needed to do anything + void ranfcv_(double&) {} + + double rangen_() { return ::epos::rndm_interface(); } + +} + diff --git a/modules/epos/epos.hpp b/modules/epos/epos.hpp new file mode 100644 index 0000000000000000000000000000000000000000..47c2939d2e331c7ce60614d98e3765189d703127 --- /dev/null +++ b/modules/epos/epos.hpp @@ -0,0 +1,276 @@ +/* + * (c) Copyright 2018 CORSIKA Project, corsika-project@lists.kit.edu + * + * This software is distributed under the terms of the GNU General Public + * Licence version 3 (GPL Version 3). See file LICENSE for a full version of + * the license. + */ + +#pragma once + +#include <array> + +/** + * \file epos.hpp + * + * Interface file for the EPOS library. + */ + +namespace epos { + /** + * \function epos::rndm_interface + * + * this is the random number hook to external packages. + * + * CORSIKA8, for example, has to provide an implementation of this. + **/ + extern double rndm_interface(); + + extern "C" { + + void aaset_(int&); + void atitle_(); + double LHCparameters_(); + void hdecin_(bool&); + void hnbspd_(int&); + void hnbpajini_(); + void conini_(); + void psaini_(); + + void idspin_(int&, int&, int&, int&); + void iclass_(int&, int&); + void emsini_(double&, int&, int&); + void paramini_(int&); + void xsigma_(); + + double cxepocrse_(double&, int&, int&, int&); + + void emsaaa_(int&); + void gakfra_(int&, int&); + void utghost_(int&); + void bjinta_(int&); + void utresc_(int&); + + void emsfrag_(int&); + + void cxidmass_(int&, int&); + + // additional random number functions + void ranfini_(double&, int&, int&); + void ranfcv_(double&); + // void ranfgt(int&); + double rangen_(); + + // common blocks as + // defined in epos.inc + + extern struct { int inicnt; } cicnt_; + + extern struct { + int intpol; + int isigma; + int iomega; + int isetcs; + } hadr6_; + + extern struct { int infragm; } nucl6_; + + extern struct { + int iorsce; + int iorsdf; + int iorshh; + int ionudi; + } cjinti_; + + extern struct { + float airznxs[3]; + float airanxs[3]; + float airwnxs[3]; + float airavznxs; + float airavanxs; + } nxsair_; + + extern struct { + int iappl; + int model; + } appli_; + + extern struct { + int nevent; + int nfull; + int nfreeze; + int ninicon; + } events_; + + extern struct { + int ifrade; + int iframe; + int idecay; + int jdecay; + int iremn; + } othe2_; + // integer ifrade,iframe,idecay,jdecay,iremn + // common/othe2/ifrade,iframe,idecay,jdecay,iremn + + extern struct { int ktnbod; } metr7_; + // integer ktnbod + // common/metr7/ktnbod + + extern struct { + float egylow; + float egyfac; + } had12_; + // real egylow,egyfac + // common/had12/egylow,egyfac + + extern struct { + int laproj; + int maproj; + int latarg; + int matarg; + float core; + float fctrmx; + } nucl1_; + // real core,fctrmx + // integer laproj,maproj,latarg,matarg + // common/nucl1/laproj,maproj,latarg,matarg,core,fctrmx + + extern struct { + float amproj; + float amtarg; + float ypjtl; + float yhaha; + float pnullx; + } chadron_; + // real amproj,amtarg,ypjtl,yhaha,pnullx + // common/chadron/amproj,amtarg,ypjtl,yhaha,pnullx + + extern struct { + int iomodl; + int idproj; + int idtarg; + float wexcit; + } hadr2_; + // integer iomodl,idproj,idtarg + // real wexcit + // common/hadr2/iomodl,idproj,idtarg,wexcit + + extern struct { + int idprojin; + int idtargin; + float rexdifi[4]; + float rexndii[4]; + int irdmpr; + int isoproj; + int isotarg; + } hadr25_; + + // real rexdifi,rexndii + // integer idprojin,idtargin,irdmpr,isoproj,isotarg + // common/hadr25/idprojin,idtargin,rexdifi(4),rexndii(4),irdmpr, + // * isoproj,isotarg + + extern struct { + float engy; + float elepti; + float elepto; + float angmue; + int icinpu; + } lept1_; + // real engy, elepti, elepto, angmue integer icinpu + // common / lept1 / engy, elepti, elepto, + // angmue, + // icinpu + + extern struct { + float egymin; + float egymax; + float elab; + float ecms; + float ekin; + } enrgy_; + // real egymin, egymax, elab, ecms, ekin + // common / enrgy / egymin, egymax, elab, ecms, + // ekin + + extern struct { + float pnll; + float ptq; + float exmass; + float cutmss; + float wproj; + float wtarg; + } hadr1_; + // real pnll, ptq, exmass, cutmss, wproj, wtarg + // common / hadr1 / pnll, ptq, exmass, cutmss, + // wproj, + // wtarg + + unsigned int constexpr idxD0 = 0; + unsigned int constexpr idxD1 = 2; + unsigned int constexpr idxD = 1; + unsigned int constexpr nclha = 4; + unsigned int constexpr nclegy = 100; + + extern struct { + float alpD[nclha][nclha][idxD1 - idxD0 + 1]; + float alpdp[nclha][nclha][idxD1 - idxD0 + 1]; + float alpDpp[nclha][nclha][idxD1 - idxD0 + 1]; + float betD[nclha][nclha][idxD1 - idxD0 + 1]; + float betDp[nclha][nclha][idxD1 - idxD0 + 1]; + float betDpp[nclha][nclha][idxD1 - idxD0 + 1]; + float gamD[nclha][nclha][idxD1 - idxD0 + 1]; + float delD[nclha][nclha][idxD1 - idxD0 + 1]; + int idxDmin; + float bmxdif[nclha][nclha]; + float bkmxndif; + } Dparam_; + // real bmxdif,bkmxndif + // integer idxDmin + // common / Dparam / alpD(idxD0: idxD1, nclha, nclha), + //* alpDp(idxD0 : idxD1, nclha, nclha), + //*alpDpp(idxD0 : idxD1, nclha, nclha), + //* betD(idxD0 : idxD1, nclha, nclha), + //* betDp(idxD0 : idxD1, nclha, nclha), + //*betDpp(idxD0 : idxD1, nclha, nclha), + //* gamD(idxD0 : idxD1, nclha, nclha), + //* delD(idxD0 : idxD1, nclha, nclha), + //*idxDmin, bmxdif(nclha, nclha), bkmxndif + + extern struct { + float phievt; + int nevt; + float bimevt; + int kolevt; + int koievt; + float pmxevt; + float egyevt; + int npjevt; + int ntgevt; + int npnevt; + int nppevt; + int ntnevt; + int ntpevt; + int jpnevt; + int jppevt; + int jtnevt; + int jtpevt; + float xbjevt; + float qsqevt; + int nglevt; + float zppevt; + float zptevt; + int minfra; + int maxfra; + int kohevt; + } cevt_; + // real phievt, bimevt, pmxevt, egyevt , xbjevt, qsqevt, zppevt, zptevt + // integer nevt, + // kolevt, koievt, kohevt, npjevt , ntgevt, npnevt, nppevt, ntnevt, ntpevt, jpnevt, + // jppevt, jtnevt, jtpevt , nglevt, minfra, maxfra + // common / cevt / phievt, nevt, + // bimevt, kolevt, koievt, pmxevt, egyevt, npjevt , ntgevt, npnevt, nppevt, ntnevt, + // ntpevt, jpnevt, jppevt, jtnevt, jtpevt , xbjevt, qsqevt, nglevt, zppevt, zptevt, + // minfra, maxfra, kohevt + } +} // namespace epos diff --git a/modules/epos/epos.inc b/modules/epos/epos.inc new file mode 100644 index 0000000000000000000000000000000000000000..97c0afca6bea8b451ed8aaca94e2db83fb430b3f --- /dev/null +++ b/modules/epos/epos.inc @@ -0,0 +1,536 @@ +c--------------------------------------------------------------------------- +c dimensions +c--------------------------------------------------------------------------- + + integer mmry,mxptl,nmxhep,myptl,nzeta,nflav,mxstr,mystr,mxtau + * ,mxtrig,mxpri,mxbins,matau,mxnucl,mxhisarg,idxD0,idxD1 + * ,idxD,nclha,nclegy,mamxx,mxjerr,mxvol,mxeps,mxidco,mxcoox + * ,mxcooy + parameter (mmry=1) !memory saving factor + + parameter (mxptl=200000/mmry) !max nr of particles in epos ptl list + parameter (nmxhep=10000) !max nr of particles in hep ptl list + parameter (myptl=1000) !max nr of droplets in epos ptl list + parameter (nzeta=60) !max nr of zeta bins for droplets + parameter (nflav=6) !max nr of flavors + parameter (mxstr=20000/mmry) !max nr of strings in epos string list + parameter (mystr=20000/mmry) + parameter (mxtau=4,mxvol=10,mxeps=16) + parameter (mxtrig=99,mxidco=99) + parameter (mxpri=200) + parameter (mxbins=10000) + parameter (matau=10,mxcoox=40,mxcooy=10) + parameter (mxnucl=20) + parameter (mxhisarg=100) + parameter (idxD0=0,idxD1=2,idxD=1,nclha=4,nclegy=100) + parameter (mamxx=250) + parameter (mxjerr=10) + +c--------------------------------------------------------------------------- +c epos event common block +c--------------------------------------------------------------------------- + + real phievt,bimevt,pmxevt,egyevt + *,xbjevt,qsqevt,zppevt,zptevt + integer nevt,kolevt,koievt,kohevt,npjevt + *,ntgevt,npnevt,nppevt,ntnevt,ntpevt,jpnevt,jppevt,jtnevt,jtpevt + *,nglevt,minfra,maxfra + common/cevt/phievt,nevt,bimevt,kolevt,koievt,pmxevt,egyevt,npjevt + *,ntgevt,npnevt,nppevt,ntnevt,ntpevt,jpnevt,jppevt,jtnevt,jtpevt + *,xbjevt,qsqevt,nglevt,zppevt,zptevt,minfra,maxfra,kohevt + real rglevt,sglevt,eglevt,fglevt,typevt + integer ng1evt,ng2evt,ikoevt + common/c2evt/ng1evt,ng2evt,rglevt,sglevt,eglevt,fglevt,ikoevt + *,typevt !qgsjet03.f and qgsjetII.f and phojet.f + +c nevt .......... error code. 1=valid event, 0=invalid event +c bimevt ........ absolute value of impact parameter +c phievt ........ angle of impact parameter +c kolevt ........ number of collisions +c koievt ........ number of inelastic collisions +c kohevt ........ number of hard collisions +c pmxevt ........ reference momentum +c egyevt ........ pp cm energy (hadron) or string energy (lepton) +c npjevt ........ number of primary projectile participants +c ntgevt ........ number of primary target participants +c npnevt ........ number of primary projectile neutron spectators +c nppevt ........ number of primary projectile proton spectators +c ntnevt ........ number of primary target neutron spectators +c ntpevt ........ number of primary target proton spectators +c jpnevt ........ number of absolute projectile neutron spectators +c jppevt ........ number of absolute projectile proton spectators +c jtnevt ........ number of absolute target neutron spectators +c jtpevt ........ number of absolute target proton spectators +c xbjevt ........ bjorken x for dis +c qsqevt ........ q**2 for dis +c sigtot ........ total cross section +c nglevt ........ number of collisions acc to Glauber +c zppevt ........ average Z-parton-proj +c zptevt ........ average Z-parton-targ +c ng1evt ........ number of Glauber participants with at least one IAs +c ng2evt ........ number of Glauber participants with at least two IAs +c ikoevt ........ number of elementary parton-parton scatterings +c typevt ........ type of event (1=Non Diff, 2=Double Diff, 3=Central Diff, 4=AB->XB, -4=AB->AX) + +c--------------------------------------------------------------------------- +c epos particle list common block +c--------------------------------------------------------------------------- + + real pptl,tivptl,xorptl + integer nptl,iorptl,idptl,istptl,ifrptl,jorptl,ibptl,ityptl + common/cptl/nptl,pptl(5,mxptl),iorptl(mxptl),idptl(mxptl) + *,istptl(mxptl),tivptl(2,mxptl),ifrptl(2,mxptl),jorptl(mxptl) + *,xorptl(4,mxptl),ibptl(4,mxptl),ityptl(mxptl) + real ekievt + integer itsptl + common/c1ptl/ekievt,itsptl(mxptl) + +c nptl .......... current particle index (=number of ptls stored) +c idptl(i) ...... particle id +c pptl(1,i) ..... x-component of particle momentum +c pptl(2,i) ..... y-component of particle momentum +c pptl(3,i) ..... z-component of particle momentum +c pptl(4,i) ..... particle energy +c pptl(5,i) ..... particle mass +c iorptl(i) ..... particle number of father (if .le. 0 : no father) +c jorptl(i) ..... particle number of mother (if .le. 0 : no mother) +c istptl(i) ..... status: 40 and 41 : Remnant +c 30 and 31 : Pomeron +c 20 and 21 : Parton +c 10 and 11 : Droplet +c 00 and 01 : Particle +c last digit = 0 : last generation +c last digit = 1 : not last generation +c xorptl(1,i) ... x-component of formation point +c xorptl(2,i) ... y-component of formation point +c xorptl(3,i) ... z-component of formation point +c xorptl(4,i) ... formation time +c tivptl(1,i) ... formation time (always in the pp-cms!) +c tivptl(2,i) ... destruction time (always in the pp-cms!) +c ityptl(i) .... type of particles origin: +c 10-19: target +c 20-29: soft Pom +c 30-39: hard Pom +c 40-49: projectile +c 50: string, droplet +c itsptl(i) ..... string type of particles origin (if string) + + real radptl + integer iaaptl + common/c2ptl/iaaptl(mxptl),radptl(mxptl) + real desptl,dezptl + common/c3ptl/desptl(mxptl),dezptl(mxptl) + integer nptlbd + common/c4ptl/nptlbd + real rinptl,vrad + integer inbxxx + common/c6ptl/rinptl(mxptl),vrad,inbxxx + real qsqptl,zpaptl + common/c8ptl/qsqptl(mxptl),zpaptl(2,mxptl) + + +c--------------------------------------------------------------------------- +c hep standard event commonblock. +c--------------------------------------------------------------------------- + + double precision phep,vhep + integer nevhep,nhep,isthep,idhep,jmohep,jdahep + + common/hepevt/nevhep,nhep,isthep(nmxhep),idhep(nmxhep), + &jmohep(2,nmxhep),jdahep(2,nmxhep),phep(5,nmxhep),vhep(4,nmxhep) + +c--------------------------------------------------------------------------- +c +c nevhep - event number +c nhep - number of entries in the event record +c +c isthep(i) - status code +c idhep(i) - particle id (particle data group standard) +c +c jmohep(1,i) - position of mother particle in list +c jmohep(2,i) - position of second mother particle in list +c jdahep(1,i) - position of first daughter in list +c jdahep(2,i) - position of first daughter in list +c +c phep(1,i) - p_x momentum in gev/c +c phep(2,i) - p_y momentum in gev/c +c phep(3,i) - p_z momentum in gev/c +c phep(4,i) - energy in gev +c phep(5,i) - mass in gev/c**2 +c +c vhep(1,i) - x position of production vertex in mm +c vhep(2,i) - y position of production vertex in mm +c vhep(3,i) - z position of production vertex in mm +c vhep(4,i) - time of production in mm/c +c +c (note: 1 mm = 10^-12 fm = 5.07 10^-12 1/gev) + +c------------------------------------------------------------------------ +c Parameters set in sr aaset and variables to communicate between moduls +c------------------------------------------------------------------------ + + integer ifop,ifmt,ifch,ifcx,ifhi,ifdt,ifcp,ifdr + common/files/ifop,ifmt,ifch,ifcx,ifhi,ifdt,ifcp,ifdr + integer ifin + common/files2/ifin + character*500 fnch,fnhi,fndt,fnii,fnid,fnie,fnrj,fnmt + * ,fngrv,fncp,fnnx,fncs,fndr,fnhpf + common/fname/ fnch, fnhi, fndt, fnii, fnid, fnie, fnrj, fnmt + * ,fngrv,fncp,fnnx,fncs,fndr,fnhpf + integer nfnch,nfnhi,nfndt,nfnii,nfnid,nfnie,nfnrj,nfnmt + *,nfngrv,nfncp,nfnnx,nfncs,nfndr,nfnhpf + common/nfname/nfnch,nfnhi,nfndt,nfnii,nfnid,nfnie,nfnrj,nfnmt + *,nfngrv,nfncp,nfnnx,nfncs,nfndr,nfnhpf + character*500 fnin + common/fname2/ fnin + integer nfnin + common/nfname2/nfnin + real delvol,deleps,dlzeta,etafac,facnuc,taurea,epscri + common/resc2/delvol,deleps,dlzeta,etafac,facnuc,taurea,epscri(3) + real epsdfm + common/resc4/epsdfm + character*3 hydt + common/hydr1/hydt + real pud,pmqu,pmqd,pmqs,pmqc,pmqq + integer ndecay,maxres + common/frag1/ndecay,maxres,pud,pmqu,pmqd,pmqs,pmqc,pmqq + real pdiqua,delrex,ptfraqq,ptfra,ptfrasr + integer ioptf + common/frag2/pdiqua,delrex,ptfraqq,ptfra,ptfrasr,ioptf + real aouni,pbreak,fkappa,strcut,diqcut,fkappag,pbreakg + *,zetacut + integer itflav + common/frag3/aouni,pbreak,fkappa,itflav,strcut,diqcut + *,fkappag,pbreakg,zetacut + real difud,difus,difuc,pudd,puds,pudc,difuuu,difuud + *,difuus,difuuc,difudd,difuds,difudc,difuss,difusc,difucc + integer nrflav + common/frag4/difud,difus,difuc,pudd,puds,pudc,difuuu,difuud + *,difuus,difuuc,difudd,difuds,difudc,difuss,difusc,difucc,nrflav + real qmass + integer isospin + common/frag5/qmass(0:6),isospin(0:6) + real pnll,ptq,exmass,cutmss,wproj,wtarg + common/hadr1/pnll,ptq,exmass,cutmss,wproj,wtarg + real rstrau,rstrad,rstras,rstrac,rstrasi + common/hadr10/rstrau(4),rstrad(4),rstras(4),rstrac(4),rstrasi + real wgtqqq,wgtval,wgtsea,wgtdiq + common/wgtqrk/wgtqqq(4),wgtval,wgtsea,wgtdiq + double precision timeini,timefin + common/time1/timeini,timefin + integer iotst1,iotst2,iotst3,iotst4 + common/ciotst/iotst1,iotst2,iotst3,iotst4 + real taumin,deltau,factau,numtau,amsiac,amprif + common/resc1/taumin,deltau,factau,numtau,amsiac,amprif + real dscale,cepara,delamf,deuamf + integer iceopt + common/resc3/dscale,cepara,iceopt,delamf,deuamf + integer ispherio,icotabm,icotabr,icocore + common/sprio/ispherio,icotabm,icotabr,icocore + integer iurqmd + common/urqm1/iurqmd + real cutico,dssico + common/incon/cutico,dssico + real gaumx + integer istore,istmax,irescl,ntrymx,nclean,iopdg,ioidch + common/othe1/istore,istmax,gaumx,irescl,ntrymx,nclean,iopdg,ioidch + integer ifrade,iframe,idecay,jdecay,iremn + common/othe2/ifrade,iframe,idecay,jdecay,iremn + integer jframe,kframe + common/othe3/jframe,kframe + integer iselect + common/othe4/iselect + real taumx,sigj + integer jpsi,jpsifi,nsttau,ijphis,ijtauan + common/jpsif/jpsi,jpsifi,taumx,nsttau,sigj,ijphis,ijtauan + real themas + integer iopenu + common/strlt/iopenu,themas + integer iappl,model + common/appli/iappl,model + integer nevent,nfull,nfreeze,ninicon + common/events/nevent,nfull,nfreeze,ninicon + real egymin,egymax,elab,ecms,ekin + common/enrgy/egymin,egymax,elab,ecms,ekin + integer iprmpt,ish,ishsub,irandm,irewch,iecho,modsho,idensi + common/prnt1/iprmpt,ish,ishsub,irandm,irewch,iecho,modsho,idensi + real engy,elepti,elepto,angmue + integer icinpu + common/lept1/engy,elepti,elepto,angmue,icinpu + real core,fctrmx + integer laproj,maproj,latarg,matarg + common/nucl1/laproj,maproj,latarg,matarg,core,fctrmx + real bmaxim,bminim,phimax,phimin + common/nucl2/bmaxim,bminim,phimax,phimin + real ymximi,wtimet,wtimei,wtimea + integer imihis,iclhis,iwtime + common/wana1/ymximi,imihis,iclhis,iwtime,wtimet,wtimei,wtimea + real wtmini,wtstep + integer isphis,ispall,iwcent,iana,nbdky + common/wana2/isphis,ispall,wtmini,wtstep,iwcent,iana,nbdky + real asuhax,asuhay + common/drop4/asuhax(7),asuhay(7) + real grigam,grirsq,gridel,grislo,gricel,sigppi,sigppd + common/gribo/grigam,grirsq,gridel,grislo,gricel,sigppi,sigppd + real bag4rt,dezzer,amuseg,taunll,yradmx,facts,factb,factq + common/drop3/bag4rt,dezzer,amuseg,taunll,yradmx,facts,factb,factq + real rcoll,ylongmx,facecc,yradpp,yradmi,yrmaxi,fradflii + integer nsegsu,nsegce + common/drop2/rcoll,ylongmx,nsegsu,nsegce,facecc,yradpp,yradmi + * ,yrmaxi,fradflii + real ptclu,yradpi,yradpx,fploss,fvisco,fplmin + integer ioclude,iocluin,ioquen,iohole,kigrid + common/drop7/ptclu,yradpi,yradpx,fploss,fvisco,fplmin,ioclude + * ,iocluin,ioquen,iohole,kigrid + real fsgrid + common/drop8/fsgrid + integer iospec,iocova,iopair,iozero,ioflac,iomom + common/metr1/iospec,iocova,iopair,iozero,ioflac,iomom + integer nadd,iograc,iocite,ioceau,iociau + common/metr2/nadd,iograc,iocite,ioceau,iociau + integer iomodl,idproj,idtarg + real wexcit + common/hadr2/iomodl,idproj,idtarg,wexcit + real rexdifi,rexndii + integer idprojin,idtargin,irdmpr,isoproj,isotarg + common/hadr25/idprojin,idtargin,rexdifi(4),rexndii(4),irdmpr, + * isoproj,isotarg + integer iostat,ioinco,ionlat,ioobsv,iosngl,iorejz,iompar + common/metr3/iostat,ioinco,ionlat,ioobsv,iosngl,iorejz,iompar + integer ioinfl,ioinct,iowidn + real epsgc + common/metr4/ioinfl,ioinct,iowidn,epsgc + real prob + integer nstmax,icbac,icfor + common/lept2/nstmax,prob(99),icbac(99,2),icfor(99,2) + integer iolept,igampr,idisco + common/lept3/iolept,igampr,idisco + real engmin,engmax + integer noebin,nrebin,iologe,iologl + common/ebin/noebin,engmin,engmax,nrebin,iologe,iologl + real pi,pii,hquer,prom,piom,ainfin + common/cnsta/pi,pii,hquer,prom,piom,ainfin + integer iversn,iverso + common/versn/iversn,iverso + integer imsg,jerr,ntevt,nrevt,naevt,nrstr,nrptl + common/accum/imsg,jerr(mxjerr),ntevt,nrevt,naevt,nrstr,nrptl + integer nglacc + common/accum2/nglacc + integer nptlu,nrclu + common/cptlu/nptlu /cnrclu/nrclu + real tecm,volu + common/drop6/tecm,volu + integer iterma,iternc,iterpr,iterpl,iozinc,iozevt + common/metr5/iterma,iternc,iterpr,iterpl,iozinc,iozevt + real epsr + integer keepr + common/metr6/epsr,keepr + integer keu,ked,kes,kec,keb,ket + common/drop5/keu,ked,kes,kec,keb,ket + double precision seedi,seedj,seedj2,seedc + integer iseqini,iseqsim + common/cseed/seedi,seedj,seedj2,seedc,iseqini,iseqsim + real clust + common/cjintc/clust(mxtau,mxvol,mxeps) + real volsum,vo2sum + integer nclsum + common/cjintd/volsum(mxtau),vo2sum(mxtau),nclsum(mxtau) + integer iutotc,iutote + common/ciutot/iutotc,iutote + integer nopen,nopenr + common/copen/nopen,nopenr + integer kchopen,khiopen,kdtopen,kcpopen,klgopen,knxopen + common/kopen/kchopen,khiopen,kdtopen,kcpopen,klgopen,knxopen + character*6 xvaria,yvaria + real xminim,xmaxim,hisfac + integer normal,nrbins + common/vana1/xvaria,yvaria,normal,xminim,xmaxim,nrbins,hisfac + integer iologb,iocnxb + common/vana3/iologb,iocnxb + integer mxnody,nrnody,nody + parameter(mxnody=200) + common/nodcy/nrnody,nody(mxnody) + real ctaumin + common/ctdcy/ctaumin + character*20 subpri + integer nrpri,ishpri + common/prnt2/nrpri,subpri(mxpri),ishpri(mxpri) + integer ishevt,ixtau,iwseed,jwseed,ixgeometry + common/prnt3/ishevt,ixtau,iwseed,jwseed,ixgeometry + integer mxcnt,ionoerr + real ar,ary,ardy + parameter (mxcnt=20) + common/vana4/ar(mxbins,5),ary(mxbins,mxcnt),ardy(mxbins,mxcnt) + *,ionoerr + real xpar1,xpar2,xpar3,xpar4,xpar5,xpar6,xpar7,xpar8 + *,xpar99 + common/xpars/xpar1,xpar2,xpar3,xpar4,xpar5,xpar6,xpar7,xpar8 + *,xpar99 + integer khisto + common/khist/khisto + integer nctcor,ncttim + common/ctcor/nctcor/ccttim/ncttim + integer kdensi + real tauv + common/densi/kdensi(matau,nzeta,mxcoox,mxcooy),tauv(matau) + integer iorsce,iorsdf,iorshh,ionudi + common/cjinti/iorsce,iorsdf,iorshh,ionudi + real amimfs,amimel + common/camim/amimfs,amimel + real scr,scs,hacore + common/craddf/scr,scs,hacore + integer iokoll + common/ckoll/iokoll + integer ncnt,inicnt,nemsi + common/cncnt/ncnt /cicnt/inicnt /cnemsi/nemsi + real gfactor,gwidth + integer iemspl,iemsct + common/ems1/iemspl,iemsct,gfactor,gwidth + real amproj,amtarg,ypjtl,yhaha,pnullx + common/chadron/amproj,amtarg,ypjtl,yhaha,pnullx + real xshift,etacut + common/vana5/xshift,etacut + double precision rnucl + real bnucl,xbtot + integer ixbDens + common/nucl5/rnucl(mxnucl,2),bnucl(mxnucl,4),xbtot(4),ixbDens + integer infragm,ibreit + common/nucl6/infragm,ibreit + real drnucl,rnuclo + integer nrnucl + common/nucl4/nrnucl(2),drnucl(2),rnuclo(mxnucl,2) + real xsig,xpom + common/sig/xsig(7),xpom(7) + integer ktnbod + common/metr7/ktnbod + integer iregge,isopom,ishpom,iscreen,nprmax,inueff,irmdrop + common/hadr3/iregge,isopom,ishpom,iscreen,nprmax,inueff,irmdrop + real sigtot,sigcut,sigela,sloela,sigsd,sigine,sigdif + *,sigineaa,sigtotaa,sigelaaa,sigcutaa,sigdd + common/hadr5/sigtot,sigcut,sigela,sloela,sigsd,sigine,sigdif + *,sigineaa,sigtotaa,sigelaaa,sigcutaa,sigdd + integer intpol,isigma,iomega,isetcs + common/hadr6/intpol,isigma,iomega,isetcs + real alppom,slopom,gamhad,r2had,chad,wdiff + *,gamtil,facdif,facmc,r2hads,gamhads,slopoms + integer isplit + common/hadr4/alppom,slopom,gamhad(4),r2had(4),chad(4),wdiff(4) + & ,gamtil,facdif,facmc,r2hads(4),gamhads(4),slopoms,isplit + real gamhadsi + common/hadr42/gamhadsi(4) + real alpreg,sloreg,gamreg,r2reg,ptdiff,ptsend,xminremn + &,xmindiff,ptsecu + common/hadr7/alpreg,sloreg,gamreg,r2reg,ptdiff,ptsend,xminremn + &,xmindiff,ptsecu + real alpqua,alppar,alpsea,alpval,alpdiq,alplea,alpdif + common/hadr8/alpqua,alppar,alpsea,alpval,alpdiq,alplea(4),alpdif + real alpndi,alpdi,ptsendi,zdrinc,zmsinc,ptsems + integer irzptn + common/hadr14/alpndi,alpdi,ptsendi,zdrinc,zmsinc,ptsems,irzptn + real zbcut,zopinc,zipinc,zoeinc,xmxrem + common/hadr15/zbcut,zopinc,zipinc,zoeinc,xmxrem + real fkainc,fkamax,zodinc,zbrmax,zdfinc,xzcut,ptvpom + common/hadr16/fkainc,fkamax,zodinc,zbrmax,zdfinc,xzcut,ptvpom + real edmaxi,epmaxi + common/hadr17/edmaxi,epmaxi + real ammsqq,ammsqd,ammsdd,cumpom,rexndi,rexdif + * ,reminv,rexpdif,rexres,zrminc,rexndf + common/hadr9/ammsqq,ammsqd,ammsdd,cumpom,rexndi(4),rexdif(4) + * ,reminv,rexpdif(4),rexres(4),zrminc,rexndf + integer iclpro,icltar,iclegy + common/had10/iclpro,icltar,iclegy + integer iclpro1,iclpro2,icltar1,icltar2,iclegy1,iclegy2 + common/had11/iclpro1,iclpro2,icltar1,icltar2,iclegy1,iclegy2 + real egylow,egyfac + common/had12/egylow,egyfac + real amdrmax,amdrmin,alpdro + common/had13/amdrmax,amdrmin,alpdro(3) + real alpcoso,alpcose,betcoso,betcose + common/had14/alpcoso,alpcose,betcoso,betcose + real accept,reject + common/emsx1/accept,reject + integer iemspr,iemspm,iemspx,iemsrx,iemspu,iemsi2,iemspbx + common/xems1/iemspr,iemspm,iemspx,iemsrx,iemspu,iemsi2,iemspbx + integer iemsse,iemsi1,iemsb,iemsbg,ioems,iemsdr + common/xems2/iemsse,iemsi1,iemsb,iemsbg,ioems,iemsdr + integer ispacetime + common/xspatim/ispacetime + real difnuc,radnuc + common /psar10/difnuc(mamxx),radnuc(mamxx) + integer mxbarray,nbarray + real barray + parameter (mxbarray=100) + common/cbarray/barray(mxbarray),nbarray + real airznxs,airanxs,airwnxs + * ,airavznxs,airavanxs + common/nxsair/airznxs(3),airanxs(3),airwnxs(3) + * ,airavznxs,airavanxs + real qgsincs + common/mod2incs/qgsincs + real gheincs + common/mod3incs/gheincs + real pytincs + common/mod4incs/pytincs + real hijincs + common/mod5incs/hijincs + real sibincs + common/mod6incs/sibincs + real qgsIIincs + common/mod7incs/qgsIIincs + real phoincs + common/mod8incs/phoincs + real fluincs + common/mod9incs/fluincs + real urqincs + common/mod10incs/urqincs + real dpmincs + common/mod12incs/dpmincs + real antot,ansh,ansf,pp4max,pp4ini,andropl,anstrg0 + *,anshf,ansff,antotf + *,anstrg1,anreso0,anreso1,anghadr,antotre + common/testpom/antot,ansh,ansf,pp4max,pp4ini,andropl,anstrg0 + *,anshf,ansff,antotf + *,anstrg1,anreso0,anreso1,anghadr,antotre + real anintdiff,anintsdif,anintine + *,sigineex,sigdifex,sigsdex + common/cdiff/anintdiff,anintsdif,anintine + *,sigineex,sigdifex,sigsdex + real epszero,alpff,betff + common/cepszer/epszero,alpff(nclha),betff(2) + real tgss,wgss + common/cgss/tgss(7,7),wgss(7,7) + + real alpDs,alpDps,alpDpps,betDs,betDps,betDpps,gamDs,delDs + * ,alpD,alpDp,alpDpp,betD,betDp,betDpp,gamD,delD + common/Dparams/alpDs( idxD0:idxD, nclegy, nclha,nclha), + * alpDps( idxD0:idxD, nclegy, nclha,nclha), + * alpDpps(idxD0:idxD, nclegy, nclha,nclha), + * betDs( idxD0:idxD, nclegy, nclha,nclha), + * betDps( idxD0:idxD, nclegy, nclha,nclha), + * betDpps(idxD0:idxD, nclegy, nclha,nclha), + * gamDs( idxD0:idxD, nclegy, nclha,nclha), + * delDs( idxD0:idxD, nclegy, nclha,nclha) + real bmxdif,bkmxndif + integer idxDmin + common/Dparam/alpD( idxD0:idxD1, nclha, nclha), + * alpDp( idxD0:idxD1, nclha, nclha), + * alpDpp(idxD0:idxD1, nclha, nclha), + * betD( idxD0:idxD1, nclha, nclha), + * betDp( idxD0:idxD1, nclha, nclha), + * betDpp(idxD0:idxD1, nclha, nclha), + * gamD( idxD0:idxD1, nclha, nclha), + * delD( idxD0:idxD1, nclha, nclha), + * idxDmin,bmxdif(nclha, nclha),bkmxndif + double precision alpUni,betUni,betpUni,fpUni,ftUni,betfom + * ,epspUni,epstUni,zzpUni,zztUni + real alpfom,alpfomi,gamfom + common/DparUni/alpUni( idxD0:idxD1,2), + * betUni( idxD0:idxD1,2), + * betpUni(idxD0:idxD1,2),fpUni,ftUni, + * epspUni(idxD0:idxD1),zzpUni, + * epstUni(idxD0:idxD1),zztUni, + * betfom,alpfom,alpfomi,gamfom + integer idlead,ilprtg + common/crvar/idlead,ilprtg + integer iLHC,ipytune + common/LHCtune/iLHC,ipytune diff --git a/modules/epos/epos.incems b/modules/epos/epos.incems new file mode 100644 index 0000000000000000000000000000000000000000..cae89765e1eb7750db9aeb9c25e90bf224abfbcd --- /dev/null +++ b/modules/epos/epos.incems @@ -0,0 +1,281 @@ + + parameter (mmrye=15,mmryk=3) !memory saving factor + + parameter (kollmx=45000/mmrye,npommx=150) + parameter (mamx=250/mmryk,ngrmx=1,ntymi=0,ntymx=2) + parameter (nflavems=4) + +!---------------------------------------------------------------------- +! POMERON +!---------------------------------------------------------------------- + + double precision om1int,om1intc + * ,atilde,btildep,btildepp + common/comega/om1int(kollmx),om1intc(kollmx) + common/comtilde/atilde(ntymi:ntymx,kollmx) + *,btildep(ntymi:ntymx,kollmx),btildepp(ntymi:ntymx,kollmx) + *,ntymin + +!---------------------------------------------------------------------- +! POMERON CONFIGURATION +!---------------------------------------------------------------------- + + common/col/koll,iproj(kollmx),itarg(kollmx),coord(4,kollmx) + common/col1/kremn(mamx,mamx,2),lremn(mamx,2) + dimension kproj(mamx,mamx),ktarg(mamx,mamx) + *,lproj(mamx),ltarg(mamx) + equivalence (kproj(1,1),kremn(1,1,1)),(ktarg(1,1),kremn(1,1,2)) + equivalence (lproj(1),lremn(1,1)),(ltarg(1),lremn(1,2)) + double precision gammaV + common/col6/kproj3(mamx,mamx),ktarg3(mamx,mamx) + *,lproj3(mamx),ltarg3(mamx) + *,epsilongp(kollmx,0:1),epsilongt(kollmx,0:1) + *,epsilongs(kollmx,0:1),gammaV(kollmx) + *,epsilongf(kollmx),epsilongb(kollmx) + common/col4/bk(kollmx),bhpr(npommx,kollmx),bkx(kollmx) + *,bky(kollmx) + double precision PomInck,xxnuc,xzcutpar + common/col7/zparremn(kollmx,2),PomInck(kollmx),xzcutpar(kollmx) + *,xxnuc(mamx,2,kollmx),npnuc(mamx,2,kollmx) + *,irnuc(mamx,2,kollmx),knucnt(2,kollmx) + real zparpro(kollmx),zpartar(kollmx) + equivalence (zparpro(1),zparremn(1,1)),(zpartar(1),zparremn(1,2)) + +!---------------------------------------------------------------------- +! koll: number of relevant pairs +! iproj(k): projectile index for k-th pair +! itarg(k): target index for k-th pair +! lproj(ip): number of pairs linked to projectile ip +! kproj(ip,l): corresponding pair index of the l-th pair +! ltarg(it): number of pairs linked to target it +! ktarg(it,l): corresponding pair index of the l-th pair +! bk(k): b value of the k-th pair (=sqrt(bx**2.+by**2.)) +! bkx(k): bx value of the k-th pair +! bky(k): by value of the k-th pair +! lproj3(ip): number of pairs linked to projectile ip (no diffraction) +! kproj3(ip,l): corresponding pair index of the l-th pair (no diffraction) +! ltarg3(it): number of pairs linked to target it (no diffraction) +! ktarg3(it,l): corresponding pair index of the l-th pair (no diffraction) +!---------------------------------------------------------------------- + + common/cems3/nprt(kollmx),npr(0:3,kollmx) + common/cems4/nprmx(kollmx) + +!---------------------------------------------------------------------- +! nprt(k): number of pomerons of collision k +! npr(id,k): number of pomerons of type id of collision k +! (id: 0=zero, 1=soft, 2=reggeon, 3=hard) +! nprmx(k): maximum number of pomerons of collision k +!---------------------------------------------------------------------- + + common/cems2/itpr(kollmx),idpr(npommx,kollmx),ivpr(npommx,kollmx) + *,idfpr(npommx,kollmx) + *,nvpr(npommx,kollmx),nbkpr(npommx,kollmx) + +!---------------------------------------------------------------------- +! itpr(k): interaction type of collision k +! (0=nothing, 1=inelastic, 2=diffractive) +! idpr(n,k): type of pomeron (n,k) +! (0=zero, 1=soft, 2=reggeon, 3=hard) +! ivpr(n,k): status of pomeron (n,k) (0=virtual, 1=real, 2=backup) +! nbkpr(n,k): position of the backup pomeron +! nvpr(n,k): position of the pomeron for this backup pomeron +! idfpr(n,k): link of pomeron (n,k) (0=no, 1=pro&tar, 2=pro, 3=tar) +! idfpr=-1 means backup pomeron +!---------------------------------------------------------------------- + + double precision xpr,ypr,xppr,xmpr,xpprbor,xmprbor + common/cems1/xpr(npommx,kollmx),ypr(npommx,kollmx) + common/cems1c/xppr(npommx,kollmx),xmpr(npommx,kollmx) + common/cems1d/xpprbor(npommx,kollmx),xmprbor(npommx,kollmx) + common/cems1e/nemispr(2,npommx,kollmx),ptprboo(2,npommx,kollmx) + +!---------------------------------------------------------------------- +! xpr(n,k): x=x+x- of pomeron (n,k) +! ypr(n,k): rapidity of pomeron (n,k) +! xpprbor(n,k): x+ of in Born parton of pomeron (n,k) +! xmprbor(n,k): x- of in Born parton of pomeron (n,k) +! nemispr(i,n,k): number of up (i=1) and down (i=2) emissions +!---------------------------------------------------------------------- + + double precision xp1pr,xp2pr,xm1pr,xm2pr,xxp1pr,xyp1pr + * ,xxp2pr,xyp2pr,xxm1pr,xym1pr,xxm2pr,xym2pr + common/cems7/xp1pr(npommx,kollmx),xp2pr(npommx,kollmx) + * ,xm1pr(npommx,kollmx),xm2pr(npommx,kollmx) + * ,idp1pr(npommx,kollmx),idp2pr(npommx,kollmx) + * ,idm1pr(npommx,kollmx),idm2pr(npommx,kollmx) + common/cems8/xxp1pr(npommx,kollmx),xyp1pr(npommx,kollmx) + * ,xxp2pr(npommx,kollmx),xyp2pr(npommx,kollmx) + * ,xxm1pr(npommx,kollmx),xym1pr(npommx,kollmx) + * ,xxm2pr(npommx,kollmx),xym2pr(npommx,kollmx) + +!---------------------------------------------------------------------- +! xp1pr(n,k): x of string end p1 p1 p2 +! xp2pr(n,k): x of string end p2 \ / +! xm1pr(n,k): x of string end m1 \ / +! xm2pr(n,k): x of string end m2 \/ +! idp1pr(n,k): id of string end p1 ( 0=0 ) /\ +! idp2pr(n,k): id of string end p2 ( 1=s 2=v ) / \ +! idm1pr(n,k): id of string end m1 ( 4=ss*2 5=ss ) / \ +! idm2pr(n,k): id of string end m2 ( 8=f ) m1 m2 +! xxp1pr(n,k),xyp1pr(n,k): px,py of string end p1 +! xxp2pr(n,k),xyp2pr(n,k): px,py of string end p2 +! xxm1pr(n,k),xym1pr(n,k): px,py of string end m1 +! xxm2pr(n,k),xym2pr(n,k): px,py of string end m2 +!---------------------------------------------------------------------- + + double precision xme + common/cems11/xme(mamx) + +!---------------------------------------------------------------------- +! xme(j): x- exchange for nucleon j +!---------------------------------------------------------------------- + + common/cems22/idhpr(npommx,kollmx),idrpr(npommx,kollmx) + * ,idsppr(npommx,kollmx),idstpr(npommx,kollmx) + +!---------------------------------------------------------------------- +! idhpr(n,k): flav hard Pom (n,k) (0=gg,1=qg,2=gq,3=qq) +! idrpr(n,k): flav Regg (n,k) (0=ss,1=0va0,2=v00a,3=0as0,4=s00a,5=0sv0,6=v00s) +! idsppr(n,k): flav soft P (n,k) (proj) (0=ss,1=vs,2=sa,3=va,4=dd,5=svv,6=aas) +! idstpr(n,k): flav soft P (n,k) (targ) (0=ss,1=vs,2=sa,3=va,4=dd,5=svv,6=aas) +!---------------------------------------------------------------------- + + +!---------------------------------------------------------------------- +! REMNANT CONFIGURATION +!---------------------------------------------------------------------- + common/remn4/jcpval(nflavems,2,mamx),jctval(nflavems,2,mamx) + common/remn3/jcpref(nflavems,2,mamx),jctref(nflavems,2,mamx) + common/remn2/zzremn(mamx,2) + common/remn/icremn(2,mamx,2) + dimension icproj(2,mamx),ictarg(2,mamx) + double precision xpp,xmp,xpt,xmt,xxp,xyp,xxt,xyt + double precision xpz,xmz,xxz,xyz + common/cemsr/xpz(mamx,2),xmz(mamx,2) + * ,xxz(mamx,2),xyz(mamx,2) + * ,idz(mamx,2),ivz(mamx,2) + * ,isz(mamx,2),iaz(mamx,2) + dimension xpp(mamx),xmp(mamx),xpt(mamx),xmt(mamx) + * ,xxp(mamx),xyp(mamx),xxt(mamx),xyt(mamx) + * ,idp(mamx),ivp(mamx),ivt(mamx),idt(mamx) + * ,isp(mamx),iap(mamx),ist(mamx),iat(mamx) + + equivalence (icproj(1,1),icremn(1,1,1)) + * ,(ictarg(1,1),icremn(1,1,2)) + equivalence (xpp(1),xpz(1,1)),(xmt(1),xpz(1,2)) + * ,(xmp(1),xmz(1,1)),(xpt(1),xmz(1,2)) + * ,(xxp(1),xxz(1,1)),(xxt(1),xxz(1,2)) + * ,(xyp(1),xyz(1,1)),(xyt(1),xyz(1,2)) + * ,(idp(1),idz(1,1)),(idt(1),idz(1,2)) + * ,(ivp(1),ivz(1,1)),(ivt(1),ivz(1,2)) + * ,(isp(1),isz(1,1)),(ist(1),isz(1,2)) + * ,(iap(1),iaz(1,1)),(iat(1),iaz(1,2)) + +!---------------------------------------------------------------------- +! xpp(ip),xmp(ip),xpt(it),xmt(it): x+,x- of projectile ip / target it +! xxp(ip),xyp(ip),xxt(it),xyt(it): px,py of projectile ip / target it +! idp(ip),idt(it): diquark counter +! ivp(ip),ivt(it): valenve quark counter +! isp(ip),ist(it): sea quark counter +! iap(ip),iat(it): anti valence quark counter +!---------------------------------------------------------------------- + + double precision xpmn,xtmn,xpmx,xtmx,xppmx,xptmx,xmpmx,xmtmx + * ,xppmn ,xptmn,xmpmn,xmtmn,xpos,xtos + double precision xzmn,xzmx,xpzmx,xmzmx + * ,xpzmn ,xmzmn,xzos + common/cemsr1/xzmn(mamx,2),xzmx(mamx,2) + * ,xpzmx(mamx,2) + * ,xmzmx(mamx,2) + * ,xpzmn(mamx,2) + * ,xmzmn(mamx,2) + * ,xzos(mamx,2) + dimension xpmn(mamx),xtmn(mamx),xpmx(mamx),xtmx(mamx) + * ,xppmx(mamx),xptmx(mamx) + * ,xmpmx(mamx),xmtmx(mamx) + * ,xppmn(mamx),xptmn(mamx) + * ,xmpmn(mamx),xmtmn(mamx) + * ,xpos(mamx),xtos(mamx) + + equivalence ( xpmn(1), xzmn(1,1)),( xtmn(1), xzmn(1,2)) + * ,( xpmx(1), xzmx(1,1)),( xtmx(1), xzmx(1,2)) + * ,(xppmx(1),xpzmx(1,1)),(xptmx(1),xpzmx(1,2)) + * ,(xmpmx(1),xmzmx(1,1)),(xmtmx(1),xmzmx(1,2)) + * ,(xppmn(1),xpzmn(1,1)),(xptmn(1),xpzmn(1,2)) + * ,(xmpmn(1),xmzmn(1,1)),(xmtmn(1),xmzmn(1,2)) + * ,( xpos(1), xzos(1,1)),( xtos(1), xzos(1,2)) + +!---------------------------------------------------------------------- +! xpmn(ip),xtmn(it),xpmx(ip),xtmx(it): x proj/targ minimum/maximum +! xppmx(ip),xptmx(it),xmpmx(ip),xmtmx(it): x+/x- proj/targ maximum +! xppmn(ip),xptmn(it),xmpmn(ip),xmtmn(it): x+/x- proj/targ minimum +! xpos(ip),xtos(it): x value for on shell condition proj/targ +!---------------------------------------------------------------------- + + common/cemsr3/kolp(mamx),kolt(mamx),npp(mamx),npt(mamx) + common/cemsr4/iez(mamx,2),ifz(mamx,2) + dimension iep(mamx),iet(mamx),ifp(mamx),ift(mamx) + equivalence (iep(1),iez(1,1)),(iet(1),iez(1,2)) + * ,(ifp(1),ifz(1,1)),(ift(1),ifz(1,2)) + +!---------------------------------------------------------------------- +! kolp(ip),kolt(it): number of cut Pomerons of proj ip / targ it +! iep(ip),iet(it): excitation type of proj ip / targ it +! (0=none,1=inelastic,2=diffractive) +! ifp(ip),ift(it): remnant flip flag proj/targ (0=no,1=yes) +! if3dp(ip), if3dp(it): triple pomeron diffraction (if 1) +!---------------------------------------------------------------------- + + +!---------------------------------------------------------------------- +! transfer from emsini +!---------------------------------------------------------------------- + + double precision amzmn,ampmn,amtmn,ammn,amemn,amemx,amprmn,xis + &,delxi,ddelx,r3pompi,r3pommi,r3pompi3,r3pommi3 + parameter (ntypmx=19) + common/cems12/ammn(0:ntypmx),amprmn(0:ntypmx) + common/cemsr6/amzmn(0:1,2),amemn(0:1,0:6),amemx(0:2) + dimension ampmn(0:1),amtmn(0:1) + equivalence (ampmn(0),amzmn(0,1)), (amtmn(0),amzmn(0,2)) + common/cemsr13/xis,delxi,ddelx,r3pompi,r3pommi + &,r3pompi3,r3pommi3,ucfpro,ucftar + +!---------------------------------------------------------------------- +! STORAGE +!---------------------------------------------------------------------- + + double precision + *xxpr,xxpr0,yx,yx0,xxppr,xxmpr,xxppr0,xxmpr0 + *,xmtx,xmtx0,xmtlx,xmtlx0 + *,xppx,xppx0,xpplx,xpplx0 + *,xppst,xmpst,xposst,xpest,xppstx0,xmpstx0,xppstx,xmpstx + *,xmtst,xptst,xtosst,xmest,xmtstx0,xptstx0,xmtstx,xptstx + dimension nprx(0:3),nprx0(0:3),iepst(mamx),ietst(mamx) + *,xppst(mamx),xmpst(mamx),xposst(mamx),xpest(mamx) + *,xmtst(mamx),xptst(mamx),xtosst(mamx),xmest(mamx) + + + common/emsstore/ + *xxpr,xxpr0,yx,yx0,xxppr,xxmpr,xxppr0,xxmpr0 + *,xmtx,xmtx0,xmtlx,xmtlx0 + *,xppx,xppx0,xpplx,xpplx0 + *,itx,itx0,idx,idx0,iepst,ietst + *,npplx0,nptlx0,npplx,nptlx + *,nppx,nppx0,nptx,nptx0,nprx,nprx0,nprtx,nprtx0 + *,xppst,xmpst,xposst,xpest,xppstx0,xmpstx0,xppstx,xmpstx + *,xmtst,xptst,xtosst,xmest,xmtstx0,xptstx0,xmtstx,xptstx + + +!---------------------------------------------------------------------- +! utilities +!---------------------------------------------------------------------- + + double precision facto,fctrl + common/factori/facto(0:npommx),fctrl(0:npommx),nfctrl + + + + + diff --git a/modules/epos/epos.incems.high b/modules/epos/epos.incems.high new file mode 100644 index 0000000000000000000000000000000000000000..662bbfaae2790493f110852e09b3845c93e1aa76 --- /dev/null +++ b/modules/epos/epos.incems.high @@ -0,0 +1,281 @@ + + parameter (mmrye=3,mmryk=1) !memory saving factor + + parameter (kollmx=45000/mmrye,npommx=150) + parameter (mamx=250/mmryk,ngrmx=1,ntymi=0,ntymx=2) + parameter (nflavems=4) + +!---------------------------------------------------------------------- +! POMERON +!---------------------------------------------------------------------- + + double precision om1int,om1intc + * ,atilde,btildep,btildepp + common/comega/om1int(kollmx),om1intc(kollmx) + common/comtilde/atilde(ntymi:ntymx,kollmx) + *,btildep(ntymi:ntymx,kollmx),btildepp(ntymi:ntymx,kollmx) + *,ntymin + +!---------------------------------------------------------------------- +! POMERON CONFIGURATION +!---------------------------------------------------------------------- + + common/col/koll,iproj(kollmx),itarg(kollmx),coord(4,kollmx) + common/col1/kremn(mamx,mamx,2),lremn(mamx,2) + dimension kproj(mamx,mamx),ktarg(mamx,mamx) + *,lproj(mamx),ltarg(mamx) + equivalence (kproj(1,1),kremn(1,1,1)),(ktarg(1,1),kremn(1,1,2)) + equivalence (lproj(1),lremn(1,1)),(ltarg(1),lremn(1,2)) + double precision gammaV + common/col6/kproj3(mamx,mamx),ktarg3(mamx,mamx) + *,lproj3(mamx),ltarg3(mamx) + *,epsilongp(kollmx,0:1),epsilongt(kollmx,0:1) + *,epsilongs(kollmx,0:1),gammaV(kollmx) + *,epsilongf(kollmx),epsilongb(kollmx) + common/col4/bk(kollmx),bhpr(npommx,kollmx),bkx(kollmx) + *,bky(kollmx) + double precision PomInck,xxnuc,xzcutpar + common/col7/zparremn(kollmx,2),PomInck(kollmx),xzcutpar(kollmx) + *,xxnuc(mamx,2,kollmx),npnuc(mamx,2,kollmx) + *,irnuc(mamx,2,kollmx),knucnt(2,kollmx) + real zparpro(kollmx),zpartar(kollmx) + equivalence (zparpro(1),zparremn(1,1)),(zpartar(1),zparremn(1,2)) + +!---------------------------------------------------------------------- +! koll: number of relevant pairs +! iproj(k): projectile index for k-th pair +! itarg(k): target index for k-th pair +! lproj(ip): number of pairs linked to projectile ip +! kproj(ip,l): corresponding pair index of the l-th pair +! ltarg(it): number of pairs linked to target it +! ktarg(it,l): corresponding pair index of the l-th pair +! bk(k): b value of the k-th pair (=sqrt(bx**2.+by**2.)) +! bkx(k): bx value of the k-th pair +! bky(k): by value of the k-th pair +! lproj3(ip): number of pairs linked to projectile ip (no diffraction) +! kproj3(ip,l): corresponding pair index of the l-th pair (no diffraction) +! ltarg3(it): number of pairs linked to target it (no diffraction) +! ktarg3(it,l): corresponding pair index of the l-th pair (no diffraction) +!---------------------------------------------------------------------- + + common/cems3/nprt(kollmx),npr(0:3,kollmx) + common/cems4/nprmx(kollmx) + +!---------------------------------------------------------------------- +! nprt(k): number of pomerons of collision k +! npr(id,k): number of pomerons of type id of collision k +! (id: 0=zero, 1=soft, 2=reggeon, 3=hard) +! nprmx(k): maximum number of pomerons of collision k +!---------------------------------------------------------------------- + + common/cems2/itpr(kollmx),idpr(npommx,kollmx),ivpr(npommx,kollmx) + *,idfpr(npommx,kollmx) + *,nvpr(npommx,kollmx),nbkpr(npommx,kollmx) + +!---------------------------------------------------------------------- +! itpr(k): interaction type of collision k +! (0=nothing, 1=inelastic, 2=diffractive) +! idpr(n,k): type of pomeron (n,k) +! (0=zero, 1=soft, 2=reggeon, 3=hard) +! ivpr(n,k): status of pomeron (n,k) (0=virtual, 1=real, 2=backup) +! nbkpr(n,k): position of the backup pomeron +! nvpr(n,k): position of the pomeron for this backup pomeron +! idfpr(n,k): link of pomeron (n,k) (0=no, 1=pro&tar, 2=pro, 3=tar) +! idfpr=-1 means backup pomeron +!---------------------------------------------------------------------- + + double precision xpr,ypr,xppr,xmpr,xpprbor,xmprbor + common/cems1/xpr(npommx,kollmx),ypr(npommx,kollmx) + common/cems1c/xppr(npommx,kollmx),xmpr(npommx,kollmx) + common/cems1d/xpprbor(npommx,kollmx),xmprbor(npommx,kollmx) + common/cems1e/nemispr(2,npommx,kollmx),ptprboo(2,npommx,kollmx) + +!---------------------------------------------------------------------- +! xpr(n,k): x=x+x- of pomeron (n,k) +! ypr(n,k): rapidity of pomeron (n,k) +! xpprbor(n,k): x+ of in Born parton of pomeron (n,k) +! xmprbor(n,k): x- of in Born parton of pomeron (n,k) +! nemispr(i,n,k): number of up (i=1) and down (i=2) emissions +!---------------------------------------------------------------------- + + double precision xp1pr,xp2pr,xm1pr,xm2pr,xxp1pr,xyp1pr + * ,xxp2pr,xyp2pr,xxm1pr,xym1pr,xxm2pr,xym2pr + common/cems7/xp1pr(npommx,kollmx),xp2pr(npommx,kollmx) + * ,xm1pr(npommx,kollmx),xm2pr(npommx,kollmx) + * ,idp1pr(npommx,kollmx),idp2pr(npommx,kollmx) + * ,idm1pr(npommx,kollmx),idm2pr(npommx,kollmx) + common/cems8/xxp1pr(npommx,kollmx),xyp1pr(npommx,kollmx) + * ,xxp2pr(npommx,kollmx),xyp2pr(npommx,kollmx) + * ,xxm1pr(npommx,kollmx),xym1pr(npommx,kollmx) + * ,xxm2pr(npommx,kollmx),xym2pr(npommx,kollmx) + +!---------------------------------------------------------------------- +! xp1pr(n,k): x of string end p1 p1 p2 +! xp2pr(n,k): x of string end p2 \ / +! xm1pr(n,k): x of string end m1 \ / +! xm2pr(n,k): x of string end m2 \/ +! idp1pr(n,k): id of string end p1 ( 0=0 ) /\ +! idp2pr(n,k): id of string end p2 ( 1=s 2=v ) / \ +! idm1pr(n,k): id of string end m1 ( 4=ss*2 5=ss ) / \ +! idm2pr(n,k): id of string end m2 ( 8=f ) m1 m2 +! xxp1pr(n,k),xyp1pr(n,k): px,py of string end p1 +! xxp2pr(n,k),xyp2pr(n,k): px,py of string end p2 +! xxm1pr(n,k),xym1pr(n,k): px,py of string end m1 +! xxm2pr(n,k),xym2pr(n,k): px,py of string end m2 +!---------------------------------------------------------------------- + + double precision xme + common/cems11/xme(mamx) + +!---------------------------------------------------------------------- +! xme(j): x- exchange for nucleon j +!---------------------------------------------------------------------- + + common/cems22/idhpr(npommx,kollmx),idrpr(npommx,kollmx) + * ,idsppr(npommx,kollmx),idstpr(npommx,kollmx) + +!---------------------------------------------------------------------- +! idhpr(n,k): flav hard Pom (n,k) (0=gg,1=qg,2=gq,3=qq) +! idrpr(n,k): flav Regg (n,k) (0=ss,1=0va0,2=v00a,3=0as0,4=s00a,5=0sv0,6=v00s) +! idsppr(n,k): flav soft P (n,k) (proj) (0=ss,1=vs,2=sa,3=va,4=dd,5=svv,6=aas) +! idstpr(n,k): flav soft P (n,k) (targ) (0=ss,1=vs,2=sa,3=va,4=dd,5=svv,6=aas) +!---------------------------------------------------------------------- + + +!---------------------------------------------------------------------- +! REMNANT CONFIGURATION +!---------------------------------------------------------------------- + common/remn4/jcpval(nflavems,2,mamx),jctval(nflavems,2,mamx) + common/remn3/jcpref(nflavems,2,mamx),jctref(nflavems,2,mamx) + common/remn2/zzremn(mamx,2) + common/remn/icremn(2,mamx,2) + dimension icproj(2,mamx),ictarg(2,mamx) + double precision xpp,xmp,xpt,xmt,xxp,xyp,xxt,xyt + double precision xpz,xmz,xxz,xyz + common/cemsr/xpz(mamx,2),xmz(mamx,2) + * ,xxz(mamx,2),xyz(mamx,2) + * ,idz(mamx,2),ivz(mamx,2) + * ,isz(mamx,2),iaz(mamx,2) + dimension xpp(mamx),xmp(mamx),xpt(mamx),xmt(mamx) + * ,xxp(mamx),xyp(mamx),xxt(mamx),xyt(mamx) + * ,idp(mamx),ivp(mamx),ivt(mamx),idt(mamx) + * ,isp(mamx),iap(mamx),ist(mamx),iat(mamx) + + equivalence (icproj(1,1),icremn(1,1,1)) + * ,(ictarg(1,1),icremn(1,1,2)) + equivalence (xpp(1),xpz(1,1)),(xmt(1),xpz(1,2)) + * ,(xmp(1),xmz(1,1)),(xpt(1),xmz(1,2)) + * ,(xxp(1),xxz(1,1)),(xxt(1),xxz(1,2)) + * ,(xyp(1),xyz(1,1)),(xyt(1),xyz(1,2)) + * ,(idp(1),idz(1,1)),(idt(1),idz(1,2)) + * ,(ivp(1),ivz(1,1)),(ivt(1),ivz(1,2)) + * ,(isp(1),isz(1,1)),(ist(1),isz(1,2)) + * ,(iap(1),iaz(1,1)),(iat(1),iaz(1,2)) + +!---------------------------------------------------------------------- +! xpp(ip),xmp(ip),xpt(it),xmt(it): x+,x- of projectile ip / target it +! xxp(ip),xyp(ip),xxt(it),xyt(it): px,py of projectile ip / target it +! idp(ip),idt(it): diquark counter +! ivp(ip),ivt(it): valenve quark counter +! isp(ip),ist(it): sea quark counter +! iap(ip),iat(it): anti valence quark counter +!---------------------------------------------------------------------- + + double precision xpmn,xtmn,xpmx,xtmx,xppmx,xptmx,xmpmx,xmtmx + * ,xppmn ,xptmn,xmpmn,xmtmn,xpos,xtos + double precision xzmn,xzmx,xpzmx,xmzmx + * ,xpzmn ,xmzmn,xzos + common/cemsr1/xzmn(mamx,2),xzmx(mamx,2) + * ,xpzmx(mamx,2) + * ,xmzmx(mamx,2) + * ,xpzmn(mamx,2) + * ,xmzmn(mamx,2) + * ,xzos(mamx,2) + dimension xpmn(mamx),xtmn(mamx),xpmx(mamx),xtmx(mamx) + * ,xppmx(mamx),xptmx(mamx) + * ,xmpmx(mamx),xmtmx(mamx) + * ,xppmn(mamx),xptmn(mamx) + * ,xmpmn(mamx),xmtmn(mamx) + * ,xpos(mamx),xtos(mamx) + + equivalence ( xpmn(1), xzmn(1,1)),( xtmn(1), xzmn(1,2)) + * ,( xpmx(1), xzmx(1,1)),( xtmx(1), xzmx(1,2)) + * ,(xppmx(1),xpzmx(1,1)),(xptmx(1),xpzmx(1,2)) + * ,(xmpmx(1),xmzmx(1,1)),(xmtmx(1),xmzmx(1,2)) + * ,(xppmn(1),xpzmn(1,1)),(xptmn(1),xpzmn(1,2)) + * ,(xmpmn(1),xmzmn(1,1)),(xmtmn(1),xmzmn(1,2)) + * ,( xpos(1), xzos(1,1)),( xtos(1), xzos(1,2)) + +!---------------------------------------------------------------------- +! xpmn(ip),xtmn(it),xpmx(ip),xtmx(it): x proj/targ minimum/maximum +! xppmx(ip),xptmx(it),xmpmx(ip),xmtmx(it): x+/x- proj/targ maximum +! xppmn(ip),xptmn(it),xmpmn(ip),xmtmn(it): x+/x- proj/targ minimum +! xpos(ip),xtos(it): x value for on shell condition proj/targ +!---------------------------------------------------------------------- + + common/cemsr3/kolp(mamx),kolt(mamx),npp(mamx),npt(mamx) + common/cemsr4/iez(mamx,2),ifz(mamx,2) + dimension iep(mamx),iet(mamx),ifp(mamx),ift(mamx) + equivalence (iep(1),iez(1,1)),(iet(1),iez(1,2)) + * ,(ifp(1),ifz(1,1)),(ift(1),ifz(1,2)) + +!---------------------------------------------------------------------- +! kolp(ip),kolt(it): number of cut Pomerons of proj ip / targ it +! iep(ip),iet(it): excitation type of proj ip / targ it +! (0=none,1=inelastic,2=diffractive) +! ifp(ip),ift(it): remnant flip flag proj/targ (0=no,1=yes) +! if3dp(ip), if3dp(it): triple pomeron diffraction (if 1) +!---------------------------------------------------------------------- + + +!---------------------------------------------------------------------- +! transfer from emsini +!---------------------------------------------------------------------- + + double precision amzmn,ampmn,amtmn,ammn,amemn,amemx,amprmn,xis + &,delxi,ddelx,r3pompi,r3pommi,r3pompi3,r3pommi3 + parameter (ntypmx=19) + common/cems12/ammn(0:ntypmx),amprmn(0:ntypmx) + common/cemsr6/amzmn(0:1,2),amemn(0:1,0:6),amemx(0:2) + dimension ampmn(0:1),amtmn(0:1) + equivalence (ampmn(0),amzmn(0,1)), (amtmn(0),amzmn(0,2)) + common/cemsr13/xis,delxi,ddelx,r3pompi,r3pommi + &,r3pompi3,r3pommi3,ucfpro,ucftar + +!---------------------------------------------------------------------- +! STORAGE +!---------------------------------------------------------------------- + + double precision + *xxpr,xxpr0,yx,yx0,xxppr,xxmpr,xxppr0,xxmpr0 + *,xmtx,xmtx0,xmtlx,xmtlx0 + *,xppx,xppx0,xpplx,xpplx0 + *,xppst,xmpst,xposst,xpest,xppstx0,xmpstx0,xppstx,xmpstx + *,xmtst,xptst,xtosst,xmest,xmtstx0,xptstx0,xmtstx,xptstx + dimension nprx(0:3),nprx0(0:3),iepst(mamx),ietst(mamx) + *,xppst(mamx),xmpst(mamx),xposst(mamx),xpest(mamx) + *,xmtst(mamx),xptst(mamx),xtosst(mamx),xmest(mamx) + + + common/emsstore/ + *xxpr,xxpr0,yx,yx0,xxppr,xxmpr,xxppr0,xxmpr0 + *,xmtx,xmtx0,xmtlx,xmtlx0 + *,xppx,xppx0,xpplx,xpplx0 + *,itx,itx0,idx,idx0,iepst,ietst + *,npplx0,nptlx0,npplx,nptlx + *,nppx,nppx0,nptx,nptx0,nprx,nprx0,nprtx,nprtx0 + *,xppst,xmpst,xposst,xpest,xppstx0,xmpstx0,xppstx,xmpstx + *,xmtst,xptst,xtosst,xmest,xmtstx0,xptstx0,xmtstx,xptstx + + +!---------------------------------------------------------------------- +! utilities +!---------------------------------------------------------------------- + + double precision facto,fctrl + common/factori/facto(0:npommx),fctrl(0:npommx),nfctrl + + + + + diff --git a/modules/epos/epos.incems.low b/modules/epos/epos.incems.low new file mode 100644 index 0000000000000000000000000000000000000000..cae89765e1eb7750db9aeb9c25e90bf224abfbcd --- /dev/null +++ b/modules/epos/epos.incems.low @@ -0,0 +1,281 @@ + + parameter (mmrye=15,mmryk=3) !memory saving factor + + parameter (kollmx=45000/mmrye,npommx=150) + parameter (mamx=250/mmryk,ngrmx=1,ntymi=0,ntymx=2) + parameter (nflavems=4) + +!---------------------------------------------------------------------- +! POMERON +!---------------------------------------------------------------------- + + double precision om1int,om1intc + * ,atilde,btildep,btildepp + common/comega/om1int(kollmx),om1intc(kollmx) + common/comtilde/atilde(ntymi:ntymx,kollmx) + *,btildep(ntymi:ntymx,kollmx),btildepp(ntymi:ntymx,kollmx) + *,ntymin + +!---------------------------------------------------------------------- +! POMERON CONFIGURATION +!---------------------------------------------------------------------- + + common/col/koll,iproj(kollmx),itarg(kollmx),coord(4,kollmx) + common/col1/kremn(mamx,mamx,2),lremn(mamx,2) + dimension kproj(mamx,mamx),ktarg(mamx,mamx) + *,lproj(mamx),ltarg(mamx) + equivalence (kproj(1,1),kremn(1,1,1)),(ktarg(1,1),kremn(1,1,2)) + equivalence (lproj(1),lremn(1,1)),(ltarg(1),lremn(1,2)) + double precision gammaV + common/col6/kproj3(mamx,mamx),ktarg3(mamx,mamx) + *,lproj3(mamx),ltarg3(mamx) + *,epsilongp(kollmx,0:1),epsilongt(kollmx,0:1) + *,epsilongs(kollmx,0:1),gammaV(kollmx) + *,epsilongf(kollmx),epsilongb(kollmx) + common/col4/bk(kollmx),bhpr(npommx,kollmx),bkx(kollmx) + *,bky(kollmx) + double precision PomInck,xxnuc,xzcutpar + common/col7/zparremn(kollmx,2),PomInck(kollmx),xzcutpar(kollmx) + *,xxnuc(mamx,2,kollmx),npnuc(mamx,2,kollmx) + *,irnuc(mamx,2,kollmx),knucnt(2,kollmx) + real zparpro(kollmx),zpartar(kollmx) + equivalence (zparpro(1),zparremn(1,1)),(zpartar(1),zparremn(1,2)) + +!---------------------------------------------------------------------- +! koll: number of relevant pairs +! iproj(k): projectile index for k-th pair +! itarg(k): target index for k-th pair +! lproj(ip): number of pairs linked to projectile ip +! kproj(ip,l): corresponding pair index of the l-th pair +! ltarg(it): number of pairs linked to target it +! ktarg(it,l): corresponding pair index of the l-th pair +! bk(k): b value of the k-th pair (=sqrt(bx**2.+by**2.)) +! bkx(k): bx value of the k-th pair +! bky(k): by value of the k-th pair +! lproj3(ip): number of pairs linked to projectile ip (no diffraction) +! kproj3(ip,l): corresponding pair index of the l-th pair (no diffraction) +! ltarg3(it): number of pairs linked to target it (no diffraction) +! ktarg3(it,l): corresponding pair index of the l-th pair (no diffraction) +!---------------------------------------------------------------------- + + common/cems3/nprt(kollmx),npr(0:3,kollmx) + common/cems4/nprmx(kollmx) + +!---------------------------------------------------------------------- +! nprt(k): number of pomerons of collision k +! npr(id,k): number of pomerons of type id of collision k +! (id: 0=zero, 1=soft, 2=reggeon, 3=hard) +! nprmx(k): maximum number of pomerons of collision k +!---------------------------------------------------------------------- + + common/cems2/itpr(kollmx),idpr(npommx,kollmx),ivpr(npommx,kollmx) + *,idfpr(npommx,kollmx) + *,nvpr(npommx,kollmx),nbkpr(npommx,kollmx) + +!---------------------------------------------------------------------- +! itpr(k): interaction type of collision k +! (0=nothing, 1=inelastic, 2=diffractive) +! idpr(n,k): type of pomeron (n,k) +! (0=zero, 1=soft, 2=reggeon, 3=hard) +! ivpr(n,k): status of pomeron (n,k) (0=virtual, 1=real, 2=backup) +! nbkpr(n,k): position of the backup pomeron +! nvpr(n,k): position of the pomeron for this backup pomeron +! idfpr(n,k): link of pomeron (n,k) (0=no, 1=pro&tar, 2=pro, 3=tar) +! idfpr=-1 means backup pomeron +!---------------------------------------------------------------------- + + double precision xpr,ypr,xppr,xmpr,xpprbor,xmprbor + common/cems1/xpr(npommx,kollmx),ypr(npommx,kollmx) + common/cems1c/xppr(npommx,kollmx),xmpr(npommx,kollmx) + common/cems1d/xpprbor(npommx,kollmx),xmprbor(npommx,kollmx) + common/cems1e/nemispr(2,npommx,kollmx),ptprboo(2,npommx,kollmx) + +!---------------------------------------------------------------------- +! xpr(n,k): x=x+x- of pomeron (n,k) +! ypr(n,k): rapidity of pomeron (n,k) +! xpprbor(n,k): x+ of in Born parton of pomeron (n,k) +! xmprbor(n,k): x- of in Born parton of pomeron (n,k) +! nemispr(i,n,k): number of up (i=1) and down (i=2) emissions +!---------------------------------------------------------------------- + + double precision xp1pr,xp2pr,xm1pr,xm2pr,xxp1pr,xyp1pr + * ,xxp2pr,xyp2pr,xxm1pr,xym1pr,xxm2pr,xym2pr + common/cems7/xp1pr(npommx,kollmx),xp2pr(npommx,kollmx) + * ,xm1pr(npommx,kollmx),xm2pr(npommx,kollmx) + * ,idp1pr(npommx,kollmx),idp2pr(npommx,kollmx) + * ,idm1pr(npommx,kollmx),idm2pr(npommx,kollmx) + common/cems8/xxp1pr(npommx,kollmx),xyp1pr(npommx,kollmx) + * ,xxp2pr(npommx,kollmx),xyp2pr(npommx,kollmx) + * ,xxm1pr(npommx,kollmx),xym1pr(npommx,kollmx) + * ,xxm2pr(npommx,kollmx),xym2pr(npommx,kollmx) + +!---------------------------------------------------------------------- +! xp1pr(n,k): x of string end p1 p1 p2 +! xp2pr(n,k): x of string end p2 \ / +! xm1pr(n,k): x of string end m1 \ / +! xm2pr(n,k): x of string end m2 \/ +! idp1pr(n,k): id of string end p1 ( 0=0 ) /\ +! idp2pr(n,k): id of string end p2 ( 1=s 2=v ) / \ +! idm1pr(n,k): id of string end m1 ( 4=ss*2 5=ss ) / \ +! idm2pr(n,k): id of string end m2 ( 8=f ) m1 m2 +! xxp1pr(n,k),xyp1pr(n,k): px,py of string end p1 +! xxp2pr(n,k),xyp2pr(n,k): px,py of string end p2 +! xxm1pr(n,k),xym1pr(n,k): px,py of string end m1 +! xxm2pr(n,k),xym2pr(n,k): px,py of string end m2 +!---------------------------------------------------------------------- + + double precision xme + common/cems11/xme(mamx) + +!---------------------------------------------------------------------- +! xme(j): x- exchange for nucleon j +!---------------------------------------------------------------------- + + common/cems22/idhpr(npommx,kollmx),idrpr(npommx,kollmx) + * ,idsppr(npommx,kollmx),idstpr(npommx,kollmx) + +!---------------------------------------------------------------------- +! idhpr(n,k): flav hard Pom (n,k) (0=gg,1=qg,2=gq,3=qq) +! idrpr(n,k): flav Regg (n,k) (0=ss,1=0va0,2=v00a,3=0as0,4=s00a,5=0sv0,6=v00s) +! idsppr(n,k): flav soft P (n,k) (proj) (0=ss,1=vs,2=sa,3=va,4=dd,5=svv,6=aas) +! idstpr(n,k): flav soft P (n,k) (targ) (0=ss,1=vs,2=sa,3=va,4=dd,5=svv,6=aas) +!---------------------------------------------------------------------- + + +!---------------------------------------------------------------------- +! REMNANT CONFIGURATION +!---------------------------------------------------------------------- + common/remn4/jcpval(nflavems,2,mamx),jctval(nflavems,2,mamx) + common/remn3/jcpref(nflavems,2,mamx),jctref(nflavems,2,mamx) + common/remn2/zzremn(mamx,2) + common/remn/icremn(2,mamx,2) + dimension icproj(2,mamx),ictarg(2,mamx) + double precision xpp,xmp,xpt,xmt,xxp,xyp,xxt,xyt + double precision xpz,xmz,xxz,xyz + common/cemsr/xpz(mamx,2),xmz(mamx,2) + * ,xxz(mamx,2),xyz(mamx,2) + * ,idz(mamx,2),ivz(mamx,2) + * ,isz(mamx,2),iaz(mamx,2) + dimension xpp(mamx),xmp(mamx),xpt(mamx),xmt(mamx) + * ,xxp(mamx),xyp(mamx),xxt(mamx),xyt(mamx) + * ,idp(mamx),ivp(mamx),ivt(mamx),idt(mamx) + * ,isp(mamx),iap(mamx),ist(mamx),iat(mamx) + + equivalence (icproj(1,1),icremn(1,1,1)) + * ,(ictarg(1,1),icremn(1,1,2)) + equivalence (xpp(1),xpz(1,1)),(xmt(1),xpz(1,2)) + * ,(xmp(1),xmz(1,1)),(xpt(1),xmz(1,2)) + * ,(xxp(1),xxz(1,1)),(xxt(1),xxz(1,2)) + * ,(xyp(1),xyz(1,1)),(xyt(1),xyz(1,2)) + * ,(idp(1),idz(1,1)),(idt(1),idz(1,2)) + * ,(ivp(1),ivz(1,1)),(ivt(1),ivz(1,2)) + * ,(isp(1),isz(1,1)),(ist(1),isz(1,2)) + * ,(iap(1),iaz(1,1)),(iat(1),iaz(1,2)) + +!---------------------------------------------------------------------- +! xpp(ip),xmp(ip),xpt(it),xmt(it): x+,x- of projectile ip / target it +! xxp(ip),xyp(ip),xxt(it),xyt(it): px,py of projectile ip / target it +! idp(ip),idt(it): diquark counter +! ivp(ip),ivt(it): valenve quark counter +! isp(ip),ist(it): sea quark counter +! iap(ip),iat(it): anti valence quark counter +!---------------------------------------------------------------------- + + double precision xpmn,xtmn,xpmx,xtmx,xppmx,xptmx,xmpmx,xmtmx + * ,xppmn ,xptmn,xmpmn,xmtmn,xpos,xtos + double precision xzmn,xzmx,xpzmx,xmzmx + * ,xpzmn ,xmzmn,xzos + common/cemsr1/xzmn(mamx,2),xzmx(mamx,2) + * ,xpzmx(mamx,2) + * ,xmzmx(mamx,2) + * ,xpzmn(mamx,2) + * ,xmzmn(mamx,2) + * ,xzos(mamx,2) + dimension xpmn(mamx),xtmn(mamx),xpmx(mamx),xtmx(mamx) + * ,xppmx(mamx),xptmx(mamx) + * ,xmpmx(mamx),xmtmx(mamx) + * ,xppmn(mamx),xptmn(mamx) + * ,xmpmn(mamx),xmtmn(mamx) + * ,xpos(mamx),xtos(mamx) + + equivalence ( xpmn(1), xzmn(1,1)),( xtmn(1), xzmn(1,2)) + * ,( xpmx(1), xzmx(1,1)),( xtmx(1), xzmx(1,2)) + * ,(xppmx(1),xpzmx(1,1)),(xptmx(1),xpzmx(1,2)) + * ,(xmpmx(1),xmzmx(1,1)),(xmtmx(1),xmzmx(1,2)) + * ,(xppmn(1),xpzmn(1,1)),(xptmn(1),xpzmn(1,2)) + * ,(xmpmn(1),xmzmn(1,1)),(xmtmn(1),xmzmn(1,2)) + * ,( xpos(1), xzos(1,1)),( xtos(1), xzos(1,2)) + +!---------------------------------------------------------------------- +! xpmn(ip),xtmn(it),xpmx(ip),xtmx(it): x proj/targ minimum/maximum +! xppmx(ip),xptmx(it),xmpmx(ip),xmtmx(it): x+/x- proj/targ maximum +! xppmn(ip),xptmn(it),xmpmn(ip),xmtmn(it): x+/x- proj/targ minimum +! xpos(ip),xtos(it): x value for on shell condition proj/targ +!---------------------------------------------------------------------- + + common/cemsr3/kolp(mamx),kolt(mamx),npp(mamx),npt(mamx) + common/cemsr4/iez(mamx,2),ifz(mamx,2) + dimension iep(mamx),iet(mamx),ifp(mamx),ift(mamx) + equivalence (iep(1),iez(1,1)),(iet(1),iez(1,2)) + * ,(ifp(1),ifz(1,1)),(ift(1),ifz(1,2)) + +!---------------------------------------------------------------------- +! kolp(ip),kolt(it): number of cut Pomerons of proj ip / targ it +! iep(ip),iet(it): excitation type of proj ip / targ it +! (0=none,1=inelastic,2=diffractive) +! ifp(ip),ift(it): remnant flip flag proj/targ (0=no,1=yes) +! if3dp(ip), if3dp(it): triple pomeron diffraction (if 1) +!---------------------------------------------------------------------- + + +!---------------------------------------------------------------------- +! transfer from emsini +!---------------------------------------------------------------------- + + double precision amzmn,ampmn,amtmn,ammn,amemn,amemx,amprmn,xis + &,delxi,ddelx,r3pompi,r3pommi,r3pompi3,r3pommi3 + parameter (ntypmx=19) + common/cems12/ammn(0:ntypmx),amprmn(0:ntypmx) + common/cemsr6/amzmn(0:1,2),amemn(0:1,0:6),amemx(0:2) + dimension ampmn(0:1),amtmn(0:1) + equivalence (ampmn(0),amzmn(0,1)), (amtmn(0),amzmn(0,2)) + common/cemsr13/xis,delxi,ddelx,r3pompi,r3pommi + &,r3pompi3,r3pommi3,ucfpro,ucftar + +!---------------------------------------------------------------------- +! STORAGE +!---------------------------------------------------------------------- + + double precision + *xxpr,xxpr0,yx,yx0,xxppr,xxmpr,xxppr0,xxmpr0 + *,xmtx,xmtx0,xmtlx,xmtlx0 + *,xppx,xppx0,xpplx,xpplx0 + *,xppst,xmpst,xposst,xpest,xppstx0,xmpstx0,xppstx,xmpstx + *,xmtst,xptst,xtosst,xmest,xmtstx0,xptstx0,xmtstx,xptstx + dimension nprx(0:3),nprx0(0:3),iepst(mamx),ietst(mamx) + *,xppst(mamx),xmpst(mamx),xposst(mamx),xpest(mamx) + *,xmtst(mamx),xptst(mamx),xtosst(mamx),xmest(mamx) + + + common/emsstore/ + *xxpr,xxpr0,yx,yx0,xxppr,xxmpr,xxppr0,xxmpr0 + *,xmtx,xmtx0,xmtlx,xmtlx0 + *,xppx,xppx0,xpplx,xpplx0 + *,itx,itx0,idx,idx0,iepst,ietst + *,npplx0,nptlx0,npplx,nptlx + *,nppx,nppx0,nptx,nptx0,nprx,nprx0,nprtx,nprtx0 + *,xppst,xmpst,xposst,xpest,xppstx0,xmpstx0,xppstx,xmpstx + *,xmtst,xptst,xtosst,xmest,xmtstx0,xptstx0,xmtstx,xptstx + + +!---------------------------------------------------------------------- +! utilities +!---------------------------------------------------------------------- + + double precision facto,fctrl + common/factori/facto(0:npommx),fctrl(0:npommx),nfctrl + + + + + diff --git a/modules/epos/epos.inchy b/modules/epos/epos.inchy new file mode 100644 index 0000000000000000000000000000000000000000..a7afb89dcb6b7c917b0160b774a9889157c71a5b --- /dev/null +++ b/modules/epos/epos.inchy @@ -0,0 +1,43 @@ + parameter (ncenthx=7) + parameter (netahx=21,ntauhx=123) + parameter (nphihx=121,nradhx=75) + parameter (nraphx=20) + + common/chydim/ncenthy,netahy,ntauhy,nphihy,nradhy + common/ctau/ntauho + + common/ctauhoc/ntauhoc(ncenthx),tauhoc(ncenthx,ntauhx) + common/ctauhec/ntauhec(ncenthx,-netahx+1:netahx-1,nphihx) + + common/hydtab/centhy(ncenthx),etahy(netahx) + * ,tauhy(ntauhx),phihy(nphihx),radhy(nradhx) + * ,epsii(ncenthx,netahx,nphihx,nradhx) + common/czeta/zetahy(1-netahx:netahx-1) + + common/cpau/ + * paut(ncenthx,-netahx+1:netahx-1,ntauhx) + * ,pauf(ncenthx,-netahx+1:netahx-1,ntauhx,nphihx) + + common/hydtab4/ + * raa(ncenthx,-netahx+1:netahx-1,ntauhx,nphihx) + *,vaa(3,ncenthx,-netahx+1:netahx-1,ntauhx,nphihx) + * ,waa(ncenthx,-netahx+1:netahx-1,ntauhx,nphihx) + + common/hydtab3/rar(ncenthx,netahx,ntauhx,nphihx) + * ,var(3,ncenthx,netahx,ntauhx,nphihx) + * ,war(ncenthx,netahx,ntauhx,nphihx) + + parameter (mxeos=50001 ) + common/ceos/eos(3,mxeos) + * ,eosmu(17,mxeos),meos,meosmu + + parameter (mxcenty=200 ) + common/ccenty/bcenty(mxcenty),pcenty(mxcenty),mcenty + + parameter (mxbimp=500 ) + common/cbimp/bimpar(2,mxbimp),nbimp + + common/hydtab6/geff(ncenthx,netahx) + + common/hydtab7/feff(ncenthx,-netahx+1:netahx-1) + diff --git a/modules/epos/epos.incico b/modules/epos/epos.incico new file mode 100644 index 0000000000000000000000000000000000000000..802f587955f0acba594fdc9e862b672c4bdc8c04 --- /dev/null +++ b/modules/epos/epos.incico @@ -0,0 +1,44 @@ +c------------------------------------------------------------------------- +c initial conditions for hydro +c------------------------------------------------------------------------- + + real xminico,xmaxico,yminico,ymaxico,zminico,zmaxico + integer nxico,nyico,nzico + real IcoE, IcoV, IcoF + + parameter (xminico=-10.25,xmaxico=10.25) !x range + parameter (yminico=-10.25,ymaxico=10.25) !y range + parameter (zminico= -6.25,zmaxico= 6.25) !eta range + + parameter (nxico=41,nyico=41,nzico=25) !number of bins (uneven!!!) + + !--------------------------------------------------------------------- + ! We think in terms of bins: + ! xminico, yminico,zminico: lower end of 1st bin + ! xmaxico,ymaxico,zmaxico: upper end of last bin + ! Concerning the mean value for the bins number "i": + ! x_i=xminico+(i-0.5)*(xmaxico-xminico)/nxico + ! y_j=xminico+(j-0.5)*(ymaxico-yminico)/nyico + ! z_k=xminico+(k-0.5)*(zmaxico-zminico)/nzico + !--------------------------------------------------------------------- + + common /Ico3/ IcoE(nxico,nyico,nzico) + common /Ico4/ IcoV(3,nxico,nyico,nzico) + common /Ico5/ IcoF(3,nxico,nyico,nzico) + + !--------------------------------------------------------------------- + !/Ico3/ IcoE(ix,iy,iz) energy-density + ! + !/Ico4/ IcoV(1,ix,iy,iz) x-velocity + ! IcoV(2,ix,iy,iz) y-velocity + ! IcoV(3,ix,iy,iz) z-velocity + ! + !/Ico5 / IcoF(1,ix,iy,iz) net flavor density of up + ! IcoF(2,ix,iy,iz) net flavor density of down + ! IcoF(3,ix,iy,iz) net flavor density of strange + !-------------------------------------------------------------------- + ! ix,iy,iz ....... transverse coordinates + pseudo-rapidity eta + !-------------------------------------------------------------------- + + real tauico + common/ctauico/tauico diff --git a/modules/epos/epos.incpar b/modules/epos/epos.incpar new file mode 100644 index 0000000000000000000000000000000000000000..d3d8b1992b0047603c8c11dcd6a94cca4d271f09 --- /dev/null +++ b/modules/epos/epos.incpar @@ -0,0 +1,8 @@ + parameter(maxdataDf=100,nbpf=30) + double precision xminDf,xmaxDf,xfitmin,xshmin,xggfit + common /parvar/ xminDf,xmaxDf,xfitmin,xshmin,xggfit + & ,nmcxDf,nmcbDf,nptf,smaxDf,bmaxDf,sfshlim + common /fitpar/ numparDf,parDf(nbpf,4),numdataDf,numminDf, + & datafitD(maxdataDF,3),fparDf,betac,betae + common /epspar/epscrw,epscrp,egyscr,iscreeni,epscrs,epscrx,epscrh + &,znurho,zbrads,epscrd,bglaubx,b2xscr,fegypp,zbcutx diff --git a/modules/epos/epos.incsem b/modules/epos/epos.incsem new file mode 100644 index 0000000000000000000000000000000000000000..2366156ed3ed9e9d434c7a90f7c277e10750b5fc --- /dev/null +++ b/modules/epos/epos.incsem @@ -0,0 +1,10 @@ + common /psar1/icdp,icdt + common /psar3/ dels,alfp,ffrr,delh,r3pom,r4pom,alpasf + common /psar5/ qcdlam,q2min,q2ini,q2fin,pt2cut, + *betpom,glusea,naflav,alfe + common /psar8/ stmass ,amhadr(8),qcmass + common /psar12/ ydmin,ydmax,qdmin,qdmax,themin,themax,elomin + common /psar14/ factk,factgam + double precision cYfus,cYscr,cYdif,cXfus,cXdif,cXscr + common /psar16/ cYfus,cYscr,cYdif,cXfus,cXdif,cXscr + common/cgamsoft/gamsoft diff --git a/modules/epos/epos.ini1b b/modules/epos/epos.ini1b new file mode 100644 index 0000000000000000000000000000000000000000..610da47b49ecdb7982088f46a6d8504b081e1cd5 --- /dev/null +++ b/modules/epos/epos.ini1b @@ -0,0 +1,6347 @@ + +++++1b + 197 197 200. 0.219999999 + 5 7 49 25 75 + 1.70000005 5.69999981 8.10000038 10. 12.8999996 0. 1.20000005 + 2.4000001 3.20000005 3.5999999 4. 4.4000001 0.600000024 1. 1.39999998 + 1.79999995 2.20000005 2.5999999 3. 3.4000001 3.79999995 4.19999981 + 4.5999999 5. 5.4000001 5.80000019 6.19999981 6.5999999 7. 7.4000001 + 7.80000019 8.19999981 8.60000038 9. 9.39999962 9.80000019 10.1999998 + 10.6000004 11. 11.3999996 11.8000002 12.1999998 12.6000004 13. + 13.3999996 13.8000002 14.1999998 14.6000004 15. 15.3999996 15.8000002 + 16.2000008 16.6000004 17. 17.3999996 17.7999992 18.2000008 18.6000004 + 19. 19.3999996 19.7999992 0. 0.0654498488 0.130899698 0.196349546 + 0.261799395 0.327249229 0.392699093 0.458148926 0.52359879 0.589048624 + 0.654498458 0.719948351 0.785398185 0.850848019 0.916297853 0.981747746 + 1.04719758 1.11264741 1.17809725 1.24354708 1.30899692 1.37444687 + 1.4398967 1.50534654 1.57079637 0. 0.405405402 0.810810804 1.21621621 + 1.62162161 2.02702713 2.43243241 2.83783793 3.24324322 3.64864874 + 4.05405426 4.4594593 4.86486483 5.27027035 5.67567587 6.08108091 + 6.48648643 6.89189196 7.29729748 7.70270252 8.10810852 8.51351357 + 8.91891861 9.32432461 9.72972965 10.1351347 10.5405407 10.9459457 + 11.3513517 11.7567568 12.1621618 12.5675678 12.9729729 13.3783779 + 13.7837839 14.189189 14.594595 15. 15.405405 15.810811 16.216217 + 16.6216221 17.0270271 17.4324322 17.8378372 18.2432442 18.6486492 + 19.0540543 19.4594593 19.8648643 20.2702694 20.6756763 21.0810814 + 21.4864864 21.8918915 22.2972965 22.7027035 23.1081085 23.5135136 + 23.9189186 24.3243237 24.7297306 25.1351357 25.5405407 25.9459457 + 26.3513508 26.7567558 27.1621628 27.5675678 27.9729729 28.3783779 + 28.783783 29.1891899 29.594595 30. + 22.0832996 20. 16.9167004 12.5 2.33332992 20.9946995 19.0140991 + 16.0827999 11.8837996 2.12333012 15.9252996 14.4229002 12.1993999 + 9.01430988 1.49333 9.44209957 8.55132961 7.2329998 5.34458017 + 0.839999974 5.11375999 4.63133001 3.91733003 2.89457989 0.443333 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 22.0832996 20. 16.9167004 12.5 2.33332992 + 20.9946995 19.0140991 16.0827999 11.8837996 2.12333012 15.9252996 + 14.4229002 12.1993999 9.01430988 1.49333 9.44209957 8.55132961 + 7.2329998 5.34458017 0.839999974 5.11375999 4.63133001 3.91733003 + 2.89457989 0.443333 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 22.0832996 20. + 16.9167004 12.5 2.33332992 20.9946995 19.0140991 16.0827999 11.8837996 + 2.12333012 15.9252996 14.4229002 12.1993999 9.01430988 1.49333 + 9.44209957 8.55132961 7.2329998 5.34458017 0.839999974 5.11375999 + 4.63133001 3.91733003 2.89457989 0.443333 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 22.0832996 20. 16.9167004 12.5 2.33332992 20.9946995 19.0140991 + 16.0827999 11.8837996 2.12333012 15.9252996 14.4229002 12.1993999 + 9.01430988 1.49333 9.44209957 8.55132961 7.2329998 5.34458017 + 0.839999974 5.11375999 4.63133001 3.91733003 2.89457989 0.443333 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 22.0832996 20. 16.9167004 12.5 2.33332992 + 20.9946995 19.0140991 16.0827999 11.8837996 2.12333012 15.9252996 + 14.4229002 12.1993999 9.01430988 1.49333 9.44209957 8.55132961 + 7.2329998 5.34458017 0.839999974 5.11375999 4.63133001 3.91733003 + 2.89457989 0.443333 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 22.0832996 20. + 16.9167004 12.5 2.33332992 20.9946995 19.0140991 16.0827999 11.8837996 + 2.12333012 15.9252996 14.4229002 12.1993999 9.01430988 1.49333 + 9.44209957 8.55132961 7.2329998 5.34458017 0.839999974 5.11375999 + 4.63133001 3.91733003 2.89457989 0.443333 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 22.0832996 20. 16.9167004 12.5 2.33332992 20.9946995 19.0140991 + 16.0827999 11.8837996 2.12333012 15.9252996 14.4229002 12.1993999 + 9.01430988 1.49333 9.44209957 8.55132961 7.2329998 5.34458017 + 0.839999974 5.11375999 4.63133001 3.91733003 2.89457989 0.443333 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 22.0832996 20. 16.9167004 12.5 2.33332992 + 20.9946995 19.0140991 16.0827999 11.8837996 2.12333012 15.9252996 + 14.4229002 12.1993999 9.01430988 1.49333 9.44209957 8.55132961 + 7.2329998 5.34458017 0.839999974 5.11375999 4.63133001 3.91733003 + 2.89457989 0.443333 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 22.0832996 20. + 16.9167004 12.5 2.33332992 20.9946995 19.0140991 16.0827999 11.8837996 + 2.12333012 15.9252996 14.4229002 12.1993999 9.01430988 1.49333 + 9.44209957 8.55132961 7.2329998 5.34458017 0.839999974 5.11375999 + 4.63133001 3.91733003 2.89457989 0.443333 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 22.0832996 20. 16.9167004 12.5 2.33332992 20.9946995 19.0140991 + 16.0827999 11.8837996 2.12333012 15.9252996 14.4229002 12.1993999 + 9.01430988 1.49333 9.44209957 8.55132961 7.2329998 5.34458017 + 0.839999974 5.11375999 4.63133001 3.91733003 2.89457989 0.443333 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 22.0832996 20. 16.9167004 12.5 2.33332992 + 20.9946995 19.0140991 16.0827999 11.8837996 2.12333012 15.9252996 + 14.4229002 12.1993999 9.01430988 1.49333 9.44209957 8.55132961 + 7.2329998 5.34458017 0.839999974 5.11375999 4.63133001 3.91733003 + 2.89457989 0.443333 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 22.0832996 20. + 16.9167004 12.5 2.33332992 20.9946995 19.0140991 16.0827999 11.8837996 + 2.12333012 15.9252996 14.4229002 12.1993999 9.01430988 1.49333 + 9.44209957 8.55132961 7.2329998 5.34458017 0.839999974 5.11375999 + 4.63133001 3.91733003 2.89457989 0.443333 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 22.0832996 20. 16.9167004 12.5 2.33332992 20.9946995 19.0140991 + 16.0827999 11.8837996 2.12333012 15.9252996 14.4229002 12.1993999 + 9.01430988 1.49333 9.44209957 8.55132961 7.2329998 5.34458017 + 0.839999974 5.11375999 4.63133001 3.91733003 2.89457989 0.443333 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 22.0832996 20. 16.9167004 12.5 2.33332992 + 20.9946995 19.0140991 16.0827999 11.8837996 2.12333012 15.9252996 + 14.4229002 12.1993999 9.01430988 1.49333 9.44209957 8.55132961 + 7.2329998 5.34458017 0.839999974 5.11375999 4.63133001 3.91733003 + 2.89457989 0.443333 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 22.0832996 20. + 16.9167004 12.5 2.33332992 20.9946995 19.0140991 16.0827999 11.8837996 + 2.12333012 15.9252996 14.4229002 12.1993999 9.01430988 1.49333 + 9.44209957 8.55132961 7.2329998 5.34458017 0.839999974 5.11375999 + 4.63133001 3.91733003 2.89457989 0.443333 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 22.0832996 20. 16.9167004 12.5 2.33332992 20.9946995 19.0140991 + 16.0827999 11.8837996 2.12333012 15.9252996 14.4229002 12.1993999 + 9.01430988 1.49333 9.44209957 8.55132961 7.2329998 5.34458017 + 0.839999974 5.11375999 4.63133001 3.91733003 2.89457989 0.443333 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 22.0832996 20. 16.9167004 12.5 2.33332992 + 20.9946995 19.0140991 16.0827999 11.8837996 2.12333012 15.9252996 + 14.4229002 12.1993999 9.01430988 1.49333 9.44209957 8.55132961 + 7.2329998 5.34458017 0.839999974 5.11375999 4.63133001 3.91733003 + 2.89457989 0.443333 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 22.0832996 20. + 16.9167004 12.5 2.33332992 20.9946995 19.0140991 16.0827999 11.8837996 + 2.12333012 15.9252996 14.4229002 12.1993999 9.01430988 1.49333 + 9.44209957 8.55132961 7.2329998 5.34458017 0.839999974 5.11375999 + 4.63133001 3.91733003 2.89457989 0.443333 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 22.0832996 20. 16.9167004 12.5 2.33332992 20.9946995 19.0140991 + 16.0827999 11.8837996 2.12333012 15.9252996 14.4229002 12.1993999 + 9.01430988 1.49333 9.44209957 8.55132961 7.2329998 5.34458017 + 0.839999974 5.11375999 4.63133001 3.91733003 2.89457989 0.443333 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 22.0832996 20. 16.9167004 12.5 2.33332992 + 20.9946995 19.0140991 16.0827999 11.8837996 2.12333012 15.9252996 + 14.4229002 12.1993999 9.01430988 1.49333 9.44209957 8.55132961 + 7.2329998 5.34458017 0.839999974 5.11375999 4.63133001 3.91733003 + 2.89457989 0.443333 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 22.0832996 20. + 16.9167004 12.5 2.33332992 20.9946995 19.0140991 16.0827999 11.8837996 + 2.12333012 15.9252996 14.4229002 12.1993999 9.01430988 1.49333 + 9.44209957 8.55132961 7.2329998 5.34458017 0.839999974 5.11375999 + 4.63133001 3.91733003 2.89457989 0.443333 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 22.0832996 20. 16.9167004 12.5 2.33332992 20.9946995 19.0140991 + 16.0827999 11.8837996 2.12333012 15.9252996 14.4229002 12.1993999 + 9.01430988 1.49333 9.44209957 8.55132961 7.2329998 5.34458017 + 0.839999974 5.11375999 4.63133001 3.91733003 2.89457989 0.443333 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 22.0832996 20. 16.9167004 12.5 2.33332992 + 20.9946995 19.0140991 16.0827999 11.8837996 2.12333012 15.9252996 + 14.4229002 12.1993999 9.01430988 1.49333 9.44209957 8.55132961 + 7.2329998 5.34458017 0.839999974 5.11375999 4.63133001 3.91733003 + 2.89457989 0.443333 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 22.0832996 20. + 16.9167004 12.5 2.33332992 20.9946995 19.0140991 16.0827999 11.8837996 + 2.12333012 15.9252996 14.4229002 12.1993999 9.01430988 1.49333 + 9.44209957 8.55132961 7.2329998 5.34458017 0.839999974 5.11375999 + 4.63133001 3.91733003 2.89457989 0.443333 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 22.0832996 20. 16.9167004 12.5 2.33332992 20.9946995 19.0140991 + 16.0827999 11.8837996 2.12333012 15.9252996 14.4229002 12.1993999 + 9.01430988 1.49333 9.44209957 8.55132961 7.2329998 5.34458017 + 0.839999974 5.11375999 4.63133001 3.91733003 2.89457989 0.443333 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 21.987051 19.8273678 16.6279411 12.1747894 + 2.19206762 20.9031639 18.8499756 15.8081951 11.5745945 1.99478698 + 15.8559036 14.2983494 11.9911394 8.77977848 1.40292525 9.40093517 + 8.47751045 7.10953045 5.20552969 0.789146245 5.09146547 4.59135008 + 3.85046244 2.81926894 0.416493356 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 21.9866066 19.8293152 16.6346684 12.1842031 2.19619274 20.9027481 + 18.8518238 15.8145971 11.5835514 1.9985404 15.8555832 14.2997589 + 11.9959955 8.7865696 1.40556502 9.40074539 8.47834206 7.11240911 + 5.20955467 0.790631115 5.09136295 4.59180117 3.85202217 2.82144928 + 0.417277038 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.9863434 19.8317776 + 16.6423588 12.1947422 2.20087981 20.9024982 18.8541584 15.821908 + 11.5935736 2.00280523 15.8553972 14.3015404 12.001543 8.79416847 + 1.40856493 9.40063381 8.47939396 7.11569834 5.21405983 0.792318225 + 5.09130335 4.59237051 3.85380292 2.82388926 0.418167472 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 21.9861927 19.8346348 16.6507835 12.2060986 + 2.20585918 20.9023571 18.8568745 15.8299208 11.6043739 2.00733542 + 15.8552885 14.303606 12.0076227 8.80235863 1.41175091 9.40056992 + 8.48061371 7.1193037 5.21891546 0.794110298 5.09126806 4.59303141 + 3.85575557 2.82651949 0.419113338 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 21.9860992 19.8378048 16.6598015 12.2180786 2.21097946 20.9022694 + 18.8598843 15.8384962 11.6157684 2.01199412 15.8552265 14.3058977 + 12.0141287 8.81099796 1.41502774 9.40053177 8.48196793 7.12316084 + 5.22403765 0.795953274 5.09124804 4.59376526 3.85784459 2.82929373 + 0.420086116 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.9861126 19.8412666 + 16.6692715 12.2305174 2.21629119 20.9022865 18.8631706 15.8475075 + 11.6275978 2.01682782 15.8552351 14.3083963 12.0209627 8.81996822 + 1.41842735 9.40053749 8.48344803 7.12721205 5.22935629 0.797865391 + 5.0912509 4.59456635 3.86003876 2.83217454 0.421095341 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 21.9862137 19.8449535 16.6790466 12.2432184 + 2.22171307 20.9023857 18.8666744 15.8568001 11.6396751 2.02176142 + 15.8553104 14.3110628 12.0280132 8.82912636 1.42189717 9.40058041 + 8.48502445 7.13139296 5.23478651 0.799816966 5.09127522 4.59541988 + 3.86230278 2.83511519 0.422125399 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 21.9863987 19.8488159 16.688982 12.2560024 2.22717214 20.9025612 + 18.8703423 15.86625 11.6518345 2.02672863 15.855443 14.3138514 + 12.035181 8.83834648 1.42539048 9.40066051 8.48667526 7.13564348 + 5.24025297 0.801782012 5.09131813 4.59631348 3.86460447 2.83807635 + 0.42316252 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.9866505 19.8527946 + 16.6989536 12.2687149 2.23260331 20.9028072 18.8741207 15.8757362 + 11.6639223 2.03167057 15.8556261 14.3167267 12.0423756 8.84751511 + 1.42886639 9.40077019 8.48837471 7.13990879 5.24568892 0.803737044 + 5.09137726 4.5972352 3.86691523 2.84102058 0.424194336 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 21.9869652 19.856842 16.7088509 12.2812147 + 2.23794723 20.9031086 18.8779678 15.8851452 11.6758089 2.03653336 + 15.8558531 14.3196497 12.0495157 8.85653114 1.43228614 9.40090466 + 8.49010658 7.1441412 5.25103331 0.805660784 5.09145117 4.59817266 + 3.86920738 2.84391499 0.425209671 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 21.9873333 19.8609104 16.7185669 12.2933731 2.24315047 20.9034595 + 18.8818378 15.8943844 11.6873722 2.04126763 15.8561182 14.322588 + 12.0565243 8.86530018 1.43561602 9.40106297 8.49184513 7.14829588 + 5.25623322 0.807533681 5.09153652 4.59911489 3.87145758 2.84673142 + 0.426198214 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.987751 19.8649654 + 16.728014 12.30509 2.24817014 20.9038582 18.8856869 15.9033661 + 11.6985111 2.04583526 15.8564186 14.3255119 12.0633392 8.87374973 + 1.43882823 9.40124226 8.49357891 7.15233612 5.26124287 0.809340596 + 5.09163284 4.60005331 3.87364602 2.84944463 0.427151889 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 21.988205 19.8689613 16.7371178 12.3162718 + 2.25296736 20.9042931 18.8894882 15.9120255 11.7091455 2.0502007 + 15.8567448 14.3284006 12.0699062 8.88181496 1.44189823 9.4014349 + 8.49528885 7.15622902 5.26602507 0.811067641 5.0917387 4.60097885 + 3.87575459 2.85203433 0.428063363 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 21.9886932 19.8728733 16.7458096 12.3268394 2.25750756 20.9047585 + 18.8932018 15.9202852 11.7191954 2.05433226 15.8570938 14.3312216 + 12.0761738 8.88943768 1.44480407 9.40164471 8.49695969 7.15994501 + 5.27054405 0.812702119 5.09185171 4.60188484 3.87776756 2.8544817 + 0.428926051 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.9892159 19.8766689 + 16.754034 12.3367357 2.26176667 20.9052601 18.8968105 15.9281054 + 11.7286072 2.05820799 15.8574705 14.3339634 12.0821056 8.89657688 + 1.44752991 9.40186787 8.49858475 7.16346264 5.27477694 0.814235449 + 5.09197378 4.60276413 3.87967181 2.85677433 0.429735303 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 21.989769 19.8803253 16.7617359 12.3459015 + 2.26572013 20.9057865 18.9002838 15.9354305 11.7373228 2.06180525 + 15.8578663 14.3365993 12.0876646 8.90318871 1.45005953 9.40210438 + 8.50014782 7.16675758 5.27869749 0.815658391 5.09210157 4.60361052 + 3.88145614 2.85889721 0.430486351 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 21.9903507 19.8838139 16.768877 12.35429 2.26934695 20.9063416 + 18.9035988 15.9422207 11.7453022 2.06510496 15.8582859 14.339119 + 12.0928173 8.90924072 1.4523803 9.40235233 8.50164127 7.1698103 + 5.28228569 0.81696403 5.09223604 4.60441923 3.88311052 2.86084032 + 0.431175381 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.990963 19.8871193 + 16.7754173 12.3618622 2.27262926 20.9069252 18.9067421 15.9484415 + 11.7525024 2.06809211 15.8587236 14.3415012 12.0975342 8.91470528 + 1.45448101 9.40261459 8.50305462 7.17260742 5.28552485 0.818145692 + 5.09237814 4.60518456 3.8846252 2.86259437 0.431799084 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 21.9916077 19.8902149 16.7813168 12.368577 + 2.2755506 20.9075375 18.9096832 15.9540462 11.7588902 2.07075 + 15.8591824 14.3437357 12.1017895 8.91954994 1.45635009 9.4028883 + 8.50438023 7.17512941 5.28839731 0.819197357 5.09252644 4.60590172 + 3.88599133 2.86415005 0.432354152 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 21.9922829 19.8930893 16.786541 12.3744011 2.27809572 20.9081745 + 18.9124126 15.9590168 11.764431 2.07306647 15.8596649 14.345808 + 12.1055613 8.92375374 1.45797908 9.40317535 8.50560951 7.17736292 + 5.29088974 0.820113897 5.09268236 4.60656738 3.88720202 2.8654995 + 0.432837754 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.9929886 19.8957176 + 16.7910633 12.379302 2.28024983 20.9088516 18.9149113 15.9633141 + 11.7690935 2.07502651 15.8601694 14.347702 12.1088219 8.92729092 + 1.45935774 9.40347862 8.50673389 7.17929554 5.29298735 0.820889533 + 5.09284592 4.60717583 3.88824844 2.86663485 0.433247119 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 21.9937344 19.8980827 16.7948475 12.3832455 + 2.28199959 20.9095612 18.9171638 15.9669104 11.7728481 2.07661891 + 15.8607016 14.349412 12.1115522 8.93013954 1.46047699 9.40379715 + 8.5077486 7.18091345 5.2946763 0.821519434 5.09301853 4.60772562 + 3.88912511 2.8675499 0.433579534 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 21.9944668 19.9001141 16.7977924 12.3861399 2.28330564 20.9102516 + 18.9190922 15.9697104 11.7756042 2.07780695 15.8612213 14.3508759 + 12.113677 8.9322319 1.46131265 9.40410614 8.50861931 7.18217278 + 5.29591656 0.821989775 5.09318686 4.60819674 3.88980651 2.86822057 + 0.433827698 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.9952202 19.9018497 + 16.7999554 12.3880396 2.28419113 20.9109669 18.9207382 15.9717674 + 11.7774134 2.0786128 15.861763 14.3521233 12.1152382 8.93360519 + 1.46187961 9.40442753 8.50936127 7.18309498 5.296731 0.822308779 + 5.0933609 4.60859728 3.89030719 2.8686614 0.433996081 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 21.996069 19.9033375 16.8013783 12.3889828 2.28466535 + 20.9117737 18.9221535 15.9731197 11.7783146 2.0790441 15.8623648 + 14.3531961 12.1162672 8.93428898 1.46218252 9.40478802 8.50999928 + 7.1837039 5.29713726 0.822479606 5.09355593 4.60894299 3.89063668 + 2.86888027 0.434086174 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.7515526 + 19.3845081 15.8587017 11.2951603 1.81305826 20.6793385 18.4289398 + 15.0769033 10.7383738 1.64988482 15.6860123 13.9790344 11.4364357 + 8.14546108 1.16035438 9.30023003 8.28818512 6.78065586 4.8294363 + 0.652700663 5.03692675 4.48881388 3.67234063 2.61558127 0.34448123 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.7523594 19.3985481 15.8992968 + 11.3500223 1.83544183 20.680088 18.4422798 15.1154957 10.790535 + 1.67025328 15.6865969 13.9891481 11.4657049 8.18502808 1.17467952 + 9.30057144 8.29417992 6.79801083 4.85289621 0.660758972 5.03711271 + 4.49206161 3.68174171 2.6282866 0.348734081 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.7533951 19.4133835 15.9411793 11.4062529 1.85873723 + 20.6810474 18.4563847 15.1553135 10.8439941 1.69145167 15.6873436 + 13.9998455 11.495904 8.22557735 1.18958831 9.30101013 8.30052185 + 6.81591702 4.87693977 0.669145286 5.03735065 4.4954958 3.69144154 + 2.64130783 0.353160113 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.7546368 + 19.4288483 15.983655 11.4626265 1.88188469 20.6822128 18.4710865 + 15.1956968 10.8975935 1.71251571 15.688242 14.010994 11.5265312 + 8.26623249 1.20440245 9.30153942 8.30713177 6.83407927 4.9010458 + 0.677478433 5.03763771 4.49907398 3.70127916 2.65436363 0.357558161 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.7560616 19.444725 16.0261078 + 11.5182018 1.90422428 20.6835499 18.4861851 15.2360573 10.950429 + 1.73284435 15.689271 14.0224447 11.5571413 8.3063097 1.21869969 + 9.30214596 8.31391907 6.85222769 4.9248085 0.685520709 5.03796673 + 4.50274992 3.71110988 2.66723323 0.361802608 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.7576103 19.4606953 16.0678253 11.5723295 1.92604363 + 20.6850147 18.5013657 15.2757196 11.0018883 1.75270009 15.6903887 + 14.0339594 11.5872211 8.34534359 1.23266411 9.30280972 8.32074451 + 6.87006426 4.94795179 0.693375707 5.03832483 4.50644588 3.72077107 + 2.67976713 0.365948349 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.7592564 + 19.476532 16.1082726 11.6243353 1.94709504 20.6865673 18.5164261 + 15.3141747 11.0513353 1.77185667 15.691576 14.0453815 11.6163845 + 8.38284779 1.24613702 9.30351257 8.32751369 6.88735723 4.97018957 + 0.700954258 5.03870487 4.51011229 3.73013759 2.69181013 0.369948059 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.7609634 19.4920578 16.1470184 + 11.6736898 1.96717691 20.6881866 18.531189 15.3510141 11.0982561 + 1.79013085 15.6928091 14.0565815 11.6443233 8.418437 1.25898921 + 9.30424213 8.33415031 6.90392303 4.99129057 0.708183646 5.03910065 + 4.51370668 3.73911023 2.70323873 0.373763561 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.7626019 19.5067673 16.1828957 11.7188997 1.9856565 + 20.6897411 18.5451794 15.3851261 11.1412401 1.80694711 15.6939907 + 14.0671949 11.6701927 8.45104027 1.27081633 9.30494499 8.34044075 + 6.91926241 5.01062155 0.71483624 5.03948116 4.51711273 3.74741793 + 2.71370792 0.377274722 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.7635784 + 19.5187397 16.2114849 11.754241 2.00002527 20.6906776 18.5565662 + 15.4123087 11.1748476 1.82002258 15.6946917 14.0758362 11.6907959 + 8.47652721 1.28001249 9.30536556 8.34555817 6.93148232 5.02573204 + 0.72000885 5.03971004 4.51988554 3.75403523 2.72189283 0.380004793 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.7647038 19.530756 16.2395096 + 11.7886276 2.01420712 20.6917496 18.5679989 15.4389534 11.2075405 + 1.83292818 15.6955004 14.0845127 11.7109957 8.5013237 1.2890892 + 9.30584812 8.35069656 6.94346237 5.04043436 0.725114286 5.03997087 + 4.52266836 3.76052284 2.7298553 0.3826994 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 21.7659397 19.5426655 16.2666454 11.8216715 2.02806234 + 20.6929379 18.5793247 15.4647522 11.2389517 1.84553599 15.6963968 + 14.0931053 11.7305584 8.52515125 1.29795635 9.30638123 8.35579205 + 6.95506239 5.05456161 0.730101764 5.04025936 4.52542734 3.76680517 + 2.73750758 0.38533178 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.7672806 + 19.5543423 16.2926121 11.8530502 2.0414784 20.6942215 18.5904293 + 15.4894447 11.2687798 1.85774529 15.6973686 14.101531 11.7492809 + 8.54778099 1.30654263 9.30695629 8.36078358 6.96616316 5.06797695 + 0.734931529 5.04057217 4.52813196 3.77281761 2.7447741 0.387880862 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.7687073 19.5656605 16.317152 + 11.8824797 2.05436516 20.6955929 18.6011848 15.5127745 11.2967482 + 1.8694725 15.6984053 14.1096954 11.7669783 8.56900024 1.31479013 + 9.30757046 8.36562061 6.97665644 5.08055782 0.739570558 5.04090405 + 4.53075266 3.77850056 2.75158834 0.390329301 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.7702007 19.576498 16.3400345 11.9096937 2.06664824 + 20.6970234 18.6114845 15.5345297 11.3226089 1.88065004 15.6994896 + 14.1175108 11.7834787 8.588624 1.32265091 9.30821228 8.37025547 + 6.98643875 5.09219313 0.743992209 5.04125166 4.53326273 3.78380036 + 2.75789046 0.392662972 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.7717514 + 19.58675 16.3610458 11.9344721 2.0782733 20.6985111 18.6212254 + 15.5545044 11.3461494 1.89122963 15.7006273 14.1249084 11.7986336 + 8.60649109 1.33009076 9.30887985 8.37463856 6.99542475 5.10278606 + 0.74817723 5.04161358 4.53563738 3.78866744 2.76362753 0.394871712 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.773365 19.5963249 16.3799801 + 11.9565964 2.08919525 20.7000599 18.6303158 15.5725098 11.3671646 + 1.90116906 15.7018042 14.1318073 11.8122969 8.6224432 1.33708024 + 9.30957413 8.37872982 7.00352383 5.11224556 0.752108872 5.04198742 + 4.53785372 3.7930553 2.76875067 0.396946698 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.7746544 19.6065311 16.4008236 11.9809055 2.09980297 + 20.7012901 18.6400166 15.592329 11.3902664 1.91082156 15.7027426 + 14.1391668 11.8273354 8.63997269 1.34386921 9.31012726 8.38309383 + 7.01243687 5.12263775 0.755927503 5.0422883 4.54021692 3.7978828 + 2.77437949 0.39896211 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.7759266 + 19.6165504 16.4210243 12.0043001 2.10985065 20.7024994 18.6495399 + 15.6115389 11.4124994 1.91996479 15.703661 14.1463881 11.8419104 + 8.65684032 1.35030007 9.3106699 8.38737774 7.0210762 5.13263798 + 0.759544909 5.04258204 4.54253674 3.80256152 2.77979517 0.400871277 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.7772217 19.6261597 16.4399738 + 12.0260611 2.11924672 20.7037296 18.6586685 15.6295624 11.4331837 + 1.92851412 15.7045994 14.1533146 11.855588 8.67252922 1.35631382 + 9.31122589 8.39148426 7.02918196 5.14194012 0.762927353 5.04288292 + 4.54476118 3.80695105 2.78483343 0.402656466 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.7785454 19.6352711 16.4575272 12.0460243 2.1279304 + 20.7049885 18.6673336 15.6462574 11.4521551 1.93641543 15.7055569 + 14.1598825 11.8682566 8.68692017 1.36187172 9.31179142 8.39538288 + 7.03668833 5.15047264 0.766053617 5.04319096 4.54687071 3.81101584 + 2.78945398 0.404306412 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.7799015 + 19.6438122 16.4735107 12.0640011 2.13583326 20.7062721 18.6754494 + 15.6614618 11.469245 1.94360602 15.7065325 14.1660366 11.879797 + 8.69988155 1.36693025 9.31237125 8.39903259 7.0435257 5.15815592 + 0.768898726 5.04350519 4.5488472 3.81471753 2.79361534 0.405808002 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.7812958 19.651701 16.4877834 + 12.0798349 2.14286232 20.7075939 18.682951 15.6750412 11.4842949 + 1.95000088 15.7075329 14.1717224 11.8901052 8.71129513 1.37142968 + 9.3129673 8.40240574 7.04963112 5.16492319 0.771429241 5.04382849 + 4.55067301 3.8180232 2.79727983 0.407143593 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.7827148 19.6588287 16.5001163 12.0932617 2.14893746 + 20.7089386 18.6897221 15.68678 11.4970636 1.95552742 15.7085562 + 14.176857 11.8990145 8.72097301 1.37531853 9.31357574 8.40545273 + 7.0549078 5.17066097 0.773616433 5.04415846 4.55232239 3.82087922 + 2.80038667 0.408297867 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.7841492 + 19.6650505 16.5102348 12.1039686 2.15395856 20.7102947 18.6956387 + 15.6964083 11.5072422 1.96009493 15.7095833 14.1813412 11.9063263 + 8.72868824 1.37853289 9.314188 8.40811348 7.05923748 5.17523527 + 0.775423944 5.04449034 4.55376196 3.82322168 2.80286288 0.409251899 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.3992805 18.6931915 14.6294317 + 9.89536858 1.26694894 20.3444729 17.7716789 13.9083176 9.40757751 + 1.15292287 15.4319792 13.4804726 10.549963 7.13599157 0.810845077 + 9.14963627 7.99256849 6.25505924 4.23093128 0.456100106 4.95536709 + 4.32871199 3.38768792 2.29143167 0.240719914 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.4020004 18.728241 14.7296152 10.0278854 1.31286728 + 20.3470497 17.804985 14.0035429 9.53356552 1.1947062 15.4339476 + 13.5057306 10.6221933 7.23155928 0.840232849 9.15079975 8.00755501 + 6.2978878 4.28759146 0.472630888 4.9559989 4.33682775 3.41088295 + 2.32212138 0.249444425 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.4048824 + 18.7639236 14.8298702 10.1598902 1.35932994 20.3497734 17.8388996 + 14.0988455 9.65906811 1.23698521 15.4360304 13.5314465 10.6944799 + 7.32675838 0.869968951 9.15203094 8.02280903 6.34074926 4.34403324 + 0.489357501 4.95666695 4.34508896 3.43409538 2.35269284 0.25827226 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.4079895 18.7998753 14.9284401 + 10.2882929 1.40451694 20.3527164 17.8730659 14.1925459 9.78114605 + 1.27810383 15.4382782 13.5573645 10.7655516 7.41935968 0.898888588 + 9.15335846 8.03818321 6.38289118 4.39893532 0.505624831 4.9573884 + 4.35341406 3.45691895 2.38242984 0.266857743 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.4113388 18.83568 15.0238485 10.4108419 1.44716418 + 20.3558826 17.9070969 14.2832441 9.89765739 1.31691217 15.4406996 + 13.5831814 10.8343468 7.50773859 0.926182926 9.15478802 8.05349159 + 6.42368364 4.451334 0.520977974 4.95816278 4.36170435 3.47901154 + 2.41080999 0.274960726 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.4147644 + 18.870636 15.1149397 10.526906 1.48809147 20.3591213 17.9403267 + 14.3698397 10.0080061 1.35415578 15.4431734 13.6083937 10.9000301 + 7.59144211 0.952376246 9.15624905 8.06844044 6.46263075 4.5009613 + 0.535711944 4.95895433 4.36980009 3.5001049 2.43768859 0.282736838 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.4177399 18.9010906 15.1915579 + 10.6228828 1.5221498 20.3619251 17.9692802 14.4426813 10.0992584 + 1.38515103 15.4453163 13.6303844 10.9552784 7.66066027 0.974173903 + 9.15751266 8.08146286 6.4953928 4.5420022 0.547973156 4.95963669 + 4.37685394 3.51784897 2.45991373 0.289207935 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.4207611 18.9309673 15.2652082 10.7144775 1.55530167 + 20.3647747 17.9976997 14.5126991 10.186348 1.41532111 15.4474916 + 13.6519661 11.0083857 7.7267189 0.995391309 9.15879917 8.0942421 + 6.52688551 4.58116961 0.559907913 4.96033192 4.38377619 3.53490496 + 2.48112392 0.295506775 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.4238529 + 18.9604473 15.3365421 10.8027267 1.58802342 20.3676987 18.0257378 + 14.5805197 10.2702532 1.44509923 15.4497166 13.6732454 11.0598259 + 7.79036045 1.01633334 9.16011524 8.10684872 6.55738783 4.61890459 + 0.571687877 4.96104431 4.39060402 3.5514245 2.50155926 0.301723897 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.4269695 18.9891891 15.4048376 + 10.886795 1.62008309 20.3706532 18.0530777 14.6454477 10.3501816 + 1.47427428 15.4519587 13.6939888 11.1090689 7.850986 1.03685153 + 9.16144562 8.11914158 6.58658743 4.65485001 0.583229363 4.96176338 + 4.39726162 3.56723905 2.5210259 0.307815313 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.4300652 19.0169182 15.469532 10.9660845 1.65136206 + 20.3736 18.0794601 14.7069521 10.4255657 1.50273848 15.4541864 + 13.7139959 11.1557207 7.90816402 1.05686998 9.16277027 8.13100052 + 6.6142478 4.68875074 0.594489813 4.96248055 4.40368366 3.58222008 + 2.53938508 0.313758433 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.4330978 + 19.0433578 15.5300922 11.0400457 1.68175566 20.3764858 18.1046162 + 14.7645254 10.4958782 1.53039598 15.4563656 13.7330666 11.1993914 + 7.96149588 1.07632184 9.16406631 8.14230824 6.6401391 4.72036982 + 0.605431557 4.9631834 4.40980768 3.59624243 2.55651045 0.319533348 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.4360142 19.067688 15.5844164 + 11.105937 1.70947623 20.379282 18.1277504 14.8161688 10.5584965 + 1.55562043 15.4584684 13.7505951 11.2385864 8.00899887 1.09406281 + 9.1653204 8.15270901 6.66336679 4.74853277 0.615410805 4.96386194 + 4.41544151 3.60882378 2.57176375 0.324800313 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.4387321 19.090683 15.6352196 11.1678581 1.73780632 + 20.3818913 18.1496181 14.8644571 10.6173382 1.58139956 15.460434 + 13.7671671 11.2752419 8.05363846 1.11219394 9.16649246 8.16254139 + 6.68508625 4.77499676 0.625609577 4.96449518 4.42076588 3.62058902 + 2.58609772 0.330183089 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.4416695 + 19.1146317 15.686697 11.2286673 1.76149678 20.3847008 18.1723766 + 14.9133892 10.6751261 1.60295761 15.4625702 13.7844305 11.3123798 + 8.09748268 1.12735558 9.16775417 8.17277622 6.70709848 4.80099106 + 0.634138167 4.96517849 4.42631102 3.63251185 2.6001761 0.334684223 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.4445858 19.1377926 15.7355881 + 11.2860279 1.78416324 20.3874874 18.1943836 14.9598665 10.7296419 + 1.62358403 15.464694 13.8011284 11.3476486 8.13884258 1.14186192 + 9.16900635 8.18267632 6.72800398 4.82551289 0.642298162 4.96585655 + 4.43167305 3.64383554 2.61345768 0.338990808 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.4474678 19.1599236 15.7814417 11.3395252 1.80592656 + 20.3902283 18.215416 15.0034523 10.7804909 1.64338875 15.4667854 + 13.8170815 11.3807201 8.17742062 1.15579045 9.17023945 8.19213676 + 6.74761105 4.84838486 0.650133193 4.96652412 4.43679523 3.65445471 + 2.62584543 0.34312579 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.4502945 + 19.1808338 15.8239088 11.3888283 1.82679021 20.3929157 18.2352886 + 15.043829 10.8273592 1.66237533 15.4688358 13.8321552 11.4113445 + 8.21297264 1.16914332 9.17144871 8.20107269 6.76577091 4.86946535 + 0.657644451 4.96717882 4.4416337 3.66428971 2.63726258 0.347089976 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.453043 19.2003021 15.8625879 + 11.4335384 1.84675765 20.3955231 18.2537937 15.0806055 10.8698683 + 1.68054581 15.47083 13.8461876 11.4392376 8.24521732 1.18192244 + 9.17262268 8.20939445 6.78231287 4.88858318 0.664833128 4.96781588 + 4.44613886 3.67324781 2.64761806 0.350883782 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.4557152 19.2184753 15.8979073 11.474185 1.86584985 + 20.3980618 18.2710705 15.114192 10.908515 1.69792044 15.472765 + 13.8592873 11.4647017 8.27453041 1.19414151 9.17376518 8.21715927 + 6.79741669 4.90596342 0.671706796 4.96843529 4.45034409 3.68142748 + 2.65703177 0.35451144 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.4584808 + 19.2381878 15.9363194 11.5179634 1.88416123 20.4006958 18.2898102 + 15.1507158 10.9501429 1.71458399 15.4747543 13.8735027 11.4924021 + 8.3061018 1.20586145 9.17494774 8.22558594 6.81384182 4.92468405 + 0.678299069 4.96907663 4.45490742 3.69032264 2.66717005 0.357990712 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.4612465 19.2570248 15.9723396 + 11.5587273 1.90139675 20.4033318 18.3077259 15.1849613 10.9889078 + 1.73026943 15.4767361 13.8870897 11.5183725 8.33550262 1.21689343 + 9.17612839 8.23363972 6.82924271 4.94211531 0.684504151 4.96971703 + 4.45926905 3.69866371 2.67661023 0.361265749 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.4640808 19.2748604 16.0056629 11.5961123 1.91733897 + 20.4060345 18.3246899 15.2166471 11.0244617 1.74477768 15.4787607 + 13.8999577 11.5424004 8.36246872 1.22709763 9.1773386 8.24126625 + 6.84349108 4.95810318 0.690243483 4.9703722 4.46340179 3.70638013 + 2.68526793 0.364294976 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.4668903 + 19.2913647 16.0356998 11.6294889 1.93190384 20.4087181 18.3403873 + 15.2452059 11.0562067 1.7580322 15.4807653 13.9118662 11.5640545 + 8.38654804 1.23642027 9.17854023 8.24832535 6.85633183 4.97237921 + 0.695486665 4.97102308 4.46722555 3.71333385 2.69299817 0.367062509 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.4695339 19.3061256 16.0617371 + 11.6581144 1.94497728 20.4112434 18.3544369 15.2699652 11.083437 + 1.76993012 15.482646 13.9225197 11.5828276 8.40720272 1.244789 + 9.17966843 8.25463772 6.86746311 4.98462343 0.700193226 4.97163391 + 4.4706459 3.71936226 2.69962788 0.369546741 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 20.9255028 17.7328072 12.9255323 8.02151871 0.692180157 + 19.8939991 16.858675 12.288394 7.62609816 0.629884303 15.0903654 + 12.7879066 9.32120705 5.78467798 0.442995727 8.94704723 7.58195257 + 5.52654457 3.4297328 0.249185383 4.84565163 4.10632849 2.99312925 + 1.8575182 0.13151446 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.930769 + 17.797945 13.1069803 8.24906254 0.748926818 19.8990116 16.9206123 + 12.4608488 7.8424263 0.681523561 15.0941324 12.8348961 9.452034 + 5.94877005 0.479313254 8.94929886 7.60981131 5.60410833 3.52702403 + 0.26961413 4.84686804 4.12141418 3.03513861 1.91020703 0.142296344 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.9360733 17.8631287 13.2860003 + 8.47300053 0.805654407 19.9040585 16.982584 12.6310081 8.05532551 + 0.733145535 15.0979366 12.8819084 9.58111668 6.11026001 0.515618622 + 8.9515686 7.6376853 5.68063831 3.62277246 0.290035993 4.84809399 + 4.13650799 3.07658768 1.96206129 0.153074577 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 20.9415855 17.9276009 13.4589586 8.68768501 0.861283302 + 19.909296 17.0438747 12.7954216 8.25942993 0.783767641 15.1018934 + 12.9284019 9.70583344 6.2650795 0.551220953 8.95392513 7.66525459 + 5.75458241 3.71456504 0.310062349 4.84936762 4.15143776 3.11663461 + 2.0117743 0.163644075 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.9473248 + 17.9896603 13.6201916 8.88539028 0.913682818 19.9147434 17.1028709 + 12.9487143 8.44739056 0.831450999 15.1060219 12.9731464 9.82210732 + 6.40765333 0.584756613 8.95637703 7.69178677 5.82352257 3.79909635 + 0.328926086 4.85069513 4.16580677 3.1539712 2.05755663 0.173600018 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.9529305 18.0467262 13.7639723 + 9.06039333 0.961942911 19.9200382 17.1571083 13.0854549 8.61376762 + 0.875367701 15.1100626 13.0142794 9.92581463 6.53385925 0.615643263 + 8.95876884 7.71617985 5.88501406 3.87392068 0.346299499 4.85198927 + 4.1790185 3.18727255 2.09808397 0.182769433 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 20.9585361 18.1030655 13.9037657 9.23007679 1.01046848 + 19.9253407 17.210659 13.2183924 8.77509117 0.919525981 15.1141043 + 13.0548983 10.0266399 6.65622902 0.646699607 8.9611578 7.74026394 + 5.94479609 3.94647193 0.363768518 4.85328531 4.19206238 3.21964931 + 2.13737917 0.191989258 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.9640827 + 18.1580009 14.0379848 9.39265156 1.05890143 19.930603 17.2628822 + 13.3460178 8.92965508 0.963600278 15.1181078 13.0945196 10.1234379 + 6.77347326 0.677696824 8.96352768 7.7637496 6.00219011 4.01598549 + 0.381204307 4.85456896 4.20478344 3.2507329 2.17502761 0.201191455 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.9695644 18.2107697 14.1646633 + 9.54571342 1.1063565 19.9358158 17.3130417 13.4664555 9.07517242 + 1.00678468 15.1220665 13.1325836 10.2147913 6.88385439 0.708067894 + 8.96587181 7.78631115 6.05635405 4.08143139 0.398288071 4.8558383 + 4.21700239 3.28006887 2.21047211 0.210207775 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 20.9750366 18.2600327 14.2799778 9.68414593 1.15015209 + 19.9410515 17.3598785 13.5760756 9.20677662 1.04663777 15.1260223 + 13.1681261 10.297945 6.98368359 0.736097097 8.96821785 7.80737734 + 6.10565376 4.14062214 0.414054424 4.85711098 4.22841215 3.30677176 + 2.24252725 0.218528882 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.9800758 + 18.3073711 14.3903399 9.81767464 1.19605887 19.9458542 17.4048958 + 13.680995 9.33372211 1.08841205 15.1296682 13.2022696 10.3775349 + 7.07997561 0.7654773 8.97037983 7.82762384 6.15284061 4.19771576 + 0.430580795 4.85828257 4.23937607 3.3323288 2.27344656 0.227251083 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.9846268 18.3523121 14.4949627 + 9.94571972 1.244192 19.9501762 17.4476376 13.7804699 9.45545101 + 1.13221169 15.1329613 13.2346792 10.4529963 7.17231131 0.796282351 + 8.97232437 7.8468442 6.19758081 4.25246334 0.447908729 4.85933781 + 4.24978542 3.35655951 2.30309486 0.236396313 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 20.9896202 18.3969803 14.5950918 10.0649538 1.2858572 + 19.9549274 17.4901161 13.8756666 9.56879711 1.17012584 15.136569 + 13.2668867 10.525219 7.25828981 0.8229478 8.97446251 7.86594534 + 6.24039698 4.30344009 0.462908089 4.86049604 4.26012897 3.37974763 + 2.33070278 0.244312704 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.9950562 + 18.4407692 14.6900082 10.1756783 1.32273996 19.9601078 17.5317421 + 13.9658899 9.67405224 1.2036891 15.1404972 13.2984619 10.593668 + 7.33813381 0.84655261 8.97679043 7.88466597 6.28097582 4.3507781 + 0.476185858 4.86175632 4.27026749 3.40172577 2.35634089 0.251320392 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.0007439 18.482832 14.7791214 + 10.2789621 1.35765183 19.9655304 17.5717278 14.050581 9.77224445 + 1.23545921 15.1446142 13.328805 10.6579123 7.41262007 0.868895948 + 8.97922516 7.90264654 6.31906462 4.39494038 0.488754034 4.8630743 + 4.28000546 3.42235446 2.38025975 0.257953554 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.0059128 18.5224419 14.8625135 10.3762474 1.39388466 + 19.9704456 17.609375 14.1298437 9.86474037 1.26843095 15.1483545 + 13.3573713 10.718029 7.48278427 0.89208436 8.98143387 7.91957808 + 6.3547101 4.43653965 0.501797438 4.86427021 4.28917456 3.4416585 + 2.40279031 0.264837533 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.0105095 + 18.5591507 14.9395084 10.4670515 1.43178475 19.9748001 17.6442738 + 14.2030287 9.95108128 1.30291939 15.1516695 13.3838577 10.7735252 + 7.54827833 0.916339755 8.98339176 7.93527794 6.38762045 4.47537041 + 0.51544106 4.8653307 4.29767609 3.45948195 2.42382026 0.272038341 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.0155201 18.5967712 15.0162849 + 10.5554228 1.4646436 19.9795609 17.6800365 14.2760248 10.0351028 + 1.33282125 15.1552868 13.4109898 10.8288832 7.61200809 0.937369227 + 8.98553371 7.95136499 6.42044735 4.51315641 0.527270079 4.86649084 + 4.30638695 3.47726035 2.44428563 0.27828148 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.0204792 18.6330929 15.0890913 10.6386309 1.49580407 + 19.9842815 17.7145596 14.3452511 10.1142082 1.3611784 15.1588621 + 13.4371815 10.8813953 7.67200708 0.957312226 8.98765659 7.96689367 + 6.45158291 4.54873085 0.53848815 4.86764145 4.31479692 3.49412394 + 2.46355343 0.284202188 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.0252132 + 18.6672421 15.1564732 10.7155504 1.52625477 19.9887981 17.7470131 + 14.4093237 10.1873283 1.38889086 15.1622715 13.4618025 10.930006 + 7.72746515 0.976801336 8.98968601 7.98149252 6.48040295 4.58161163 + 0.549450815 4.86874151 4.32270432 3.50973415 2.48136282 0.28998822 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.029623 18.6987152 15.217576 + 10.7854071 1.55619955 19.9930134 17.7769165 14.4674263 10.2537231 + 1.41614342 15.1654558 13.4844933 10.9741011 7.77782249 0.995967269 + 8.99158382 7.99494743 6.50654078 4.61146784 0.560231745 4.86976957 + 4.32999229 3.52389288 2.49753451 0.295678288 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.0343838 18.7311268 15.2796135 10.8554726 1.58435833 + 19.9975491 17.8077259 14.5264196 10.3203278 1.44176888 15.16889 + 13.5078602 11.0188503 7.82834625 1.01398969 8.99362278 8.00880432 + 6.53307152 4.64142227 0.570369244 4.8708744 4.33749866 3.53826213 + 2.51375937 0.301028669 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.0394173 + 18.763031 15.3395491 10.9224968 1.61064327 20.0023289 17.8380623 + 14.5834093 10.3840475 1.46568775 15.1725264 13.5308676 11.0620632 + 7.87669182 1.03081262 8.99577427 8.02244759 6.55869579 4.67008495 + 0.579832077 4.87203932 4.34488964 3.55213928 2.52928352 0.306022853 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 21.0443707 18.7929878 15.3947439 + 10.98388 1.63542461 20.0070286 17.8665524 14.6358948 10.4424076 + 1.48823833 15.1760979 13.5524664 11.1018505 7.92097378 1.0466733 + 8.99788857 8.03525639 6.58229208 4.69633913 0.588753581 4.87318325 + 4.35182953 3.5649178 2.54350281 0.310731232 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 21.0489426 18.820219 15.4439507 11.038394 1.65881622 + 20.0113602 17.8924541 14.682683 10.4942417 1.50952291 15.1793947 + 13.5721016 11.13731 7.96030951 1.06164384 8.99983597 8.0468998 + 6.60332584 4.71966219 0.597174644 4.87423849 4.35813904 3.5763073 + 2.55613375 0.315175414 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.3132801 + 16.4703732 10.7669945 5.8278017 0.26236707 19.3119831 15.6585035 + 10.2362499 5.54052591 0.238754034 14.6488314 11.8775167 7.76459074 + 4.20268917 0.167914852 8.68529701 7.04218102 4.60361719 2.4917748 + 0.0944522247 4.70388269 3.81399131 2.49328351 1.34952855 0.0498497561 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.3218689 16.5750732 11.0411425 + 6.13790703 0.305608213 19.3201141 15.7580681 10.4968624 5.83534145 + 0.278103083 14.6549902 11.9530525 7.96228123 4.42632151 0.195589006 + 8.68895435 7.08695459 4.72082663 2.62436533 0.110018723 4.70586634 + 3.83823872 2.55676556 1.42133701 0.0580655597 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 20.3303604 16.678915 11.3101358 6.44261885 0.348729998 + 19.3281612 15.856802 10.7525797 6.12503195 0.317343652 14.6610928 + 12.0279598 8.15625477 4.64606476 0.223186806 8.69257355 7.13135862 + 4.83583212 2.75465107 0.125542372 4.70782804 3.86228657 2.6190536 + 1.49189663 0.0662586838 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.3389969 + 16.7803764 11.5678215 6.7346406 0.393204927 19.3363571 15.9532604 + 10.9975424 6.40265512 0.357815623 14.6673126 12.1011333 8.34207344 + 4.85665464 0.251650691 8.69626045 7.17474174 4.94600439 2.8795104 + 0.141553208 4.70982504 3.885782 2.6787219 1.55951726 0.0747089013 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.3479919 16.8743458 11.7985535 + 6.99621582 0.438281387 19.3449116 16.042551 11.2168827 6.65133667 + 0.398835391 14.6738291 12.1688738 8.50845242 5.04528666 0.280499816 + 8.7001133 7.21491814 5.04465199 2.99135041 0.157780841 4.71191025 + 3.90754271 2.73214602 1.62008858 0.0832734108 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 20.3568459 16.9666691 12.0224419 7.25060177 0.484997422 + 19.3533325 16.130291 11.4297304 6.89318275 0.441347212 14.6802368 + 12.2354317 8.6699028 5.22873497 0.310398251 8.7039032 7.25438786 + 5.14037704 3.10011625 0.174598768 4.71396255 3.92892003 2.783988 + 1.67899585 0.0921494588 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.3655605 + 17.0564556 12.2375383 7.495893 0.533212662 19.3616142 16.2156258 + 11.6342258 7.12638378 0.485223174 14.686533 12.300168 8.82501602 + 5.40562677 0.341256171 8.70763111 7.29277134 5.23234653 3.20499396 + 0.191956386 4.71598005 3.9497087 2.83379507 1.73579812 0.101310395 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.3745518 17.1411781 12.4357462 + 7.72166634 0.579185009 19.370163 16.296154 11.8226719 7.34102678 + 0.527058244 14.6930246 12.3612709 8.96794796 5.56844234 0.370678663 + 8.71147728 7.32898569 5.31709146 3.30152678 0.208506629 4.71806145 + 3.96931934 2.87969184 1.78808069 0.110045232 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 20.3830013 17.2228432 12.6259193 7.94034481 0.627531826 + 19.3782177 16.3737812 12.0034771 7.54892445 0.571053982 14.6991224 + 12.420167 9.10508823 5.72614193 0.401620686 8.71509552 7.36389446 + 5.39840126 3.39502549 0.225911617 4.72002172 3.98822427 2.92372942 + 1.83872008 0.119231202 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.3907623 + 17.3013153 12.8090143 8.15393162 0.67906338 19.3856297 16.4483929 + 12.1775522 7.75198269 0.617947757 14.7047052 12.4767628 9.2371273 + 5.88017082 0.4346008 8.71841431 7.39744759 5.47668505 3.48634911 + 0.244462952 4.7218194 4.00639772 2.96612978 1.88818038 0.129022181 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.398159 17.3759556 12.9832754 + 8.36031532 0.73179388 19.3926868 16.5193806 12.3432379 7.94819164 + 0.665932477 14.7100172 12.5305891 9.36280251 6.0290041 0.468348175 + 8.72157669 7.42936945 5.55119753 3.57459092 0.263445854 4.72353125 + 4.02368927 3.00648665 1.93597019 0.139040902 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 20.4072189 17.4497375 13.1446495 8.54290104 0.774716377 + 19.4012756 16.5895462 12.4966812 8.12177658 0.704991639 14.7165537 + 12.5837879 9.47919273 6.16067505 0.495818347 8.72544289 7.46092653 + 5.62020731 3.65265918 0.278898001 4.72562313 4.04078007 3.04385829 + 1.97824824 0.14719598 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.4157677 + 17.5208035 13.2983007 8.71687794 0.819078684 19.4093876 16.657114 + 12.642766 8.28717804 0.745361447 14.722724 12.6350346 9.59000683 + 6.28613663 0.524210095 8.7290926 7.49131393 5.68590975 3.72704673 + 0.294868499 4.72760105 4.05723763 3.07943988 2.01853371 0.155624762 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.4235744 17.5883827 13.4441338 + 8.88392925 0.866362691 19.4168148 16.7213612 12.7813997 8.44599152 + 0.788389981 14.728364 12.6837645 9.69517422 6.40660286 0.55447191 + 8.73243427 7.52020407 5.74826241 3.79847193 0.311890781 4.72941113 + 4.07288265 3.11320782 2.0572176 0.164608717 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 20.430685 17.6520844 13.5818882 9.04446125 0.916835129 + 19.4235973 16.7819061 12.9123487 8.59860992 0.834320128 14.7335005 + 12.7297001 9.79451084 6.52237034 0.58677429 8.73548126 7.54743004 + 5.80715799 3.86711049 0.33006084 4.73106289 4.0876255 3.14510632 + 2.09439278 0.174198538 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.4394417 + 17.7158089 13.7137623 9.19388008 0.959076107 19.4319096 16.8424664 + 13.0377254 8.74066639 0.872758865 14.7398024 12.7756453 9.8896122 + 6.63012409 0.613808632 8.73922443 7.57467079 5.86354256 3.93099904 + 0.345267326 4.73309088 4.10237694 3.17564392 2.12899375 0.182224289 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.4480457 17.7777443 13.8394289 + 9.33467484 0.999242008 19.440073 16.9013367 13.1572075 8.87452793 + 0.909309328 14.7459917 12.8203039 9.98023224 6.73165941 0.639514744 + 8.74289703 7.60115385 5.91727543 3.99120021 0.359726787 4.73507929 + 4.11672068 3.20474553 2.16159821 0.18985571 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 20.4557991 17.8358994 13.9571714 9.46810055 1.04204166 + 19.4474392 16.9566078 13.2691536 9.00138092 0.948256671 14.7515697 + 12.8622389 10.0651436 6.82788229 0.666906476 8.74620724 7.62601852 + 5.9676199 4.04824972 0.375134587 4.7368722 4.13018894 3.23201346 + 2.19249678 0.197987601 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.4628677 + 17.8905621 14.0674973 9.59447861 1.08672976 19.4541531 17.0085659 + 13.3740454 9.12153053 0.988922894 14.7566519 12.9016552 10.1447086 + 6.91901779 0.695506632 8.74922466 7.64938927 6.01479578 4.10228443 + 0.391222328 4.73850489 4.1428504 3.25756478 2.2217629 0.206478313 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.4707031 17.9460678 14.1761818 + 9.71588421 1.12548459 19.4615955 17.0613461 13.4773836 9.23694611 + 1.02419055 14.7623158 12.9416904 10.2231007 7.00656509 0.720310509 + 8.75257874 7.67312431 6.06126642 4.15419054 0.405174464 4.74032164 + 4.15570641 3.28273368 2.24987531 0.21384187 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 20.4781609 17.9984665 14.2776079 9.82937622 1.16434467 + 19.4686718 17.1111832 13.573823 9.3448391 1.05955386 14.7677221 + 12.979496 10.296257 7.08840847 0.745181739 8.7557745 7.69553566 + 6.10463095 4.20271301 0.419164479 4.74205351 4.16784477 3.30621958 + 2.27615523 0.221225515 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.4850597 + 18.0469875 14.3706474 9.93412781 1.20390153 19.4752007 17.1573563 + 13.6622896 9.44441986 1.09555125 14.7727346 13.0145197 10.3633661 + 7.16394949 0.77049917 8.75872993 7.71629333 6.1444068 4.24749947 + 0.433405399 4.74365616 4.17908573 3.32776165 2.30040979 0.228741482 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.4930534 18.0974655 14.465044 + 10.0383453 1.23922265 19.4827843 17.2053661 13.7520247 9.54349899 + 1.12769282 14.7784967 13.0509243 10.431427 7.23910236 0.793103755 + 8.76214504 7.73788214 6.1847682 4.29205894 0.446120441 4.74550486 + 4.19077539 3.34962058 2.32454276 0.235452205 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 20.5009346 18.1453953 14.5532675 10.1354856 1.27335811 + 19.4902668 17.2509441 13.8358879 9.63584614 1.15875506 14.7841635 + 13.0854807 10.4950275 7.30915117 0.814948738 8.76550961 7.75837946 + 6.22249126 4.33359146 0.458408445 4.74732447 4.20187235 3.37005186 + 2.3470366 0.241937533 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 20.5082016 + 18.1895142 14.63344 10.223938 1.30702412 19.4971676 17.2928982 + 13.9120998 9.71993351 1.18939006 14.7893753 13.1172752 10.5528183 + 7.37293291 0.836492956 8.76860905 7.77724409 6.25677681 4.37141085 + 0.470527351 4.74900055 4.21208525 3.38861918 2.36751914 0.248333514 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.5389786 14.8763199 8.26398373 + 3.62159061 0.0577243902 18.5757351 14.1429796 7.85661268 3.44305706 + 0.0525291935 14.0904217 10.7279692 5.95953274 2.61168694 0.0369435884 + 8.35419941 6.36060333 3.53340769 1.54847181 0.0207808055 4.52456379 + 3.44485259 1.91366446 0.838638127 0.0109675881 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 19.5517273 15.0291862 8.62092972 3.95995903 0.075831905 + 18.5878773 14.288312 8.19596004 3.76474857 0.0690071136 14.099618 + 10.8382215 6.21694231 2.85570288 0.0485325083 8.35965919 6.42596722 + 3.68602324 1.69314563 0.0272995327 4.52752352 3.48025203 1.99631906 + 0.916996956 0.0144080454 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.5642796 + 15.1801653 8.97166729 4.29538012 0.0940538347 18.599823 14.4318504 + 8.52940369 4.08363771 0.0855891928 14.108674 10.9471073 6.46987581 + 3.09759164 0.0601946414 8.36502934 6.49052477 3.8359859 1.83655941 + 0.0338594541 4.53043509 3.5152142 2.07753658 0.994671285 0.0178702418 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.5770741 15.3241692 9.30257511 + 4.61946535 0.11578244 18.6119976 14.5687447 8.843997 4.39174652 + 0.105362445 14.1179104 11.0509386 6.7085042 3.33130336 0.074101001 + 8.37050438 6.55209637 3.97746801 1.97512865 0.0416817777 4.53339911 + 3.54856014 2.15416384 1.06971669 0.0219986998 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 19.5901737 15.4622803 9.61410236 4.9299655 0.142292842 + 18.6244583 14.7000351 9.14016533 4.68693876 0.129487097 14.1273708 + 11.1505127 6.93315792 3.55521679 0.0910676643 8.37610626 6.6111474 + 4.1106658 2.10788989 0.0512255244 4.53643179 3.58054256 2.22630286 + 1.14161456 0.0270356908 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.6030159 + 15.5969229 9.91602421 5.23489952 0.171615571 18.6366711 14.8280392 + 9.42719364 4.97684097 0.156170756 14.1366415 11.2476006 7.15088177 + 3.77511787 0.109834172 8.38159657 6.66871786 4.2397542 2.23827052 + 0.0617816895 4.53940248 3.61172199 2.29621625 1.2122252 0.0326069966 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.6163445 15.7245893 10.1980066 + 5.52314091 0.201641992 18.6493473 14.94946 9.69527435 5.25087547 + 0.183494344 14.1462584 11.3397007 7.35423183 3.98298502 0.12905094 + 8.38729477 6.72331381 4.36031818 2.36151195 0.0725911409 4.54248571 + 3.64128852 2.36151147 1.27897406 0.0383119546 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 19.6288586 15.8485203 10.4725866 5.80921984 0.234752074 + 18.6612434 15.0672884 9.95631218 5.52285337 0.213624284 14.1552944 + 11.4290924 7.55223846 4.189291 0.150241405 8.39264774 6.77630281 + 4.47771645 2.48382902 0.0845108256 4.54538298 3.66998482 2.42509222 + 1.34522212 0.0446028523 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.6407394 + 15.968132 10.7388763 6.09230709 0.269860983 18.6725349 15.1809759 + 10.2094717 5.79198647 0.245573476 14.1638718 11.5153446 7.74427032 + 4.39343882 0.172711253 8.39772797 6.82743359 4.59157276 2.60486698 + 0.0971501917 4.54813623 3.69767642 2.48675585 1.41077662 0.0512735955 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.6526451 16.0825386 10.9941607 + 6.36846399 0.303388506 18.6838703 15.2897339 10.4521666 6.05453396 + 0.276083708 14.1724548 11.597827 7.92837334 4.59259081 0.194168985 + 8.40281391 6.87634182 4.70072937 2.72294044 0.109220088 4.5508976 + 3.72416639 2.54587817 1.47472668 0.0576438382 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 19.6648102 16.1937618 11.2338543 6.62408161 0.340117782 + 18.6954651 15.395503 10.6800528 6.29755306 0.309507489 14.1812077 + 11.678031 8.10124111 4.77692938 0.217675641 8.40801239 6.92390251 + 4.80322123 2.83223319 0.122442529 4.55371332 3.74992633 2.60138988 + 1.53391922 0.0646223724 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.6769905 + 16.3010178 11.4600124 6.86488438 0.379924685 18.7070408 15.4974794 + 10.8950739 6.52648497 0.345731765 14.1899643 11.7553806 8.2643404 + 4.95058346 0.243151903 8.41321087 6.96976757 4.89992428 2.93519354 + 0.136772946 4.55652952 3.77476931 2.65376139 1.58967936 0.0721855909 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.68997 16.4042568 11.6749849 + 7.09552336 0.41877681 18.7193432 15.5955963 11.0994463 6.74575138 + 0.381087065 14.1992817 11.8298416 8.41935539 5.11690378 0.268016905 + 8.41875553 7.01390839 4.99183512 3.03381085 0.150759622 4.55952883 + 3.79867625 2.70353627 1.64308536 0.0795674473 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 19.7007637 16.5021572 11.8852959 7.33020592 0.462619394 + 18.7295761 15.6886568 11.2993708 6.96886539 0.420983762 14.2070532 + 11.9004498 8.57100677 5.28614187 0.296075702 8.42337132 7.05577087 + 5.0817523 3.13415527 0.166542813 4.56202745 3.82134771 2.75223422 + 1.69742942 0.0878975317 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.7127857 + 16.5988045 12.0818691 7.54111576 0.502437949 18.7410126 15.7805386 + 11.4862499 7.1693778 0.457218498 14.2157278 11.9701443 8.71276474 + 5.43823719 0.321559668 8.42851639 7.09709167 5.16579914 3.22433376 + 0.180877373 4.56481457 3.84372568 2.79775429 1.74626958 0.0954630896 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.7246685 16.6914635 12.2686653 + 7.74313211 0.544442415 18.7523308 15.8686275 11.6638527 7.36143637 + 0.495442301 14.2243185 12.0369635 8.84748173 5.58392239 0.348442882 + 8.43360329 7.13671255 5.24566984 3.31070876 0.195998937 4.56756926 + 3.86518359 2.84101129 1.79304981 0.10344395 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 19.7363529 16.7796383 12.4467564 7.93959999 0.589002728 + 18.7634869 15.9524546 11.8331728 7.54821634 0.535992086 14.2327862 + 12.1005621 8.97592068 5.72560406 0.376961917 8.43861294 7.17441607 + 5.32181787 3.39470887 0.212040812 4.57028246 3.88560319 2.88225317 + 1.83854568 0.111910433 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.7485657 + 16.8669319 12.6179304 8.12441826 0.628914535 18.7751141 16.0354443 + 11.9959021 7.72392368 0.572311997 14.2416115 12.1635227 9.09936047 + 5.85888529 0.402505457 8.44383812 7.21173906 5.39500523 3.4737289 + 0.226409167 4.57311153 3.90581656 2.92189145 1.88134468 0.119493641 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.760107 16.9502544 12.7802839 + 8.30086517 0.670913696 18.7860699 16.1146603 12.1502562 7.89167452 + 0.610531509 14.2499323 12.2235966 9.21643257 5.98612881 0.429384708 + 8.44876575 7.2473588 5.46441889 3.54917407 0.241528913 4.57577944 + 3.92510676 2.95948482 1.92220449 0.127473354 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 19.7705231 17.02841 12.9332762 8.47043991 0.71706605 + 18.7959328 16.1889572 12.2957335 8.05288982 0.65253073 14.2574244 + 12.2799177 9.32675457 6.1084156 0.458922207 8.45320415 7.28076029 + 5.52983284 3.62168241 0.258143812 4.57818031 3.9431963 2.99490952 + 1.96147156 0.136242181 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.7819824 + 17.1069489 13.0823126 8.63174057 0.757768989 18.8068085 16.2636318 + 12.4374161 8.2062397 0.689570189 14.265686 12.3365641 9.43423271 + 6.22473574 0.48497197 8.45810223 7.31434631 5.59355307 3.69064808 + 0.27279672 4.58083534 3.96138406 3.02942228 1.99882233 0.143975794 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.7927933 17.180954 13.2218657 + 8.78398514 0.800438523 18.8170681 16.3340015 12.5700665 8.35097885 + 0.728399098 14.2734747 12.3899565 9.53487492 6.33452797 0.512280464 + 8.46272659 7.34599972 5.6532197 3.75574017 0.288157433 4.58334351 + 3.97852731 3.06174064 2.03407693 0.152083144 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 19.803894 17.2527695 13.3550892 8.92883205 0.842076659 + 18.8276215 16.4022865 12.6967049 8.48868752 0.766289413 14.2814751 + 12.4417648 9.63095093 6.43898535 0.538928688 8.46748066 7.37671614 + 5.71018076 3.81767058 0.303146958 4.58592081 3.9951632 3.09259295 + 2.06761861 0.159994498 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.8155212 + 17.3236656 13.4840622 9.06762791 0.881024897 18.8386822 16.4696922 + 12.819315 8.6206398 0.801732242 14.2898645 12.492877 9.72395897 + 6.53907776 0.563855529 8.47245789 7.40703011 5.76532555 3.87701678 + 0.317168385 4.58861637 4.0115819 3.12245774 2.09975791 0.167394623 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 19.8263054 17.3896294 13.6032248 + 9.19681168 0.921138763 18.8489475 16.5323944 12.9326086 8.74345303 + 0.838235915 14.2976561 12.5404186 9.80988979 6.63223839 0.589528322 + 8.47707844 7.43523216 5.81627989 3.93225431 0.331609488 4.59111691 + 4.02685642 3.15005159 2.12967062 0.17501612 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 18.5745869 12.9425583 5.65712881 1.80141282 0.00562468544 + 17.6589241 12.3045692 5.37826538 1.7126075 0.00511846365 13.3949728 + 9.3334856 4.07960987 1.29908168 0.00359979807 7.94186497 5.53381538 + 2.41880059 0.770222068 0.00202488783 4.30125475 2.99706697 1.30999863 + 0.417145669 0.001068688 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 18.5926094 + 13.148881 6.05530119 2.08574796 0.00894650444 17.6760998 12.5007038 + 5.75680351 1.98292804 0.00814129971 13.4079695 9.48225784 4.36675072 + 1.50412524 0.00572574791 7.94957352 5.62202168 2.58904767 0.891798615 + 0.00322073442 4.30542374 3.04484367 1.40220189 0.482989281 0.00169982982 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 18.6103535 13.3525124 6.44997072 + 2.37361121 0.0124126943 17.692997 12.6942816 6.13201523 2.25660181 + 0.01129553 13.4207573 9.62909317 4.65136433 1.71171463 0.00794410799 + 7.95716095 5.70908117 2.75779533 1.01488149 0.00446855929 4.30953074 + 3.09199572 1.49359405 0.549649358 0.00235840422 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 18.6284008 13.5458679 6.82940578 2.66923952 0.0181700028 + 17.7101784 12.8780994 6.49275208 2.53765774 0.0165347476 13.4337635 + 9.76853371 4.92499638 1.92490971 0.0116288261 7.96488571 5.79175758 + 2.92002821 1.14127994 0.00654120231 4.31371641 3.13677096 1.58146024 + 0.61810708 0.0034522987 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 18.6464729 + 13.7332964 7.1957283 2.96681166 0.0269968249 17.7273579 13.056283 + 6.84102011 2.82056189 0.0245672259 13.4467936 9.90369511 5.18916941 + 2.13950491 0.0172780212 7.97261572 5.8718977 3.07665396 1.26851034 + 0.00971887168 4.31790495 3.18017173 1.66628897 0.687014401 0.00512940204 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 18.6649342 13.9130421 7.54743052 + 3.26244926 0.0374774747 17.7448387 13.22717 7.17538214 3.1016283 + 0.0341045596 13.4601021 10.0333042 5.44279718 2.35270143 0.0239855871 + 7.98049831 5.9487462 3.22702861 1.39491498 0.0134918829 4.32217646 + 3.22178936 1.74772966 0.755473614 0.00712071592 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 18.6827564 14.0874319 7.89210606 3.56216764 0.049658075 + 17.7617359 13.3929806 7.50306463 3.38657379 0.0451887734 13.4729595 + 10.1590557 5.69135714 2.56884098 0.0317810811 7.98811197 6.0233078 + 3.37439966 1.52306485 0.0178768523 4.32629919 3.26216841 1.82754409 + 0.824878454 0.00943500549 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 18.7002678 14.2563734 8.22928143 3.86391115 0.0624377057 17.7783985 + 13.5536032 7.82361794 3.67344165 0.0568181612 13.4856033 10.2808828 + 5.93450785 2.78644061 0.0399600118 7.99560213 6.09554243 3.51856327 + 1.65208113 0.0224775039 4.33035374 3.30128956 1.90562332 0.894752741 + 0.011863132 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 18.7172184 14.4201212 + 8.56165504 4.16983652 0.0745665208 17.7945404 13.7092323 8.13960648 + 3.96428514 0.0678554699 13.4978542 10.3989429 6.17419481 3.00705671 + 0.0477225445 8.00286388 6.16554928 3.66067624 1.78288543 0.0268439297 + 4.33428478 3.33920503 1.98259127 0.965595126 0.014167645 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 18.7333241 14.5791845 8.88594151 4.47469568 + 0.0903438181 17.8098507 13.8604116 8.44790459 4.25411797 0.0822128803 + 13.5094795 10.5136347 6.40804958 3.22690535 0.0578201115 8.00975704 + 6.23355675 3.79933214 1.91323209 0.0325238034 4.33801842 3.37603664 + 2.0576849 1.03619075 0.0171653647 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 18.7520313 14.7309742 9.17851353 4.74761152 0.111052737 17.8276539 + 14.0047894 8.72605324 4.51357937 0.101058066 13.5229349 10.6231422 + 6.61903906 3.42371845 0.0710738301 8.01774883 6.29847002 3.9244287 + 2.02991962 0.039978981 4.34234571 3.41119409 2.12543535 1.0993892 + 0.0211000387 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 18.769001 14.8778448 + 9.46860695 5.02855587 0.133013561 17.843792 14.1444426 9.00184631 + 4.7806716 0.121042408 13.5351324 10.729084 6.82823849 3.62631941 + 0.0851287544 8.02499485 6.36126804 4.04846287 2.15004253 0.0478848256 + 4.34626865 3.4452076 2.19261026 1.16444552 0.0252725724 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 18.7839966 15.0198183 9.7596674 5.32224035 + 0.155125678 17.8580341 14.2793627 9.27855873 5.05988121 0.141164362 + 13.5459185 10.8314562 7.0381341 3.83810925 0.0992805138 8.03139687 + 6.42195606 4.17290783 2.2756176 0.0558451638 4.34973478 3.47808003 + 2.26000762 1.23245287 0.0294738561 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 18.8026409 15.1578417 10.0215454 5.57520247 0.179984301 17.8757439 + 14.4106188 9.52752495 5.30037832 0.163785741 13.5593977 10.9309855 + 7.22698498 4.02053404 0.115189977 8.03936386 6.48097515 4.28487539 + 2.38377762 0.0647942871 4.35404921 3.51004696 2.32065296 1.29103208 + 0.0341969952 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 18.8193493 15.290432 + 10.2781725 5.83176088 0.207760155 17.8916588 14.5367069 9.77150917 + 5.54429007 0.189061835 13.5714874 11.0266018 7.41205931 4.20555162 + 0.132966623 8.04651737 6.5376792 4.39460325 2.49347377 0.0747935995 + 4.35792398 3.54075766 2.38008213 1.35044312 0.0394744165 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 18.834137 15.4174089 10.5311165 6.09440041 + 0.237607569 17.9057713 14.6574469 10.0119982 5.79397821 0.216222987 + 13.5821838 11.1181784 7.59448051 4.39495325 0.152069166 8.05285454 + 6.59198761 4.50275946 2.60576844 0.0855386481 4.36135626 3.5701704 + 2.43865561 1.41126108 0.0451454408 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 18.8518295 15.5423288 10.7646284 6.32716179 0.267337203 17.9225903 + 14.7761993 10.233983 6.01526594 0.243276924 13.5949507 11.2082758 + 7.76287127 4.56280708 0.171096027 8.06042099 6.64539814 4.60259962 + 2.70528555 0.09624134 4.36545563 3.59909534 2.49272752 1.46516001 + 0.0507940799 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 18.8683472 15.6615973 + 10.9909582 6.55971432 0.300300926 17.9382782 14.8895826 10.4491482 + 6.23635149 0.273273796 13.6068659 11.2943211 7.92608595 4.73050928 + 0.192192495 8.06748486 6.69639301 4.69936991 2.8047123 0.10810826 + 4.3692832 3.62671375 2.54513884 1.51900947 0.0570571683 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 18.8845234 15.7775288 11.2095432 6.78527832 + 0.333032638 17.9536343 14.9998026 10.656971 6.45079231 0.303059787 + 13.6185284 11.377944 8.08372498 4.89317322 0.213140726 8.0744009 + 6.74596167 4.7928319 2.90115499 0.119891644 4.37302732 3.65356016 + 2.5957582 1.57124043 0.063276194 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 18.9004459 15.8894224 11.4179773 7.00080013 0.367471755 17.9687347 + 15.1061668 10.8551407 6.65569305 0.33439973 13.6299953 11.4586143 + 8.23404217 5.04859447 0.235181957 8.08120251 6.79379702 4.88195658 + 2.99330711 0.132289603 4.37671089 3.67946649 2.64402795 1.62114716 + 0.0698196515 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 18.9155197 15.9963179 + 11.6176558 7.21077681 0.4048177 17.9830379 15.207778 11.0449762 + 6.85532331 0.368384778 13.6408491 11.5356741 8.37804413 5.20001554 + 0.259083688 8.08764553 6.83949518 4.9673357 3.08308768 0.145734042 + 4.38019943 3.70421481 2.69026971 1.66977155 0.0769154355 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 18.9313202 16.1013794 11.8093061 7.40971327 + 0.440684766 17.9980831 15.3076668 11.2271652 7.04445505 0.401023477 + 13.6522255 11.6114302 8.51623917 5.3434782 0.282038361 8.09440804 + 6.88441515 5.04927063 3.16814661 0.15864642 4.38386345 3.72854161 + 2.73464441 1.71584022 0.0837301537 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 18.9466572 16.2009907 11.9900799 7.59943104 0.479664445 18.0126934 + 15.4023809 11.3990116 7.22482252 0.436494529 13.66327 11.6832571 + 8.64658356 5.48029184 0.306984991 8.10096741 6.92700291 5.12655067 + 3.24926305 0.172679424 4.3874197 3.75160503 2.77649641 1.75977397 + 0.0911362171 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 18.9629612 16.3000641 + 12.1658535 7.78140736 0.515773118 18.0281887 15.4965668 11.5661125 + 7.39782667 0.469353497 13.6750412 11.7546892 8.7733345 5.61152315 + 0.330094665 8.10793972 6.96936035 5.20170212 3.32707095 0.185678452 + 4.39119625 3.77454543 2.81719851 1.80191243 0.0979970023 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 18.9782467 16.3931961 12.3308983 7.95458603 + 0.5546152 18.0427094 15.5850945 11.7230167 7.56246567 0.504700005 + 13.6860971 11.8218327 8.89234638 5.73641014 0.354953825 8.11448097 + 7.00917864 5.27226925 3.40111613 0.199661344 4.39473724 3.7961123 + 2.85541868 1.84201252 0.105377279 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 17.3917503 10.706069 3.30087352 0.653567672 0.000159925083 16.5344181 + 10.1782932 3.13815475 0.62135011 0.000145531623 12.5419626 7.72061682 + 2.38040614 0.471317321 0.000102352118 7.43612528 4.57755184 1.4113394 + 0.27944392 5.75730446E-05 4.02734613 2.47916222 0.764371037 0.151344582 + 3.03857905E-05 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 17.416111 10.9636736 + 3.66985893 0.824063659 0.000342590996 16.5576077 10.4232426 3.48895073 + 0.783444643 0.00031175738 12.5595789 7.9064126 2.64649963 0.594272077 + 0.000219258392 7.4465518 4.68770742 1.56911063 0.352343708 + 0.000123332604 4.03298807 2.53882575 0.849816263 0.190826178 + 6.50922884E-05 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 17.4402905 + 11.2180319 4.04203653 1.00420642 0.000563909998 16.5806122 10.6650877 + 3.84278131 0.954708338 0.000513157633 12.577034 8.08985519 2.91489506 + 0.724181473 0.000360902573 7.45689631 4.79647017 1.72824407 0.429366857 + 0.000203007352 4.03858948 2.59773159 0.936000645 0.232541144 + 0.000107142943 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 17.464592 11.4620695 + 4.41559076 1.20793295 0.00122532132 16.6036873 10.897109 4.1979208 + 1.14839029 0.00111504353 12.5945168 8.26584148 3.18428159 0.871094584 + 0.000784206553 7.46727896 4.90081596 1.88796294 0.516471744 + 0.000441115553 4.04422045 2.65423799 1.02250421 0.279716581 + 0.000232811261 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 17.4888859 + 11.6972752 4.78341866 1.42820215 0.00264002499 16.6267853 11.120697 + 4.54761839 1.35779881 0.00240242714 12.6120052 8.43545246 3.44953847 + 1.02994001 0.00168961834 7.47766304 5.00137901 2.04523182 0.610650957 + 0.000950408983 4.04984665 2.70870233 1.10767984 0.330723286 + 0.000501605042 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 17.5132523 + 11.9243364 5.14788389 1.66195273 0.00453034556 16.6499577 11.3365135 + 4.89411736 1.58002436 0.0041226116 12.6295586 8.59918308 3.7123704 + 1.19850922 0.00289941556 7.48808146 5.09845304 2.20106173 0.710595727 + 0.00163092196 4.0554862 2.76128125 1.19207454 0.384852201 0.000860764994 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 17.5369968 12.1463995 5.51384926 + 1.90890479 0.00668518199 16.6725044 11.5476208 5.24204397 1.81480289 + 0.0060835043 12.6466799 8.75931644 3.97628713 1.37659645 0.00427850196 + 7.49822712 5.19339371 2.35753441 0.816184282 0.00240666047 4.06098032 + 2.81269956 1.27681994 0.442037821 0.00127018371 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 17.5606384 12.3629465 5.87986803 2.16572642 0.00860045757 + 16.694973 11.7535257 5.59002209 2.05896258 0.0078264121 12.663744 + 8.9154768 4.24024296 1.56179917 0.00550428545 7.5083313 5.28598118 + 2.51403213 0.925992966 0.00309616118 4.06645203 2.86283994 1.36158133 + 0.501508892 0.00163408893 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 17.5827904 12.578289 6.25836706 2.43957615 0.0101973992 16.7160645 + 11.9582567 5.94986343 2.31931257 0.00927963667 12.6797371 9.07075691 + 4.51319408 1.75928271 0.00652633328 7.51780987 5.37804747 2.6758666 + 1.04308319 0.00367106358 4.0715847 2.91270351 1.44923067 0.564923525 + 0.00193750998 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 17.607233 12.7797527 + 6.59805393 2.69776607 0.016403731 16.7392883 12.149765 6.27280235 + 2.56478357 0.0149274049 12.6973782 9.21604443 4.75815535 1.94547856 + 0.0104983924 7.5282712 5.46418953 2.82110906 1.15347648 0.00590534648 + 4.07725048 2.95935988 1.52788782 0.624713063 0.00311671454 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 17.6299915 12.9761992 6.93981409 2.97198963 + 0.0228172541 16.7609177 12.3365517 6.59771442 2.82549024 0.0207637232 + 12.7137852 9.35772991 5.00461435 2.14323545 0.0146030495 7.53800344 + 5.54819584 2.96723723 1.2707231 0.00821420643 4.08252048 3.00485563 + 1.60702682 0.688214302 0.0043352819 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 17.6529942 13.16852 7.28273058 3.2536366 0.0276147313 16.7828217 + 12.5194321 6.92372847 3.09324527 0.0251294188 12.7303944 9.4964323 + 5.25190544 2.34634399 0.0176734347 7.54783869 5.63043308 3.11385584 + 1.39114094 0.00994129293 4.08784676 3.04939151 1.68643451 0.753432751 + 0.00524679944 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 17.6757812 13.3546343 + 7.61083269 3.52833962 0.0364606455 16.8045101 12.6963778 7.23565865 + 3.35440683 0.0331791751 12.7468624 9.63063908 5.48851347 2.54444718 + 0.0233348217 7.55758095 5.71000576 3.25413895 1.50859475 0.013125835 + 4.09312248 3.09248662 1.76241279 0.817044914 0.0069275205 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 17.698494 13.5335455 7.92576265 3.80094719 + 0.0470548384 16.8260803 12.8664446 7.53506374 3.61358094 0.0428198986 + 12.7632256 9.75964546 5.71562338 2.74103856 0.0301151145 7.56728458 + 5.78649378 3.38879061 1.62515676 0.0169397723 4.09837723 3.13391447 + 1.83534265 0.880173206 0.00894041825 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 17.7207432 13.7083797 8.24212933 4.08310986 0.0569058694 16.8472137 + 13.0325775 7.83583593 3.88183427 0.0517843217 12.7792234 9.88569641 + 5.94377041 2.94451737 0.036419753 7.57679081 5.86122847 3.52405739 + 1.7458005 0.0204861332 4.10352325 3.17439318 1.90860426 0.945512593 + 0.0108121121 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 17.7435417 13.8771715 + 8.53723335 4.3457818 0.0708458647 16.8688946 13.1930313 8.11638832 + 4.13155699 0.0644697323 12.7956581 10.0074043 6.15658188 3.13394022 + 0.0453413539 7.58654022 5.93339634 3.65023446 1.85810828 0.0255045015 + 4.10880518 3.21347737 1.97693741 1.00633752 0.0134607209 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 17.7643261 14.0401735 8.83369637 4.62320566 + 0.0849530101 16.8886452 13.3480349 8.39823341 4.39530945 0.0773072988 + 12.8106537 10.1249456 6.3703723 3.33400297 0.0543699339 7.59542608 + 6.00309753 3.77699494 1.97672594 0.0305830557 4.11362076 3.25122595 + 2.04558349 1.07057929 0.0161410943 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 17.7877808 14.1985712 9.10784435 4.87334633 0.102565102 16.9109764 + 13.4986458 8.65887165 4.63311863 0.0933342725 12.8275757 10.239212 + 6.56807709 3.51439309 0.0656416118 7.60546446 6.07083225 3.89421153 + 2.08367848 0.0369234197 4.11905813 3.28791285 2.10906911 1.12850416 + 0.0194873717 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 17.8094521 14.3513966 + 9.37926388 5.13081694 0.12153133 16.9315681 13.6439676 8.91692162 + 4.87789249 0.110593505 12.8431873 10.3494577 6.76381969 3.70006657 + 0.0777799413 7.61472416 6.13618374 4.01026249 2.1937654 0.043751277 + 4.12407017 3.32331038 2.17192388 1.18812704 0.0230909176 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 17.8312683 14.5006094 9.6417408 5.38057613 + 0.140736073 16.9522915 13.785841 9.16645527 5.11534166 0.128069833 + 12.858902 10.4570704 6.95310307 3.88017845 0.090071097 7.6240468 + 6.19998074 4.12248707 2.30055594 0.050665006 4.12911749 3.35786366 + 2.23270464 1.24596465 0.0267398376 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 17.852169 14.6438093 9.89489651 5.62683105 0.16287595 16.9721432 + 13.9219809 9.40712452 5.34945869 0.148217052 12.8739576 10.5603409 + 7.13565588 4.05776215 0.104240805 7.63298035 6.26120043 4.23072815 + 2.40584636 0.0586354025 4.13395357 3.39101624 2.29132533 1.30298877 + 0.0309464745 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 17.8734589 14.7836103 + 10.1388636 5.86419916 0.185649082 16.9923649 14.0548792 9.63906765 + 5.57512665 0.16894044 12.8893166 10.6611605 7.31158733 4.22893763 + 0.118815646 7.64207935 6.32097197 4.33504009 2.50733685 0.0668337047 + 4.13888264 3.42338467 2.34781885 1.35795355 0.035273362 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 17.8944511 14.917448 10.3709669 6.09250879 + 0.212153167 17.0123138 14.1820974 9.85973454 5.79218054 0.193058997 + 12.9044943 10.7576761 7.47897243 4.39358091 0.135778233 7.65105438 + 6.37819815 4.43427896 2.60495329 0.0763750523 4.14374781 3.45437503 + 2.40156865 1.41081977 0.0403090566 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 17.9160786 15.0488586 10.5951729 6.31186867 0.238546282 17.0329018 + 14.3070164 10.072896 6.00072718 0.217076898 12.9200993 10.8524313 + 7.64066267 4.55177212 0.152669847 7.66030979 6.43438721 4.53014612 + 2.69874525 0.0858764946 4.14876223 3.48480821 2.45349097 1.46161568 + 0.0453237891 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 17.9368382 15.1742287 + 10.8096189 6.52522564 0.267594069 17.0526791 14.4262152 10.2767801 + 6.20356464 0.243510738 12.93505 10.942831 7.79531431 4.70563602 + 0.171260536 7.66919851 6.48800039 4.62184048 2.78997111 0.0963336229 + 4.15357971 3.51384926 2.50315404 1.51102161 0.0508430004 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 15.966217 8.27233315 1.5424422 0.151820451 + 7.00154658E-07 15.1792316 7.86455345 1.46640337 0.144336149 + 6.37139976E-07 11.5139666 5.96555662 1.11232364 0.109484196 + 4.48098575E-07 6.82663822 3.53697896 0.659495175 0.0649133846 + 2.5205523E-07 3.69725275 1.91559494 0.357176781 0.0351565629 + 1.33029516E-07 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 15.9980001 + 8.56746197 1.81180096 0.216797382 2.33983315E-06 15.2093534 8.14513206 + 1.72248828 0.206110537 2.12925079E-06 11.536869 6.17838812 1.30657053 + 0.156342432 1.49749121E-06 6.84020805 3.66316628 0.774666727 0.092695497 + 8.42340626E-07 3.70460558 1.98393655 0.419552982 0.0502030365 + 4.44568741E-07 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 16.0298214 + 8.86014175 2.09294343 0.291346401 5.29638055E-06 15.2396069 8.4233799 + 1.98977041 0.276984692 4.81970983E-06 11.5598431 6.38945198 1.50931537 + 0.210103169 3.38968448E-06 6.85381794 3.78830385 0.894873857 0.124570087 + 1.90669903E-06 3.71197438 2.05171061 0.484656125 0.0674660578 + 1.00631166E-06 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 16.0613079 + 9.14515495 2.39101362 0.386528492 3.32217387E-05 15.2695932 8.69433975 + 2.27314329 0.367474675 3.0231784E-05 11.582593 6.59498692 1.72426844 + 0.278743148 2.12619216E-05 6.86729956 3.91016316 1.02231729 0.165266663 + 1.19598244E-05 3.71927166 2.11770844 0.553678274 0.0895070285 + 6.31213561E-06 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 16.0927334 + 9.41776276 2.6989944 0.50586009 0.000116087249 15.2994394 8.95350742 + 2.56594586 0.480923325 0.000105639403 11.6052399 6.79157734 1.94636774 + 0.364798695 7.42958364E-05 6.88072252 4.02671957 1.15399742 0.216289163 + 4.1791398E-05 3.72654295 2.18083596 0.624996543 0.117140166 + 2.2056598E-05 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 16.1234417 9.68623734 + 3.02006888 0.643573105 0.00023300435 15.3286171 9.20873928 2.8711977 + 0.611846983 0.000212033949 11.6273537 6.98518658 2.17790914 0.464109987 + 0.000149122759 6.89383984 4.14150953 1.29127693 0.275170833 + 8.38815613E-05 3.73364806 2.24300647 0.699346662 0.149029911 + 4.42708333E-05 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 16.1545162 + 9.94834614 3.34736228 0.793694556 0.000336209021 15.3581829 9.45794487 + 3.1823597 0.754568398 0.000305950467 11.6497383 7.17421293 2.413939 + 0.572368443 0.000215174005 6.90712595 4.25358248 1.43121946 0.33935684 + 0.000121035358 3.74084425 2.30370212 0.775137305 0.183792874 + 6.38797283E-05 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 16.1846085 + 10.2120419 3.69313407 0.958674312 0.00041201245 15.3867817 9.70865822 + 3.51108503 0.911416054 0.000374931813 11.6714382 7.3643837 2.66329169 + 0.691342175 0.000263688416 6.91998863 4.36633587 1.57905936 0.409896195 + 0.000148324703 3.74781203 2.36476755 0.855206907 0.22199659 + 7.82823918E-05 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 16.2156239 + 10.4695387 4.03693247 1.13130188 0.000762144162 15.4162979 9.95345211 + 3.83793187 1.07553434 0.000693551206 11.6938133 7.55006504 2.91121531 + 0.815832496 0.000487772108 6.93325377 4.4764266 1.72605228 0.483706981 + 0.000274372054 3.75499797 2.42439938 0.934818506 0.261971951 + 0.000144807462 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 16.2457142 + 10.7121887 4.3735466 1.33104062 0.00161752955 15.4449024 10.1841249 + 4.15795183 1.26542878 0.00147195149 11.7155161 7.72504139 3.15396237 + 0.95987314 0.00103521754 6.94611931 4.58017063 1.86997926 0.569109142 + 0.000582311885 3.76196432 2.48058891 1.01276648 0.308225036 + 0.000307330629 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 16.2760162 + 10.9521704 4.71824503 1.53976905 0.00206879689 15.4736519 10.4122572 + 4.48565817 1.46386611 0.00188260828 11.7373438 7.89810514 3.40254307 + 1.11039424 0.00132402719 6.95906687 4.6827817 2.01736665 0.658353329 + 0.000744768244 3.76897287 2.53616047 1.09258711 0.356558621 + 0.000393071503 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 16.3052502 11.192071 + 5.07556105 1.76382339 0.00297656655 15.5014257 10.6403294 4.82536077 + 1.67687249 0.00270868 11.7584009 8.07111549 3.66022062 1.27196872 + 0.00190499914 6.97156858 4.78536034 2.17014575 0.754149795 0.0010715645 + 3.77574325 2.59171462 1.1753298 0.408441216 0.000565547554 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 16.3358135 11.4157286 5.40296745 1.98582828 + 0.00506984396 15.5305347 10.8529997 5.13662386 1.88793612 0.00461355597 + 11.7804852 8.23240948 3.89632392 1.43207014 0.00324469712 6.98464966 + 4.88099432 2.3101294 0.849072099 0.00182514405 3.78282785 2.64350533 + 1.25114632 0.459850967 0.000963270082 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 16.3642693 11.6429844 5.76035833 2.23709249 0.00580455875 15.5576296 + 11.0690794 5.47639847 2.12681651 0.00528214918 11.801034 8.39631176 + 4.15405273 1.61327291 0.00371491606 6.99682808 4.97817135 2.46294045 + 0.956507504 0.00208964222 3.78942204 2.6961298 1.33390832 0.518036425 + 0.00110286684 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 16.3943825 11.8560295 + 6.08120871 2.47059989 0.00963554624 15.5862408 11.2715998 5.78143644 + 2.34881163 0.00876833871 11.8227386 8.54993153 4.3854332 1.78166461 + 0.00616673985 7.00969744 5.06925058 2.6001265 1.05634618 0.00346879684 + 3.79639173 2.74546003 1.40820861 0.572108865 0.00183075387 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 16.4231186 12.0677814 6.41760111 2.72718525 + 0.0123798288 15.6135473 11.4728937 6.10124254 2.59274578 0.0112656364 + 11.8434448 8.70261002 4.62802076 1.96670091 0.00792308338 7.02198219 + 5.1597724 2.7439518 1.16605115 0.0044567408 3.80304623 2.79448748 + 1.48610592 0.631525218 0.00235216855 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 16.452179 12.2733946 6.74107027 2.97853708 0.016562948 15.6411963 + 11.6683712 6.40876341 2.831707 0.0150722824 11.864398 8.85088539 + 4.86128712 2.14796305 0.0106002828 7.03441238 5.24768543 2.88225436 + 1.27352059 0.00596267171 3.80977941 2.84209991 1.56100953 0.689729989 + 0.00314696133 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 16.4803314 12.4714365 + 7.0599184 3.23818469 0.0216827691 15.6679802 11.8566265 6.71189785 + 3.07855844 0.019731313 11.8847132 8.99370384 5.09122229 2.33520484 + 0.0138769541 7.04644012 5.33236217 3.01858449 1.38453674 0.00780581497 + 3.81629705 2.88796139 1.63484228 0.749855578 0.00411972217 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 16.5097389 12.6644897 7.36344767 3.48468971 + 0.0290216077 15.6959124 12.040184 7.00046968 3.31291318 0.0264096577 + 11.9059095 9.13293076 5.31011629 2.51297045 0.018573802 7.05900621 + 5.41490889 3.14836335 1.48993504 0.010447789 3.82310057 2.93267012 + 1.70513034 0.80693841 0.00551409228 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 16.5374908 12.8529024 7.67126894 3.74712062 0.0362060256 15.7223349 + 12.2193575 7.29311609 3.56241417 0.032947477 11.9259081 9.26882744 + 5.53210449 2.7022264 0.023171816 7.07089281 5.49547911 3.27997518 + 1.60214496 0.0130341621 3.82953501 2.97630525 1.77641201 0.867709458 + 0.00687912526 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 16.5660801 13.0366526 + 7.96601629 3.99886703 0.044278603 15.7494793 12.3940134 7.57332897 + 3.80174828 0.0402935445 11.946537 9.40132713 5.74465704 2.88376784 + 0.0283382721 7.0831151 5.57403946 3.40600157 1.70978022 0.0159403048 + 3.83615685 3.01885486 1.8446641 0.926004291 0.00841292925 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 16.5936031 13.2143621 8.2564373 4.25579882 + 0.0535678156 15.7755861 12.5629005 7.84943008 4.04600954 0.0487467684 + 11.9664087 9.52945423 5.95409107 3.06904626 0.0342833884 7.094872 + 5.65000963 3.53017974 1.8196317 0.0192844421 3.84252763 3.06000352 + 1.91191423 0.985500515 0.0101778824 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 16.6214504 13.3863707 8.53329849 4.50177956 0.0654329881 15.8020849 + 12.7264147 8.11264896 4.27986622 0.0595440269 11.986496 9.65348434 + 6.15374851 3.24643469 0.0418770835 7.10677671 5.72354984 3.64855766 + 1.92480791 0.0235558972 3.8489728 3.09982848 1.9760288 1.04246342 + 0.0124322306 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 16.6491299 13.5533209 + 8.80174828 4.74346018 0.0792463496 15.8284178 12.8851824 8.36787033 + 4.50963116 0.0721142367 12.0064363 9.77390003 6.34734106 3.42072153 + 0.0507177152 7.11860561 5.79494143 3.76333785 2.02814436 0.0285287257 + 3.85537791 3.13849258 2.03819537 1.09842801 0.0150567964 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 16.6763744 13.7148237 9.06255722 4.98257589 + 0.0947086141 15.8543262 13.0388241 8.61582088 4.73695421 0.0861851349 + 12.0260553 9.89041042 6.53542233 3.59316111 0.0606137253 7.13025522 + 5.86401463 3.87484884 2.13038206 0.0340951942 3.86168694 3.17590523 + 2.09858966 1.1537956 0.0179947428 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 14.2858524 5.82927513 0.53012383 0.0187347624 1.79536483E-10 13.5816813 + 5.54192495 0.503991365 0.0178112537 1.63378394E-10 10.3022232 4.20375729 + 0.382295936 0.0135104731 1.14903309E-10 6.10816765 2.49240446 + 0.226662859 0.00801036879 6.46330836E-11 3.30813122 1.34986532 + 0.122759022 0.00433834735 3.41118973E-11 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 14.3256531 6.13368082 0.673408449 0.0320216455 1.09533205E-09 + 13.6194477 5.8313241 0.640213192 0.0304430872 9.96748017E-10 10.3308792 + 4.42327213 0.485625476 0.0230922047 7.01010805E-10 6.12518024 2.62256074 + 0.287927419 0.0136913434 3.94318911E-10 3.31734824 1.42035544 + 0.155938804 0.00741512747 2.08113013E-10 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 14.365942 6.43885231 0.831013441 0.0493503809 4.52031124E-09 + 13.6577501 6.12144899 0.790048897 0.0469175987 4.11348022E-09 10.3598938 + 4.6433444 0.599281728 0.0355887562 2.89299606E-09 6.1423893 2.75303769 + 0.355313838 0.0211005602 1.6273114E-09 3.32666683 1.49102187 0.192434773 + 0.0114278663 8.58857097E-10 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 14.4055796 6.74048328 1.0114007 0.0763233677 3.06061963E-07 13.6954498 + 6.40821123 0.961543441 0.0725609809 2.78516495E-07 10.3884563 4.86086416 + 0.729367137 0.0550402328 1.95879892E-07 6.15932035 2.88200068 + 0.432440966 0.0326333493 1.10182391E-07 3.3358345 1.56086862 0.234206423 + 0.0176739022 5.81517305E-08 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 14.4440937 7.03065014 1.21745086 0.119338699 1.36804351E-06 13.73207 + 6.68407536 1.15743661 0.113455929 1.24492112E-06 10.4162712 5.07012033 + 0.877958536 0.0860606208 8.75548892E-07 6.17579126 3.00606561 + 0.520540774 0.0510253273 4.92495928E-07 3.34475636 1.62806201 + 0.281920999 0.027634846 2.59929209E-07 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 14.4822054 7.31887436 1.44093251 0.172680408 2.64202504E-06 + 13.7683067 6.95808983 1.36990309 0.164168075 2.40424447E-06 10.443759 + 5.27797318 1.03912139 0.124527708 1.69089742E-06 6.19208956 3.12930036 + 0.616093993 0.0738323852 9.5112938E-07 3.35358286 1.69480693 0.333671957 + 0.039987009 5.01985539E-07 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 14.5202761 7.60897589 1.68285596 0.234794676 3.49508332E-06 13.8045206 + 7.23389101 1.59990287 0.223220348 3.18052389E-06 10.4712114 5.48717785 + 1.21358466 0.169320911 2.23685333E-06 6.20837545 3.25333953 0.719533622 + 0.100390062 1.25823033E-06 3.36240292 1.76198542 0.389693499 + 0.0543705784 6.64063009E-07 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 14.5595951 7.90257978 1.9347347 0.298244923 3.34841775E-06 13.8418894 + 7.5130167 1.83936274 0.283542782 3.04705804E-06 10.499609 5.69890356 + 1.39522338 0.215077639 2.14299212E-06 6.22520351 3.37887931 0.827228963 + 0.12751922 1.20543166E-06 3.37152219 1.82997203 0.448019981 0.069063589 + 6.36197797E-07 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 14.5978308 + 8.18540764 2.20258927 0.389953017 3.05743088E-05 13.878211 7.78190279 + 2.09401155 0.370730162 2.78226144E-05 10.527194 5.9028616 1.58838332 + 0.281212568 1.95675366E-05 6.24154949 3.49980736 0.941753864 0.166730717 + 1.10067331E-05 3.38037944 1.89546561 0.510046184 0.0903001875 + 5.80911365E-06 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 14.6353559 + 8.45685387 2.48124361 0.498745948 4.74616754E-05 13.9138708 8.03997612 + 2.35893154 0.474160165 4.31901426E-05 10.554225 6.09861898 1.78933692 + 0.359668165 3.03754405E-05 6.25758028 3.61586595 1.06089711 0.213246956 + 1.70861858E-05 3.3890574 1.95832324 0.574573696 0.115492932 + 9.01769545E-06 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 14.6735096 8.7391386 + 2.78241324 0.610564768 4.13953785E-05 13.9501724 8.30834389 2.64525342 + 0.580467224 3.76698445E-05 10.5817385 6.30218887 2.00652289 0.44030565 + 2.6493035E-05 6.27388906 3.73656154 1.18966627 0.261057168 + 1.49023426E-05 3.3978858 2.02369046 0.644313335 0.141386628 + 7.8650919E-06 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 14.7109842 9.00232887 + 3.07597637 0.747458696 0.000188334045 13.9858227 8.55855751 2.92434621 + 0.71061343 0.000171384396 10.6087532 6.49199152 2.21822214 0.539025605 + 0.000120533587 6.28992558 3.84909606 1.31518388 0.319588453 + 6.78003344E-05 3.40657067 2.08463645 0.71229285 0.173086837 + 3.57834688E-05 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 14.7478704 + 9.26675129 3.38982606 0.898711979 0.000210654005 14.020895 8.80994511 + 3.22272134 0.854410589 0.000191695246 10.6353636 6.68267488 2.44455576 + 0.648101091 0.000134818474 6.30570078 3.96215391 1.44937384 0.384258747 + 7.58355382E-05 3.41511631 2.14586854 0.784970045 0.208111808 + 4.0024257E-05 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 14.785327 9.52543545 + 3.7017591 1.05828655 0.000508311554 14.0565166 9.05588055 3.51927948 + 1.00611842 0.000462563708 10.6624002 6.86922646 2.66950631 0.763178527 + 0.000325319357 6.32171631 4.07276058 1.58274829 0.452488333 + 0.000182992197 3.42379308 2.20577002 0.857204735 0.245063886 + 9.65791987E-05 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 14.8220139 + 9.78042603 4.02698612 1.23948729 0.000586161215 14.0913639 9.29831791 + 3.82847857 1.17838752 0.000533406972 10.6888494 7.05311966 2.9040401 + 0.893849969 0.000375143398 6.33739662 4.18178844 1.72180796 0.529964089 + 0.00021101789 3.43228364 2.26482129 0.932517946 0.287024111 + 0.000111370558 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 14.858511 10.025425 + 4.34115219 1.42309916 0.00124864199 14.12605 9.53123188 4.12715578 + 1.35294735 0.00113626465 10.7151489 7.22979355 3.13059688 1.02626133 + 0.000799131696 6.35300207 4.28653908 1.85612977 0.608470201 + 0.000449511572 3.44073248 2.32155609 1.00526655 0.329542726 + 0.000237242319 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 14.8950186 + 10.2711582 4.6724844 1.62777603 0.00159248966 14.1608143 9.76483631 + 4.44215393 1.5475316 0.00144916587 10.7414541 7.40699244 3.36953521 + 1.17386281 0.00101919402 6.36861277 4.39160442 1.99779499 0.695982993 + 0.000573296624 3.44918633 2.37845111 1.08198977 0.376938939 + 0.000302573724 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 14.9312849 + 10.5069189 4.99035978 1.83377588 0.00242331135 14.1952744 9.98896694 + 4.74436235 1.74337637 0.0022052112 10.7676153 7.57700586 3.59877181 + 1.32241762 0.00155091821 6.38410902 4.49240494 2.13371038 0.78406024 + 0.000872392906 3.45758057 2.43304443 1.15559936 0.424641311 + 0.000460428651 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 14.9665213 + 10.7371893 5.31149483 2.0527389 0.00376674603 14.2287273 10.2078896 + 5.04966974 1.95154572 0.0034277353 10.7930651 7.7430644 3.83035851 + 1.48032153 0.00241071475 6.3991785 4.59085798 2.27102137 0.87768048 + 0.0013560293 3.46574235 2.48636889 1.22996569 0.475345403 0.000715680013 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 15.0027447 10.963275 5.62686872 + 2.27283549 0.00556359626 14.2632217 10.4228582 5.34949541 2.1607933 + 0.00506286835 10.8191986 7.90612555 4.05778885 1.63904285 0.00356069626 + 6.41468525 4.68753767 2.40586495 0.971787214 0.00200289139 3.47414184 + 2.53872967 1.30299735 0.526312411 0.00105708127 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 15.0386419 11.1860313 5.94645834 2.50470972 0.00723200291 + 14.2973614 10.6346245 5.65332651 2.38123751 0.00658112206 10.8450804 + 8.06676579 4.28825998 1.80625772 0.00462848088 6.43003702 4.78278351 + 2.54250908 1.07092965 0.00260351901 3.48245621 2.5903151 1.37700403 + 0.580006599 0.00137407973 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 15.0738859 11.4027147 6.26332092 2.74479985 0.00910436455 14.3308144 + 10.8405733 5.95457268 2.60949516 0.00828497671 10.8704939 8.22299004 + 4.51677084 1.97940135 0.00582679594 6.4451108 4.87541294 2.67798638 + 1.17358637 0.00327756861 3.49061513 2.64048052 1.4503777 0.635603428 + 0.001729829 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 15.1091089 11.612133 + 6.56595755 2.97731781 0.0121665699 14.3642673 11.0396976 6.24228764 + 2.83054996 0.0110715516 10.8958426 8.37403679 4.73501062 2.14707685 + 0.00778659992 6.4601512 4.96496773 2.8073833 1.27300143 0.00437995931 + 3.49875879 2.68898344 1.52045786 0.689446688 0.00231164438 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 15.1435642 11.8155718 6.86436319 3.2142303 + 0.016557578 14.3970127 11.233139 6.52598238 3.05578208 0.0150673529 + 10.92066 8.52076244 4.9501996 2.31792259 0.0105968285 6.47486782 + 5.05195856 2.93497276 1.37429667 0.00596072106 3.50673032 2.73609972 + 1.58955789 0.744307876 0.00314593432 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 15.178009 12.0143719 7.15835238 3.45307088 0.0217541717 14.4297686 + 11.422123 6.80548763 3.28285742 0.0197962821 10.9455404 8.66409779 + 5.16221666 2.49016905 0.013922615 6.48960447 5.13693619 3.06067467 + 1.4764235 0.00783149246 3.51471519 2.78212404 1.65763819 0.799616814 + 0.00413329061 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 12.3608475 3.62749815 + 0.119246967 0.000933755364 6.26456939E-16 11.7515326 3.44867611 + 0.113368936 0.000887724455 5.70075885E-16 8.91395092 2.61595201 + 0.0859942511 0.000673370669 4.00932616E-16 5.28507423 1.55099463 + 0.0509860925 0.000399241631 2.25524322E-16 2.86235213 0.840006292 + 0.0276136454 0.000216225759 1.19026459E-16 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 12.4086294 3.90213728 0.169065684 0.00206787651 5.87792966E-15 + 11.7969255 3.70978069 0.16073209 0.00196594279 5.3489868E-15 8.94843388 + 2.81400466 0.12192136 0.00149123557 3.76191261E-15 5.30551815 1.66842568 + 0.0722870305 0.000884157955 2.11608291E-15 2.87342477 0.903603554 + 0.0391500741 0.000478851172 1.11681029E-15 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 12.4574175 4.18186665 0.227941141 0.003863869 9.82691237E-14 + 11.8433113 3.97572351 0.216705173 0.0036733998 8.94243785E-14 8.98360825 + 3.01573181 0.16437909 0.00278640888 6.28918507E-14 5.32637596 1.78802443 + 0.0974602848 0.00165206392 3.53767512E-14 2.8847177 0.968377352 + 0.0527836382 0.000894742319 1.86710744E-14 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 12.5052576 4.46284628 0.304405123 0.00801751576 3.3991876E-10 + 11.8887911 4.24285078 0.289399594 0.00762228807 3.09325981E-10 + 9.01808929 3.21835804 0.219520494 0.00578179304 2.17548091E-10 + 5.34682369 1.9081614 0.130153626 0.00342802424 1.22370905E-10 2.8957901 + 1.03344309 0.0704901218 0.00185658666 6.4584553E-11 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 12.5504503 4.74132109 0.406341255 0.0168732181 + 1.64441871E-09 11.9317427 4.50759554 0.386310458 0.0160414539 + 1.49642054E-09 9.05066395 3.41917753 0.293030918 0.0121680479 + 1.05242948E-09 5.36613607 2.02723265 0.173737943 0.00721442979 + 5.91992233E-10 2.90625143 1.09793103 0.0940951183 0.00390727306 + 3.12440185E-10 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 12.595314 5.02058077 + 0.523287356 0.0288317762 2.73130896E-09 11.9744482 4.77309322 + 0.497491807 0.0274105165 2.48549137E-09 9.08302975 3.6205678 0.377366066 + 0.020791905 1.7480386E-09 5.385324 2.14663553 0.223740339 0.0123274978 + 9.83272241E-10 2.91664815 1.16260028 0.121175781 0.00667648343 + 5.18949828E-10 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 12.6412849 + 5.30716848 0.652027071 0.0423432291 2.87253887E-09 12.0181456 5.04555225 + 0.619885504 0.0402559191 2.61401123E-09 9.11618614 3.82723999 + 0.470206171 0.030535616 1.83842519E-09 5.40498257 2.26916885 0.27878508 + 0.0181045271 1.03411368E-09 2.92729425 1.22896588 0.150987521 + 0.00980529096 5.45783252E-10 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 12.6913376 5.60869646 0.786944509 0.0552113503 2.97700398E-09 12.0657711 + 5.33221292 0.748152494 0.0524896979 2.70907341E-09 9.15231514 4.04468489 + 0.567501247 0.0398153737 1.90528726E-09 5.42640686 2.39809084 0.3364712 + 0.0236064959 1.0717216E-09 2.93889213 1.29878914 0.182229757 + 0.0127851171 5.65630875E-10 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 12.734623 5.88201952 0.95780009 0.0914561749 2.02334121E-07 12.1069145 + 5.59206438 0.910586298 0.0869478732 1.84123849E-07 9.18354702 4.24179125 + 0.690713167 0.0659532174 1.29494367E-07 5.44491768 2.51495051 + 0.409523845 0.0391035527 7.28403862E-08 2.94892192 1.36207712 + 0.221794441 0.0211781953 3.84435168E-08 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 12.7795954 6.16712141 1.14368641 0.127598658 1.55340331E-07 + 12.1496372 5.86311531 1.08730972 0.121308707 1.41359365E-07 9.21595383 + 4.44739199 0.824763656 0.0920171961 9.94178322E-08 5.46413183 2.6368525 + 0.489002973 0.0545568317 5.59224844E-08 2.9593308 1.42809665 0.264839828 + 0.0295475274 2.95146272E-08 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 12.8271112 6.4590807 1.33884931 0.168744609 1.31325135E-06 12.1948481 + 6.14068079 1.27284968 0.160426408 1.19505933E-06 9.25023079 4.65793228 + 0.965502858 0.121689126 8.40480595E-07 5.48445511 2.76168585 0.572447062 + 0.0721494332 4.72770864E-07 2.97033405 1.49570489 0.310032219 + 0.0390755311 2.49517456E-07 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 12.8702278 6.73267889 1.55539489 0.231836617 2.05565129E-06 12.2358389 + 6.40078926 1.47872281 0.22040835 1.87064165E-06 9.28132343 4.85523701 + 1.12166512 0.167187586 1.3156158E-06 5.50289583 2.87866592 0.665035129 + 0.099125497 7.40034977E-07 2.98031878 1.55906129 0.360177279 + 0.0536856838 3.90574286E-07 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 12.917594 7.02405787 1.78887653 0.294208795 4.72348893E-06 12.2808771 + 6.67780733 1.70069742 0.279705584 4.29837291E-06 9.31547832 5.06536674 + 1.29004371 0.212166741 3.02303124E-06 5.52314663 3.00325155 0.764865756 + 0.125793338 1.70045701E-06 2.99128509 1.62653375 0.41424498 0.0681288913 + 8.97462712E-07 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 12.9600859 + 7.29176998 2.0292294 0.381750494 1.06807584E-05 12.3212481 6.93232203 + 1.92919755 0.362931967 9.7194843E-06 9.34612465 5.25842571 1.46337152 + 0.275297552 6.83568351E-06 5.54131222 3.11772013 0.867630899 0.163223594 + 3.84507393E-06 3.00112724 1.68852699 0.469902217 0.0884006172 + 2.02934302E-06 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 13.0065632 + 7.57431078 2.29038262 0.472867548 2.28405224E-05 12.3653936 7.20093727 + 2.17747402 0.449557632 2.07848807E-05 9.37960434 5.46218014 1.65170062 + 0.34100616 1.46179309E-05 5.5611639 3.23852563 0.979289889 0.202182069 + 8.2225888E-06 3.01188159 1.75395465 0.530375838 0.109500296 + 4.33969262E-06 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 13.0491085 + 7.84062624 2.55625486 0.584674597 3.31544252E-05 12.405818 7.45412254 + 2.43024158 0.555853665 3.01705368E-05 9.41028881 5.65422964 1.84343207 + 0.42163524 2.12188188E-05 5.57935381 3.35238814 1.09296632 0.249987677 + 1.19356073E-05 3.02173233 1.81562781 0.591942728 0.135391325 + 6.29932447E-06 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 13.0938692 + 8.10933113 2.83154249 0.704747558 9.31093018E-05 12.4483461 7.70957804 + 2.69195724 0.670007408 8.47294868E-05 9.44255733 5.84800243 2.04195547 + 0.508225083 5.95899619E-05 5.59848452 3.46727538 1.21067083 0.301326841 + 3.35193399E-05 3.03209591 1.87785077 0.655689597 0.163196281 + 1.76907961E-05 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 13.1395273 + 8.38133144 3.12823558 0.841329753 7.64316719E-05 12.4918051 7.96816969 + 2.97403049 0.799856186 6.95528433E-05 9.47548389 6.0441618 2.25591516 + 0.606720388 4.8916274E-05 5.61801052 3.58357215 1.33752942 0.359724194 + 2.75153925E-05 3.04266834 1.94083786 0.724394143 0.194824234 + 1.45220229E-05 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 13.1802387 + 8.63210011 3.40855813 0.989865363 0.000222501054 12.5305519 8.20658112 + 3.2405324 0.941069543 0.00020247596 9.50489902 6.22499752 2.45806432 + 0.713836193 0.000142400793 5.63544226 3.69079447 1.45738685 0.423232913 + 8.01002534E-05 3.05211043 1.99890423 0.789307475 0.229219839 + 4.22750963E-05 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 13.2239895 + 8.88872147 3.70471716 1.14845526 0.000428826228 12.5721951 8.45055389 + 3.52209044 1.09184229 0.000390231464 9.53646469 6.41005707 2.67163968 + 0.828202903 0.000274449296 5.65415335 3.80051637 1.58401406 0.491041064 + 0.00015437734 3.06224537 2.05832815 0.857887983 0.265943825 + 8.1476901E-05 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 13.2682161 9.14373398 + 4.01106501 1.32190919 0.000610051851 12.6142035 8.6930027 3.81333995 + 1.2567482 0.000555146777 9.56833935 6.59396267 2.8925612 0.953288972 + 0.000390434201 5.6730566 3.90955687 1.71500027 0.565204978 + 0.000219618625 3.07247877 2.11738896 0.928828776 0.306110084 + 0.000115909839 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 13.3122845 + 9.39269543 4.31534433 1.50298095 0.000772558327 12.6560459 8.92968655 + 4.10262299 1.42889726 0.000703027938 9.60011005 6.7735033 3.11199379 + 1.08386981 0.000494437234 5.6918993 4.01600504 1.84510159 0.642625272 + 0.000278120511 3.08268213 2.17503691 0.999292374 0.348040283 + 0.000146785926 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 13.3544807 + 9.63399696 4.61782598 1.69377315 0.00110533368 12.6961288 9.159091 + 4.39019203 1.61028063 0.00100585213 9.63052368 6.94751644 3.3301239 + 1.22145736 0.000707412022 5.70993376 4.1191783 1.9744308 0.724200249 + 0.00039791927 3.09245062 2.23091269 1.06933498 0.392221034 + 0.000210012935 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 13.3958559 + 9.86950302 4.91951561 1.89326108 0.00180127018 12.7354479 9.38298607 + 4.67700768 1.7999289 0.00163915381 9.66034889 7.11734772 3.54768062 + 1.3653152 0.00115281064 5.72761631 4.21987152 2.10342002 0.80949384 + 0.000648456567 3.10202956 2.28544927 1.13919127 0.438415617 + 0.000342240761 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 13.4377871 + 10.1015739 5.2215538 2.09931922 0.00272658258 12.7753305 9.60361385 + 4.9641571 1.9958359 0.00248119212 9.69058228 7.28469992 3.76549482 + 1.5139147 0.00174501177 5.745543 4.31909084 2.23256016 0.897600412 + 0.00098157092 3.11173415 2.33918905 1.20913601 0.486132979 + 0.000518050627 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 10.236352 1.90963185 + 0.0149045344 1.25513661E-05 3.26092458E-24 9.73177624 1.81550181 + 0.0141698094 1.19326478E-05 2.96744091E-24 7.38191795 1.37712455 + 0.0107483482 9.05132856E-06 2.0869901E-24 4.37673235 0.816495419 + 0.00637269579 5.3665367E-06 1.17393438E-24 2.37040091 0.442207009 + 0.00345139788 2.90646949E-06 6.1957525E-25 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 10.2909384 2.11765838 0.0246322583 4.03583945E-05 -4.28753349E-22 + 9.78369331 2.01326728 0.023418013 3.83689585E-05 -3.90164571E-22 + 7.42128754 1.52714145 0.0177634358 2.9104307E-05 -2.74397907E-22 + 4.40007496 0.905441046 0.0105319545 1.72559321E-05 -1.54350216E-22 + 2.38304257 0.490379125 0.00570400758 9.34564832E-06 -8.14628132E-23 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 10.3471909 2.33376837 0.0372934006 + 9.93259746E-05 7.31686731E-21 9.83713818 2.2187283 0.0354550332 + 9.44296553E-05 6.65834147E-21 7.46182728 1.68298936 0.0268939901 + 7.16284485E-05 4.68275023E-21 4.4241128 0.997843325 0.0159454532 + 4.2468444E-05 2.63405629E-21 2.39605951 0.540422857 0.00863590185 + 2.30005899E-05 1.39020253E-21 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 10.4018135 2.55733585 0.0578628965 0.000398975681 1.12319525E-14 + 9.88904953 2.43127322 0.0550104976 0.000379307836 1.02210458E-14 + 7.50121164 1.8442086 0.0417275317 0.000287719071 7.18842896E-15 + 4.44746685 1.09342945 0.0247402638 0.000170588624 4.04350659E-15 + 2.40870643 0.592193007 0.0133990711 9.23893749E-05 2.13406817E-15 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 10.452219 2.78819728 0.0914548784 + 0.00125703646 5.22550854E-14 9.93697166 2.65075254 0.086946547 + 0.00119506975 4.75520502E-14 7.53756523 2.01069212 0.0659522191 + 0.000906505389 3.34432189E-14 4.46901941 1.19213736 0.0391030535 + 0.000537466898 1.88118733E-14 2.42038155 0.645652652 0.0211778581 + 0.000291087403 9.9284662E-15 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 10.5030727 3.02762008 0.132905975 0.00248655095 7.45674274E-14 + 9.98533058 2.87837768 0.126354426 0.00236397679 6.78562634E-14 + 7.57423687 2.18335724 0.0958446264 0.00179316546 4.7723161E-14 + 4.49075842 1.29451084 0.0568262637 0.00106316665 2.68443003E-14 + 2.43216133 0.701095581 0.0307765752 0.000575801707 1.41678254E-14 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 10.5564537 3.2748816 0.176914543 + 0.00368619128 4.96203319E-14 10.0360403 3.11345077 0.168193713 + 0.00350448373 4.51544387E-14 7.61271715 2.36166549 0.127581403 + 0.00265828334 3.17570236E-14 4.51357126 1.40023267 0.0756428987 + 0.00157609174 1.78633201E-14 2.44452 0.758353293 0.0409675092 + 0.000853598467 9.42786634E-15 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 10.6133013 3.52939677 0.228174299 0.00618996192 4.44581351E-11 10.090085 + 3.35542417 0.216926768 0.00588483084 4.04569156E-11 7.65371943 + 2.54521179 0.164547399 0.00446386356 2.84532242E-11 4.53788424 + 1.50905502 0.0975599289 0.00264662015 1.60049092E-11 2.45768094 + 0.8172912 0.0528376028 0.00143338833 8.44703994E-12 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 10.6624289 3.78168082 0.311717391 0.0130683919 + 4.63456808E-11 10.1368322 3.59526896 0.296351582 0.0124242017 + 4.21746596E-11 7.68916607 2.72714663 0.224794075 0.00942420959 + 2.96612145E-11 4.55890322 1.61692154 0.133280173 0.00558760576 + 1.66844316E-11 2.46906209 0.875710666 0.0721832886 0.00302620349 + 8.80567581E-12 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 10.7169485 + 4.04765797 0.391599208 0.0175999161 2.32633617E-11 10.1886501 3.84812737 + 0.372295111 0.0167323351 2.11696962E-11 7.72845173 2.91895223 + 0.282399923 0.0126920547 1.48885453E-11 4.58219337 1.73064578 + 0.167434961 0.00752512971 8.37480345E-12 2.48168206 0.937302053 + 0.0906812474 0.00407554721 4.42003769E-12 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 10.7673931 4.30614901 0.495899767 0.0311505515 2.7756164E-09 + 10.2366171 4.09387589 0.471454144 0.0296149813 2.52581267E-09 7.76484776 + 3.10535479 0.357615322 0.0224640183 1.77638992E-09 4.60377073 1.8411622 + 0.212030172 0.0133189159 9.99221816E-10 2.49336314 0.997159421 + 0.114833683 0.00721340301 5.27366539E-10 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 10.8217545 4.58056164 0.613906264 0.0436189584 4.81888918E-10 + 10.2883034 4.35475969 0.583643436 0.0414687432 4.38518888E-10 7.80407047 + 3.3032434 0.442715347 0.0314556211 3.08408632E-10 4.62702942 1.95848906 + 0.262485594 0.0186500028 1.73479522E-10 2.50595784 1.06070518 + 0.142159864 0.0101006767 9.15590589E-11 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 10.8714151 4.84302998 0.746675491 0.0670201257 3.57212215E-08 + 10.3355217 4.60429096 0.709867597 0.0637163743 3.25062786E-08 7.8398838 + 3.49252582 0.538461626 0.048331257 2.28615225E-08 4.64826393 2.07071447 + 0.319253832 0.0286555383 1.285962E-08 2.51745725 1.12148404 0.172905132 + 0.0155196264 6.78702872E-09 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 10.9253931 5.12266445 0.895924866 0.0891900063 6.93555702E-09 10.386838 + 4.87014198 0.851759851 0.0847934857 6.31135677E-09 7.87882137 3.6941812 + 0.646091998 0.064319022 4.43875781E-09 4.67135096 2.19028187 0.383067638 + 0.0381346941 2.49679877E-09 2.52996182 1.1862371 0.207466483 + 0.0206534602 1.31775912E-09 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 10.9743395 5.38536549 1.06253374 0.129286364 2.12042863E-07 10.4333735 + 5.11989498 1.01015711 0.122913241 1.92958936E-07 7.91409206 3.88362908 + 0.766242802 0.0932343602 1.35707083E-07 4.69226217 2.30260062 + 0.454304636 0.0552785285 7.63354677E-08 2.54128885 1.247069 0.246047661 + 0.0299384128 4.02881213E-08 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 11.0272598 5.6629014 1.2445997 0.170275629 3.26228786E-07 10.4836941 + 5.38375044 1.18325007 0.161881953 2.96868194E-07 7.95225239 4.08377457 + 0.897540212 0.1227936 2.08786361E-07 4.71488762 2.42126417 0.532150507 + 0.0728043094 1.17442347E-07 2.55354285 1.31133699 0.288208425 + 0.0394301787 6.19834921E-08 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 11.0766506 5.93237114 1.44205201 0.225336462 7.43585645E-07 10.5305977 + 5.63993502 1.3709631 0.214228347 6.76662921E-07 7.98785496 4.27809906 + 1.0399313 0.162500098 4.75894609E-07 4.73599386 2.53648376 0.616574049 + 0.0963463038 2.6769078E-07 2.56497693 1.37374055 0.333931029 + 0.0521803498 1.41281333E-07 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 11.1300554 6.20570993 1.65087795 0.287723601 2.13580347E-06 10.5813789 + 5.89980221 1.56949341 0.273540288 1.94357858E-06 8.0263834 4.47521782 + 1.19052088 0.207490325 1.36691347E-06 4.75883913 2.65335727 0.705860972 + 0.123020694 7.68888867E-07 2.57734942 1.43703914 0.382288128 + 0.0666271225 4.05803036E-07 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 11.177475 6.47195196 1.87526357 0.365904629 4.03726108E-06 10.6264849 + 6.15292072 1.78281808 0.347867906 3.67389543E-06 8.06060314 4.66721392 + 1.35233438 0.263870627 2.58384421E-06 4.77912664 2.76719379 0.801799417 + 0.156448394 1.45341278E-06 2.58833671 1.49868762 0.434247881 + 0.0847313702 7.67078575E-07 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 11.2276669 6.74081993 2.11211085 0.454532564 1.0539351E-05 10.6742163 + 6.40852308 2.00799656 0.432126492 9.59079171E-06 8.09678078 4.86110258 + 1.52314413 0.327784061 6.7451856E-06 4.80057812 2.88214636 0.903068364 + 0.194342643 3.79416474E-06 2.59995604 1.56094611 0.489094347 0.105254613 + 2.00247405E-06 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 11.279665 7.00889778 + 2.35701799 0.551714897 2.3075665E-05 10.7236013 6.66339207 2.24083328 + 0.524518192 2.0998863E-05 8.13426113 5.05443048 1.69975412 0.397866696 + 1.47684714E-05 4.82280207 2.99676538 1.00778317 0.235894993 + 8.30723639E-06 2.61199212 1.62302291 0.545806706 0.127758786 + 4.38437519E-06 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 11.3319035 + 7.27640533 2.61366153 0.660281897 2.90544685E-05 10.773262 6.9177146 + 2.48482084 0.627733231 2.64395549E-05 8.17191887 5.24734259 1.8848263 + 0.476159334 1.85948647E-05 4.84513044 3.11114311 1.11751211 0.282314599 + 1.04595911E-05 2.62408185 1.68496847 0.605236173 0.152899355 + 5.52034044E-06 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 11.3807573 + 7.53710079 2.87880206 0.785394847 3.62979408E-05 10.8197174 7.16555691 + 2.73688817 0.74667871 3.30310868E-05 8.20714664 5.43534088 2.07603097 + 0.566383958 2.32306847E-05 4.86601686 3.22260976 1.23087621 0.335808635 + 1.30672479E-05 2.635391 1.74533951 0.666633904 0.181871474 + 6.89661101E-06 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 11.42834 7.79285955 + 3.14882016 0.923045754 7.75759545E-05 10.8649225 7.40870523 2.9936018 + 0.877543747 7.05940911E-05 8.24147034 5.61978436 2.27075553 0.66565001 + 4.96486355E-05 4.8863678 3.33196306 1.34633183 0.394663751 2.7927339E-05 + 2.64641905 1.80456626 0.729162216 0.213746682 1.47394476E-05 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 11.4770861 8.04732609 3.42468023 1.06995893 + 0.000144973805 10.9113674 7.65062761 3.25585604 1.01721394 + 0.000131926412 8.27666283 5.80328512 2.46968746 0.771596074 + 9.27834772E-05 4.90722609 3.4407692 1.46427846 0.457478881 + 5.21905531E-05 2.65771031 1.86348999 0.793040216 0.247766674 + 2.75450002E-05 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 8.00428581 + 0.803435624 0.000817954598 2.52920014E-08 8.85293286E-37 7.60971737 + 0.7638309 0.000777637528 2.40452049E-08 8.05614514E-37 5.77225113 + 0.579393864 0.000589865434 1.82391648E-08 5.66585909E-37 3.42236257 + 0.343522191 0.000349731214 1.08140448E-08 3.18704395E-37 1.85352266 + 0.186049074 0.00018941141 5.85678084E-09 1.68205052E-37 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 8.06281185 0.928566933 0.00167614722 1.3909326E-07 + -1.06099878E-32 7.66535664 0.882786751 0.00159352529 1.32236806E-07 + -9.65506758E-33 5.81445312 0.669629872 0.00120874739 1.00306565E-07 + -6.79040107E-33 3.44738698 0.397023171 0.000716665993 5.94715743E-08 + -3.81959147E-33 1.86707997 0.215024412 0.000388140063 3.22093072E-08 + -2.01589622E-33 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 8.1235857 1.06141937 + 0.00295376079 5.08904463E-07 6.68724395E-32 7.72313309 1.00909328 + 0.00280815898 4.83818212E-07 6.08537615E-32 5.8582859 0.765435517 + 0.00213008979 3.66994698E-07 4.27985327E-32 3.47337151 0.453826606 + 0.00126292824 2.1759034E-07 2.40739862E-32 1.88115191 0.24578853 + 0.000683992286 1.17845282E-07 1.27056745E-32 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 8.18202591 1.20616031 0.00607102411 8.67935614E-06 + 1.72460574E-21 7.77868938 1.14670205 0.00577174779 8.25150073E-06 + 1.56939023E-21 5.90042543 0.869818032 0.00437809015 6.25905614E-06 + 1.1037457E-21 3.49835515 0.515714586 0.00259577087 3.71099782E-06 + 6.2085918E-22 1.89468229 0.279306442 0.00140584365 2.00984778E-06 + 3.27674847E-22 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 8.23467255 + 1.36606705 0.0125815878 3.77131655E-05 6.91918811E-21 7.8287406 + 1.29872894 0.011961381 3.58540929E-05 6.29645278E-21 5.93838882 + 0.985134959 0.009073155 2.71965691E-05 4.42827546E-21 3.52086639 + 0.584085643 0.00537946494 1.61248772E-05 2.49090921E-21 1.90687037 + 0.316335589 0.00291347364 8.73309909E-06 1.31464455E-21 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 8.28868771 1.53627849 0.0207699947 7.68518585E-05 + 7.64823877E-21 7.88009787 1.46055007 0.019746162 7.30635875E-05 + 6.95988233E-21 5.97734547 1.10788167 0.0149781965 5.54211911E-05 + 4.89486874E-21 3.54396415 0.656862319 0.00888055749 3.28593087E-05 + 2.75336235E-21 1.91938126 0.35575071 0.00480964407 1.77963211E-05 + 1.45316378E-21 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 8.34947586 + 1.71524405 0.0288256053 0.00010680929 2.03551721E-21 7.9378891 + 1.63069093 0.0274046808 0.000101544611 1.8523173E-21 6.02118492 + 1.2369374 0.0207874496 7.70249171E-05 1.30273161E-21 3.56995511 + 0.733380854 0.0123249013 4.56682064E-05 7.32785592E-22 1.93346131 + 0.397192508 0.00667504827 2.47335138E-05 3.86748109E-22 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 8.40879154 1.89886057 0.0441525169 0.0004082823 + 5.25734874E-16 7.99428415 1.80525601 0.0419760607 0.00038815607 + 4.78417814E-16 6.06396532 1.3693521 0.0318404362 0.000294430705 + 3.36470762E-16 3.59532118 0.811888158 0.0188782066 0.000174567904 + 1.89264258E-16 1.94719291 0.439711541 0.0102242595 9.45444626E-05 + 9.98895234E-17 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 8.46024609 + 2.09435725 0.0679197684 0.00082733779 2.23402769E-16 8.0432024 + 1.99111176 0.0645717382 0.00078655564 2.03295928E-16 6.10106993 + 1.51033568 0.0489800982 0.000596631318 1.42978103E-16 3.61732244 + 0.895477474 0.0290402789 0.00035374274 8.04248122E-17 1.95910919 + 0.484982401 0.0157279726 0.000191583924 4.24464456E-17 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 8.52325916 2.30042839 0.0877591819 0.00115333498 + 6.80053277E-14 8.10310173 2.18702316 0.0834331214 0.0010964832 + 6.18848167E-14 6.14650774 1.65894139 0.0632870942 0.000831722282 + 4.35234327E-14 3.64426422 0.983587563 0.037522912 0.00049312826 + 2.44818898E-14 1.97370565 0.53270191 0.0203220919 0.000267074036 + 1.29210116E-14 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 8.57655716 + 2.51286864 0.131187141 0.00302228658 1.80962863E-14 8.15377235 + 2.38899207 0.124720387 0.00287330407 1.64676181E-14 6.18494606 + 1.81213748 0.09460482 0.00217950856 1.15816153E-14 3.66705084 1.07441604 + 0.056091249 0.00129223126 6.51467143E-15 1.98604524 0.581895769 + 0.0303785484 0.000699859229 3.43829647E-15 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 8.63592052 2.73387599 0.169124871 0.00447116187 6.79861332E-12 + 8.21021366 2.59910631 0.160788432 0.0042507546 6.18673732E-12 6.22775412 + 1.97152066 0.12196368 0.00322436099 4.35110888E-12 3.69242644 1.1689111 + 0.0723122731 0.0019117198 2.44749403E-12 1.99979055 0.633074462 + 0.0391636975 0.00103537017 1.29173853E-12 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 8.68703842 2.95615983 0.230889544 0.00869399961 1.45346788E-12 + 8.25881577 2.81042933 0.219507873 0.00826542638 1.32265607E-12 + 6.26461744 2.13182163 0.166504785 0.00626965612 9.30220527E-13 + 3.71428466 1.2639538 0.098720789 0.00371726812 5.23247244E-13 2.01162505 + 0.684547484 0.0534662977 0.00201324164 2.76158924E-13 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 8.74824333 3.19275069 0.294965863 0.0136717856 + 1.04430811E-10 8.31700611 3.03535724 0.280425519 0.0129978303 + 9.50320517E-11 6.30875921 2.30243659 0.212712824 0.00985935237 + 6.68357453E-11 3.74045849 1.365116 0.126117527 0.00584559189 + 3.75950764E-11 2.02579927 0.739332974 0.0683041215 0.00316592935 + 1.98419024E-11 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 8.80242348 + 3.43168044 0.373922646 0.0202574674 1.9308069E-11 8.36850071 3.26251674 + 0.355489492 0.0192588754 1.75703705E-11 6.34782124 2.47473693 + 0.269652158 0.0146085871 1.23571865E-11 3.76361847 1.46727252 + 0.159876585 0.00866139587 6.95092508E-12 2.03834534 0.794662595 + 0.0865877941 0.0046909526 3.66853639E-12 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 8.86058235 3.67396116 0.46875912 0.0318076462 4.17291007E-10 + 8.42379665 3.49285531 0.44565168 0.0302396417 3.79735021E-10 6.38976717 + 2.64945769 0.338043422 0.0229379442 2.67067035E-10 3.7884891 1.57086408 + 0.20042567 0.0135998949 1.50225027E-10 2.05181384 0.850766301 0.10854876 + 0.00736559974 7.92853561E-11 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 8.91128635 3.91601229 0.578458726 0.0488355309 3.22955751E-09 8.47200489 + 3.72297502 0.54994297 0.0464280806 2.93889846E-09 6.42633009 2.82401252 + 0.417152941 0.035217464 2.06692152E-09 3.8101666 1.67435491 0.247330129 + 0.0208804104 1.16264187E-09 2.06355405 0.906818211 0.13395153 + 0.0113086672 6.13616269E-10 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 8.97179604 4.17258072 0.698239148 0.06662824 1.65632912E-08 8.52952576 + 3.96689916 0.663818896 0.0633437485 1.50725299E-08 6.46996975 3.00904083 + 0.503532231 0.0480486266 1.06004991E-08 3.83603573 1.7840569 0.298544198 + 0.0284879506 5.96277472E-09 2.07756686 0.966231585 0.161688626 + 0.0154288756 3.14702575E-09 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 9.0252552 4.42553329 0.83850348 0.0934055224 4.27195257E-09 8.58035183 + 4.20738029 0.797169447 0.0888012946 3.88747745E-09 6.50851917 3.19145179 + 0.604683161 0.0673591793 2.73405298E-09 3.85889173 1.89221334 + 0.358516216 0.0399371944 1.53790602E-09 2.08994794 1.0248034 0.194169179 + 0.0216296893 8.11672174E-10 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 9.07754517 4.67523623 0.989546061 0.129759252 6.30806909E-08 8.63006401 + 4.44476509 0.940768242 0.123362809 5.74035148E-08 6.54622364 3.37152243 + 0.713608563 0.0935753211 4.03716669E-08 3.8812511 1.99897587 0.423097193 + 0.0554806851 2.27090311E-08 2.10205412 1.08262682 0.229145795 + 0.0300479196 1.19853141E-08 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 9.13555717 4.93480587 1.15262926 0.169097126 2.91827718E-07 8.6852169 + 4.69154167 1.09580994 0.160761371 2.65563443E-07 6.58806658 3.55871296 + 0.831212997 0.121943481 1.86769796E-07 3.90605903 2.10995936 0.492825329 + 0.0723002777 1.050579E-07 2.1154871 1.14273691 0.266909748 0.0391572192 + 5.54471953E-08 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 9.19449711 + 5.19829559 1.33161366 0.215424925 4.33402477E-07 8.7412529 4.94205189 + 1.26596892 0.204805568 3.94396153E-07 6.63057184 3.74872565 0.960285664 + 0.155352592 2.77377751E-07 3.93125701 2.22261667 0.569353044 + 0.0921085775 1.56024683E-07 2.12913871 1.20375466 0.308356345 + 0.0498852804 8.23463679E-08 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 9.24841213 5.4573431 1.52672172 0.275945574 2.78435522E-07 8.79250717 + 5.18832636 1.45146525 0.262343109 2.53376584E-07 6.66944551 3.93553638 + 1.10099053 0.198997185 1.78198931E-07 3.95430779 2.33337474 0.652777135 + 0.117985196 1.00236733E-07 2.14162493 1.26373601 0.353538305 + 0.0638998672 5.29027808E-08 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 9.30040741 5.71374035 1.73314691 0.348976552 8.87431611E-07 8.84193993 + 5.43207884 1.64771795 0.33177352 8.07562628E-07 6.70694113 4.12043667 + 1.24985051 0.25166294 5.6795642E-07 3.97654223 2.44300222 0.741037607 + 0.149211153 3.19475191E-07 2.15366292 1.32311261 0.401339322 + 0.0808113292 1.68612232E-07 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 9.35427666 5.97176504 1.94951177 0.430507809 2.26467023E-06 8.89315319 + 5.67738867 1.85340571 0.409285694 2.06084837E-06 6.74578762 4.30651236 + 1.40588069 0.310458422 1.4493902E-06 3.99957252 2.55332637 0.833544493 + 0.184070885 8.15280202E-07 2.16613793 1.38286304 0.451440692 + 0.0996908918 4.30287457E-07 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 5.80585241 0.250635117 1.40196553E-05 3.27411102E-12 0. 5.51965284 + 0.238280207 1.33285912E-05 3.11271234E-12 0. 4.18686199 0.180744067 + 1.01102432E-05 2.36110675E-12 0. 2.4823885 0.107163586 5.9943477E-06 + 1.39990168E-12 0. 1.34444177 0.0580386743 3.24648704E-06 7.58175803E-13 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 5.86369848 0.306138396 + 3.89665511E-05 3.95435316E-11 0. 5.57464933 0.291047871 3.70456946E-05 + 3.75942506E-11 0. 4.22857714 0.22077024 2.81005287E-05 2.85166231E-11 + 0. 2.50711966 0.130894691 1.66608279E-05 1.69075084E-11 0. 1.35783827 + 0.0708914474 9.02334523E-06 9.15697032E-12 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 5.92400074 0.366322905 8.4060579E-05 2.53147669E-10 0. + 5.63197708 0.348264903 7.99167829E-05 2.40668263E-10 0. 4.27206707 + 0.264171869 6.06198882E-05 1.82555818E-10 0. 2.53290486 0.156627297 + 3.59415062E-05 1.0823694E-10 0. 1.37180507 0.0848281085 1.94655931E-05 + 5.86204002E-11 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 5.98166895 + 0.438057184 0.000315727171 5.38763736E-08 7.31781204E-32 5.68680096 + 0.416462779 0.000300163316 5.1220443E-08 6.65919842E-32 4.31364775 + 0.315902591 0.000227685421 3.88526189E-08 4.68339695E-32 2.55756116 + 0.187298968 0.000134994698 2.30357156E-08 2.63441626E-32 1.38515329 + 0.101439387 7.31118489E-05 1.24759536E-08 1.39038765E-32 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 6.03326464 0.526530683 0.000926672947 + 2.68087746E-07 2.52924678E-31 5.73585224 0.500575364 0.000880992739 + 2.54873356E-07 2.30160995E-31 4.3508625 0.379705459 0.000668266264 + 1.93330621E-07 1.61871532E-31 2.57962537 0.225126997 0.000396214513 + 1.14625536E-07 9.10528168E-32 1.3971045 0.121926896 0.0002145865 + 6.20802822E-08 4.80555668E-32 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 6.08706093 0.621821702 0.00165053399 5.06673757E-07 1.71280577E-31 + 5.7869997 0.591169059 0.00156917446 4.81698066E-07 1.55865038E-31 + 4.38965607 0.448423624 0.0011902774 3.65385574E-07 1.09619386E-31 + 2.60262799 0.265870064 0.000705715211 2.16636764E-07 6.16609147E-32 + 1.40955639 0.143993065 0.00038220876 1.17328838E-07 3.25431732E-32 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 6.14910173 0.717093527 0.00217908039 + 5.76096681E-07 2.46036316E-32 5.84598589 0.681744516 0.0020716677 + 5.47697937E-07 2.23893132E-32 4.43439579 0.517128229 0.00157143758 + 4.15449364E-07 1.57463316E-32 2.62915087 0.306605309 0.000931704999 + 2.46319559E-07 8.85729924E-33 1.42392778 0.166054919 0.000504602969 + 1.33404754E-07 4.67467838E-33 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 6.20445871 0.82878089 0.00521967886 1.01888518E-05 5.99792758E-24 + 5.89861059 0.787925601 0.00496237678 9.68658696E-06 5.45811559E-24 + 4.47431421 0.597670913 0.0037641495 7.34763353E-06 3.83867921E-24 + 2.65282011 0.354358941 0.00223176577 4.35641005E-06 2.15926021E-24 + 1.43674731 0.191917732 0.00120870362 2.35939547E-06 1.13960621E-24 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 6.26070356 0.954013348 0.00825015176 + 1.38529531E-05 7.76559852E-26 5.95208359 0.906981707 0.00784346554 + 1.31701154E-05 7.06669611E-26 4.51487541 0.687980711 0.00594956568 + 9.98999167E-06 4.96997346E-26 2.67687035 0.407903224 0.00352749485 + 5.92309061E-06 2.79560903E-26 1.4497689 0.220916942 0.00191045995 + 3.2078849E-06 1.47546217E-26 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 6.32210302 1.08099234 0.0131477062 5.84215741E-05 1.4782842E-19 + 6.01045418 1.02770293 0.012499596 5.554171E-05 1.34523866E-19 4.55915546 + 0.779551446 0.0094814077 4.21304721E-05 9.46101267E-20 2.70312619 + 0.462195396 0.00562152173 2.49791192E-05 5.32183029E-20 1.46398449 + 0.250321269 0.00304457126 1.35284999E-05 2.80874153E-20 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 6.37442541 1.22381163 0.0208695047 9.88082538E-05 + 5.67937079E-21 6.06019783 1.16348267 0.0198407359 9.39375095E-05 + 5.16822568E-21 4.59688425 0.882546246 0.0150499614 7.12551264E-05 + 3.63480488E-21 2.7254951 0.523261428 0.00892310031 4.22470948E-05 + 2.04458186E-21 1.47610378 0.283393919 0.00483267382 2.28806894E-05 + 1.07908094E-21 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 6.43151045 + 1.37231064 0.0323785804 0.000310100761 8.25325495E-18 6.11446762 + 1.30466163 0.0307825506 0.000294814294 7.51046247E-18 4.63805151 + 0.989637077 0.0233497005 0.000223627852 5.2820896E-18 2.74989939 + 0.586754322 0.0138440076 0.000132588582 2.97117755E-18 1.48932099 + 0.317781329 0.00749780284 7.18088486E-05 1.56812041E-18 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 6.49632406 1.53553641 0.0431424528 0.000336170313 + 1.09438208E-20 6.17608976 1.45983672 0.041015774 0.000319599087 + 9.95886118E-21 4.6847887 1.10734737 0.0311119892 0.000242427806 + 7.00406136E-21 2.77760673 0.656543016 0.0184462462 0.000143735233 + 3.93978654E-21 1.5043267 0.355578601 0.00999038015 7.7845878E-05 + 2.07933314E-21 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 6.54560137 + 1.70219541 0.0675681978 0.00110777025 6.3035562E-16 6.22293854 + 1.61828399 0.0642374307 0.00105316215 5.73623682E-16 4.72033072 + 1.22753131 0.0487263985 0.000798863417 4.03427605E-16 2.79868102 + 0.727802396 0.0288898833 0.000473645487 2.26927988E-16 1.5157423 + 0.394171417 0.0156465098 0.000256522355 1.1976756E-16 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 6.60289574 1.88028312 0.0935566649 0.00207060855 + 6.0060328E-15 6.27740335 1.7875967 0.0889447108 0.00196853722 + 5.4654856E-15 4.76164532 1.35595882 0.0674678311 0.00149320974 + 3.84385796E-15 2.82317781 0.803947628 0.0400016308 0.000885322108 + 2.16217526E-15 1.52901292 0.435411185 0.0216645524 0.000479483395 + 1.14114481E-15 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 6.66471529 + 2.06901789 0.124183863 0.00322265341 7.28853935E-13 6.33617783 + 1.96702015 0.118062057 0.00306379097 6.63257264E-13 4.80622578 + 1.49206209 0.089554511 0.00232400373 4.66466438E-13 2.84961224 + 0.884641469 0.0530968495 0.00137789978 2.62387497E-13 1.54332066 + 0.479114503 0.0287567955 0.000746258826 1.38482243E-13 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 6.71758652 2.26316094 0.168807313 0.00566450506 + 1.94159315E-14 6.38644123 2.15159726 0.160485506 0.00538527407 + 1.76685262E-14 4.84435272 1.63206708 0.121734381 0.00408493076 + 1.24262122E-14 2.8722167 0.967649937 0.0721764937 0.00242195418 + 6.989718E-15 1.55556417 0.524072528 0.0390900671 0.00131170754 + 3.68902754E-15 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 6.77522612 2.4627285 + 0.220662937 0.00983032305 4.2842444E-12 6.44124174 2.34132957 + 0.209785104 0.00934572984 3.89865831E-12 4.88592434 1.7759856 + 0.159130111 0.00708908774 2.74192084E-12 2.89686322 1.05298126 + 0.0943481922 0.00420311186 1.54232367E-12 1.56891632 0.570285797 + 0.0510981344 0.00227637566 8.14006414E-13 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 6.83357 2.67276835 0.281735122 0.0146662705 1.38422683E-12 + 6.49671125 2.54101324 0.267847002 0.013943309 1.25964582E-12 4.9279952 + 1.92745256 0.203172207 0.0105765127 8.8590642E-13 2.92180586 1.14278662 + 0.120460652 0.00627080817 4.98320406E-13 1.58243001 0.618923485 + 0.0652404875 0.00339621888 2.63003351E-13 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 6.88603067 2.88520861 0.359148979 0.0241642371 5.88247367E-11 + 6.5465827 2.74297976 0.341444939 0.0229730532 5.35304578E-11 4.96582699 + 2.08065462 0.258998692 0.017425919 3.7647753E-11 2.94423532 1.23361838 + 0.153560147 0.010331817 2.11768502E-11 1.5945785 0.668117762 + 0.0831668004 0.005595617 1.11767002E-11 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 6.94606876 3.10718751 0.442787975 0.0347676612 6.07964956E-10 + 6.60365486 2.9540174 0.420960665 0.0330537371 5.5324606E-10 5.00911999 + 2.24073076 0.31931451 0.0250725131 3.89097671E-10 2.9699049 1.32853007 + 0.189321443 0.0148654897 2.1886748E-10 1.60847783 0.719520509 + 0.102534629 0.00805101357 1.15513168E-10 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 7.00786972 3.33675814 0.53801775 0.0471471995 1.59011126E-09 + 6.66241455 3.17227793 0.511496425 0.0448231548 1.4470013E-09 5.05368996 + 2.40628457 0.387989044 0.0340000317 1.01767306E-09 2.99632835 1.42668974 + 0.230038419 0.0201586019 5.72439929E-10 1.62278354 0.772682309 + 0.124586709 0.0109177297 3.02120884E-10 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 7.06368732 3.56776643 0.651880205 0.0665007532 2.59092997E-10 + 6.71548557 3.39189315 0.619746149 0.0632225871 2.35774955E-10 5.09394264 + 2.57287478 0.470100164 0.0479566976 1.65819469E-10 3.02019835 1.52546191 + 0.278722018 0.0284335222 9.32734723E-11 1.63571334 0.82617569 + 0.150953665 0.0153993741 4.92276948E-11 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 7.11707926 3.80001235 0.780357718 0.0937919691 1.50752788E-09 + 6.76623821 3.6126914 0.741889894 0.0891680568 1.37185197E-09 5.13244247 + 2.74035811 0.562751114 0.0676375553 9.64817115E-10 3.04302168 1.6247555 + 0.333655 0.0401023179 5.42709877E-10 1.64807343 0.879955173 0.180704638 + 0.0217191 2.8643013E-10 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 7.17281055 + 4.03681087 0.919493437 0.126311928 6.12196605E-09 6.8192277 3.83781552 + 0.874164045 0.120084673 5.57098678E-09 5.17263365 2.91113091 0.663085461 + 0.0910887644 3.91805655E-09 3.06685638 1.72600543 0.393142819 + 0.0540065989 2.2039095E-09 1.66098392 0.934794307 0.212922886 + 0.0292495228 1.16317522E-09 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 3.81677675 0.0524662063 4.61236489E-08 7.99093695E-18 0. 3.62862945 + 0.0498799272 4.38499619E-08 7.59701782E-18 0. 2.75244665 0.037835747 + 3.32618413E-08 5.76264431E-18 0. 1.63192964 0.0224328469 1.97209147E-08 + 3.41666973E-18 0. 0.883837938 0.0121493973 1.06807079E-08 1.85043736E-18 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3.86823153 0.068936348 + 1.98503571E-07 3.36533257E-16 0. 3.6775496 0.0655381531 1.88717948E-07 + 3.19944144E-16 0. 2.78955722 0.0497131124 1.43149776E-07 2.4268963E-16 + 0. 1.65392935 0.0294749141 8.48737116E-08 1.43890225E-16 0. 0.895753384 + 0.0159633458 4.59667362E-08 7.79301347E-17 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 3.92153811 0.087102294 5.62771731E-07 4.44990876E-15 0. + 3.72823119 0.082808584 5.35030324E-07 4.23055391E-15 0. 2.8280015 + 0.062813431 4.05839842E-07 3.20902943E-15 0. 1.67672348 0.0372420363 + 2.40622313E-07 1.90263209E-15 0. 0.908097744 0.0201699845 1.30318995E-07 + 1.03045116E-15 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3.97272158 + 0.112430096 7.37601385E-06 3.93652194E-11 0. 3.77688766 0.106887855 + 7.01241743E-06 3.74247126E-11 0. 2.86491227 0.0810783803 5.31918522E-06 + 2.83880176E-11 0. 1.69859886 0.0480713323 3.15374245E-06 1.6831276E-11 + 0. 0.919948697 0.0260350797 1.70803867E-06 9.11568564E-12 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 4.01995134 0.148796767 2.80565455E-05 + 2.11697077E-10 0. 3.82179213 0.14146176 2.66734114E-05 2.01261438E-10 + 0. 2.89896989 0.107304052 2.02328192E-05 1.52664312E-10 0. 1.71879828 + 0.0636205077 1.19960287E-05 9.05146791E-11 0. 0.930888116 0.0344563238 + 6.4969563E-06 4.9021915E-11 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 4.07007647 0.187240779 4.86548488E-05 3.47102375E-10 0. 3.86944532 + 0.178010508 4.6256373E-05 3.29992228E-10 0. 2.93511748 0.135027409 + 3.50872215E-05 2.50311299E-10 0. 1.7402302 0.0800575316 2.08031761E-05 + 1.48409313E-10 0. 0.942491531 0.0433586612 1.12668331E-05 8.03772673E-11 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.12745667 0.22066544 + 5.48547105E-05 2.79876983E-10 0. 3.92399573 0.209788054 5.21506663E-05 + 2.66080658E-10 0. 2.9764967 0.15913175 3.95582574E-05 2.01832343E-10 0. + 1.76475906 0.0943490565 2.34540094E-05 1.19666471E-10 0. 0.955780685 + 0.0510986559 1.27025132E-05 6.48101711E-11 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 4.17367268 0.276923597 0.000307746406 4.20748378E-08 + 1.57614607E-35 3.96792889 0.263272852 0.000292576238 4.00005753E-08 + 1.43429266E-35 3.00982547 0.199702829 0.00022193011 3.03419796E-08 + 1.00873257E-35 1.78452611 0.118403539 0.000131582128 1.79897484E-08 + 5.67413469E-36 0.96648401 0.0641262904 7.12637921E-05 9.74308989E-09 + 2.99467984E-36 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.22686434 + 0.331387252 0.000398529432 3.29653673E-08 2.87918518E-38 4.01849937 + 0.315051407 0.000378883793 3.13401962E-08 2.62005426E-38 3.0481782 + 0.238978148 0.000287397619 2.37727331E-08 1.84268072E-38 1.80726588 + 0.14169012 0.000170397805 1.40948497E-08 1.0365067E-38 0.978800535 + 0.076738134 9.22860927E-05 7.63365282E-09 5.4704506E-39 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 4.27681684 0.397068143 0.00114523002 + 7.31258069E-07 3.96583921E-30 4.06599283 0.377494752 0.00108877604 + 6.95211725E-07 3.6089106E-30 3.08420229 0.286343426 0.000825876254 + 5.27343502E-07 2.53813662E-30 1.82862377 0.169772893 0.000489661878 + 3.12661257E-07 1.42770259E-30 0.990368128 0.0919476002 0.000265197275 + 1.69335053E-07 7.53508994E-31 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 4.33344316 0.466171056 0.00143143476 4.78101356E-07 3.0173101E-34 + 4.11982298 0.443191558 0.00136087101 4.54533875E-07 2.745753E-34 + 3.12503934 0.336177289 0.00103226863 3.44780659E-07 1.93108215E-34 + 1.85283577 0.199318975 0.000612032716 2.04420104E-07 1.08623369E-34 + 1.00348186 0.107949644 0.000331471645 1.10712364E-07 5.73289111E-35 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.384758 0.551906347 0.00333707198 + 4.08265623E-06 3.88971224E-29 4.16860771 0.524700642 0.00317256874 + 3.88140506E-06 3.53963685E-29 3.16204691 0.398004919 0.00240651169 + 2.94418692E-06 2.48941416E-29 1.87477767 0.235976368 0.00142681925 + 1.7456091E-06 1.40029852E-29 1.01536298 0.127802968 0.000772753498 + 9.4540502E-07 7.3904432E-30 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 4.43746901 0.638981521 0.00557489041 1.71952597E-05 2.95835764E-22 + 4.21872807 0.607482493 0.00530007016 1.63476252E-05 2.6921008E-22 + 3.20006227 0.460798353 0.00402030628 1.24002927E-05 1.89335326E-22 + 1.89731634 0.27320686 0.00238363491 7.35212507E-06 1.06501157E-22 + 1.02756965 0.147966221 0.00129095791 3.98184966E-06 5.62089838E-23 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.49078798 0.738204718 0.00820251461 + 2.03100099E-05 4.64779065E-26 4.26941538 0.701815009 0.0077981418 + 1.93088108E-05 4.22949623E-26 3.2385118 0.532353282 0.00591518776 + 1.46464909E-05 2.97459202E-26 1.9201113 0.315631956 0.00350711029 + 8.6838927E-06 1.67320726E-26 1.03991461 0.170943648 0.00189942366 + 4.7031217E-06 8.83081943E-27 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 4.54429865 0.847865582 0.0137604298 5.83068213E-05 1.8425154E-24 + 4.3202858 0.80607301 0.0130820889 5.54325998E-05 1.67668993E-24 + 3.27709746 0.61143595 0.00992323831 4.20476972E-05 1.17920772E-24 + 1.94298899 0.362520278 0.00588348694 2.49300374E-05 6.63307677E-25 + 1.05230725 0.196337819 0.00318645081 1.35019391E-05 3.50078178E-25 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.59347486 0.964991271 0.022589894 + 0.000205263612 2.42580718E-19 4.36703539 0.917421579 0.0214763433 + 0.000195145039 2.2074832E-19 3.31255746 0.695899546 0.0162906125 + 0.000148025254 1.55250996E-19 1.9640187 0.412597895 0.00965868589 + 8.77640559E-05 8.73288952E-20 1.06369245 0.223459303 0.00523106335 + 4.75322668E-05 4.60901935E-20 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 4.64882851 1.09210277 0.0324219167 0.000351391267 1.73614186E-19 + 4.41966391 1.03826702 0.030823715 0.000334069424 1.57988899E-19 + 3.35247993 0.787565053 0.023380965 0.000253404723 1.11113078E-19 + 1.98768842 0.466946185 0.0138625344 0.000150243592 6.25010885E-20 + 1.07651091 0.252894402 0.00750783226 8.13707375E-05 3.29867124E-20 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.70139503 1.22762454 0.0475773998 + 0.000786307559 2.5095781E-16 4.46963739 1.16710806 0.0452320129 + 0.000747546612 2.28371809E-16 3.39039087 0.885295987 0.0343102552 + 0.000567042443 1.60612865E-16 2.01016378 0.524890661 0.0203425027 + 0.000336199184 9.03449378E-17 1.08868635 0.284276724 0.0110173328 + 0.000182082906 4.76819264E-17 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 4.76055717 1.37292755 0.0636336729 0.00106238772 1.20215134E-17 + 4.52588701 1.30524683 0.0604969002 0.001010017 1.09395653E-17 3.43305516 + 0.990079999 0.0458891019 0.000766135694 7.69374915E-18 2.03545618 + 0.587018013 0.0272076353 0.000454241526 4.32773245E-18 1.10238779 + 0.317923814 0.014735451 0.000246013282 2.28407935E-18 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 4.80806065 1.52818358 0.0928404108 0.00244768569 + 1.82430737E-15 4.57104301 1.45285189 0.0882639289 0.00232702424 + 1.66011925E-15 3.46730995 1.10204411 0.0669513419 0.00176513602 + 1.1675553E-15 2.05576777 0.653401017 0.0396954194 0.00104654755 + 6.56748901E-16 1.11338794 0.353876144 0.0214987062 0.000566801406 + 3.46618376E-16 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.86360073 + 1.68904161 0.12392474 0.00424629264 5.15051868E-14 4.62384605 1.60578609 + 0.11781583 0.0040369546 4.68697143E-14 3.50736165 1.21804512 + 0.0893677026 0.00306218839 3.296329E-14 2.07951188 0.722178757 + 0.052986078 0.00181557168 1.85418782E-14 1.12624812 0.391126096 + 0.0286968239 0.000983297825 9.7860122E-15 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 4.9220109 1.85925472 0.159458771 0.00609082077 3.97910302E-13 + 4.67937946 1.76760387 0.15159817 0.00579057541 3.62098481E-13 3.54948306 + 1.34079218 0.114992715 0.00439237105 2.54662448E-13 2.10449171 + 0.794955313 0.0681791008 0.00260423589 1.4324784E-13 1.13977015 + 0.430540383 0.0369252451 0.00141043006 7.56031793E-14 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 4.9753871 2.03827667 0.208122239 0.00957699306 + 8.67451354E-15 4.73012352 1.93779564 0.197862834 0.00910485722 + 7.89379989E-15 3.58797717 1.46989453 0.150086313 0.00690637669 + 5.55168136E-15 2.12730408 0.871498287 0.0889862627 0.00409478508 + 3.12282095E-15 1.1521287 0.471996516 0.0481942557 0.00221770443 + 1.64815734E-15 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 5.02628517 + 2.22304463 0.269148856 0.0159309246 1.57604724E-13 4.77851105 2.11346078 + 0.255881041 0.0151456082 1.43420066E-13 3.6246798 1.60313821 0.194095448 + 0.0114885001 1.00866865E-13 2.14907575 0.950500607 0.11507915 + 0.00681154197 5.67376211E-14 1.16391742 0.51478231 0.0623259246 + 0.0036890714 2.99448237E-14 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 5.07944202 2.41418099 0.338171214 0.0243039075 1.34497361E-12 4.82905817 + 2.29516959 0.321501374 0.023105843 1.22392916E-12 3.66301727 1.7409755 + 0.243870765 0.0175266583 8.6078139E-13 2.17180347 1.03222156 0.144590512 + 0.0103915352 4.84190758E-13 1.17622924 0.559042454 0.0783091784 + 0.00562797533 2.55545422E-13 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 2.20650387 0.0064335526 1.46276411E-11 6.20084115E-26 0. 2.09773421 + 0.00611641072 1.39065886E-11 5.89516925E-26 0. 1.59120727 0.00463952869 + 1.05486375E-11 4.47170704E-26 0. 0.94342953 0.00275077182 6.25429483E-12 + 2.65127306E-26 0. 0.51095295 0.00148979248 3.38727549E-12 1.43590496E-26 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.24617338 0.00931683835 + 1.2231173E-10 -2.67486325E-23 0. 2.13544917 0.00885749981 1.16282609E-10 + -2.54301177E-23 0. 1.61981547 0.00671877153 8.82042564E-11 -1.92897317E-23 + 0. 0.960392177 0.00398355396 5.2296438E-11 -1.143681E-23 0. 0.52013886 + 0.00215745973 2.83232795E-11 -6.19412123E-24 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 2.28589487 0.0125015276 5.08378284E-10 7.94023463E-22 0. + 2.17321658 0.0118852081 4.83317386E-10 7.54881826E-22 0. 1.64846313 + 0.00901539624 3.66614461E-10 5.72607651E-22 0. 0.97737658 0.00534522161 + 2.17365848E-10 3.39497789E-22 0. 0.529337287 0.00289492798 + 1.17723137E-10 1.83869076E-22 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 2.3247757 0.0183267519 5.35129061E-08 1.19500128E-15 0. 2.21017766 + 0.0174233001 5.0874938E-08 1.13609395E-15 0. 1.67650282 0.0132162338 + 3.85905459E-08 8.61771797E-16 0. 0.993996799 0.00783589762 + 2.28802932E-08 5.1094335E-16 0. 0.53834033 0.00424385956 1.23917925E-08 + 2.76722593E-16 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.36410975 + 0.028226288 2.14555897E-07 6.35912569E-15 0. 2.24756932 0.0268348902 + 2.03978686E-07 6.04565023E-15 0. 1.70486498 0.0203552525 1.54725555E-07 + 4.58584485E-15 0. 1.01081395 0.0120686311 9.17366734E-08 2.71894739E-15 + 0. 0.547448695 0.00653626909 4.96837593E-08 1.47255852E-15 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 2.40560842 0.0378261283 3.24153604E-07 + 8.34789594E-15 0. 2.28702188 0.0359614901 3.08174378E-07 7.93638701E-15 + 0. 1.73479342 0.0272781178 2.33761767E-07 6.02002579E-15 0. 1.02855623 + 0.0161731727 1.38597329E-07 3.56928207E-15 0. 0.557058334 0.00875927042 + 7.50629638E-08 1.9330952E-15 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 2.44822788 0.0446435139 6.79198308E-07 1.72385326E-12 0. 2.32753921 + 0.0424428098 6.45717876E-07 1.63887719E-12 0. 1.76552796 0.0321944728 + 4.89800868E-07 1.24315152E-12 0. 1.04677689 0.019088082 2.9040271E-07 + 7.37065248E-13 0. 0.56692785 0.0103379143 1.572797E-07 3.9918676E-13 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.48741841 0.0655812398 + 5.77780429E-06 1.1429707E-11 0. 2.36480045 0.0623484626 5.49299875E-06 + 1.08662645E-11 0. 1.79378963 0.0472937562 4.1666267E-06 8.24247615E-12 + 0. 1.06353784 0.0280403942 2.47039679E-06 4.88695282E-12 0. 0.576003611 + 0.0151864439 1.33794777E-06 2.6467255E-12 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 2.53253388 0.0784479454 4.65395624E-06 3.08828354E-12 0. + 2.40769911 0.0745808929 4.42453529E-06 2.93604399E-12 0. 1.82632542 + 0.0565723293 3.35617915E-06 2.22709785E-12 0. 1.08282471 0.033541739 + 1.98987232E-06 1.32044538E-12 0. 0.586450994 0.0181659106 1.07770006E-06 + 7.15143114E-13 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.57312894 + 0.106369413 3.34709875E-05 4.84468743E-10 0. 2.44629002 0.101126127 + 3.18210477E-05 4.60586874E-10 0. 1.85559762 0.0767076835 2.41374528E-05 + 3.4937131E-10 0. 1.10018337 0.0454800278 1.43110838E-05 2.07142067E-10 + 0. 0.595851243 0.0246315617 7.75074841E-06 1.12186316E-10 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 2.61667061 0.128962532 6.96087955E-05 + 8.59816929E-09 2.81971223E-36 2.487679 0.122605443 6.61774829E-05 + 8.17432699E-09 2.56593883E-36 1.88700104 0.0930007771 5.01980794E-05 + 6.20052987E-09 1.80461934E-36 1.11879504 0.0551400743 2.97624138E-05 + 3.67629016E-09 1.01509837E-36 0.605932832 0.0298633948 1.61190801E-05 + 1.99104688E-09 5.3574555E-37 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 2.65749073 0.163297161 0.000132302768 9.48852286E-09 2.34661441E-41 + 2.52648973 0.155247286 0.000125780905 9.02078412E-09 2.13543873E-41 + 1.91643596 0.117760763 9.54095303E-05 6.84260026E-09 1.50177156E-41 + 1.13625348 0.0698203593 5.65682567E-05 4.0569752E-09 8.44842844E-42 + 0.615386069 0.0378141329 3.06369584E-05 2.19721952E-09 4.45893171E-42 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.69845128 0.202916533 0.000373068411 + 1.12548641E-07 4.05826725E-36 2.56543446 0.192913577 0.000354678661 + 1.0700046E-07 3.69301955E-36 1.94597876 0.146332234 0.0002690377 + 8.11639467E-08 2.5972924E-36 1.15376735 0.0867603272 0.000159511823 + 4.81220574E-08 1.46097486E-36 0.624871671 0.0469885692 8.63902897E-05 + 2.60625015E-08 7.7106957E-37 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 2.74402547 0.244700924 0.000667086919 4.06470406E-07 2.63433757E-33 + 2.60875607 0.232638389 0.000634202734 3.86433442E-07 2.39724679E-33 + 1.97884309 0.176465169 0.000481066498 2.93124799E-07 1.68597481E-33 + 1.17325222 0.10462606 0.000285223214 1.73793495E-07 9.48362669E-34 + 0.635425031 0.0566646159 0.000154474881 9.41251486E-08 5.00524393E-34 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.79026747 0.292195261 0.00106687588 + 1.15332546E-06 1.72188475E-26 2.65272164 0.277791739 0.00101428479 + 1.09647249E-06 1.56691596E-26 2.01218772 0.210714892 0.000769372564 + 8.31715113E-07 1.10200425E-26 1.19302416 0.124933004 0.000456160749 + 4.9312365E-07 6.19880467E-27 0.646131933 0.067662701 0.000247052667 + 2.67071982E-07 3.27158336E-27 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 2.83317447 0.351787299 0.00195079902 2.01480975E-06 7.80389658E-32 + 2.69351077 0.334445775 0.00185463624 1.91549043E-06 7.10152989E-32 + 2.04313016 0.253689736 0.00140680885 1.45296917E-06 4.9945074E-32 + 1.21137249 0.15041247 0.00083409762 8.61466674E-07 2.80940035E-32 + 0.656067789 0.0814619884 0.000451739994 4.6656271E-07 1.48274066E-32 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.87952805 0.414400965 0.00309527689 + 3.86604643E-06 4.57978036E-32 2.73758745 0.393972993 0.00294269365 + 3.67546977E-06 4.16760561E-32 2.07656097 0.298843056 0.00223214598 + 2.78798257E-06 2.93105902E-32 1.23119521 0.177183703 0.00132343674 + 1.65299684E-06 1.64872119E-32 0.66680336 0.0959614292 0.000716761919 + 8.95248832E-07 8.70155579E-33 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 2.92018867 0.490570635 0.00628022291 2.36763462E-05 7.89213797E-26 + 2.77623367 0.466387808 0.00597062567 2.25092299E-05 7.18183652E-26 + 2.10587573 0.353772819 0.00452896254 1.70740896E-05 5.05095897E-26 + 1.24857783 0.209751517 0.00268521369 1.0123209E-05 2.84117838E-26 + 0.676217556 0.113599785 0.00145428767 5.48264006E-06 1.49950456E-26 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.96890426 0.56581223 0.00860051438 + 3.2205593E-05 1.80630088E-22 2.82255125 0.537919998 0.00817655027 + 3.06179645E-05 1.64373546E-22 2.14100599 0.408032805 0.00620221952 + 2.32249131E-05 1.15603262E-22 1.26940179 0.241922572 0.00367729529 + 1.37700272E-05 6.50268331E-23 0.687498331 0.131023154 0.00199159468 + 7.45773195E-06 3.4319684E-23 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 3.01068211 0.660455346 0.0154546266 0.000115952425 2.36008708E-23 + 2.86227131 0.627898157 0.0146928011 0.000110236499 2.14767776E-23 + 2.17113638 0.476284117 0.0111450413 8.36186082E-05 1.51045327E-23 + 1.28726661 0.282388955 0.00660788594 4.95774293E-05 8.49630253E-24 + 0.697172761 0.1529392 0.00357877719 2.68507247E-05 4.48417371E-24 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 3.05623364 0.755511343 0.0232039727 + 0.000280018168 3.58400654E-20 2.90558195 0.718269646 0.0220600832 + 0.00026621396 3.26144746E-20 2.20399117 0.54483366 0.0167334098 + 0.000201933814 2.29377006E-20 1.30674636 0.323031813 0.00992122293 + 0.000119726545 1.29024294E-20 0.707722068 0.17495133 0.0053732628 + 6.48428468E-05 6.80961495E-21 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 3.10488534 0.857669115 0.0314037241 0.000419196294 3.77036451E-18 + 2.9518292 0.815390527 0.0298556592 0.000398531876 3.43103434E-18 + 2.2390728 0.618504107 0.0226466823 0.000302301196 2.41303598E-18 + 1.32754683 0.366710246 0.0134271923 0.000179234848 1.35733245E-18 + 0.718987167 0.198607534 0.00727205304 9.70717956E-05 7.16369378E-19 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 3.15171957 0.973519921 0.044862628 + 0.000686443935 5.06357925E-21 2.99635124 0.925530553 0.0426511206 + 0.000652605668 4.60785403E-21 2.27284861 0.702047944 0.0323525183 + 0.000495026005 3.2406923E-21 1.3475666 0.416243732 0.0191817917 + 0.00029350043 1.82288716E-21 0.729832828 0.225434482 0.0103886621 + 0.000158957555 9.62079715E-22 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 3.19672322 1.09852433 0.0650934204 0.00145241828 3.7045643E-19 + 3.03913927 1.0443759 0.0618845858 0.00138082192 3.37115106E-19 + 2.30530071 0.792196631 0.046941828 0.00104740239 2.37092349E-19 + 1.36681342 0.469693482 0.0278317928 0.000621005718 1.33364081E-19 + 0.740254343 0.254381686 0.0150734847 0.000336331286 7.03869374E-20 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 3.24276733 1.22972119 0.0895852149 + 0.00265182601 8.14584058E-18 3.08291435 1.16910195 0.0851692855 + 0.00252110371 7.41274514E-18 2.33850551 0.886808157 0.0646041259 + 0.00191234704 5.21336082E-18 1.38649631 0.525786877 0.0383037589 + 0.0011338325 2.93251512E-18 0.750916302 0.284761757 0.0207450036 + 0.000614073826 1.54771469E-18 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.0788461 0.000382227969 1.68591439E-16 1.14785032E-37 0. 1.02566016 + 0.000363385916 1.6028059E-16 1.09126308E-37 0. 0.778002679 + 0.000275642087 1.2157894E-16 8.27763762E-38 0. 0.461276978 0.00016342834 + 7.20840986E-17 4.9078203E-38 0. 0.249824122 8.8510933E-05 3.9040086E-17 + 2.65803702E-38 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.10427761 + 0.000630550261 3.56969118E-15 -2.49695983E-32 0. 1.04983974 + 0.000599467836 3.39372221E-15 -2.37387293E-32 0. 0.796343505 + 0.00045471848 2.57426675E-15 -1.80067029E-32 0. 0.472151667 + 0.000269602402 1.52628529E-15 -1.067616E-32 0. 0.255713344 0.000146014179 + 8.26622259E-16 -5.78211675E-33 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.12788916 0.000903383596 2.66396978E-14 1.03242458E-31 0. 1.07228589 + 0.000858854328 2.53265037E-14 9.81537313E-32 0. 0.813368857 + 0.000651473238 1.92110647E-14 7.44528382E-32 0. 0.48224622 + 0.000386257947 1.13902248E-14 4.41431542E-32 0. 0.261180758 + 0.000209194288 6.1688643E-15 2.39074892E-32 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 1.15265179 0.00170413579 5.83034176E-11 3.60726503E-22 0. + 1.09583008 0.0016201312 5.54294492E-11 3.42944568E-22 0. 0.831227362 + 0.00122893089 4.20452249E-11 2.60136539E-22 0. 0.492834568 + 0.000728632556 2.49285922E-11 1.54234752E-22 0. 0.266914994 + 0.000394621165 1.3501123E-11 8.35323866E-23 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 1.18251967 0.00324440794 2.18372889E-10 1.7649522E-21 0. + 1.12422585 0.00308447611 2.07608597E-10 1.67794839E-21 0. 0.852768064 + 0.00233969069 1.57478502E-10 1.27278661E-21 0. 0.505605519 0.0013872016 + 9.33689445E-11 7.54635702E-22 0. 0.273832113 0.000751297455 + 5.05679144E-11 4.08704064E-22 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.21157181 0.00444578752 2.56815041E-10 1.59021252E-21 0. 1.15184438 + 0.00422663288 2.44155168E-10 1.5118206E-21 0. 0.873717964 0.0032060612 + 1.85200785E-10 1.14677323E-21 0. 0.518026769 0.00190086965 + 1.09805616E-10 6.79922319E-22 0. 0.280558974 0.00102949538 + 5.94697763E-11 3.68239387E-22 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.23526931 0.00572673604 8.0241449E-09 9.21990466E-17 0. 1.17437541 + 0.00544443354 7.62861063E-09 8.76540994E-17 0. 0.890807331 0.004129807 + 5.78658366E-09 6.64888769E-17 0. 0.528159022 0.00244856346 + 3.43086715E-09 3.94212873E-17 0. 0.286046863 0.00132611906 + 1.85812743E-09 2.13502513E-17 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.26660717 0.00978045538 1.86395646E-08 8.009617E-17 0. 1.20416915 + 0.00929834787 1.77207582E-08 7.61478318E-17 0. 0.913408577 0.00705313403 + 1.34418574E-08 5.77609899E-17 0. 0.541559339 0.00418180181 + 7.96966404E-09 3.42464222E-17 0. 0.293304145 0.00226482959 + 4.31630331E-09 1.85475532E-17 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.29259324 0.0119245462 1.07633866E-07 4.9114992E-14 0. 1.22887027 + 0.0113367476 1.0232813E-07 4.669385E-14 0. 0.932145476 0.00859933253 + 7.76197595E-08 3.5418991E-14 0. 0.552668154 0.00509854686 4.60206273E-08 + 2.09999085E-14 0. 0.299320668 0.00276133162 2.49244341E-08 + 1.13733892E-14 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.32370305 + 0.0184230953 2.28169142E-07 2.60427208E-14 0. 1.25844991 0.0175149478 + 2.16922487E-07 2.4759017E-14 0. 0.954581857 0.0132857123 1.64543707E-07 + 1.87805416E-14 0. 0.565971732 0.0078771105 9.75578089E-08 1.11349935E-14 + 0. 0.306525499 0.00426616892 5.28366044E-08 6.03062175E-15 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 1.35185087 0.0251103528 1.53762664E-06 + 3.84797706E-12 0. 1.28521025 0.0238725487 1.46183436E-06 3.65829502E-12 + 0. 0.974881828 0.0181082096 1.10885708E-06 2.77495344E-12 0. + 0.578006387 0.01073635 6.57439045E-07 1.64526606E-12 0. 0.313043356 + 0.00581471575 3.56063282E-07 8.9106294E-13 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 1.38203442 0.0313277878 2.05654715E-06 2.42917041E-11 0. + 1.31390584 0.0297834761 1.95516964E-06 2.3094247E-11 0. 0.996647775 + 0.0225918759 1.48306958E-06 1.7517824E-11 0. 0.590911806 0.013394706 + 8.79310051E-07 1.03862986E-11 0. 0.320032895 0.00725445757 + 4.76227456E-07 5.62513924E-12 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.41338265 0.0431740135 4.84976772E-06 1.28648437E-11 0. 1.34371388 + 0.0410458073 4.61069976E-06 1.22306358E-11 0. 1.01925707 0.0311347675 + 3.4973873E-06 9.27740523E-12 0. 0.604316294 0.0184597746 2.07359585E-06 + 5.50057482E-12 0. 0.32729274 0.00999765005 1.12304326E-06 2.97906361E-12 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.4433347 0.0564117432 + 1.58512667E-05 3.59522689E-10 0. 1.37218654 0.0536310002 1.5069857E-05 + 3.41800255E-10 0. 1.04085362 0.0406811312 1.14310615E-05 2.59268385E-10 + 0. 0.617123485 0.0241197664 6.77748358E-06 1.53719884E-10 0. + 0.334228963 0.0130630787 3.67062034E-06 8.3253425E-11 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 1.47369134 0.0740581006 5.49749893E-05 + 6.21230622E-09 1.15747253E-42 1.40104568 0.0704074204 5.22650553E-05 + 5.90606675E-09 1.05237515E-42 1.06274378 0.0534065887 3.96450232E-05 + 4.47997284E-09 7.41286888E-43 0.630100965 0.0316647664 2.35055268E-05 + 2.65617173E-09 4.16185644E-43 0.341257244 0.0171493702 1.27303701E-05 + 1.43856216E-09 2.20003859E-43 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.5061065 0.0941918641 0.000110310502 1.85440587E-08 5.95411717E-42 + 1.43186188 0.0895486847 0.00010487267 1.76299242E-08 5.41741986E-42 + 1.08612013 0.0679259971 7.95498418E-05 1.33729996E-08 3.81013052E-42 + 0.643960059 0.0402733199 4.71651474E-05 7.92884602E-09 2.14398665E-42 + 0.348763615 0.0218116734 2.55442137E-05 4.29419966E-09 1.13084786E-42 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.53705335 0.115049899 0.000190299761 + 7.85204008E-08 6.56212742E-34 1.46127713 0.109378763 0.00018091868 + 7.46497335E-08 5.9715439E-34 1.10843468 0.0829677358 0.000137233656 + 5.66246356E-08 4.19976122E-34 0.657190502 0.049191501 8.13657607E-05 + 3.35727641E-08 2.3623662E-34 0.355928898 0.0266417023 4.40670374E-05 + 1.81827318E-08 1.24680037E-34 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.57055521 0.146995977 0.000454888243 3.06554114E-07 4.78324235E-35 + 1.493132 0.139750093 0.000432464934 2.91442831E-07 4.35274796E-35 + 1.13259625 0.106005527 0.000328040624 2.21069953E-07 3.06127485E-35 + 0.671516716 0.0628506094 0.000194495326 1.31072525E-07 1.72196778E-35 + 0.363687783 0.0340393558 0.000105336912 7.09876815E-08 9.08815621E-36 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.60190487 0.175760269 0.000687309017 + 7.57409111E-07 1.39274873E-29 1.5229398 0.167096242 0.000653427909 + 7.2007191E-07 1.26739311E-29 1.15520704 0.126748398 0.000495649467 + 5.46202045E-07 8.91356715E-30 0.684922338 0.0751491413 0.000293870486 + 3.23842926E-07 5.01388289E-30 0.370948642 0.0407001413 0.000159157891 + 1.75390511E-07 2.64621646E-30 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.63710821 0.219167396 0.00142011768 1.96432597E-06 1.95054024E-32 + 1.55640686 0.208363816 0.00135011389 1.86749503E-06 1.77498956E-32 + 1.18059158 0.158051476 0.00102411164 1.41656301E-06 1.24834517E-32 + 0.699973047 0.0937088504 0.000607195485 8.39880443E-07 7.02193379E-33 + 0.379099548 0.0507519171 0.000328851718 4.54871781E-07 3.70602879E-33 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.66916037 0.263078451 0.00262426608 + 7.99753434E-06 5.12371514E-28 1.58687556 0.250110239 0.00249489513 + 7.60329522E-06 4.66257769E-28 1.20370662 0.189718097 0.00189247308 + 5.7673783E-06 3.27917692E-28 0.71367681 0.112483747 0.00112204626 + 3.41948112E-06 1.84453774E-28 0.386521161 0.0609202422 0.000607690832 + 1.85196234E-06 9.73505406E-29 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.70222068 0.309032381 0.00369378342 1.39448757E-05 4.90330695E-25 + 1.61830866 0.293798685 0.00351169379 1.32574614E-05 4.461994E-25 + 1.22754848 0.222857699 0.00266375253 1.00562702E-05 3.13811432E-25 + 0.727814138 0.132131755 0.00157933787 5.96237669E-06 1.76519004E-25 + 0.39417848 0.0715615302 0.000855355931 3.22916821E-06 9.31628952E-26 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.73814166 0.36737743 0.00572901219 + 1.9157751E-05 9.09347383E-30 1.65246034 0.349267364 0.00544660026 + 1.82133717E-05 8.27504915E-30 1.25345075 0.264932215 0.00413144752 + 1.38155265E-05 5.81983228E-30 0.743172526 0.157077938 0.00244953134 + 8.19123306E-06 3.2736472E-30 0.402496368 0.0850722417 0.00132664677 + 4.43629187E-06 1.72776059E-30 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.77391386 0.435346276 0.00983964652 5.69531221E-05 3.70125679E-27 + 1.68646765 0.413886547 0.0093546072 5.41456393E-05 3.36814255E-27 + 1.27924931 0.313948423 0.00709583052 4.10714601E-05 2.36880081E-27 + 0.758467019 0.186139956 0.00420711283 2.43512568E-05 1.33244943E-27 + 0.410779446 0.100811869 0.00227853819 1.31884144E-05 7.03237671E-28 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.80899477 0.508011818 0.0153861614 + 0.000133798763 2.87859806E-25 1.71981692 0.482969105 0.0146276513 + 0.000127203602 2.61952283E-25 1.3045435 0.366350025 0.0110956542 + 9.64882856E-05 1.8423044E-25 0.773465395 0.217209026 0.00657859351 + 5.72079553E-05 1.03629366E-25 0.418902516 0.11763861 0.00356291491 + 3.09833267E-05 5.46934275E-26 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.424341172 8.42020017E-06 1.76276097E-23 0. 0. 0.403423071 + 8.00508769E-06 1.67586557E-23 0. 0. 0.306011796 6.07218089E-06 + 1.27120667E-23 0. 0. 0.181433827 3.60019476E-06 7.53696089E-24 0. 0. + 0.0982630104 1.9498334E-06 4.08197022E-24 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.437141061 1.65877318E-05 9.26696943E-22 0. 0. + 0.415591687 1.57700633E-05 8.81028839E-22 0. 0. 0.315242231 + 1.19622046E-05 6.68286861E-22 0. 0. 0.186906874 7.09235246E-06 + 3.96224385E-22 0. 0. 0.101227432 3.84116538E-06 2.14592784E-22 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.4472754 2.55583509E-05 + 2.42522328E-20 -1.40129846E-45 0. 0.425226778 2.4298497E-05 + 2.30567371E-20 -1.40129846E-45 0. 0.322550416 1.84313049E-05 + 1.74893624E-20 -1.40129846E-45 0. 0.191240296 1.09278844E-05 + 1.03694651E-20 -1.40129846E-45 0. 0.103574224 5.91846856E-06 + 5.61599696E-21 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.460205317 + 8.23175869E-05 3.820958E-15 1.32118594E-31 0. 0.437519163 7.8259829E-05 + 3.6326054E-15 1.25605486E-31 0. 0.331874579 5.9363043E-05 2.7554653E-15 + 9.52766736E-32 0. 0.196768433 3.51963026E-05 1.63371522E-15 + 5.64893508E-32 0. 0.106568158 1.90620212E-05 8.8480384E-16 + 3.05942036E-32 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.480158061 + 0.000192601598 1.25559446E-14 5.76719487E-31 0. 0.456488073 + 0.00018310723 1.19370041E-14 5.48289498E-31 0. 0.346263319 + 0.000138893811 9.05466277E-15 4.15898788E-31 0. 0.20529902 + 8.23499722E-05 5.36849397E-15 2.46586224E-31 0. 0.111188523 + 4.45999904E-05 2.90753525E-15 1.33549006E-31 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.495723873 0.000245179806 9.84063396E-15 2.61492409E-31 + 0. 0.471286684 0.000233093961 9.35550855E-15 2.48602197E-31 0. + 0.35748899 0.000176810689 7.09651742E-15 1.88574532E-31 0. 0.211954728 + 0.000104830906 4.20751716E-15 1.11805758E-31 0. 0.114793241 + 5.67754869E-05 2.27875749E-15 6.05529878E-32 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.506367922 0.000436839822 5.46818667E-12 7.01076464E-24 + 0. 0.481406689 0.000415305345 5.19863709E-12 6.66515679E-24 0. + 0.365164399 0.000315024983 3.94335779E-12 5.05577523E-24 0. 0.216505945 + 0.00018677862 2.3380152E-12 2.99757027E-24 0. 0.11725764 0.000101157551 + 1.26624948E-12 1.62346016E-24 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.526365161 0.000748740917 3.73086631E-12 6.00955815E-25 0. 0.500418186 + 0.000711828645 3.54695288E-12 5.71335173E-25 0. 0.379585892 + 0.000539952191 2.69049735E-12 4.33377797E-25 0. 0.225055963 + 0.000320136052 1.59519533E-12 2.56949401E-25 0. 0.121888496 + 0.000173382941 8.6394417E-13 1.3916167E-25 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0.538395643 0.00116836815 2.32917907E-10 3.95974881E-20 0. + 0.511855125 0.00111077377 2.21436272E-10 3.76455325E-20 0. 0.388261259 + 0.000842563109 1.67967182E-10 2.85555963E-20 0. 0.230200261 + 0.000499555608 9.95877686E-11 1.69306229E-20 0. 0.124674521 + 0.000270555291 5.3935946E-11 9.16945784E-21 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0.556002796 0.00160624506 8.5281622E-11 9.21186983E-22 0. + 0.528594553 0.0015270618 8.10773393E-11 8.75774444E-22 0. 0.400958419 + 0.00115833501 6.15003187E-11 6.64305549E-22 0. 0.237728298 + 0.000686778105 3.6463485E-11 3.93868405E-22 0. 0.128751785 + 0.000371951784 1.97483176E-11 2.13315537E-22 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.573457003 0.00284235203 2.2666351E-09 2.56454011E-18 0. + 0.545188367 0.00270223618 2.15489937E-09 2.43811837E-18 0. 0.413545638 + 0.00204974716 1.63457359E-09 1.8494038E-18 0. 0.245191127 0.00121529342 + 9.69137326E-10 1.09651279E-18 0. 0.132793367 0.000658193137 + 5.2487753E-10 5.93860104E-19 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.588264108 0.00396427978 1.56380224E-08 3.83882187E-16 0. 0.559265435 + 0.0037688585 1.48671448E-08 3.64959392E-16 0. 0.424223781 0.00285881222 + 1.12772822E-08 2.76834508E-16 0. 0.251522303 0.00169498939 + 6.68628308E-09 1.6413545E-16 0. 0.136222064 0.000917992322 3.6212322E-09 + 8.88944402E-17 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.604361117 + 0.00532231713 5.78963544E-08 7.52715761E-14 0. 0.574569404 0.0050599589 + 5.50423671E-08 7.15608603E-14 0. 0.435832441 0.00383816799 + 4.17517043E-08 5.42816423E-14 0. 0.258404911 0.00227564457 + 2.47545024E-08 3.21835894E-14 0. 0.139949858 0.00123246945 + 1.34068268E-08 1.74303558E-14 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.623143435 0.00775340665 8.91822651E-08 1.42955885E-14 0. 0.592425704 + 0.00737121794 8.47860306E-08 1.35908783E-14 0. 0.449377507 0.00559134595 + 6.43134257E-08 1.03091863E-14 0. 0.266435713 0.00331510068 + 3.81312724E-08 6.1123096E-15 0. 0.14429903 0.00179543253 2.06515534E-08 + 3.31038602E-15 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.643274605 + 0.0116506573 3.90858872E-07 2.12825647E-13 0. 0.611563802 0.0110763488 + 3.7159063E-07 2.02334555E-13 0. 0.46389389 0.00840180367 2.81865709E-07 + 1.53478115E-13 0. 0.275042504 0.0049814349 1.67117747E-07 9.09970274E-14 + 0. 0.14896059 0.00269789994 9.05096158E-08 4.92834499E-14 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0.661281645 0.0157345943 8.75545425E-07 + 8.00026224E-13 0. 0.628683507 0.014958973 8.32384046E-07 7.60591947E-13 + 0. 0.476879925 0.011346912 6.313943E-07 5.76935364E-13 0. 0.282741755 + 0.00672759349 3.7435359E-07 3.42064484E-13 0. 0.153130636 0.00364360888 + 2.02746904E-07 1.85259509E-13 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.678875923 0.0215907171 4.19238904E-06 6.6772976E-11 0. 0.64541012 + 0.0205263831 3.98572411E-06 6.34814562E-11 0. 0.489567667 0.0155700538 + 3.0233216E-06 4.81530302E-11 0. 0.290264845 0.00923146028 1.79252527E-06 + 2.85499246E-11 0. 0.157204852 0.00499968464 9.70817155E-07 + 1.54623814E-11 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.701470613 + 0.0298439302 9.3246299E-06 1.29817782E-10 0. 0.666891515 0.0283727907 + 8.86497401E-06 1.23418165E-10 0. 0.5058617 0.0215218104 6.7243991E-06 + 9.36174749E-11 0. 0.299925029 0.0127602573 3.98689735E-06 5.55054475E-11 + 0. 0.162437126 0.00691083865 2.15926934E-06 3.00614048E-11 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0.717437923 0.0377784781 2.35317912E-05 + 2.45812859E-09 4.21748799E-41 0.682072461 0.0359161384 2.23717689E-05 + 2.33695796E-09 3.83787623E-41 0.517377496 0.0272437539 1.69697796E-05 + 1.77267301E-09 2.6991811E-41 0.306752443 0.0161527451 1.00613997E-05 + 1.05101561E-09 1.51830689E-41 0.166135058 0.00874821469 5.4491652E-06 + 5.6922117E-10 8.01262462E-42 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.741417944 0.051213026 5.25186733E-05 5.5555005E-09 1.40129846E-45 + 0.704868793 0.0486884788 4.99297785E-05 5.28164312E-09 1.40129846E-45 + 0.534669876 0.0369320586 3.78736222E-05 4.00632549E-09 1.40129846E-45 + 0.317005306 0.0218970142 2.24552477E-05 2.37534237E-09 1.40129846E-45 + 0.17168735 0.0118592512 1.21615667E-05 1.28646882E-09 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0.760638058 0.0664985999 0.000151057815 + 6.3573026E-08 3.83706348E-39 0.723141372 0.0632205904 0.000143611309 + 6.04391843E-08 3.49172749E-39 0.548530281 0.0479551889 0.000108934597 + 4.58453684E-08 2.45571951E-39 0.325223386 0.0284326281 6.45872497E-05 + 2.71816685E-08 1.38134117E-39 0.176138192 0.0153988656 3.49798975E-05 + 1.47213708E-08 7.29039539E-40 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.7770648 0.0807025582 0.00023181233 1.85970421E-07 8.54516435E-35 + 0.738759816 0.0767243207 0.000220385336 1.76802942E-07 7.77609774E-35 + 0.560376406 0.0581982881 0.000167170278 1.34111673E-07 5.46889735E-35 + 0.332247227 0.0345057473 9.91152992E-05 7.9514713E-08 3.07626671E-35 + 0.179942414 0.0186880082 5.3679978E-05 4.30645635E-08 1.62358112E-35 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.79982096 0.101621613 0.000361855316 + 1.48172262E-07 3.34209684E-42 0.760394037 0.0966119468 0.000344018132 + 1.40868067E-07 3.04081767E-42 0.576786757 0.0732838586 0.000260950008 + 1.06853356E-07 2.13838146E-42 0.34197706 0.043449983 0.000154717491 + 6.33531982E-08 1.20231408E-42 0.185211778 0.0235321559 8.37934203E-05 + 3.43117037E-08 6.34788204E-43 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.824516833 0.129349425 0.000793873565 7.05064963E-07 1.44950593E-38 + 0.783872008 0.122973435 0.00075473747 6.70309646E-07 1.31904645E-38 + 0.594596386 0.093280077 0.0005724972 5.08452899E-07 9.27683265E-39 + 0.352536082 0.0553055778 0.000339433522 3.01461398E-07 5.21822809E-39 + 0.190930322 0.0299530234 0.000183834054 1.63269092E-07 2.75405455E-39 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.847158849 0.159812182 0.00148428127 + 2.34189156E-06 6.34642469E-36 0.805398345 0.151934043 0.00141111226 + 2.22644599E-06 5.77524629E-36 0.610925138 0.115248032 0.00107037916 + 1.68884151E-06 4.06171037E-36 0.362217098 0.0683303773 0.000634628523 + 1.00131308E-06 2.28471415E-36 0.196173936 0.0370071381 0.000343709311 + 5.42303212E-07 1.20581764E-36 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.125933453 4.73859032E-08 2.30993419E-33 0. 0. 0.119725257 + 4.50499869E-08 2.19606314E-33 0. 0. 0.0908164158 3.41720821E-08 + 1.66579635E-33 0. 0. 0.0538449064 2.02606039E-08 9.87648976E-34 0. 0. + 0.0291619189 1.09729941E-08 5.34903056E-34 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.130610794 1.19297326E-07 -3.0312612E-30 0. 0. + 0.12417227 1.13416199E-07 -2.8818459E-30 0. 0. 0.0941893905 + 8.60302691E-08 -2.18597976E-30 0. 0. 0.0558448061 5.10074258E-08 + -1.29605785E-30 0. 0. 0.030245062 2.76251786E-08 -7.01930935E-31 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.133174658 2.00017098E-07 + 6.73620901E-29 0. 0. 0.12660946 1.90157465E-07 6.40415822E-29 0. 0. + 0.0960379615 1.44241227E-07 4.85777099E-29 0. 0. 0.0569409207 + 8.55206039E-08 2.88016955E-29 0. 0. 0.0308387149 4.63172185E-08 + 1.55987416E-29 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.138678953 + 1.80447296E-06 4.54426775E-21 2.80259693E-45 0. 0.131843105 + 1.71552063E-06 4.32025811E-21 2.80259693E-45 0. 0.100007914 + 1.30128956E-06 3.27708057E-21 1.40129846E-45 0. 0.0592946708 + 7.71532711E-07 1.94297738E-21 1.40129846E-45 0. 0.0321134962 + 4.17856171E-07 1.05230026E-21 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0.149346292 4.49350364E-06 1.22783386E-20 1.12103877E-44 0. + 0.141984165 4.2719771E-06 1.16730662E-20 9.80908925E-45 0. 0.107700303 + 3.24046232E-06 8.85446763E-21 8.40779079E-45 0. 0.0638553575 + 1.92126777E-06 5.24980475E-21 4.20389539E-45 0. 0.0345836096 + 1.04054129E-06 2.84324736E-21 2.80259693E-45 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.15403749 4.61854916E-06 5.33355477E-21 1.40129846E-45 + 0. 0.146444127 4.39087853E-06 5.07065189E-21 1.40129846E-45 0. + 0.111083522 3.33064349E-06 3.84627837E-21 1.40129846E-45 0. 0.0658613518 + 1.97473855E-06 2.28045617E-21 0. 0. 0.0356699713 1.06950222E-06 + 1.23507395E-21 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.158597365 + 1.72799464E-05 1.39156978E-16 5.31143541E-34 0. 0.150779307 1.642813E-05 + 1.32296766E-16 5.04960414E-34 0. 0.114371933 1.24613707E-05 + 1.00352328E-16 3.83031528E-34 0. 0.0678110197 7.38834296E-06 + 5.94987441E-17 2.27099447E-34 0. 0.0367258862 4.00146064E-06 + 3.22240582E-17 1.22994775E-34 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.166993767 2.2118129E-05 3.28110851E-17 9.4349952E-36 0. 0.158762157 + 2.10277794E-05 3.11938412E-17 8.96989577E-36 0. 0.120427169 + 1.5950327E-05 2.36616106E-17 6.80401371E-36 0. 0.0714009702 + 9.4569632E-06 1.40289551E-17 4.03410304E-36 0. 0.0386702307 + 5.12180486E-06 7.59796081E-18 2.18483049E-36 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.173057005 6.0546623E-05 2.90680261E-14 2.76955106E-28 + 0. 0.164526224 5.75618687E-05 2.76351123E-14 2.63302501E-28 0. + 0.124799304 4.36627888E-05 2.09622782E-14 1.9972487E-28 0. 0.0739934742 + 2.58877026E-05 1.24285458E-14 1.18416754E-28 0. 0.0400742777 + 1.40205539E-05 6.73120143E-15 6.41335996E-29 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.176007345 5.25416581E-05 2.68621528E-15 6.76452142E-31 + 0. 0.167331323 4.99514463E-05 2.55379947E-15 6.43107787E-31 0. + 0.12692751 3.78900368E-05 1.93715482E-15 4.87820093E-31 0. 0.0752549767 + 2.24650248E-05 1.14853845E-15 2.89228316E-31 0. 0.0407574624 + 1.21668691E-05 6.22038074E-16 1.56643932E-31 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.187213495 0.000145245052 4.39022598E-13 1.22754917E-25 + 0. 0.17798467 0.000138084986 4.17380675E-13 1.16703984E-25 0. + 0.135007873 0.000104742823 3.16599096E-13 8.8524202E-26 0. 0.0800461546 + 6.21018917E-05 1.87710619E-13 5.24859236E-26 0. 0.0433523543 + 3.36339253E-05 1.01662846E-13 2.84259371E-26 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.194914088 0.000287672388 1.48299983E-11 4.66053318E-22 + 0. 0.185305744 0.000273491431 1.40989746E-11 4.4307982E-22 0. + 0.140561223 0.000207452875 1.06945945E-11 3.36092157E-22 0. 0.0833388194 + 0.000122998943 6.34081806E-12 1.99268638E-22 0. 0.0451355577 + 6.66152555E-05 3.43413145E-12 1.07922622E-22 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.202262029 0.000480362592 1.68091777E-10 1.20023946E-19 + 0. 0.192291424 0.000456683221 1.59806265E-10 1.14106787E-19 0. + 0.14586027 0.000346411281 1.21219063E-10 8.65543828E-20 0. 0.0864806026 + 0.000205386794 7.18705373E-11 5.1318114E-20 0. 0.0468371473 + 0.000111235859 3.8924506E-11 2.77934528E-20 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0.210296884 0.000747612852 8.64325667E-10 4.33347019E-18 0. + 0.199929997 0.000710759545 8.21719526E-10 4.11984997E-18 0. 0.151654467 + 0.000539137807 6.2330513E-10 3.12505796E-18 0. 0.0899159089 + 0.000319654209 3.69557496E-10 1.85284962E-18 0. 0.0486976318 + 0.000173122389 2.00149106E-10 1.00348661E-18 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.218221456 0.00109978695 2.45977616E-09 3.4760141E-17 0. + 0.20746398 0.0010455735 2.33851938E-09 3.30466397E-17 0. 0.157368973 + 0.000793106097 1.77385984E-09 2.50671311E-17 0. 0.0933041126 + 0.000470233092 1.05171993E-09 1.48622717E-17 0. 0.0505327173 + 0.000254673621 5.69602143E-10 8.04927469E-18 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.222928807 0.00145450572 4.18654844E-09 7.82416973E-17 + 0. 0.211939722 0.00138280541 3.98018019E-09 7.43847923E-17 0. + 0.160764292 0.00104890822 3.01911252E-09 5.64236373E-17 0. 0.0953168869 + 0.000621898274 1.79002979E-09 3.34535596E-17 0. 0.0516227707 + 0.000336814555 9.69466396E-10 1.81181472E-17 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.235216916 0.00263789785 6.04339903E-08 4.61818694E-14 + 0. 0.223622128 0.00250786101 5.74549013E-08 4.39052921E-14 0. + 0.169625804 0.0019023068 4.35816929E-08 3.33038379E-14 0. 0.100571081 + 0.00112787739 2.58395723E-08 1.97458101E-14 0. 0.0544684865 + 0.000610848598 1.39944705E-08 1.06941814E-14 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.245064124 0.00375174102 9.18966094E-08 3.88880619E-14 + 0. 0.232983693 0.00356679899 8.73665797E-08 3.69711213E-14 0. + 0.176726729 0.00270554982 6.6270772E-08 2.8043931E-14 0. 0.104781047 + 0.0016041185 3.92920434E-08 1.66272483E-14 0. 0.0567486845 + 0.000868777046 2.12802007E-08 9.00517487E-15 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.252092153 0.00537635433 4.908145E-07 2.79565E-12 0. + 0.239665464 0.00511132181 4.66619611E-07 2.65783749E-12 0. 0.181795463 + 0.0038771315 3.53948167E-07 2.0160709E-12 0. 0.10778629 0.00229874719 + 2.09856111E-07 1.19532617E-12 0. 0.0583761446 0.00124498236 + 1.13656036E-07 6.47379286E-13 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.263800591 0.00754107675 6.15851889E-07 1.06373872E-12 0. 0.250796527 + 0.00716933189 5.85490852E-07 1.01129879E-12 0. 0.190238893 0.00543820066 + 4.44117575E-07 7.6710784E-13 0. 0.112792589 0.00322430767 2.63317361E-07 + 4.54818203E-13 0. 0.0610874258 0.00174625719 1.42610176E-07 + 2.46325909E-13 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.274733067 + 0.0111493906 3.13594251E-06 4.6605407E-11 0. 0.261190891 0.0105997846 + 2.9813657E-06 4.43080225E-11 0. 0.19812265 0.00804032665 2.26147813E-06 + 3.36093653E-11 0. 0.117466912 0.00476710685 1.3408295E-06 1.99269663E-11 + 0. 0.0636190623 0.00258182571 7.26181781E-07 1.07922924E-11 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0.279520571 0.0139314281 6.86204203E-06 + 6.18787688E-10 0. 0.265741736 0.0132446736 6.52378958E-06 5.88284699E-10 + 0. 0.201574743 0.0100465827 4.9485302E-06 4.46236048E-10 0. 0.119513772 + 0.00595661532 2.93398602E-06 2.64573113E-10 0. 0.0647277012 + 0.00322604645 1.58901923E-06 1.43290588E-10 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0.290507406 0.0186451208 8.82763288E-06 1.99801925E-10 0. + 0.276187181 0.0177259911 8.39246513E-06 1.89952498E-10 0. 0.209498376 + 0.0134458458 6.36599543E-06 1.44086021E-10 0. 0.1242112 0.00797201414 + 3.77440415E-06 8.54286017E-11 0. 0.0672718361 0.00431757653 + 2.04418689E-06 4.62675141E-11 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.30460158 0.0263868626 2.74886515E-05 1.80529891E-09 0. 0.289585918 + 0.0250860974 2.61335663E-05 1.7163071E-09 0. 0.219661772 0.0190287195 + 1.98232829E-05 1.30188227E-09 0. 0.130237341 0.0112821106 1.17532054E-05 + 7.71884889E-10 0. 0.0705355331 0.00611030962 6.36543564E-06 + 4.18046792E-10 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.316417217 + 0.0352868289 6.58613135E-05 9.53532098E-09 0. 0.300819039 0.0335473605 + 6.26149122E-05 9.06526942E-09 0. 0.228182688 0.0254469607 4.74957997E-05 + 6.8763808E-09 0. 0.135289043 0.0150874872 2.81601915E-05 4.07698941E-09 + 0. 0.07327158 0.00817122217 1.52513603E-05 2.20806462E-09 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0.0259586088 4.08144386E-11 0. 0. 0. + 0.0246789735 3.8802489E-11 0. 0. 0. 0.0187199544 2.94331434E-11 0. 0. + 0. 0.011099007 1.74508949E-11 0. 0. 0. 0.00601114705 9.45126703E-12 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.0270783287 + 1.44572451E-10 -5.35015754E-42 0. 0. 0.0257435162 1.37445832E-10 + -5.08671343E-42 0. 0. 0.019527413 1.04257512E-10 -3.85777467E-42 0. 0. + 0.0115777841 6.1814498E-11 -2.28691909E-42 0. 0. 0.0062704403 + 3.34781126E-11 -1.23874784E-42 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0.0272106305 2.68373546E-10 4.63059078E-41 0. 0. 0.0258693006 + 2.55144322E-10 4.40217913E-41 0. 0. 0.019622799 1.93536145E-10 + 3.33929424E-41 0. 0. 0.0116343191 1.14747448E-10 1.9798946E-41 0. 0. + 0.0063010687 6.21463714E-11 1.07227358E-41 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.0291326568 1.26384174E-08 1.8016533E-29 0. 0. + 0.0276966263 1.20153913E-08 1.71284235E-29 0. 0. 0.0210088566 + 9.11410947E-09 1.29925551E-29 0. 0. 0.0124561628 5.40375567E-09 + 7.70328118E-30 0. 0. 0.00674615102 2.92662805E-09 4.17203145E-30 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.0330035239 2.68545364E-08 + 3.38020897E-29 0. 0. 0.0313766375 2.55308485E-08 3.21359377E-29 0. 0. + 0.0238003489 1.93660643E-08 2.43763268E-29 0. 0. 0.0141112115 + 1.14821308E-08 1.44526718E-29 0. 0. 0.007642515 6.21862251E-09 + 7.82743219E-30 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.0332735218 + 1.94938856E-08 7.41190528E-30 0. 0. 0.0316333324 1.85329014E-08 + 7.04651875E-30 0. 0. 0.0239950754 1.40578829E-08 5.34505707E-30 0. 0. + 0.0142266871 8.33492031E-09 3.16908199E-30 0. 0. 0.0077050277 + 4.51411353E-09 1.71634739E-30 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0.0356143229 2.25515706E-07 2.96023431E-23 0. 0. 0.0338586681 + 2.1439908E-07 2.81430924E-23 0. 0. 0.0256830715 1.62629789E-07 + 2.13475985E-23 0. 0. 0.0152274976 9.64230935E-08 1.26569821E-23 0. 0. + 0.00824708026 5.22218642E-08 6.8549015E-24 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.0367243253 1.42208066E-07 6.23555152E-25 0. 0. + 0.0349139906 1.35198164E-07 5.92815954E-25 0. 0. 0.0264835991 + 1.02552853E-07 4.49673544E-25 0. 0. 0.0157021191 6.08036075E-08 + 2.6661169E-25 0. 0. 0.00850413274 3.29306786E-08 1.44394345E-25 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.0400546081 9.3422932E-07 + 9.61600047E-21 5.53512893E-43 0. 0.0380801111 8.88176771E-07 + 9.14198074E-21 5.25486924E-43 0. 0.0288851764 6.73714908E-07 + 6.93451842E-21 3.99370062E-43 0. 0.0171260256 3.99445952E-07 + 4.11146731E-21 2.3681944E-43 0. 0.00927532371 2.16336019E-07 + 2.22674214E-21 1.2751816E-43 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.0405706353 1.9575773E-06 7.19648539E-18 1.56704919E-35 0. 0.0385707244 + 1.86107559E-06 6.8417556E-18 1.48979918E-35 0. 0.0292573888 + 1.41169687E-06 5.18972951E-18 1.13006929E-35 0. 0.017346641 + 8.36993422E-07 3.07698656E-18 6.70017789E-36 0. 0.00939480867 + 4.53308985E-07 1.66647022E-18 3.62876017E-36 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.0426063314 1.96011365E-06 1.91415229E-19 8.63829037E-40 + 0. 0.0405060686 1.86348802E-06 1.81979502E-19 8.21247781E-40 0. + 0.0307253525 1.41352473E-06 1.38037923E-19 6.22947232E-40 0. + 0.0182170477 8.38077938E-07 8.18429882E-20 3.69345841E-40 0. + 0.00986621063 4.53896462E-07 4.43253552E-20 2.00033954E-40 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0.046183493 6.16960551E-06 4.26007975E-17 + 2.92404541E-34 0. 0.0439068787 5.86548504E-06 4.05010392E-17 + 2.77990547E-34 0. 0.0333050005 4.44918351E-06 3.07214846E-17 + 2.10866077E-34 0. 0.0197465122 2.6379214E-06 1.82147537E-17 + 1.25022411E-34 0. 0.0106945466 1.42867702E-06 9.8649717E-18 + 6.77110288E-35 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.0489171036 + 1.40638658E-05 1.75159785E-15 1.61214066E-30 0. 0.0465057082 + 1.33705771E-05 1.66525057E-15 1.53266916E-30 0. 0.0352763273 + 1.01420837E-05 1.26315493E-15 1.16258742E-30 0. 0.0209153127 + 6.01323836E-06 7.48924191E-16 6.89297709E-31 0. 0.0113275712 + 3.25671817E-06 4.05611547E-16 3.73317516E-31 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.0511929244 2.58675718E-05 2.07197693E-14 4.27526018E-28 + 0. 0.0486693643 2.4592433E-05 1.96984102E-14 4.06450855E-28 0. + 0.0369175114 1.86542511E-05 1.49419848E-14 3.08308162E-28 0. + 0.0218883362 1.10601213E-05 8.85909218E-15 1.82795801E-28 0. + 0.0118545517 5.99007808E-06 4.79802109E-15 9.90007015E-29 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0.0525881536 3.95510469E-05 8.95151805E-14 + 1.02788545E-26 0. 0.049995847 3.76013886E-05 8.51028639E-14 + 9.77214851E-27 0. 0.0379236788 2.85220594E-05 6.45536006E-14 + 7.41255692E-27 0. 0.0224848967 1.69106952E-05 3.8273736E-14 + 4.39488778E-27 0. 0.0121776396 9.15870896E-06 2.07287529E-14 + 2.38023583E-27 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.0553483628 + 8.08395416E-05 7.4835884E-12 8.57263754E-22 0. 0.0526199155 + 7.68545651E-05 7.11469295E-12 8.15003074E-22 0. 0.0399141498 + 5.82970752E-05 5.39676463E-12 6.18212192E-22 0. 0.0236650575 + 3.4564302E-05 3.1997367E-12 3.66536533E-22 0. 0.0128168343 + 1.87197293E-05 1.73295308E-12 1.98513123E-22 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.0598816313 0.000154013163 2.32684687E-11 2.60584531E-21 + 0. 0.0569298342 0.000146421211 2.2121428E-11 2.4773821E-21 0. + 0.0431834497 0.000111065754 1.67799385E-11 1.87918694E-21 0. + 0.0256034248 6.5850807E-05 9.94882909E-12 1.11416957E-21 0. 0.0138666136 + 3.56642486E-05 5.38818773E-12 6.03423511E-22 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.0614912212 0.00020023789 4.81816947E-11 1.26662897E-19 + 0. 0.0584600121 0.000190367035 4.58064385E-11 1.20418976E-19 0. + 0.0443441123 0.000144400736 3.4745911E-11 9.13423303E-20 0. 0.0262916032 + 8.5614578E-05 2.06008873E-11 5.41567522E-20 0. 0.0142393261 + 4.63683573E-05 1.11572609E-11 2.93309101E-20 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.0654310659 0.000435215246 2.39644771E-09 2.6057714E-16 + 0. 0.0622056425 0.000413760921 2.27831309E-09 2.47731911E-16 0. + 0.0471853204 0.000313853147 1.72818726E-09 1.87913862E-16 0. 0.027976146 + 0.000186083518 1.02464037E-09 1.11413923E-16 0. 0.0151516395 + 0.000100781173 5.54937096E-10 6.03408603E-17 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.0684011877 0.000597024919 1.92680449E-09 3.36709295E-17 + 0. 0.0650295168 0.000567593495 1.83182214E-09 3.20109831E-17 0. + 0.0493272766 0.000430540938 1.3895064E-09 2.42816172E-17 0. 0.0292460937 + 0.000255267747 8.23836555E-10 1.43965756E-17 0. 0.0158394556 + 0.000138250951 4.46183451E-10 7.79705326E-18 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.0735934079 0.00112738984 2.20656684E-08 5.3659677E-15 + 0. 0.0699658617 0.00107181398 2.09778506E-08 5.10146895E-15 0. + 0.0530716442 0.000813011604 1.59124767E-08 3.86964757E-15 0. + 0.0314661153 0.000482032716 9.43450829E-09 2.29431135E-15 0. 0.017041795 + 0.000261065521 5.10965759E-09 1.24258166E-15 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.0739235505 0.00143169041 7.29662801E-08 1.87804945E-13 + 0. 0.0702794418 0.00136111456 6.93693707E-08 1.78547254E-13 0. + 0.0533095784 0.00103245606 5.26192636E-08 1.3543493E-13 0. 0.0316072814 + 0.000612142612 3.11979242E-08 8.02991706E-14 0. 0.017118182 + 0.000331531191 1.68965286E-08 4.34893956E-14 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.0774421766 0.00198363862 5.91998131E-08 2.48017041E-14 + 0. 0.0736246482 0.00188585289 5.62816638E-08 2.35790289E-14 0. + 0.0558470562 0.00143049343 4.26916884E-08 1.78856089E-14 0. 0.0331116468 + 0.000848137308 2.53118841E-08 1.0604368E-14 0. 0.0179330371 + 0.000459344446 1.37087026E-08 5.74324422E-15 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.0836088136 0.00328747323 3.02903857E-07 5.37876601E-13 + 0. 0.0794872344 0.00312541751 2.87972483E-07 5.11363087E-13 0. + 0.0602941476 0.00237074262 2.18437847E-07 3.87887557E-13 0. 0.0357483402 + 0.00140561408 1.29511662E-07 2.29978092E-13 0. 0.0193610135 + 0.000761267787 7.01425833E-08 1.24554121E-13 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.0882944539 0.00491051516 1.0174324E-06 5.213871E-12 0. + 0.083941713 0.00466845091 9.67276605E-07 4.95685437E-12 0. 0.0636730641 + 0.0035411946 7.33718196E-07 3.75995545E-12 0. 0.0377516709 0.00209956989 + 4.35019729E-07 2.22927492E-12 0. 0.0204460323 0.00113711378 + 2.35603309E-07 1.20735713E-12 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.00333189475 2.66391227E-15 0. 0. 0. 0.00316764694 2.53259802E-15 0. + 0. 0. 0.00240278151 1.92106882E-15 0. 0. 0. 0.00142460549 + 1.138998E-15 0. 0. 0. 0.000771558436 6.16875831E-16 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0.00348439626 1.51915783E-14 0. 0. 0. + 0.00331263547 1.4442708E-14 0. 0. 0. 0.0025127593 1.09553336E-14 0. + 0. 0. 0.00148981297 6.49538364E-15 0. 0. 0. 0.000806868193 + 3.5178551E-15 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.0033839643 3.19449667E-14 0. 0. 0. 0.00321715069 3.0370285E-14 0. + 0. 0. 0.00244032685 2.30369956E-14 0. 0. 0. 0.00144687295 + 1.36586146E-14 0. 0. 0. 0.00078361301 7.39738945E-15 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0.00388234202 1.53817323E-11 1.96349941E-41 + 0. 0. 0.00369096873 1.46235316E-11 1.86666968E-41 0. 0. 0.00279973447 + 1.10924612E-11 1.4160121E-41 0. 0. 0.00165995769 6.57674089E-12 + 8.3951791E-42 0. 0. 0.000899020524 3.56190142E-12 4.54721352E-42 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.00475088926 2.40520538E-11 + 2.38010544E-41 0. 0. 0.00451669469 2.28664362E-11 2.26281676E-41 0. 0. + 0.00342607847 1.73450247E-11 1.71645049E-41 0. 0. 0.00203132094 + 1.02838502E-11 1.01776307E-41 0. 0. 0.00110014773 5.56964717E-12 + 5.51270816E-42 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.0044019483 + 9.91870388E-12 1.5484348E-42 0. 0. 0.00418494968 9.42975992E-12 + 1.47276469E-42 0. 0. 0.00317444094 7.15282174E-12 1.11543358E-42 0. 0. + 0.00188212504 4.2409019E-12 6.61412875E-43 0. 0. 0.00101934723 + 2.2968398E-12 3.57331108E-43 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.00529186241 5.28194988E-10 2.47903236E-33 0. 0. 0.00503098965 + 5.02156539E-10 2.35681456E-33 0. 0. 0.00381618901 3.80904502E-10 + 1.78773075E-33 0. 0. 0.00226261932 2.25837959E-10 1.05994748E-33 0. 0. + 0.00122541585 1.22312174E-10 5.74060151E-34 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.00493994774 1.65472941E-10 1.36912634E-35 0. 0. + 0.0046964325 1.57316007E-10 1.30163356E-35 0. 0. 0.00356242131 + 1.19330004E-10 9.8734028E-36 0. 0. 0.00211215625 7.07508496E-11 + 5.85390662E-36 0. 0. 0.00114392722 3.83179946E-11 3.1704397E-36 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.00604714919 3.18856652E-09 + 7.8240904E-29 0. 0. 0.00574905006 3.03139025E-09 7.43839464E-29 0. 0. + 0.00436087186 2.29941644E-09 5.64230427E-29 0. 0. 0.00258556055 + 1.36332456E-09 3.34532196E-29 0. 0. 0.00140031858 7.38364814E-10 + 1.81179603E-29 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.00625001406 + 1.63340417E-08 2.03636061E-24 0. 0. 0.0059419116 1.55288689E-08 + 1.93597688E-24 0. 0. 0.00450717518 1.17792016E-08 1.4685121E-24 0. 0. + 0.00267229718 6.9838908E-09 8.70679685E-25 0. 0. 0.00144729379 + 3.78241261E-09 4.71553686E-25 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0.00609202636 2.68908114E-08 5.86124561E-22 2.57278398E-42 0. + 0.00579172513 2.55652193E-08 5.57231805E-22 2.44666712E-42 0. + 0.00439323718 1.93921785E-08 4.2268018E-22 1.85531917E-42 0. + 0.00260475231 1.1497602E-08 2.50607932E-22 1.10001929E-42 0. + 0.00141070725 6.22700558E-09 1.357268E-22 5.95551847E-43 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0.00617823238 1.23114745E-08 2.31374922E-26 0. + 0. 0.00587367406 1.17046319E-08 2.19969164E-26 0. 0. 0.00445539877 + 8.87837182E-09 1.66855082E-26 0. 0. 0.00264160358 5.26398614E-09 + 9.89285116E-27 0. 0. 0.00143066724 2.85093127E-09 5.35787008E-27 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.00681217574 4.37152075E-08 + 6.90885406E-24 0. 0. 0.0064763655 4.15603125E-08 6.56827993E-24 0. 0. + 0.00491257152 3.15250404E-08 4.98229165E-24 0. 0. 0.00291266106 + 1.86911553E-08 2.95399241E-24 0. 0. 0.00157747022 1.0123018E-08 + 1.59985646E-24 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.00713588903 + 1.01751652E-07 2.84887612E-22 7.00649232E-45 0. 0.00678411731 + 9.67354339E-08 2.70843691E-22 7.00649232E-45 0. 0.00514600845 + 7.33775423E-08 2.05445469E-22 4.20389539E-45 0. 0.00305106165 + 4.35054801E-08 1.21808113E-22 2.80259693E-45 0. 0.00165243156 + 2.35622331E-08 6.59704938E-23 1.40129846E-45 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.00801181886 6.03976389E-07 2.69987596E-16 3.06171643E-29 + 0. 0.00761687569 5.74203398E-07 2.56679544E-16 2.91078612E-29 0. + 0.0057776738 4.35555364E-07 1.94700714E-16 2.20794522E-29 0. + 0.00342558254 2.58240107E-07 1.15437766E-16 1.30908558E-29 0. + 0.00185526791 1.39860859E-07 6.25201834E-17 7.08990258E-30 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0.00929191988 2.29222064E-06 3.98618787E-15 + 7.88801731E-28 0. 0.0088338647 2.17922457E-06 3.78968639E-15 + 7.49918409E-28 0. 0.00670080259 1.65302447E-06 2.87463331E-15 + 5.68839731E-28 0. 0.00397290802 9.80077857E-07 1.70436338E-15 + 3.37265698E-28 0. 0.00215169531 5.30801515E-07 9.23069824E-16 + 1.82659987E-28 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.0102711283 + 4.52451241E-06 7.84753664E-15 9.22405273E-28 0. 0.00976481382 + 4.30148066E-06 7.46069669E-15 8.76934933E-28 0. 0.00740697095 + 3.26282748E-06 5.65921177E-15 6.65187362E-28 0. 0.00439158874 + 1.93452911E-06 3.35534992E-15 3.9438931E-28 0. 0.00237844652 + 1.0477255E-06 1.81722978E-15 2.13597957E-28 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0.00996844284 4.99213456E-06 3.66006791E-15 8.66517109E-29 0. + 0.00947705191 4.74604349E-06 3.47964205E-15 8.23801909E-29 0. + 0.00718870061 3.60005993E-06 2.63943831E-15 6.24883197E-29 0. + 0.0042621661 2.13447242E-06 1.56492079E-15 3.70493972E-29 0. + 0.00230835681 1.15601301E-06 8.47549849E-16 2.00656547E-29 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0.0116478875 1.67276248E-05 4.55999225E-13 + 3.44998377E-24 0. 0.0110737039 1.59030296E-05 4.33519648E-13 + 3.279931E-24 0. 0.00839980505 1.20630548E-05 3.28841284E-13 + 2.48794877E-24 0. 0.00498024514 7.15216402E-06 1.94970193E-13 + 1.47510097E-24 0. 0.00269726012 3.87356022E-06 1.05594095E-13 + 7.98903105E-25 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.0116103105 + 1.88909362E-05 5.84922844E-13 1.87710604E-23 0. 0.0110379299 + 1.79597446E-05 5.56088758E-13 1.78457597E-23 0. 0.00837271009 + 1.36230819E-05 4.2181433E-13 1.35366701E-23 0. 0.00496417005 + 8.07714605E-06 2.50093511E-13 8.02586769E-24 0. 0.00268855318 + 4.3745049E-06 1.35448727E-13 4.34675414E-24 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0.0135621084 5.79270854E-05 2.92476078E-11 3.05896916E-20 0. + 0.0128935743 5.50716068E-05 2.78058149E-11 2.90816767E-20 0. + 0.00978026725 4.17738811E-05 2.1091736E-11 2.20595337E-20 0. + 0.00579870399 2.47676562E-05 1.25053266E-11 1.30790785E-20 0. + 0.00314053358 1.34139764E-05 6.77277375E-12 7.08353533E-21 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0.0131906401 8.03278162E-05 2.09986348E-10 + 3.23630134E-18 0. 0.0125403926 7.63680364E-05 1.99634725E-10 + 3.07677108E-18 0. 0.00951236114 5.7928024E-05 1.51430521E-10 + 2.33384274E-18 0. 0.00563987345 3.43454703E-05 8.9783167E-11 + 1.38373554E-18 0. 0.00305450661 1.86012367E-05 4.86257493E-11 + 7.49419173E-19 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.0137632322 + 0.000101905658 6.7734103E-11 1.14425096E-19 0. 0.0130847525 + 9.68823006E-05 6.43951073E-11 1.08784448E-19 0. 0.00992526487 + 7.34887944E-05 4.88462326E-11 8.25170434E-20 0. 0.00588470837 + 4.35714755E-05 2.89608094E-11 4.89243179E-20 0. 0.00318711018 + 2.35979514E-05 1.56849585E-11 2.64970394E-20 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.0156209646 0.000213362815 7.08834991E-10 8.48391261E-18 + 0. 0.0148509322 0.000202845011 6.73893552E-10 8.06571325E-18 0. + 0.0112649966 0.000153865243 5.11172049E-10 6.11814834E-18 0. + 0.00667900173 9.12267569E-05 3.03074288E-10 3.62743473E-18 0. + 0.00361729274 4.94076849E-05 1.64142672E-10 1.96459304E-18 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0.0169197042 0.000372116483 3.73196807E-09 + 1.79885036E-16 0. 0.0160856694 0.000353773183 3.54799812E-09 + 1.71017686E-16 0. 0.0122015756 0.000268349861 2.69128919E-09 + 1.29723228E-16 0. 0.00723428465 0.000159104879 1.59566149E-09 + 7.69131592E-17 0. 0.00391804148 8.61700391E-05 8.64197824E-10 + 4.16554094E-17 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.000229588186 + 4.99875382E-21 0. 0. 0. 0.000218270696 4.75234003E-21 0. 0. 0. + 0.000165566336 3.60482363E-21 0. 0. 0. 9.81642079E-05 2.1373E-21 0. + 0. 0. 5.31649566E-05 1.15754274E-21 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.000239255707 5.53368191E-20 0. 0. 0. 0.00022746154 + 5.26091199E-20 0. 0. 0. 0.000172537897 3.99058779E-20 0. 0. 0. + 0.000102297498 2.36601686E-20 0. 0. 0. 5.54036269E-05 1.28141384E-20 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.000217965353 + 1.35765348E-19 0. 0. 0. 0.00020722 1.2907272E-19 0. 0. 0. + 0.000157184608 9.79062088E-20 0. 0. 0. 9.31947361E-05 5.80487243E-20 + 0. 0. 0. 5.04733398E-05 3.14387376E-20 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0.000299800362 1.56525188E-15 0. 0. 0. + 0.000285021873 1.48809342E-15 0. 0. 0. 0.000216199973 1.1287741E-15 0. + 0. 0. 0.000128184591 6.69249573E-16 0. 0. 0. 6.94237679E-05 + 3.62460354E-16 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.000391744426 1.52837503E-15 0. 0. 0. 0.000372433336 1.45303589E-15 + 0. 0. 0. 0.000282504392 1.10218214E-15 0. 0. 0. 0.000167496764 + 6.53483907E-16 0. 0. 0. 9.07150315E-05 3.53921256E-16 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.000300093729 2.8812003E-16 0. 0. 0. + 0.000285300601 2.7391685E-16 0. 0. 0. 0.000216411121 2.0777611E-16 0. + 0. 0. 0.000128309941 1.23190447E-16 0. 0. 0. 6.94916453E-05 + 6.67187669E-17 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.000465132209 1.36507654E-13 0. 0. 0. 0.000442203367 1.29779081E-13 + 0. 0. 0. 0.000335427321 9.84418845E-14 0. 0. 0. 0.00019887471 + 5.8366113E-14 0. 0. 0. 0.000107708933 3.16106225E-14 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0.000320205378 7.14004661E-14 + 2.86782597E-39 0. 0. 0.000304420508 6.78807325E-14 2.72645177E-39 0. + 0. 0.00023091452 5.1490113E-14 2.06812175E-39 0. 0. 0.0001369089 + 3.05284803E-14 1.2261824E-39 0. 0. 7.41488766E-05 1.6533951E-14 + 6.64092158E-40 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.000481941883 5.30027357E-13 2.87266185E-43 0. 0. 0.000458184542 + 5.03901716E-13 2.73253201E-43 0. 0. 0.000347550027 3.82228266E-13 + 2.07392173E-43 0. 0. 0.000206062323 2.26623055E-13 1.23314265E-43 0. + 0. 0.000111601628 1.22737148E-13 6.58610278E-44 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0.000590640411 1.31771156E-11 3.57050598E-36 0. + 0. 0.00056152523 1.25275536E-11 3.39450002E-36 0. 0. 0.000425937993 + 9.50261831E-12 2.57484849E-36 0. 0. 0.000252538099 5.63410213E-12 + 1.52662791E-36 0. 0. 0.000136772564 3.05138011E-12 8.26808066E-37 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.000631015981 1.03903053E-10 + 2.84471043E-31 0. 0. 0.000599910505 9.87806781E-11 2.7044796E-31 0. 0. + 0.000455054222 7.49287229E-11 2.05145229E-31 0. 0. 0.000269801589 + 4.44253419E-11 1.21630505E-31 0. 0. 0.000146121907 2.40603839E-11 + 6.58738629E-32 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.000655027165 4.06642442E-10 6.89763239E-28 0. 0. 0.000622738793 + 3.86598475E-10 6.55760994E-28 0. 0. 0.000472370477 2.93248537E-10 + 4.9741999E-28 0. 0. 0.000280068023 1.73867101E-10 2.94920686E-28 0. 0. + 0.000151682354 9.41649467E-11 1.59726121E-28 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0.000699965458 1.21333876E-09 1.66841025E-25 0. 0. + 0.000665461237 1.15352849E-09 1.58616546E-25 0. 0. 0.000504776544 + 8.74994133E-10 1.2031672E-25 0. 0. 0.000299282256 5.18783017E-10 + 7.13355823E-26 0. 0. 0.000162088691 2.80969636E-10 3.86347278E-26 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.000779697904 3.45296458E-09 + 8.49290333E-24 0. 0. 0.000741261581 3.28273853E-09 8.07423276E-24 0. + 0. 0.000562274538 2.49008347E-09 6.12461983E-24 0. 0. 0.000333372562 + 1.47636836E-09 3.6312719E-24 0. 0. 0.00018055187 7.99589672E-10 + 1.96667362E-24 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.000889121962 8.7701979E-09 1.14142152E-22 4.34402524E-44 0. + 0.000845292758 8.33788238E-09 1.08515921E-22 4.06376555E-44 0. + 0.00064118614 6.32460351E-09 8.2313363E-23 3.08285662E-44 0. + 0.000380159239 3.74985243E-09 4.8803451E-23 1.821688E-44 0. + 0.000205890916 2.03088968E-09 2.64315135E-23 9.80908925E-45 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0.000988009153 1.62417439E-08 + 3.79355863E-22 3.97968764E-43 0. 0.000939305115 1.54411151E-08 + 3.60654357E-22 3.79751884E-43 0. 0.000712497276 1.17126584E-08 + 2.73569944E-22 2.87266185E-43 0. 0.000422439596 6.94443125E-09 + 1.62199622E-22 1.70958413E-43 0. 0.000228789824 3.76105236E-09 + 8.78459096E-23 9.24856986E-44 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.000983322854 1.84015096E-08 2.79539438E-22 1.52741533E-43 0. + 0.000934849028 1.74944041E-08 2.65759439E-22 1.4573504E-43 0. + 0.00070911611 1.32701636E-08 2.01588595E-22 1.10702579E-43 0. + 0.000420435361 7.86785748E-09 1.1952149E-22 6.58610278E-44 0. + 0.000227704164 4.26117275E-09 6.47318244E-23 3.50324616E-44 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0.00084062363 2.67161617E-08 7.97818648E-19 + 1.82298368E-32 0. 0.000799184723 2.53991548E-08 7.58489518E-19 + 1.73311904E-32 0. 0.000606211077 1.92662686E-08 5.7534258E-19 + 1.31463292E-32 0. 0.00035942276 1.14229408E-08 3.4112016E-19 + 7.79447308E-33 0. 0.000194660461 6.18657126E-09 1.84748218E-19 + 4.22142356E-33 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.00129618472 + 2.76923345E-07 3.17019782E-17 4.5802726E-32 0. 0.00123228901 + 2.63271744E-07 3.01391826E-17 4.35448305E-32 0. 0.000934736978 + 1.99701844E-07 2.28616889E-17 3.30304127E-32 0. 0.000554205035 + 1.18402504E-07 1.35547241E-17 1.9583705E-32 0. 0.000300152926 + 6.41261053E-08 7.34111213E-18 1.06063459E-32 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.00111707172 1.82609867E-07 1.76854772E-18 3.79518797E-35 + 0. 0.00106200448 1.73608456E-07 1.6813695E-18 3.60810587E-35 0. + 0.000805574004 1.31688168E-07 1.27537974E-18 2.73688404E-35 0. + 0.000477622787 7.80776617E-08 7.56169483E-19 1.62269333E-35 0. + 0.000258676271 4.22863735E-08 4.0953663E-19 8.78841233E-36 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0.00154752913 1.13698354E-06 3.40028269E-15 + 1.98091736E-27 0. 0.00147124252 1.08093593E-06 3.23266482E-15 + 1.8832704E-27 0. 0.00111599255 8.19930506E-07 2.45209834E-15 + 1.4285284E-27 0. 0.000661672384 4.86135832E-07 1.45384926E-15 + 8.46972664E-28 0. 0.000358356076 2.63287035E-07 7.87393887E-16 + 4.58714239E-28 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.00145250256 + 2.19607819E-06 9.33993822E-14 1.91541975E-24 0. 0.00138090027 + 2.08782239E-06 8.87954058E-14 1.82099646E-24 0. 0.00104746432 + 1.58369278E-06 6.73545489E-14 1.38129436E-24 0. 0.000621041399 + 9.38970061E-07 3.9934483E-14 8.1896719E-25 0. 0.000336350931 + 5.08538335E-07 2.16281901E-14 4.43547743E-25 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.00143448217 1.96396877E-06 6.36269593E-15 4.65566755E-27 + 0. 0.00136376591 1.86715954E-06 6.04904937E-15 4.42615641E-27 0. + 0.00103446888 1.41630755E-06 4.58842957E-15 3.35740049E-27 0. + 0.000613336626 8.39728273E-07 2.7204784E-15 1.99060132E-27 0. + 0.000332177675 4.54790268E-07 1.47338872E-15 1.07809418E-27 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0.00176841649 5.80141977E-06 2.04581943E-13 + 2.38117309E-24 0. 0.00168124493 5.51542189E-06 1.94497142E-13 + 2.26379118E-24 0. 0.00127528538 4.18366199E-06 1.47533339E-13 + 1.71717211E-24 0. 0.000756116584 2.48049241E-06 8.74723742E-14 + 1.01810911E-24 0. 0.000409506756 1.34341383E-06 4.73744884E-14 + 5.51398636E-25 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.0019920764 + 1.25489405E-05 1.93207798E-12 1.37922446E-22 0. 0.00189387926 + 1.19303531E-05 1.83683385E-12 1.31123955E-22 0. 0.00143657881 + 9.04961962E-06 1.39330908E-12 9.94622903E-23 0. 0.000851748104 + 5.36551443E-06 8.26092395E-13 5.89711392E-23 0. 0.000461298332 + 2.90591765E-06 4.47404673E-13 3.19382391E-23 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 6.92362619E-06 7.05339583E-29 0. 0. 0. 6.58235922E-06 + 6.70573418E-29 0. 0. 0. 4.99295584E-06 5.08653987E-29 0. 0. 0. + 2.96032249E-06 3.01580527E-29 0. 0. 0. 1.60328545E-06 1.63333815E-29 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 7.12765313E-06 + 1.95926567E-27 0. 0. 0. 6.77629441E-06 1.86268125E-27 0. 0. 0. + 5.14007661E-06 1.41291344E-27 0. 0. 0. 3.0475494E-06 8.37717607E-28 0. + 0. 0. 1.65052893E-06 4.53700561E-28 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 5.83440124E-06 5.76995322E-27 0. 0. 0. 5.54679309E-06 + 5.4855238E-27 0. 0. 0. 4.20744936E-06 4.16097164E-27 0. 0. 0. + 2.49459663E-06 2.46704018E-27 0. 0. 0. 1.35104938E-06 1.33612574E-27 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.21524326E-05 + 5.17547643E-21 0. 0. 0. 1.15533749E-05 4.92033322E-21 0. 0. 0. + 8.76368085E-06 3.73226679E-21 0. 0. 0. 5.19597916E-06 2.21285576E-21 + 0. 0. 0. 2.81409757E-06 1.19846677E-21 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 1.51918493E-05 2.36327783E-21 0. 0. 0. + 1.44429641E-05 2.24677784E-21 0. 0. 0. 1.09555231E-05 1.70426712E-21 + 0. 0. 0. 6.49552294E-06 1.01045807E-21 0. 0. 0. 3.51792301E-06 + 5.47255857E-22 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 8.39584209E-06 2.10363884E-22 0. 0. 0. 7.98199017E-06 1.99993721E-22 + 0. 0. 0. 6.05461355E-06 1.51702887E-22 0. 0. 0. 3.58978264E-06 + 8.99445257E-23 0. 0. 0. 1.94419499E-06 4.87130728E-23 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.8726485E-05 8.88936159E-19 0. 0. 0. + 1.78033752E-05 8.45113733E-19 0. 0. 0. 1.35045184E-05 6.41051326E-19 + 0. 0. 0. 8.0068121E-06 3.80079281E-19 0. 0. 0. 4.33642208E-06 + 2.05847372E-19 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.62411125E-05 1.04480177E-16 0. 0. 0. 1.54404952E-05 9.93297538E-17 + 0. 0. 0. 1.1712189E-05 7.53454402E-17 0. 0. 0. 6.94414484E-06 + 4.46722132E-17 0. 0. 0. 3.76089497E-06 2.41940916E-17 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.68571605E-05 1.03756805E-17 0. 0. + 0. 1.60262207E-05 9.86422393E-18 0. 0. 0. 1.21564726E-05 + 7.48237142E-18 0. 0. 0. 7.20757043E-06 4.4362937E-18 0. 0. 0. + 3.90355581E-06 2.40266293E-18 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 2.13792591E-05 3.57117826E-16 0. 0. 0. 2.03253385E-05 + 3.39513913E-16 0. 0. 0. 1.54175596E-05 2.57533988E-16 0. 0. 0. + 9.14104567E-06 1.52691824E-16 0. 0. 0. 4.95071663E-06 8.26965744E-17 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.73348505E-05 + 3.40574436E-15 0. 0. 0. 2.59873686E-05 3.23785946E-15 0. 0. 0. + 1.97124027E-05 2.45603513E-15 0. 0. 0. 1.1687468E-05 1.45618156E-15 0. + 0. 0. 6.32982892E-06 7.88657395E-16 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 3.332294E-05 4.60067436E-14 2.12997367E-42 0. 0. + 3.16803889E-05 4.37387519E-14 2.02487628E-42 0. 0. 2.40308E-05 + 3.31774742E-14 1.53582312E-42 0. 0. 1.42478139E-05 1.96708511E-14 + 9.10844002E-43 0. 0. 7.71649593E-06 1.06536136E-14 4.93257059E-43 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3.80843012E-05 2.9060646E-13 + 1.23991863E-38 0. 0. 3.62069695E-05 2.76281195E-13 1.17879581E-38 0. + 0. 2.74643498E-05 2.09570276E-13 8.94161403E-39 0. 0. 1.62836022E-05 + 1.2425377E-13 5.30147222E-39 0. 0. 8.81906453E-06 6.72948703E-14 + 2.87124094E-39 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 4.14943388E-05 1.03449985E-12 3.8883106E-36 0. 0. 3.94488197E-05 + 9.8350386E-13 3.69663091E-36 0. 0. 2.9923367E-05 7.46023523E-13 + 2.80403993E-36 0. 0. 1.77415786E-05 4.42316783E-13 1.66251144E-36 0. + 0. 9.60868056E-06 2.39554904E-13 9.00402288E-37 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 4.26635961E-05 2.2265809E-12 1.10310456E-34 0. 0. + 4.05604551E-05 2.11682104E-12 1.04872842E-34 0. 0. 3.07666814E-05 + 1.60568824E-12 7.95498124E-35 0. 0. 1.82415424E-05 9.52011473E-13 + 4.71650492E-35 0. 0. 9.87945896E-06 5.15600746E-13 2.55442384E-35 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.28250751E-05 1.24795582E-11 + 4.86434564E-29 0. 0. 4.07140433E-05 1.18643845E-11 4.62455713E-29 0. + 0. 3.08831186E-05 8.99957626E-12 3.50789241E-29 0. 0. 1.83105749E-05 + 5.33584548E-12 2.0798283E-29 0. 0. 9.9168592E-06 2.88984982E-12 + 1.12641917E-29 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 4.51154629E-05 3.46969502E-11 5.37561233E-29 0. 0. 4.28915118E-05 + 3.29866863E-11 5.11062242E-29 0. 0. 3.25348155E-05 2.50215629E-11 + 3.87660177E-29 0. 0. 1.92898751E-05 1.4835284E-11 2.29842887E-29 0. 0. + 1.04472401E-05 8.03466495E-12 1.2448115E-29 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 5.12656079E-05 2.93946312E-10 9.74265207E-25 0. 0. + 4.8738435E-05 2.79456208E-10 9.26238764E-25 0. 0. 3.69699155E-05 + 2.11977824E-10 7.02587034E-25 0. 0. 2.19194499E-05 1.25681535E-10 + 4.16562241E-25 0. 0. 1.18714015E-05 6.80681206E-11 2.2560707E-25 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 7.26384678E-05 7.11461001E-10 + 3.374758E-23 4.27396032E-43 0. 6.90578745E-05 6.76389222E-10 + 3.20839764E-23 4.06376555E-43 0. 5.23830095E-05 5.13066367E-10 + 2.43368038E-23 3.08285662E-43 0. 3.10577889E-05 3.04196723E-10 + 1.4429312E-23 1.821688E-43 0. 1.68206552E-05 1.64750297E-10 + 7.8148048E-24 9.9492191E-44 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 5.03313786E-05 4.63734717E-10 9.46730806E-25 0. 0. 4.78503061E-05 + 4.40875447E-10 9.0006357E-25 0. 0. 3.62962455E-05 3.34419659E-10 + 6.82732095E-25 0. 0. 2.15200525E-05 1.98277256E-10 4.04791179E-25 0. + 0. 1.16550655E-05 1.07385448E-10 2.19231225E-25 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 9.3594972E-05 5.25462163E-09 1.26754665E-21 + 6.83385235E-41 0. 8.89810835E-05 4.99559905E-09 1.20506079E-21 + 6.49712033E-41 0. 6.7495479E-05 3.78933684E-09 9.14083145E-22 + 4.92822657E-41 0. 4.00180325E-05 2.24669883E-09 5.41960619E-22 + 2.92198756E-41 0. 2.16734843E-05 1.21679522E-09 2.93520956E-22 + 1.58248636E-41 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 9.00309969E-05 + 2.27950103E-08 2.90881785E-18 6.29988565E-33 0. 8.55929029E-05 + 2.16713403E-08 2.76544098E-18 5.98931306E-33 0. 6.4925378E-05 + 1.64385234E-08 2.09768826E-18 4.54312624E-33 0. 3.8494265E-05 + 9.7463797E-09 1.24371899E-18 2.69362271E-33 0. 2.08481706E-05 + 5.27854827E-09 6.73587131E-19 1.45884157E-33 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 7.36912043E-05 1.01771258E-08 1.5094261E-20 1.37631429E-38 + 0. 7.00586243E-05 9.67544089E-09 1.435017E-20 1.30846622E-38 0. + 5.31420737E-05 7.33919014E-09 1.08851952E-20 9.92521345E-39 0. + 3.15079196E-05 4.35139835E-09 6.4538045E-21 5.8846464E-39 0. + 1.7064418E-05 2.35668129E-09 3.49532398E-21 3.18707539E-39 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0.000103610371 4.91557977E-08 3.49680926E-18 + 2.60027873E-33 0. 9.85031511E-05 4.67327261E-08 3.32443661E-18 + 2.47209639E-33 0. 7.4718293E-05 3.54484833E-08 2.52171262E-18 + 1.87517669E-33 0. 4.43003955E-05 2.10173905E-08 1.49512317E-18 + 1.11179009E-33 0. 2.39927376E-05 1.13828635E-08 8.09746851E-19 + 6.02136879E-34 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.000123899139 + 1.42730229E-07 6.95911152E-17 5.53226104E-31 0. 0.000117791242 + 1.35694251E-07 6.61603141E-17 5.2595487E-31 0. 8.93491742E-05 + 1.02929533E-07 5.01852364E-17 3.98956341E-31 0. 5.29751451E-05 + 6.10264692E-08 2.97547686E-17 2.3654092E-31 0. 2.86908908E-05 + 3.30515668E-08 1.6114954E-17 1.28108548E-31 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 6.91225566E-08 1.16528337E-39 0. 0. 0. 6.57150494E-08 + 1.10784415E-39 0. 0. 0. 4.98472268E-08 8.4033767E-40 0. 0. 0. + 2.95544105E-08 4.98237274E-40 0. 0. 0. 1.60064264E-08 2.69841039E-40 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 6.95272249E-08 + 1.14841342E-37 0. 0. 0. 6.60999788E-08 1.09180118E-37 0. 0. 0. + 5.01392634E-08 8.28169915E-38 0. 0. 0. 2.97275484E-08 4.91021652E-38 + 0. 0. 0. 1.61001825E-08 2.65934191E-38 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 4.82280171E-08 4.17084134E-37 0. 0. 0. + 4.58506193E-08 3.96524059E-37 0. 0. 0. 3.47793652E-08 3.00778267E-37 + 0. 0. 0. 2.06206998E-08 1.78331171E-37 0. 0. 0. 1.11679732E-08 + 9.6582546E-38 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 2.16519112E-07 1.50754911E-28 0. 0. 0. 2.05845652E-07 1.43323843E-28 + 0. 0. 0. 1.56141766E-07 1.08716194E-28 0. 0. 0. 9.25762507E-08 + 6.44578238E-29 0. 0. 0. 5.01385919E-08 3.49098515E-29 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.14565745E-07 3.12765215E-29 0. 0. + 0. 2.03988535E-07 2.9734628E-29 0. 0. 0. 1.54733073E-07 2.25548891E-29 + 0. 0. 0. 9.17411782E-08 1.33727818E-29 0. 0. 0. 4.96861965E-08 + 7.24258745E-30 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 6.66081803E-08 6.26014736E-31 0. 0. 0. 6.33246984E-08 5.95154812E-31 + 0. 0. 0. 4.80342024E-08 4.51447289E-31 0. 0. 0. 2.84794357E-08 + 2.67662814E-31 0. 0. 0. 1.54242397E-08 1.44964385E-31 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.85373858E-07 7.04053982E-26 0. 0. + 0. 2.71306504E-07 6.6934854E-26 0. 0. 0. 2.05796169E-07 5.07726255E-26 + 0. 0. 0. 1.22016246E-07 3.01030431E-26 0. 0. 0. 6.60831603E-08 + 1.63035239E-26 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 3.93062606E-07 3.14905751E-22 0. 0. 0. 3.73686362E-07 2.99381574E-22 + 0. 0. 0. 2.83455222E-07 2.2709291E-22 0. 0. 0. 1.68060168E-07 + 1.3464288E-22 0. 0. 0. 9.102002E-08 7.29214438E-23 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 1.39312633E-07 1.19350846E-25 0. 0. 0. + 1.32445464E-07 1.13467472E-25 0. 0. 0. 1.00464803E-07 8.60691066E-26 + 0. 0. 0. 5.9565437E-08 5.10304351E-26 0. 0. 0. 3.22601217E-08 + 2.76376617E-26 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 3.23085658E-07 1.93945303E-22 0. 0. 0. 3.07157904E-07 1.84384751E-22 + 0. 0. 0. 2.32990729E-07 1.39862615E-22 0. 0. 0. 1.38140081E-07 + 8.29245598E-23 0. 0. 0. 7.48155955E-08 4.4911123E-23 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 4.271308E-07 2.51406861E-20 0. 0. 0. + 4.0607506E-07 2.39013773E-20 0. 0. 0. 3.08023033E-07 1.81300784E-20 0. + 0. 0. 1.82626906E-07 1.07493316E-20 0. 0. 0. 9.89090765E-08 + 5.82174643E-21 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 3.27039658E-07 9.72231337E-21 0. 0. 0. 3.1091804E-07 9.24301795E-21 0. + 0. 0. 2.35843103E-07 7.01117318E-21 0. 0. 0. 1.39831272E-07 + 4.15692791E-21 0. 0. 0. 7.57314638E-08 2.25135561E-21 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.1955218E-07 1.65717648E-19 0. 0. 0. + 3.98870554E-07 1.57548645E-19 0. 0. 0. 3.02558362E-07 1.19506609E-19 + 0. 0. 0. 1.79386802E-07 7.08555287E-20 0. 0. 0. 9.71541425E-08 + 3.83746179E-20 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 4.40747897E-07 9.74572514E-19 0. 0. 0. 4.19021376E-07 9.26531311E-19 + 0. 0. 0. 3.17843273E-07 7.02807132E-19 0. 0. 0. 1.88448936E-07 + 4.16693836E-19 0. 0. 0. 1.02062373E-07 2.25677722E-19 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 8.13367365E-07 6.33996008E-16 + 7.00649232E-44 0. 0. 7.73272063E-07 6.02742769E-16 6.72623263E-44 0. + 0. 5.86556325E-07 4.57202921E-16 5.04467447E-44 0. 0. 3.47768776E-07 + 2.71075292E-16 2.94272678E-44 0. 0. 1.8834875E-07 1.46812078E-16 + 1.68155816E-44 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 8.62921354E-07 8.99448722E-16 1.33123354E-43 0. 0. 8.20382468E-07 + 8.55110359E-16 1.26116862E-43 0. 0. 6.22291793E-07 6.48633585E-16 + 9.52882956E-44 0. 0. 3.6895625E-07 3.84573684E-16 5.7453237E-44 0. 0. + 1.99823603E-07 2.08282067E-16 3.08285662E-44 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 5.54076962E-07 3.82034041E-16 1.12103877E-44 0. 0. + 5.26763699E-07 3.6320156E-16 1.12103877E-44 0. 0. 3.99569785E-07 + 2.75502204E-16 8.40779079E-45 0. 0. 2.36904413E-07 1.63345328E-16 + 4.20389539E-45 0. 0. 1.28305771E-07 8.84664239E-17 2.80259693E-45 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.62278764E-06 4.17886673E-13 + 5.68546004E-32 0. 0. 1.54279144E-06 3.97286669E-13 5.40520044E-32 0. + 0. 1.17026514E-06 3.01357355E-13 4.10005171E-32 0. 0. 6.93849302E-07 + 1.78673469E-13 2.43091233E-32 0. 0. 3.75782861E-07 9.67684252E-14 + 1.31656308E-32 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.78500989E-06 2.89822989E-13 8.85514772E-34 0. 0. 1.69701639E-06 + 2.75535562E-13 8.41863065E-34 0. 0. 1.28724901E-06 2.09004268E-13 + 6.38584092E-34 0. 0. 7.63210323E-07 1.23918508E-13 3.78615963E-34 0. + 0. 4.13347749E-07 6.71132868E-14 2.05055507E-34 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 7.69981398E-07 1.24552536E-13 2.71531297E-33 0. + 0. 7.32025796E-07 1.18413024E-13 2.58146421E-33 0. 0. 5.55269594E-07 + 8.98206612E-14 1.958135E-33 0. 0. 3.29217983E-07 5.32546216E-14 + 1.16097231E-33 0. 0. 1.78302344E-07 2.88422511E-14 6.28775051E-34 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.46994182E-06 5.7889713E-12 + 6.42094571E-29 0. 0. 2.34818913E-06 5.50361189E-12 6.10443778E-29 0. + 0. 1.78118955E-06 4.17468707E-12 4.63044024E-29 0. 0. 1.0560658E-06 + 2.47517675E-12 2.74538274E-29 0. 0. 5.71956662E-07 1.3405337E-12 + 1.48687765E-29 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 2.79063079E-06 5.6765339E-11 2.29982201E-24 1.54142831E-44 0. + 2.6530663E-06 5.39670218E-11 2.18645205E-24 1.40129846E-44 0. + 2.01245007E-06 4.09359976E-11 1.65851063E-24 1.12103877E-44 0. + 1.19318111E-06 2.42709845E-11 9.83326557E-25 7.00649232E-45 0. + 6.46217131E-07 1.31449313E-11 5.32561526E-25 4.20389539E-45 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 1.47886215E-06 9.68644435E-12 + 7.48487828E-28 0. 0. 1.40595841E-06 9.20892963E-12 7.11592548E-28 0. + 0. 1.06647133E-06 6.98534329E-12 5.39769071E-28 0. 0. 6.32311867E-07 + 4.14159766E-12 3.20028794E-28 0. 0. 3.42454825E-07 2.24305383E-12 + 1.73325113E-28 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 2.53349299E-06 8.72914172E-11 1.3013442E-24 1.40129846E-45 0. + 2.40860504E-06 8.29883662E-11 1.23719422E-24 1.40129846E-45 0. + 1.82701797E-06 6.29498953E-11 9.38458712E-25 1.40129846E-45 0. + 1.08323934E-06 3.73229052E-11 5.56412045E-25 0. 0. 5.8667257E-07 + 2.02137682E-11 3.01348465E-25 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 3.30815033E-06 3.76446818E-10 6.6324017E-23 1.55684259E-42 0. + 3.1450752E-06 3.57889829E-10 6.30547439E-23 1.47977118E-42 0. + 2.38565622E-06 2.71473038E-10 4.78294571E-23 1.12244007E-42 0. + 1.41445321E-06 1.60956221E-10 2.83580192E-23 6.65616771E-43 0. + 7.66059259E-07 8.71722278E-11 1.53584955E-23 3.61535004E-43 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 1.5696415E-10 0. 0. 0. 0. 1.4922627E-10 + 0. 0. 0. 0. 1.13193885E-10 0. 0. 0. 0. 6.71127667E-11 0. 0. 0. + 0. 3.63475708E-11 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.52192509E-10 0. 0. 0. 0. 1.44689871E-10 0. 0. 0. 0. + 1.09752527E-10 0. 0. 0. 0. 6.50723087E-11 0. 0. 0. 0. + 3.52426109E-11 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 8.35297942E-11 0. 0. 0. 0. 7.94120672E-11 0. 0. 0. 0. 6.0237218E-11 + 0. 0. 0. 0. 3.57145979E-11 0. 0. 0. 0. 1.93427323E-11 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.19363386E-09 6.1053383E-39 0. + 0. 0. 1.13479137E-09 5.80437722E-39 0. 0. 0. 8.60780558E-10 + 4.40283353E-39 0. 0. 0. 5.10356091E-10 2.61044248E-39 0. 0. 0. + 2.76404843E-10 1.41379104E-39 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 7.45675188E-10 4.79993769E-40 0. 0. 0. 7.08917314E-10 + 4.56332845E-40 0. 0. 0. 5.37739298E-10 3.46145944E-40 0. 0. 0. + 3.18826077E-10 2.05229969E-40 0. 0. 0. 1.72673556E-10 1.11150994E-40 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.36932501E-10 + 2.08667375E-34 0. 0. 0. 2.2525283E-10 1.98381064E-34 0. 0. 0. + 1.70862741E-10 1.50479337E-34 0. 0. 0. 1.01304409E-10 8.92192808E-35 + 0. 0. 0. 5.48656363E-11 4.8320377E-35 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 1.01597253E-09 2.95709064E-35 0. 0. 0. 9.65889813E-10 + 2.81132388E-35 0. 0. 0. 7.3266293E-10 2.13249225E-35 0. 0. 0. + 4.34395631E-10 1.26435696E-35 0. 0. 0. 2.3526503E-10 6.84763628E-36 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.35939246E-09 + 2.27909382E-31 0. 0. 0. 2.24309171E-09 2.16674078E-31 0. 0. 0. + 1.70147008E-09 1.64355739E-31 0. 0. 0. 1.00879838E-09 9.7446354E-32 0. + 0. 0. 5.46356516E-10 5.27761816E-32 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 1.94112326E-09 1.13514561E-27 0. 0. 0. 1.84543514E-09 + 1.07918897E-27 0. 0. 0. 1.39983225E-09 8.18603138E-28 0. 0. 0. + 8.29959101E-10 4.85350428E-28 0. 0. 0. 4.49498688E-10 2.62861728E-28 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.00127959E-10 + 3.16834482E-33 0. 0. 0. 3.80403764E-10 3.01216313E-33 0. 0. 0. + 2.88550572E-10 2.28483629E-33 0. 0. 0. 1.71081233E-10 1.35467679E-33 + 0. 0. 0. 9.26560773E-11 7.33682962E-34 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 1.13719845E-09 1.1361962E-29 0. 0. 0. 1.08114051E-09 + 1.08019008E-29 0. 0. 0. 8.20085722E-10 8.19364325E-30 0. 0. 0. + 4.86230278E-10 4.85800105E-30 0. 0. 0. 2.6333738E-10 2.63105108E-30 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.738658E-09 3.17786048E-27 + 0. 0. 0. 1.65295044E-09 3.02120245E-27 0. 0. 0. 1.2538246E-09 + 2.29170217E-27 0. 0. 0. 7.43392514E-10 1.35874502E-27 0. 0. 0. + 4.02614164E-10 7.35885458E-28 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 3.57470653E-09 6.53982654E-22 0. 0. 0. 3.3984926E-09 + 6.21744724E-22 0. 0. 0. 2.57788391E-09 4.71616895E-22 0. 0. 0. + 1.52842594E-09 2.79621858E-22 0. 0. 0. 8.27781732E-10 1.51440304E-22 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.95565084E-09 + 1.66003818E-23 0. 0. 0. 2.80996382E-09 1.57820586E-23 0. 0. 0. + 2.13146389E-09 1.19712798E-23 0. 0. 0. 1.26374089E-09 7.09776416E-24 + 0. 0. 0. 6.84432122E-10 3.84409316E-24 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 2.89844637E-09 3.72355095E-23 0. 0. 0. + 2.75556666E-09 3.54000006E-23 0. 0. 0. 2.09020268E-09 2.68522288E-23 + 0. 0. 0. 1.2392789E-09 1.59206709E-23 0. 0. 0. 6.71184663E-10 + 8.62251238E-24 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.62201574E-09 2.14048256E-23 0. 0. 0. 1.5420627E-09 2.03497178E-23 0. + 0. 0. 1.16970666E-09 1.54360405E-23 0. 0. 0. 6.93519853E-10 + 9.15201239E-24 0. 0. 0. 3.75604714E-10 4.95665051E-24 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 8.60378702E-09 3.64134956E-18 0. 0. + 0. 8.17966317E-09 3.46184826E-18 0. 0. 0. 6.20457818E-09 + 2.62594358E-18 0. 0. 0. 3.6786878E-09 1.55692276E-18 0. 0. 0. + 1.99234917E-09 8.43215922E-19 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 1.57623674E-08 3.60751746E-18 0. 0. 0. 1.49854262E-08 + 3.42968583E-18 0. 0. 0. 1.13669882E-08 2.60153535E-18 0. 0. 0. + 6.73947831E-09 1.54244896E-18 0. 0. 0. 3.65005182E-09 8.3537973E-19 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.24814097E-08 + 1.58718026E-17 1.12103877E-44 0. 0. 1.18661427E-08 1.50893907E-17 + 1.12103877E-44 0. 0. 9.00090846E-09 1.14458843E-17 8.40779079E-45 0. + 0. 5.33662847E-09 6.78624889E-18 4.20389539E-45 0. 0. 2.89027424E-09 + 3.67536943E-18 2.80259693E-45 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 4.42939463E-09 5.76687758E-17 6.75567391E-40 0. 0. 4.21104884E-09 + 5.48261762E-17 6.42264132E-40 0. 0. 3.1942422E-09 4.15876402E-17 + 4.87181029E-40 0. 0. 1.89385863E-09 2.46572945E-17 2.88851054E-40 0. + 0. 1.02570108E-09 1.33541982E-17 1.56438158E-40 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 2.04607407E-08 6.70535369E-16 9.82991255E-39 0. + 0. 1.94521554E-08 6.3748139E-16 9.34535755E-39 0. 0. 1.47552006E-08 + 4.83554275E-16 7.08879198E-39 0. 0. 8.74834427E-09 2.86698577E-16 + 4.20293971E-39 0. 0. 4.73803885E-09 1.55273527E-16 2.27628184E-39 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3.42362085E-08 1.57787788E-14 + 6.6618255E-33 0. 0. 3.25484706E-08 1.5000967E-14 6.33341883E-33 0. 0. + 2.46892888E-08 1.13787628E-14 4.80414623E-33 0. 0. 1.46382835E-08 + 6.74646623E-15 2.84837636E-33 0. 0. 7.9279534E-09 3.65382739E-15 + 1.5426545E-33 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 8.54860893E-09 + 9.38693559E-16 1.0090155E-37 0. 0. 8.12719581E-09 8.92418773E-16 + 9.59275231E-38 0. 0. 6.16477491E-09 6.7693465E-16 7.2764435E-38 0. 0. + 3.65509378E-09 4.01354333E-16 4.31420813E-38 0. 0. 1.97956362E-09 + 2.17370121E-16 2.33653683E-38 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 1.93287377E-08 1.91443625E-14 2.65427635E-33 0. 0. 1.83759283E-08 + 1.82006797E-14 2.52343887E-33 0. 0. 1.39388288E-08 1.38058756E-14 + 1.91412137E-33 0. 0. 8.264327E-09 8.1854977E-15 1.13488231E-33 0. 0. + 4.47588588E-09 4.43320273E-15 6.14643588E-34 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 2.85984658E-08 1.39388325E-13 4.44254063E-31 0. 0. + 2.71886993E-08 1.32517505E-13 4.22355026E-31 0. 0. 2.06236326E-08 + 1.00519331E-13 3.20371887E-31 0. 0. 1.22277326E-08 5.95976041E-14 + 1.89948144E-31 0. 0. 6.6224155E-09 3.22776948E-14 1.02874611E-31 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.91449126E-14 0. 0. 0. 0. + 4.67222865E-14 0. 0. 0. 0. 3.54405836E-14 0. 0. 0. 0. + 2.10127326E-14 0. 0. 0. 0. 1.13802959E-14 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 4.51374981E-14 0. 0. 0. 0. 4.29124272E-14 + 0. 0. 0. 0. 3.25506969E-14 0. 0. 0. 0. 1.92992679E-14 0. 0. 0. + 0. 1.04523501E-14 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.79435053E-14 0. 0. 0. 0. 1.70589742E-14 0. 0. 0. 0. + 1.29399004E-14 0. 0. 0. 0. 7.67204497E-15 0. 0. 0. 0. + 4.15511843E-15 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.27294356E-12 0. 0. 0. 0. 1.21019937E-12 0. 0. 0. 0. + 9.17981186E-13 0. 0. 0. 0. 5.44269057E-13 0. 0. 0. 0. + 2.94771667E-13 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 3.65258361E-13 0. 0. 0. 0. 3.47253151E-13 0. 0. 0. 0. + 2.63404099E-13 0. 0. 0. 0. 1.56172371E-13 0. 0. 0. 0. + 8.45817286E-14 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.42043311E-12 2.80259693E-45 0. 0. 0. 1.35041403E-12 2.80259693E-45 + 0. 0. 0. 1.02433893E-12 1.40129846E-45 0. 0. 0. 6.07329779E-13 + 1.40129846E-45 0. 0. 0. 3.28924388E-13 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 3.10707785E-13 0. 0. 0. 0. 2.95391451E-13 0. + 0. 0. 0. 2.24065246E-13 0. 0. 0. 0. 1.32847997E-13 0. 0. 0. 0. + 7.19495671E-14 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 3.07600234E-12 3.54948901E-42 0. 0. 0. 2.9243693E-12 3.3743267E-42 0. + 0. 0. 2.21824577E-12 2.558771E-42 0. 0. 0. 1.31519752E-12 + 1.51760624E-42 0. 0. 0. 7.12299143E-13 8.211609E-43 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 3.47692491E-12 1.69346359E-39 0. 0. 0. + 3.30553098E-12 1.60998263E-39 0. 0. 0. 2.50736628E-12 1.22123301E-39 + 0. 0. 0. 1.4866179E-12 7.24069133E-40 0. 0. 0. 8.05135472E-13 + 3.92150573E-40 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 6.53182716E-12 4.73693344E-35 0. 0. 0. 6.20984254E-12 4.50342906E-35 + 0. 0. 0. 4.71039874E-12 3.41601614E-35 0. 0. 0. 2.79278944E-12 + 2.02535209E-35 0. 0. 0. 1.51254996E-12 1.09691574E-35 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.45528879E-12 1.22023115E-35 0. 0. + 0. 2.33425518E-12 1.16007704E-35 0. 0. 0. 1.77061772E-12 + 8.79962415E-36 0. 0. 0. 1.04979653E-12 5.21730834E-36 0. 0. 0. + 5.68562612E-13 2.82564549E-36 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 8.41415739E-12 9.7099955E-33 0. 0. 0. 7.99940236E-12 + 9.23132758E-33 0. 0. 0. 6.06783287E-12 7.00233242E-33 0. 0. 0. + 3.59761613E-12 4.15166568E-33 0. 0. 0. 1.94843555E-12 2.24850488E-33 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.51909752E-11 + 8.3386118E-31 0. 0. 0. 1.44421003E-11 7.92755835E-31 0. 0. 0. + 1.09549123E-11 6.01336736E-31 0. 0. 0. 6.49516075E-12 3.56532209E-31 + 0. 0. 0. 3.51771737E-12 1.93094613E-31 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 1.29577963E-11 9.25671521E-30 0. 0. 0. + 1.23190061E-11 8.8004308E-30 0. 0. 0. 9.34442801E-12 6.67541914E-30 0. + 0. 0. 5.54031343E-12 3.9578639E-30 0. 0. 0. 3.00058741E-12 + 2.1435463E-30 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 5.98911459E-12 1.85604081E-29 0. 0. 0. 5.69392016E-12 1.7645483E-29 0. + 0. 0. 4.31903688E-12 1.33847437E-29 0. 0. 0. 2.56075217E-12 + 7.93579584E-30 0. 0. 0. 1.38688334E-12 4.29796959E-30 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.70826174E-11 3.200847E-25 0. 0. 0. + 2.57476384E-11 3.04306767E-25 0. 0. 0. 1.95304658E-11 2.30828318E-25 + 0. 0. 0. 1.15796253E-11 1.36857876E-25 0. 0. 0. 6.27142956E-12 + 7.41210379E-26 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 2.48740525E-11 1.50897751E-25 0. 0. 0. 2.36479083E-11 1.43459828E-25 + 0. 0. 0. 1.79378457E-11 1.08819565E-25 0. 0. 0. 1.06352861E-11 + 6.45188997E-26 0. 0. 0. 5.76000402E-12 3.49428927E-26 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.17644808E-11 1.61380762E-23 0. 0. + 0. 3.97057491E-11 1.53425794E-23 0. 0. 0. 3.01182447E-11 + 1.16378867E-23 0. 0. 0. 1.78571029E-11 6.9000985E-24 0. 0. 0. + 9.67123083E-12 3.73704197E-24 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 1.00936958E-11 3.89737075E-25 0. 0. 0. 9.59615807E-12 + 3.70524664E-25 0. 0. 0. 7.27904889E-12 2.81056842E-25 0. 0. 0. + 4.31573527E-12 1.66638448E-25 0. 0. 0. 2.33736489E-12 9.02501002E-26 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.2173199E-11 + 6.44224013E-21 0. 0. 0. 4.00942959E-11 6.12467426E-21 0. 0. 0. + 3.04130471E-11 4.64579488E-21 0. 0. 0. 1.80318243E-11 2.75448761E-21 + 0. 0. 0. 9.7659077E-12 1.49181024E-21 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 3.31197951E-11 3.11750196E-21 0. 0. 0. 3.14871809E-11 + 2.96382428E-21 0. 0. 0. 2.38842262E-11 2.24817048E-21 0. 0. 0. + 1.41609051E-11 1.33293714E-21 0. 0. 0. 7.66944321E-12 7.21909258E-22 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.16309122E-10 + 3.05548834E-19 0. 0. 0. 1.10575646E-10 2.90486237E-19 0. 0. 0. + 8.3876045E-11 2.20344811E-19 0. 0. 0. 4.97299042E-11 1.3064245E-19 0. + 0. 0. 2.6933282E-11 7.07548259E-20 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 9.44984715E-12 4.3230967E-21 0. 0. 0. 8.98399671E-12 + 4.10998783E-21 0. 0. 0. 6.81471719E-12 3.11757244E-21 0. 0. 0. + 4.04043639E-12 1.84840798E-21 0. 0. 0. 2.18826433E-12 1.00108211E-21 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3.11996852E-11 + 2.55608994E-19 4.20389539E-45 0. 0. 2.96616898E-11 2.43008552E-19 + 4.20389539E-45 0. 0. 2.24995092E-11 1.84331461E-19 2.80259693E-45 0. + 0. 1.33399194E-11 1.09289739E-19 1.40129846E-45 0. 0. 7.22480019E-12 + 5.91904145E-20 1.40129846E-45 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 5.48880698E-11 3.69462413E-18 3.38273449E-42 0. 0. 5.2182203E-11 + 3.51250046E-18 3.21597998E-42 0. 0. 3.95821674E-11 2.66436261E-18 + 2.43966063E-42 0. 0. 2.34682135E-11 1.57970104E-18 1.44614002E-42 0. + 0. 1.27102114E-11 8.555542E-19 7.83325842E-43 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 1.08628956E-18 0. 0. 0. 0. 1.03274595E-18 0. 0. + 0. 0. 7.83372145E-19 0. 0. 0. 0. 4.64462276E-19 0. 0. 0. 0. + 2.51548804E-19 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 9.23201392E-19 0. 0. 0. 0. 8.7769219E-19 0. 0. 0. 0. 6.65761434E-19 + 0. 0. 0. 0. 3.94731183E-19 0. 0. 0. 0. 2.13783136E-19 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.36376502E-19 0. 0. 0. 0. + 2.24724577E-19 0. 0. 0. 0. 1.70462111E-19 0. 0. 0. 0. 1.0106673E-19 + 0. 0. 0. 0. 5.47368547E-20 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 1.46388615E-16 0. 0. 0. 0. 1.39172688E-16 0. 0. 0. 0. + 1.05567351E-16 0. 0. 0. 0. 6.25907916E-17 0. 0. 0. 0. + 3.38987251E-17 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.16568492E-17 0. 0. 0. 0. 1.10822358E-17 0. 0. 0. 0. + 8.40627261E-18 0. 0. 0. 0. 4.98408124E-18 0. 0. 0. 0. + 2.69933891E-18 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 3.67809605E-16 0. 0. 0. 0. 3.49678335E-16 0. 0. 0. 0. + 2.65243868E-16 0. 0. 0. 0. 1.57263221E-16 0. 0. 0. 0. + 8.51725047E-17 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.59545769E-17 0. 0. 0. 0. 1.51680953E-17 0. 0. 0. 0. + 1.15055662E-17 0. 0. 0. 0. 6.82163402E-18 0. 0. 0. 0. + 3.69453438E-18 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 8.32624454E-17 0. 0. 0. 0. 7.91579024E-17 0. 0. 0. 0. + 6.00441672E-17 0. 0. 0. 0. 3.56002488E-17 0. 0. 0. 0. + 1.92807843E-17 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.10596806E-15 0. 0. 0. 0. 1.05145228E-15 0. 0. 0. 0. + 7.97563576E-16 0. 0. 0. 0. 4.72875995E-16 0. 0. 0. 0. 2.5610552E-16 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 6.02446996E-16 0. + 0. 0. 0. 5.72749173E-16 0. 0. 0. 0. 4.34451722E-16 0. 0. 0. 0. + 2.57586531E-16 0. 0. 0. 0. 1.39506393E-16 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 2.76305853E-15 0. 0. 0. 0. 2.6268533E-15 0. + 0. 0. 0. 1.99256475E-15 0. 0. 0. 0. 1.18139306E-15 0. 0. 0. 0. + 6.39830848E-16 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.88405327E-16 0. 0. 0. 0. 1.79117875E-16 0. 0. 0. 0. + 1.35867685E-16 0. 0. 0. 0. 8.05559038E-17 0. 0. 0. 0. 4.3628351E-17 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3.82414147E-16 0. + 0. 0. 0. 3.63561708E-16 0. 0. 0. 0. 2.75775822E-16 0. 0. 0. 0. + 1.63507349E-16 0. 0. 0. 0. 8.85542506E-17 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 3.48383089E-16 1.821688E-44 0. 0. 0. + 3.31211561E-16 1.68155816E-44 0. 0. 0. 2.51235716E-16 1.26116862E-44 + 0. 0. 0. 1.48957401E-16 7.00649232E-45 0. 0. 0. 8.06740252E-17 + 4.20389539E-45 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.06427504E-14 2.30999169E-36 0. 0. 0. 1.01181228E-14 2.19612141E-36 + 0. 0. 0. 7.67497146E-15 1.66584173E-36 0. 0. 0. 4.55047868E-15 + 9.87675246E-37 0. 0. 0. 2.46450165E-15 5.34916385E-37 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.49479304E-15 1.02158111E-36 0. 0. + 0. 4.27321896E-15 9.71222433E-37 0. 0. 0. 3.24139985E-15 + 7.36708924E-37 0. 0. 0. 1.92181844E-15 4.3679361E-37 0. 0. 0. + 1.04084203E-15 2.36563844E-37 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 1.71084528E-14 1.3819476E-32 0. 0. 0. 1.62651197E-14 + 1.31382594E-32 0. 0. 0. 1.23376718E-14 9.96584625E-33 0. 0. 0. + 7.31498924E-15 5.90872815E-33 0. 0. 0. 3.9617497E-15 3.20012835E-33 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3.29931318E-15 + 2.45382586E-34 0. 0. 0. 3.13666359E-15 2.33286313E-34 0. 0. 0. + 2.37928209E-15 1.76956463E-34 0. 0. 0. 1.41067408E-15 1.04917302E-34 + 0. 0. 0. 7.64008525E-16 5.6822249E-35 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 1.87441551E-15 6.29555763E-33 0. 0. 0. 1.78201587E-15 + 5.98520104E-33 0. 0. 0. 1.35172525E-15 4.54001485E-33 0. 0. 0. + 8.01437799E-16 2.69176176E-33 0. 0. 0. 4.34052902E-16 1.45783845E-33 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3.64186457E-14 + 4.26707074E-27 0. 0. 0. 3.46233899E-14 4.05672414E-27 0. 0. 0. + 2.6263107E-14 3.07717518E-27 0. 0. 0. 1.55713404E-14 1.82445674E-27 0. + 0. 0. 8.43331244E-15 9.88107891E-28 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 5.46680231E-15 1.2302101E-29 0. 0. 0. 5.19734122E-15 + 1.16956572E-29 0. 0. 0. 3.94236366E-15 8.87161348E-30 0. 0. 0. + 2.33742617E-15 5.25995241E-30 0. 0. 0. 1.26593013E-15 2.84875451E-30 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 6.70222748E-14 + 2.40368432E-25 0. 0. 0. 6.37184262E-14 2.28519618E-25 0. 0. 0. + 4.83327943E-14 1.73340511E-25 0. 0. 0. 2.86565205E-14 1.02773372E-25 + 0. 0. 0. 1.55201373E-14 5.56613845E-26 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 1.15576047E-15 3.37103487E-28 0. 0. 0. + 1.09878607E-15 3.20487671E-28 0. 0. 0. 8.33470626E-16 2.43101278E-28 + 0. 0. 0. 4.94164686E-16 1.44134659E-28 0. 0. 0. 2.67635042E-16 + 7.80620092E-29 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 6.35456484E-15 8.01715825E-26 0. 0. 0. 6.04131765E-15 7.62194818E-26 + 0. 0. 0. 4.5825681E-15 5.78153322E-26 0. 0. 0. 2.7170009E-15 + 3.42786687E-26 0. 0. 0. 1.47150566E-15 1.85650818E-26 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.41675502E-14 2.82570272E-24 0. 0. + 0. 1.3469174E-14 2.68640961E-24 0. 0. 0. 1.02168868E-14 2.03774171E-24 + 0. 0. 0. 6.05757857E-15 1.20817736E-24 0. 0. 0. 3.28073754E-15 + 6.54338082E-25 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 6.89362865E-25 0. 0. 0. 0. 6.55383865E-25 0. 0. 0. 0. + 4.97131416E-25 0. 0. 0. 0. 2.94749126E-25 0. 0. 0. 0. + 1.59633868E-25 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 5.25143965E-25 0. 0. 0. 0. 4.99256706E-25 0. 0. 0. 0. + 3.78705102E-25 0. 0. 0. 0. 2.24533899E-25 0. 0. 0. 0. + 1.21605694E-25 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 7.3625966E-26 0. 0. 0. 0. 6.99965279E-26 0. 0. 0. 0. 5.30949488E-26 + 0. 0. 0. 0. 3.14800059E-26 0. 0. 0. 0. 1.70493118E-26 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 8.32386085E-22 0. 0. 0. 0. + 7.91354059E-22 0. 0. 0. 0. 6.00271501E-22 0. 0. 0. 0. + 3.55900088E-22 0. 0. 0. 0. 1.92752457E-22 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 1.91826028E-23 0. 0. 0. 0. 1.82369858E-23 + 0. 0. 0. 0. 1.38334301E-23 0. 0. 0. 0. 8.20183653E-24 0. 0. 0. + 0. 4.44204065E-24 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.91072966E-21 0. 0. 0. 0. 1.81653649E-21 0. 0. 0. 0. + 1.37791276E-21 0. 0. 0. 0. 8.16961317E-22 0. 0. 0. 0. + 4.42460091E-22 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.95388871E-23 0. 0. 0. 0. 1.85756911E-23 0. 0. 0. 0. + 1.40903795E-23 0. 0. 0. 0. 8.35419476E-24 0. 0. 0. 0. + 4.52454959E-24 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 5.48414688E-22 0. 0. 0. 0. 5.21380513E-22 0. 0. 0. 0. + 3.95487122E-22 0. 0. 0. 0. 2.34483918E-22 0. 0. 0. 0. + 1.26994451E-22 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 7.81139711E-22 0. 0. 0. 0. 7.42633808E-22 0. 0. 0. 0. + 5.63314793E-22 0. 0. 0. 0. 3.33988864E-22 0. 0. 0. 0. + 1.80885566E-22 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.64605856E-20 0. 0. 0. 0. 1.56491974E-20 0. 0. 0. 0. 1.1870478E-20 + 0. 0. 0. 0. 7.03799273E-21 0. 0. 0. 0. 3.81172662E-21 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.72920633E-21 0. 0. 0. 0. + 1.64396714E-21 0. 0. 0. 0. 1.24701042E-21 0. 0. 0. 0. + 7.39350531E-22 0. 0. 0. 0. 4.00426452E-22 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 8.12078589E-21 0. 0. 0. 0. 7.72046682E-21 + 0. 0. 0. 0. 5.85626425E-21 0. 0. 0. 0. 3.47217665E-21 0. 0. 0. + 0. 1.88049718E-21 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.56441846E-23 0. 0. 0. 0. 1.48729689E-23 0. 0. 0. 0. + 1.12816947E-23 0. 0. 0. 0. 6.68891412E-24 0. 0. 0. 0. + 3.62266464E-24 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 2.50082032E-20 0. 0. 0. 0. 2.37754342E-20 0. 0. 0. 0. + 1.80345423E-20 0. 0. 0. 0. 1.06926439E-20 0. 0. 0. 0. + 5.79106643E-21 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.21726372E-20 0. 0. 0. 0. 1.15725944E-20 0. 0. 0. 0. 8.7782418E-21 + 0. 0. 0. 0. 5.20462041E-21 0. 0. 0. 0. 2.81877223E-21 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.88490638E-19 0. 0. 0. 0. + 2.74269336E-19 0. 0. 0. 0. 2.08043692E-19 0. 0. 0. 0. + 1.23348837E-19 0. 0. 0. 0. 6.68047736E-20 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 3.930676E-20 0. 0. 0. 0. 3.73692186E-20 0. + 0. 0. 0. 2.83459609E-20 0. 0. 0. 0. 1.68062744E-20 0. 0. 0. 0. + 9.1021436E-21 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 8.67916608E-20 1.821688E-44 0. 0. 0. 8.25132307E-20 1.68155816E-44 0. + 0. 0. 6.25893254E-20 1.26116862E-44 0. 0. 0. 3.71092416E-20 + 7.00649232E-45 0. 0. 0. 2.0098038E-20 4.20389539E-45 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 1.33011814E-20 1.87773994E-43 0. 0. 0. + 1.26454889E-20 1.79366203E-43 0. 0. 0. 9.59204131E-21 1.35925951E-43 + 0. 0. 0. 5.68713207E-21 7.98740125E-44 0. 0. 0. 3.08010253E-21 + 4.34402524E-44 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.09498375E-18 3.31984085E-38 0. 0. 0. 1.04101114E-18 3.15618993E-38 + 0. 0. 0. 7.89645069E-19 2.3940848E-38 0. 0. 0. 4.68179005E-19 + 1.41945018E-38 0. 0. 0. 2.53561748E-19 7.68763968E-39 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 8.35484149E-20 3.07337544E-39 0. 0. + 0. 7.94297986E-20 2.92187125E-39 0. 0. 0. 6.02503947E-20 2.2163469E-39 + 0. 0. 0. 3.57223958E-20 1.31407044E-39 0. 0. 0. 1.93470081E-20 + 7.11688661E-40 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 3.44631919E-18 1.79744051E-33 0. 0. 0. 3.27643428E-18 1.70883689E-33 + 0. 0. 0. 2.48529538E-18 1.29621735E-33 0. 0. 0. 1.47353003E-18 + 7.685276E-34 0. 0. 0. 7.98051137E-19 4.16226524E-34 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 7.47517546E-21 1.08029675E-37 0. 0. 0. + 7.10670042E-21 1.02704371E-37 0. 0. 0. 5.39069162E-21 7.79050704E-38 + 0. 0. 0. 3.19613279E-21 4.61898186E-38 0. 0. 0. 1.73100205E-21 + 2.50160446E-38 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 8.1854181E-20 1.61583913E-34 0. 0. 0. 7.7819181E-20 1.53618779E-34 0. + 0. 0. 5.90287653E-20 1.16525619E-34 0. 0. 0. 3.49981604E-20 + 6.90879241E-35 0. 0. 0. 1.89547113E-20 3.74174201E-35 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.52145201E-19 1.82320202E-32 0. 0. + 0. 2.39715675E-19 1.73332593E-32 0. 0. 0. 1.8183344E-19 1.31479102E-32 + 0. 0. 0. 1.07809073E-19 7.79541275E-33 0. 0. 0. 5.8388269E-20 + 4.22192461E-33 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 3.73363528E-33 0. 0. 0. 0. 3.54958703E-33 0. 0. 0. 0. + 2.69249332E-33 0. 0. 0. 0. 1.59637735E-33 0. 0. 0. 0. + 8.64583809E-34 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 2.44100641E-33 0. 0. 0. 0. 2.32068042E-33 0. 0. 0. 0. + 1.76032318E-33 0. 0. 0. 0. 1.04369269E-33 0. 0. 0. 0. + 5.65255882E-34 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.46125198E-34 0. 0. 0. 0. 1.38922E-34 0. 0. 0. 0. 1.05377501E-34 + 0. 0. 0. 0. 6.24782193E-35 0. 0. 0. 0. 3.38377557E-35 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 8.08278071E-29 0. 0. 0. 0. + 7.6843365E-29 0. 0. 0. 0. 5.82885225E-29 0. 0. 0. 0. 3.45592962E-29 + 0. 0. 0. 0. 1.87170208E-29 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 3.82555961E-31 0. 0. 0. 0. 3.63698164E-31 0. 0. 0. 0. + 2.75878909E-31 0. 0. 0. 0. 1.63568252E-31 0. 0. 0. 0. + 8.85872232E-32 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 5.32757338E-28 0. 0. 0. 0. 5.06493768E-28 0. 0. 0. 0. + 3.84195483E-28 0. 0. 0. 0. 2.27789533E-28 0. 0. 0. 0. + 1.23368981E-28 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.82247175E-32 0. 0. 0. 0. 1.73263048E-32 0. 0. 0. 0. + 1.31426719E-32 0. 0. 0. 0. 7.79229695E-33 0. 0. 0. 0. 4.220233E-33 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.19931721E-31 0. + 0. 0. 0. 3.99230983E-31 0. 0. 0. 0. 3.02831701E-31 0. 0. 0. 0. + 1.79548851E-31 0. 0. 0. 0. 9.72419826E-32 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 2.35742781E-28 0. 0. 0. 0. 2.24122057E-28 + 0. 0. 0. 0. 1.70005387E-28 0. 0. 0. 0. 1.00796306E-28 0. 0. 0. + 0. 5.45902616E-29 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 4.61591512E-29 0. 0. 0. 0. 4.3883692E-29 0. 0. 0. 0. 3.32875715E-29 + 0. 0. 0. 0. 1.97361025E-29 0. 0. 0. 0. 1.06889052E-29 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 8.82987168E-28 0. 0. 0. 0. + 8.39459322E-28 0. 0. 0. 0. 6.36760251E-28 0. 0. 0. 0. 3.7753634E-28 + 0. 0. 0. 0. 2.04469891E-28 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 4.28340775E-30 0. 0. 0. 0. 4.07225774E-30 0. 0. 0. 0. + 3.0889618E-30 0. 0. 0. 0. 1.8314422E-30 0. 0. 0. 0. 9.91892195E-31 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3.34214382E-25 0. + 0. 0. 0. 3.17738505E-25 0. 0. 0. 0. 2.41016383E-25 0. 0. 0. 0. + 1.42898554E-25 0. 0. 0. 0. 7.73927522E-26 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 2.20661588E-29 0. 0. 0. 0. 2.09784342E-29 + 0. 0. 0. 0. 1.59129014E-29 0. 0. 0. 0. 9.43476743E-30 0. 0. 0. + 0. 5.10978555E-30 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.6046195E-26 0. 0. 0. 0. 1.52551894E-26 0. 0. 0. 0. 1.15716481E-26 + 0. 0. 0. 0. 6.86082036E-27 0. 0. 0. 0. 3.71574787E-27 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.89852052E-27 0. 0. 0. 0. + 2.75564945E-27 0. 0. 0. 0. 2.09026184E-27 0. 0. 0. 0. + 1.23931387E-27 0. 0. 0. 0. 6.71202041E-28 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 5.44569726E-26 0. 0. 0. 0. 5.17725653E-26 + 0. 0. 0. 0. 3.92713879E-26 0. 0. 0. 0. 2.32839538E-26 0. 0. 0. + 0. 1.26103815E-26 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 5.29666268E-28 0. 0. 0. 0. 5.03556291E-28 0. 0. 0. 0. + 3.81966412E-28 0. 0. 0. 0. 2.26467767E-28 0. 0. 0. 0. + 1.22653101E-28 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.78666727E-28 0. 0. 0. 0. 1.69859751E-28 0. 0. 0. 0. + 1.28844689E-28 0. 0. 0. 0. 7.63920774E-29 0. 0. 0. 0. + 4.13732935E-29 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 3.10012593E-24 0. 0. 0. 0. 2.94730425E-24 0. 0. 0. 0. + 2.23564285E-24 0. 0. 0. 0. 1.32551095E-24 0. 0. 0. 0. + 7.17883589E-25 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 3.47797526E-26 0. 0. 0. 0. 3.30652651E-26 0. 0. 0. 0. + 2.50812778E-26 0. 0. 0. 0. 1.4870689E-26 0. 0. 0. 0. 8.05383381E-27 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 6.73631756E-24 + 2.38220739E-44 0. 0. 0. 6.40424854E-24 2.24207754E-44 0. 0. 0. + 4.8578658E-24 1.68155816E-44 0. 0. 0. 2.88022524E-24 9.80908925E-45 0. + 0. 0. 1.55990529E-24 5.60519386E-45 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 9.20767847E-28 0. 0. 0. 0. 8.75378493E-28 0. 0. 0. + 0. 6.64007104E-28 0. 0. 0. 0. 3.93688994E-28 0. 0. 0. 0. + 2.13218573E-28 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 2.63353263E-26 0. 0. 0. 0. 2.50371478E-26 0. 0. 0. 0. + 1.89915983E-26 0. 0. 0. 0. 1.12600873E-26 0. 0. 0. 0. + 6.09837898E-27 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.26443544E-25 1.86372696E-43 0. 0. 0. 1.20210372E-25 1.77964905E-43 + 0. 0. 0. 9.11842163E-26 1.34524653E-43 0. 0. 0. 5.40629613E-26 + 7.98740125E-44 0. 0. 0. 2.9280027E-26 4.34402524E-44 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 3.36311631E-44 0. 0. 0. 0. + 3.22298647E-44 0. 0. 0. 0. 2.38220739E-44 0. 0. 0. 0. + 1.40129846E-44 0. 0. 0. 0. 8.40779079E-45 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 1.821688E-44 0. 0. 0. 0. 1.68155816E-44 0. + 0. 0. 0. 1.26116862E-44 0. 0. 0. 0. 7.00649232E-45 0. 0. 0. 0. + 4.20389539E-45 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 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.29705889E-38 + 0. 0. 0. 0. 2.18382669E-38 0. 0. 0. 0. 1.65651275E-38 0. 0. 0. + 0. 9.82147112E-39 0. 0. 0. 0. 5.31921547E-39 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 1.48915988E-41 0. 0. 0. 0. + 1.41573184E-41 0. 0. 0. 0. 1.07381501E-41 0. 0. 0. 0. + 6.36609892E-42 0. 0. 0. 0. 3.44859552E-42 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 7.58599314E-37 0. 0. 0. 0. 7.21204913E-37 + 0. 0. 0. 0. 5.47061046E-37 0. 0. 0. 0. 3.24352816E-37 0. 0. 0. + 0. 1.75666619E-37 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 8.07147915E-43 0. 0. 0. 0. 7.67911558E-43 0. 0. 0. 0. + 5.81538863E-43 0. 0. 0. 0. 3.44719422E-43 0. 0. 0. 0. + 1.86372696E-43 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 8.1928316E-41 0. 0. 0. 0. 7.78897738E-41 0. 0. 0. 0. 5.90829472E-41 + 0. 0. 0. 0. 3.5029659E-41 0. 0. 0. 0. 1.89721799E-41 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.026311E-40 0. 0. 0. 0. + 9.75710108E-41 0. 0. 0. 0. 7.4012381E-41 0. 0. 0. 0. 4.38816614E-41 + 0. 0. 0. 0. 2.3766022E-41 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 9.35250753E-38 0. 0. 0. 0. 8.89148875E-38 0. 0. 0. 0. + 6.74452294E-38 0. 0. 0. 0. 3.99881424E-38 0. 0. 0. 0. + 2.16572906E-38 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 7.77908422E-40 0. 0. 0. 0. 7.39561889E-40 0. 0. 0. 0. + 5.60984617E-40 0. 0. 0. 0. 3.32606598E-40 0. 0. 0. 0. + 1.80136918E-40 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 5.93391426E-37 0. 0. 0. 0. 5.64140072E-37 0. 0. 0. 0. + 4.27921395E-37 0. 0. 0. 0. 2.53714347E-37 0. 0. 0. 0. + 1.37409949E-37 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 4.77025566E-36 0. 0. 0. 0. 4.5351019E-36 0. 0. 0. 0. 3.44004827E-36 + 0. 0. 0. 0. 2.0395948E-36 0. 0. 0. 0. 1.10463206E-36 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.19124391E-36 0. 0. 0. 0. + 2.0832224E-36 0. 0. 0. 0. 1.58020101E-36 0. 0. 0. 0. 9.36902234E-37 + 0. 0. 0. 0. 5.0741847E-37 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 5.32751087E-38 0. 0. 0. 0. 5.06489353E-38 0. 0. 0. 0. + 3.84190525E-38 0. 0. 0. 0. 2.27786657E-38 0. 0. 0. 0. + 1.23367248E-38 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 3.22566871E-35 0. 0. 0. 0. 3.06665727E-35 0. 0. 0. 0. + 2.32617604E-35 0. 0. 0. 0. 1.37918864E-35 0. 0. 0. 0. 7.4695642E-36 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2.63368441E-37 0. + 0. 0. 0. 2.50385848E-37 0. 0. 0. 0. 1.89926837E-37 0. 0. 0. 0. + 1.12607425E-37 0. 0. 0. 0. 6.09872669E-38 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 1.68912382E-36 0. 0. 0. 0. 1.60585665E-36 + 0. 0. 0. 0. 1.21810414E-36 0. 0. 0. 0. 7.2221183E-37 0. 0. 0. 0. + 3.91143387E-37 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 2.3279749E-37 0. 0. 0. 0. 2.21322313E-37 0. 0. 0. 0. 1.67881565E-37 + 0. 0. 0. 0. 9.9536898E-38 0. 0. 0. 0. 5.39083667E-38 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1.04394149E-31 0. 0. 0. 0. + 9.92479402E-32 0. 0. 0. 0. 7.52832309E-32 0. 0. 0. 0. + 4.46354277E-32 0. 0. 0. 0. 2.41742074E-32 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 8.57904705E-35 0. 0. 0. 0. 8.15611532E-35 + 0. 0. 0. 0. 6.18673353E-35 0. 0. 0. 0. 3.66810888E-35 0. 0. 0. + 0. 1.98661645E-35 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 1.15192604E-31 0. 0. 0. 0. 1.09513909E-31 0. 0. 0. 0. + 8.30704754E-32 0. 0. 0. 0. 4.92525021E-32 0. 0. 0. 0. 2.6674741E-32 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.38980891E-37 0. + 0. 0. 0. 4.17341749E-37 0. 0. 0. 0. 3.16569107E-37 0. 0. 0. 0. + 1.87694075E-37 0. 0. 0. 0. 1.01653341E-37 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 5.99592519E-35 0. 0. 0. 0. 5.70035208E-35 + 0. 0. 0. 0. 4.32394778E-35 0. 0. 0. 0. 2.56366594E-35 0. 0. 0. + 0. 1.38846216E-35 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 5.36847673E-34 0. 0. 0. 0. 5.1038027E-34 0. 0. 0. 0. 3.871436E-34 + 0. 0. 0. 0. 2.29537198E-34 0. 0. 0. 0. 1.24315668E-34 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 7.00649232E-45 0. 0. 0. 0. + 7.00649232E-45 0. 0. 0. 0. 5.60519386E-45 0. 0. 0. 0. + 2.80259693E-45 0. 0. 0. 0. 1.40129846E-45 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.76441478E-44 0. 0. 0. 0. + 4.48415509E-44 0. 0. 0. 0. 3.36311631E-44 0. 0. 0. 0. + 1.96181785E-44 0. 0. 0. 0. 1.12103877E-44 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 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.75775538E-42 0. 0. 0. 0. 2.62182943E-42 0. 0. 0. + 0. 1.98844252E-42 0. 0. 0. 0. 1.17849201E-42 0. 0. 0. 0. + 6.37590801E-43 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.20389539E-45 0. 0. 0. + 0. 4.20389539E-45 0. 0. 0. 0. 2.80259693E-45 0. 0. 0. 0. + 1.40129846E-45 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. + 7.70185184 6.49179173 5.31080151 4.57987309 2.735116 7.6851449 + 6.47573853 5.29536676 4.56426191 2.6970911 7.59420729 6.38133192 + 5.20971441 4.47737026 2.54382849 7.3888092 6.19153738 5.03019571 + 4.29757929 2.23660541 7.12033367 5.93013144 4.78280497 4.04461765 + 1.73259997 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 7.51524496 6.30389214 + 5.14351606 4.40869522 2.46203971 7.49243259 6.28346348 5.12430382 + 4.3894515 2.41149664 7.36214113 6.17284966 5.0164094 4.28206968 + 2.20067954 7.11847448 5.92858028 4.78565645 4.04344797 1.70635879 + 6.73635244 5.56783819 4.43701172 3.68307781 0. 5.09587479 3.98513937 + 2.85564852 1.75082016 0. 0. 0. 0. 0. 0. 7.38170767 6.20064354 + 5.05450392 4.31404257 2.22417974 7.35277319 6.17503738 5.02993774 + 4.28939438 2.15727663 7.21850443 6.04141617 4.89622402 4.15371418 + 1.86029816 6.90195513 5.74349785 4.61024857 3.85633874 1.02003717 + 6.48131514 5.33632469 4.2143383 3.43272853 0. 5.1447401 4.02818203 + 2.89018941 1.77852702 0. 0. 0. 0. 0. 0. 7.31748676 6.15228987 + 5.01661634 4.26311064 1.99545169 7.28622341 6.12196112 4.98598671 + 4.23266792 1.91221547 7.13745594 5.96027565 4.8258009 4.07209253 + 1.52026892 6.77137661 5.61084843 4.48532486 3.71124744 0. 6.30693817 + 5.15808725 4.03945112 3.22767568 0. 4.98090458 3.85322404 2.68475389 + 1.4043715 0. 0. 0. 0. 0. 0. 7.28986073 6.13558865 5.00428104 + 4.23278952 1.7537365 7.25432491 6.09935713 4.96830559 4.19511127 + 1.64723396 7.07264614 5.90413332 4.7739048 4.00602627 1.12546027 + 6.65964985 5.50273228 4.37745428 3.57995272 0. 6.12667942 4.98696041 + 3.85908556 3.0112021 0. 4.74324274 3.59923339 2.37532568 0.601103663 + 0. 0. 0. 0. 0. 0. 7.2818532 6.13495827 5.00395727 4.20771408 + 1.4391005 7.2389183 6.09149408 4.96312141 4.16604424 1.2895304 + 7.01938391 5.86335802 4.73058319 3.93647194 0.411347598 6.54213858 + 5.39749718 4.26472521 3.43205333 0. 5.95597029 4.81260395 3.67163181 + 2.76766038 0. 4.44982433 3.27749634 1.94576728 0. 0. 0. 0. 0. 0. + 0. 7.28362799 6.14219236 5.00770283 4.18368959 0.889379561 7.23247147 + 6.09018993 4.95893574 4.13528013 0.578269005 6.97826815 5.82591867 + 4.68830538 3.85352373 0. 6.4371562 5.29177237 4.1473012 3.26866651 0. + 5.76816463 4.62005997 3.4569006 2.4710536 0. 4.07928181 2.85873532 + 1.34339619 0. 0. 0. 0. 0. 0. 0. 7.2915926 6.15053654 5.00594091 + 4.14753389 0. 7.22922802 6.08802652 4.94711304 4.08601904 0. + 6.93916321 5.7886548 4.63776541 3.74842858 0. 6.33212662 5.17469263 + 4.01008654 3.06835341 0. 5.55559731 4.39140129 3.1880641 2.08303452 0. + 3.66618919 2.38221836 0. 0. 0. 0. 0. 0. 0. 0. 7.30062819 + 6.15246058 4.99390459 4.0856452 0. 7.22658443 6.07663345 4.91798115 + 4.00291204 0. 6.89321232 5.7378726 4.56267691 3.60769892 0. 6.20317507 + 5.03491354 3.82898355 2.78577852 0. 5.309484 4.11908245 2.85011768 + 1.54655874 0. 3.22178626 1.8249321 0. 0. 0. 0. 0. 0. 0. 0. + 7.30191517 6.14308691 4.95514154 3.96752286 0. 7.21721745 6.05061102 + 4.86085224 3.86240649 0. 6.8346858 5.66153193 4.44497871 3.38864732 0. + 6.04413366 4.85412979 3.58037019 2.33884239 0. 5.02402306 3.79885125 + 2.43236423 0.464768112 0. 2.7300539 1.03713512 0. 0. 0. 0. 0. 0. + 0. 0. 7.28832769 6.10941219 4.87036324 3.77034783 0. 7.19325447 + 6.00341797 4.75110579 3.62727141 0. 6.75401163 5.54779863 4.24953461 + 2.99456286 0. 5.84802914 4.60901642 3.19579268 1.54873371 0. + 4.69735718 3.42226911 1.87176991 0. 0. 2.14944506 0. 0. 0. 0. 0. + 0. 0. 0. 0. 7.25384808 6.04080725 4.71161318 3.37504768 0. + 7.14495611 5.92050695 4.57095385 3.14092588 0. 6.63914204 5.38657904 + 3.9259305 2.1796155 0. 5.59895897 4.27512217 2.60526729 0. 0. + 4.32652617 2.97259688 0.961444497 0. 0. 1.30869961 0. 0. 0. 0. 0. + 0. 0. 0. 0. 7.18907309 5.92813396 4.42114353 2.60265541 0. + 7.06289625 5.78843641 4.23085976 2.30779552 0. 6.47969627 5.13057947 + 3.33609056 0.671632886 0. 5.26375055 3.80314755 1.78815591 0. 0. + 3.89789748 2.42051911 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 7.08748674 5.74069786 3.8821435 1.24823821 0. 6.94369078 5.5588789 + 3.64227152 0.495912582 0. 6.23308897 4.68794775 2.59603858 0. 0. + 4.81475449 3.22423291 0. 0. 0. 3.40730071 1.70569503 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 6.94638681 5.40083647 3.24337363 0. + 0. 6.75462484 5.14442778 2.9387033 0. 0. 5.83872652 4.13159466 + 1.50449538 0. 0. 4.30441952 2.58024049 0. 0. 0. 2.85084343 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 6.68423176 4.91022205 + 2.2821877 0. 0. 6.447124 4.63335943 1.83455312 0. 0. 5.31254721 + 3.53571892 0. 0. 0. 3.76778078 1.81837332 0. 0. 0. 2.16268563 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 6.22714424 4.38238573 + 0. 0. 0. 5.93081522 4.07860613 0. 0. 0. 4.8181591 2.86766768 0. 0. + 0. 3.20743823 0.410383165 0. 0. 0. 1.14583826 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 5.76188612 3.77231574 0. 0. 0. + 5.47461891 3.44871998 0. 0. 0. 4.32095766 2.03986716 0. 0. 0. + 2.58853292 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 5.31285954 3.03845358 0. 0. 0. 5.01187658 2.63922668 0. + 0. 0. 3.77176929 0.551957428 0. 0. 0. 1.82739115 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4.83745718 + 2.01617575 0. 0. 0. 4.50717258 1.45514464 0. 0. 0. 3.16845489 0. + 0. 0. 0. 0.309877902 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 4.2926383 0. 0. 0. 0. 3.92928863 0. 0. 0. 0. + 2.47605348 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 3.66361928 0. 0. 0. 0. 3.27540708 0. + 0. 0. 0. 1.55619764 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.93670797 0. 0. 0. 0. + 2.48855734 0. 0. 0. 0. 0. 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.96575475 0. 0. 0. + 0. 1.33148444 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. -0.117605828 + -0.598513663 -0.773298085 -0.785614491 -0.497843891 -0.112486765 -0.598047078 + -0.772739112 -0.78461796 -0.494032621 -0.102022856 -0.594935 -0.764659524 + -0.775510311 -0.480799556 -0.135028183 -0.584410846 -0.751668036 -0.75732857 + -0.438114911 -0.113950111 -0.573396146 -0.731930494 -0.732820451 -0.363774419 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. -0.12010283 -0.584283412 -0.748967946 + -0.753601551 -0.462611467 -0.126285389 -0.583035231 -0.748622954 -0.753076971 + -0.455333114 -0.133163586 -0.579854608 -0.741322756 -0.744056582 -0.429619372 + -0.115490109 -0.568615496 -0.72326231 -0.723761261 -0.359530926 -0.107433245 + -0.550227284 -0.697754204 -0.684472561 0. -0.0989767164 -0.457586616 + -0.528092027 -0.406513184 0. 0. 0. 0. 0. 0. -0.139417917 -0.570315599 + -0.722019553 -0.723567963 -0.415891081 -0.132933274 -0.570030928 -0.719536662 + -0.721298635 -0.405656815 -0.0939743221 -0.562425315 -0.711455405 -0.70575577 + -0.371037602 -0.113918424 -0.552600741 -0.6906932 -0.683171749 -0.236271128 + -0.110169277 -0.537359834 -0.665813625 -0.649865389 0. -0.0970482379 + -0.454398483 -0.522428513 -0.402592748 0. 0. 0. 0. 0. 0. -0.121992491 + -0.557718694 -0.690303147 -0.693196416 -0.378665537 -0.109751567 -0.554628253 + -0.685660064 -0.68760407 -0.369261146 -0.104361132 -0.543414831 -0.690312326 + -0.668386877 -0.321735859 -0.0936394706 -0.53214854 -0.662572503 -0.647729814 + 0. -0.103009924 -0.514520764 -0.635300338 -0.609673083 0. -0.0949828774 + -0.43494311 -0.48172906 -0.313956589 0. 0. 0. 0. 0. 0. -0.111299664 + -0.542529941 -0.660516441 -0.659394264 -0.333778232 -0.097495243 -0.538624704 + -0.655504823 -0.648781419 -0.319177806 -0.119341455 -0.528155208 -0.668835342 + -0.637325466 -0.2493985 -0.116569564 -0.516947925 -0.641766369 -0.615542829 + 0. -0.116599701 -0.508685231 -0.616598129 -0.574188113 0. -0.0895180851 + -0.411838531 -0.422149062 -0.148958504 0. 0. 0. 0. 0. 0. -0.10571073 + -0.529142916 -0.634458125 -0.622918427 -0.265546054 -0.0887427106 -0.523263156 + -0.632071137 -0.616435349 -0.251457989 -0.13213931 -0.522673428 -0.647293091 + -0.607416153 -0.126066968 -0.123620994 -0.514142394 -0.623266995 -0.588563979 + 0. -0.0960212797 -0.487630993 -0.584153116 -0.52581954 0. -0.0911568776 + -0.376190126 -0.355089962 0. 0. 0. 0. 0. 0. 0. -0.10285797 -0.517439127 + -0.613371849 -0.592734337 -0.169267237 -0.0828243047 -0.50848788 -0.61073935 + -0.587586224 -0.15924637 -0.132124364 -0.517210841 -0.619698405 -0.576124966 + 0. -0.0973877385 -0.496608883 -0.594736755 -0.556466281 0. -0.105184749 + -0.464246362 -0.537049592 -0.454848796 0. -0.0798710361 -0.338666141 + -0.260029644 0. 0. 0. 0. 0. 0. 0. -0.102270298 -0.504975319 -0.5924685 + -0.557196259 0. -0.0771251023 -0.491417259 -0.589015603 -0.554411173 0. + -0.124557443 -0.503746331 -0.586302638 -0.551061511 0. -0.0926501378 + -0.471632987 -0.555897713 -0.491687953 0. -0.0973703191 -0.440053374 + -0.483400047 -0.388079911 0. -0.0764653683 -0.295143634 0. 0. 0. 0. 0. + 0. 0. 0. -0.102055535 -0.486703783 -0.559431255 -0.508866429 0. + -0.0755006075 -0.469798356 -0.561774254 -0.508794069 0. -0.110271201 + -0.482916772 -0.547060251 -0.506028235 0. -0.1012116 -0.448160768 + -0.502421916 -0.387809366 0. -0.0909688845 -0.410144269 -0.430215329 + -0.289227635 0. -0.0691384673 -0.236129731 0. 0. 0. 0. 0. 0. 0. 0. + -0.0988164395 -0.454759836 -0.51638484 -0.436522961 0. -0.0767587423 + -0.445653677 -0.518241227 -0.430571705 0. -0.0942503735 -0.452694684 + -0.498554945 -0.399293631 0. -0.0990445167 -0.41859144 -0.425904661 + -0.259215951 0. -0.0883951113 -0.377343744 -0.357291043 -0.0542508475 0. + -0.0612315759 -0.157507673 0. 0. 0. 0. 0. 0. 0. 0. -0.0922442004 + -0.418230206 -0.460293651 -0.320548326 0. -0.0795356184 -0.418764502 + -0.44548139 -0.279816806 0. -0.0860292166 -0.412479818 -0.403706104 + -0.158461154 0. -0.0830534548 -0.37337482 -0.303256094 -0.00809008535 0. + -0.0821122676 -0.336577475 -0.255343378 0. 0. -0.0491269492 0. 0. 0. 0. + 0. 0. 0. 0. 0. -0.084248215 -0.38037926 -0.358869314 -0.0361054242 0. + -0.0821662471 -0.385176986 -0.339673072 0.0346417725 0. -0.0806353837 + -0.369285315 -0.214050516 0.167298883 0. -0.0880206749 -0.296153069 + -0.13009645 0. 0. -0.0776561946 -0.28238675 -0.130335376 0. 0. + -0.0307084564 0. 0. 0. 0. 0. 0. 0. 0. 0. -0.0780801922 -0.338311791 + -0.158937544 0.359302402 0. -0.0827709213 -0.340515643 -0.122317113 + 0.358418971 0. -0.0837482214 -0.258657962 0.0371566601 0.0421453379 0. + -0.070093371 -0.217943668 -0.0460581593 0. 0. -0.0688873753 -0.224936977 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. -0.0708434284 -0.258303285 + 0.107166588 0.310114652 0. -0.0829177052 -0.225629583 0.142906263 + 0.0697748661 0. -0.0564816408 -0.119058885 0.148378402 0. 0. -0.056830477 + -0.147343367 0. 0. 0. -0.0563628562 -0.157024756 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. -0.0619655848 -0.0912955627 0.322680324 0. 0. + -0.0818152651 -0.0696662739 0.302563339 0. 0. -0.0363534503 -0.0421130843 + 0.0902507976 0. 0. -0.0496607237 -0.133997545 0. 0. 0. -0.0502257347 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. -0.041991964 0.0294726752 + 0.38657701 0. 0. -0.0317216851 0.0207751319 0.286731869 0. 0. + -0.0269514248 -0.0406343862 0. 0. 0. -0.0444574542 -0.106990293 0. 0. 0. + -0.0361419916 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + -0.00640812935 0.0727545395 0. 0. 0. -0.0189424232 0.0401898362 0. 0. + 0. -0.0360589661 -0.00671684928 0. 0. 0. -0.0400758311 -0.0121765304 0. + 0. 0. -0.0289835129 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + -0.0251110028 0.0976442397 0. 0. 0. -0.0211795457 0.100832164 0. 0. 0. + -0.0268331058 -0.00659580389 0. 0. 0. -0.0319162533 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. -0.0130795296 0.159322634 + 0. 0. 0. -0.0119442204 0.106178932 0. 0. 0. -0.0192864276 + -0.000201512201 0. 0. 0. -0.0219336413 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. -0.00115514523 0.135113552 0. 0. + 0. 0.000503129151 0.0936970711 0. 0. 0. -0.0180826373 0. 0. 0. 0. + -0.0290350616 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0.00957168359 0. 0. 0. 0. 0.00262443046 0. 0. 0. 0. + -0.00988695212 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0.00866127387 0. 0. 0. 0. 0.003128374 + 0. 0. 0. 0. -0.00615307083 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.0101130698 0. 0. 0. 0. + 0.00427461881 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.019407589 0. 0. 0. + 0. 0.00333721493 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.149239838 0.159585044 + 0.174531057 0.172589898 0.114062853 0.0802506134 0.0864585564 + 0.0937036946 0.0929495171 0.0594429784 0.023313418 0.025275806 + 0.0265688188 0.0269260276 0.0157515593 0.00852110609 0.00897599664 + 0.00973887276 0.00929049216 0.00424297666 0.003904599 0.00409835344 + 0.00433867145 0.00408644136 0. 0.0014290167 0.00144138699 0.00135697902 + 0.00086309918 0. 0. 0. 0. 0. 0. 0.262173027 0.28560698 0.302517682 + 0.298571706 0.159328386 0.138499096 0.150429755 0.15859817 0.156734571 + 0.0815172046 0.0399498604 0.0422231182 0.0443932824 0.0436583608 + 0.0199249685 0.0138653023 0.0148681384 0.0156103913 0.0149922958 + 0.00331643107 0.00673095975 0.0071088518 0.00739510776 0.00674488582 0. + 0.00246590655 0.00247358927 0.0023187655 0.00152229844 0. 0. 0. 0. 0. + 0. 0.361290783 0.384792745 0.399715215 0.388280511 0.187200218 + 0.18861118 0.199085355 0.205812335 0.200678691 0.0942677632 0.0541274771 + 0.0563742742 0.0587866604 0.0558585748 0.0210202951 0.0187931489 + 0.0195609797 0.0202561356 0.0188980829 0. 0.00923638884 0.00955073256 + 0.00971970614 0.00864196476 0. 0.00321596814 0.0031770179 0.00288918591 + 0.00162503193 0. 0. 0. 0. 0. 0. 0.439423233 0.458729267 0.470537245 + 0.449318409 0.192417756 0.226211876 0.234059528 0.23974362 0.22975859 + 0.0946356729 0.0640438125 0.0663028061 0.0681421086 0.0640970245 + 0.0181651954 0.0223010872 0.0230133329 0.0233051572 0.0212691091 0. + 0.0106728403 0.0109330835 0.0108498894 0.00942467805 0. 0.00371720991 + 0.0035895647 0.00309301424 0.000825797964 0. 0. 0. 0. 0. 0. + 0.495200694 0.511294127 0.519748271 0.48909393 0.165638134 0.251854748 + 0.258069485 0.262172222 0.247333869 0.0767945722 0.07068488 0.0727737024 + 0.0734100491 0.068579644 0.00565913646 0.0243208539 0.0249726605 + 0.0248757638 0.0221031811 0. 0.0114845689 0.0115830153 0.0112317558 + 0.00941198412 0. 0.00387501484 0.0036452522 0.00287323189 0. 0. 0. 0. + 0. 0. 0. 0.533800006 0.547105432 0.550484598 0.510337353 0.0901271403 + 0.269048035 0.273932725 0.275131404 0.256735414 0.0274754819 + 0.0751305372 0.0766263083 0.0762118697 0.0697896555 0. 0.0255622361 + 0.0258263815 0.0252741538 0.0217816196 0. 0.0117345871 0.0116955088 + 0.0110798385 0.00875623338 0. 0.00371014513 0.0033537203 0.00214696792 + 0. 0. 0. 0. 0. 0. 0. 0.56057173 0.570367694 0.567218542 0.517704129 + 0. 0.280437469 0.283946991 0.281940728 0.259205639 0. 0.0778463185 + 0.0786840692 0.0772792697 0.0688907504 0. 0.0260681603 0.0259297304 + 0.0247961804 0.0206178129 0. 0.0115614943 0.0112975845 0.0103371693 + 0.00739286747 0. 0.00345202675 0.00294498913 0. 0. 0. 0. 0. 0. 0. + 0. 0.578787506 0.583820701 0.574078083 0.509908319 0. 0.287584335 + 0.289026052 0.283400923 0.252737284 0. 0.0790760741 0.0791487545 + 0.0762308314 0.0654525533 0. 0.0257057175 0.0253044441 0.0235289577 + 0.0185049381 0. 0.0110537335 0.0105805248 0.00919993035 0.0054396675 0. + 0.00311607006 0.00235232385 0. 0. 0. 0. 0. 0. 0. 0. 0.589774549 + 0.589068174 0.567540646 0.484970093 0. 0.291140854 0.289645821 + 0.27826789 0.240069285 0. 0.078903608 0.0776518211 0.0729377493 + 0.0604252815 0. 0.0247791409 0.0239207149 0.0215434711 0.0153394481 0. + 0.010374763 0.00966334995 0.00779268844 0.00158933783 0. 0.00266125239 + 0.00133480446 0. 0. 0. 0. 0. 0. 0. 0. 0.592153907 0.583219886 + 0.546221554 0.45042178 0. 0.290922731 0.285644621 0.267901748 + 0.222781911 0. 0.0772308111 0.0747642517 0.0685186014 0.0535517074 0. + 0.02352814 0.022271933 0.0190719347 0.0102888634 0. 0.0095626181 + 0.00861293543 0.00601082342 0. 0. 0.00208123703 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0.584318578 0.566388309 0.518232346 0.407258719 0. + 0.285863429 0.276912421 0.254059345 0.198538914 0. 0.0741934851 + 0.0709491521 0.0633903518 0.0406414233 0. 0.0219778977 0.0203577317 + 0.015778698 0. 0. 0.00867223181 0.00747406669 0.00306962896 0. 0. + 0.00121761998 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.56713748 0.542203724 + 0.485209614 0.324990571 0. 0.276763469 0.26512292 0.237737551 + 0.151256189 0. 0.0706081539 0.0668986291 0.0557313412 0.0133793568 0. + 0.0203841124 0.0181460492 0.0111581255 0. 0. 0.00773961935 + 0.00612020912 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.545069396 0.515756965 0.438630402 0.162819415 0. 0.26589033 + 0.252643138 0.212349191 0.034271311 0. 0.0673150122 0.0622126609 + 0.0444074646 0. 0. 0.018568024 0.015701944 0. 0. 0. 0.00673358748 + 0.0042818049 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.521591663 + 0.487929761 0.370396674 0. 0. 0.255770594 0.238597304 0.175099924 0. + 0. 0.0635062009 0.0559432209 0.0265861284 0. 0. 0.0166871082 + 0.0127801336 0. 0. 0. 0.00562115526 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0.499708265 0.452427119 0.264067352 0. 0. + 0.244809076 0.219828367 0.11315003 0. 0. 0.0587273203 0.0484589227 0. + 0. 0. 0.0147334188 0.00902462192 0. 0. 0. 0.00424839882 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.474410594 0.407402903 0. 0. + 0. 0.231610641 0.196071461 0. 0. 0. 0.0533519611 0.0396795459 0. 0. + 0. 0.0125995688 0.00204721908 0. 0. 0. 0.00216588238 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.443243772 0.351206899 0. 0. 0. + 0.215294063 0.167160526 0. 0. 0. 0.04796803 0.0284256842 0. 0. 0. + 0.0101697557 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0.406668246 0.283408791 0. 0. 0. 0.197185531 0.129254654 + 0. 0. 0. 0.0420064367 0.00793066062 0. 0. 0. 0.00715919118 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.368742108 0.188970387 0. 0. 0. 0.177783564 0.072480917 0. 0. 0. + 0.0352703221 0. 0. 0. 0. 0.00121389155 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.326705843 0. 0. 0. 0. + 0.155515447 0. 0. 0. 0. 0.0276313312 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.277704835 0. + 0. 0. 0. 0.129682541 0. 0. 0. 0. 0.017777646 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.222083822 0. 0. 0. 0. 0.0992613658 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0.15011315 0. 0. 0. 0. 0.0543650687 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + -0.00339230732 0.0122140888 0.0237953607 0.0243429113 0.0165713634 + -0.00186809048 0.00709280139 0.0120943198 0.0135665424 0.0076754638 + 0.000477323018 0.00167555595 0.0021064363 0.00414446974 0.00159650645 + -8.96511556E-05 0.000497306813 0.00112188747 0.00104520377 0.000619933533 + 7.90161648E-05 0.000306648901 0.000522020215 0.000570766802 0. + 2.13982321E-06 9.68216627E-05 0.000169285835 0.000167659149 0. 0. 0. + 0. 0. 0. 0.00206436915 0.0234661475 0.0317236483 0.0476639941 + 0.0231826212 0.00266592647 0.0112205371 0.0151612815 0.024552349 + 0.0117812045 0.0011441895 0.00233827508 0.0038262005 0.00530256843 + 0.00296169799 0.000367867382 0.0010346598 0.00186242175 0.0023897076 + 0.000660117075 7.70292827E-05 0.00043583673 0.000801348302 0.000903944951 + 0. 2.96351732E-06 0.000151326443 0.000266826944 0.000268378295 0. 0. + 0. 0. 0. 0. 0.0103517668 0.0222665165 0.0330724791 0.0503026433 + 0.0251849219 0.00558510609 0.0101916613 0.0161629692 0.0232719481 + 0.0126187224 -0.00033196804 0.00254276674 0.00427320972 0.00547219673 + 0.00305183535 0.000155731614 0.00105625123 0.00169237494 0.0022273995 0. + 0.000135932743 0.000579260814 0.00101251167 0.00109232229 0. + 4.73341352E-05 0.000204005089 0.000355296448 0.000340016006 0. 0. 0. + 0. 0. 0. 0.0100542773 0.0194974933 0.0355850942 0.0433114432 + 0.0287657827 0.00479462184 0.00951590203 0.0162988808 0.0198758729 + 0.0141947065 -0.000356659264 0.00283902232 0.00473490171 0.00596685009 + 0.00337112718 -4.65846424E-05 0.00109356362 0.00196499843 0.00231226278 + 0. 4.97438293E-07 0.000542541675 0.000956582255 0.00112939382 0. + 3.29281575E-05 0.00024429179 0.00043607704 0.000187035737 0. 0. 0. 0. + 0. 0. 0.00856417697 0.0211365186 0.0354712829 0.0413769893 0.0315834843 + 0.00456797052 0.0101931272 0.0157832205 0.0196359511 0.0149802621 + -0.000174984569 0.00279719871 0.0051314095 0.00641008606 0.000757714093 + 7.5998556E-05 0.00113172829 0.00201078621 0.00239995681 0. 0.00018014574 + 0.000591312186 0.000961508078 0.00120757974 0. 4.22657722E-05 + 0.000276130886 0.000451831787 0. 0. 0. 0. 0. 0. 0. 0.00836561527 + 0.0222812742 0.0359429419 0.0439072847 0.0165546276 0.00462201331 + 0.0105026299 0.0167792346 0.0211317576 0.00234693917 7.73764841E-05 + 0.00283993059 0.00511877146 0.00684236223 0. 0.000376340904 + 0.00117391977 0.00206011673 0.00229249545 0. 4.60744086E-05 + 0.000662631355 0.00113579561 0.00135648379 0. 4.71182866E-05 + 0.000290920725 0.000388116605 0. 0. 0. 0. 0. 0. 0. 0.00740133226 + 0.0220532138 0.0379732996 0.0477256402 0. 0.00452336296 0.0104253553 + 0.0178475194 0.02327241 0. 0.000236937674 0.00290858792 0.00529217161 + 0.00687919324 0. 0.000331216463 0.00139008125 0.00235845195 + 0.00282492675 0. 0.000121094519 0.000688612985 0.00124712312 + 0.00127801904 0. 3.73182629E-05 0.000284346868 0. 0. 0. 0. 0. 0. 0. + 0. 0.00601291051 0.0214110557 0.0421222411 0.0574440062 0. + 0.00398041587 0.0112864673 0.0192206372 0.0276098195 0. 0.000557037944 + 0.00328268879 0.00614754111 0.00812883023 0. 7.88709804E-05 + 0.00149220671 0.00262203999 0.00337307365 0. 0.00011128559 + 0.000729722611 0.00126659486 0.00103358366 0. 4.79095761E-05 + 0.000256810599 0. 0. 0. 0. 0. 0. 0. 0. 0.00504413852 0.0260705594 + 0.0505853482 0.0689486638 0. 0.00349910604 0.0126813743 0.0234534796 + 0.0321577154 0. 0.00112113182 0.00425655814 0.00757786771 0.00972208939 + 0. 0.00026825149 0.00161120587 0.00291213347 0.00324602518 0. + 9.58580713E-05 0.000754344917 0.00119745487 0.000405410188 0. + 5.06982251E-05 0.000153370391 0. 0. 0. 0. 0. 0. 0. 0. 0.00598638132 + 0.0335003063 0.0627121329 0.0775965974 0. 0.00304546207 0.0144572081 + 0.0285125319 0.0368711315 0. 0.00103709975 0.0047876942 0.00838538632 + 0.011228987 0. 0.000271545374 0.00172320416 0.00310413865 0.00271722255 + 0. 0.000122589874 0.000738391769 0.000964987848 0. 0. 3.9018465E-05 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0.00776046328 0.0391844921 0.0701050013 + 0.0863377228 0. 0.00271566678 0.0170643497 0.0311791338 0.0436240248 0. + 0.000687358843 0.00511623686 0.00909920502 0.0121602025 0. + 0.000311735639 0.00173249992 0.00290036527 0. 0. 0.000130764514 + 0.000721369463 0.000597667356 0. 0. 2.55722043E-05 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.00796592515 0.0424570255 0.0721472725 0.10820967 0. + 0.00256643095 0.0188388936 0.0329195969 0.0514248498 0. 0.000697889365 + 0.00499072485 0.0107362708 0.00436412683 0. 0.000238402688 0.00173817948 + 0.00242170878 0. 0. 0.000115708222 0.000638894679 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0.00677152118 0.0427005105 0.0825766549 + 0.0717115328 0. 0.00244788127 0.0185886174 0.0402565226 0.0132539496 0. + 0.000725530845 0.00550338998 0.0107552474 0. 0. 0.000277627201 + 0.00165213086 0. 0. 0. 0.000120383491 0.000494167674 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0.00560792629 0.041878067 0.0959518105 0. + 0. 0.00312913535 0.0193557162 0.0456209108 0. 0. 0.000795422064 + 0.00617723353 0.00715777464 0. 0. 0.000262871356 0.00147688505 0. 0. + 0. 9.40629616E-05 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.00621687528 0.0467695296 0.0851874426 0. 0. 0.00288119609 0.022937689 + 0.0365207344 0. 0. 0.000974419119 0.0057558273 0. 0. 0. + 0.000252849713 0.00107622659 0. 0. 0. 7.97861212E-05 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.00674816221 0.0531551614 0. 0. 0. + 0.00330423843 0.0242465064 0. 0. 0. 0.000875831523 0.005391418 0. 0. + 0. 0.000227630793 0.0003368287 0. 0. 0. 3.36363046E-05 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.00766999088 0.0498373024 0. 0. + 0. 0.00370922545 0.0238613505 0. 0. 0. 0.000885077228 0.00402771169 + 0. 0. 0. 0.00019053572 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0.0079540927 0.0481447168 0. 0. 0. 0.00360520347 + 0.0208571795 0. 0. 0. 0.000856874452 0.0011527664 0. 0. 0. + 0.000165146572 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.00760919088 0.0351135693 0. 0. 0. 0.00361310854 + 0.01366009 0. 0. 0. 0.00072616135 0. 0. 0. 0. -7.78129324E-05 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0.00752389384 0. 0. 0. 0. 0.00346719217 0. 0. 0. 0. 0.000628107053 + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0.00693766726 0. 0. 0. 0. 0.00318264565 0. 0. 0. + 0. 0.000436958158 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.00592185883 0. 0. 0. 0. + 0.00248429715 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.00475088786 0. 0. 0. + 0. 0.00136208697 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.631256163 0.547144413 + 0.411019862 0.363247633 0.299884558 0.631669819 0.538386583 0.40190205 + 0.354156792 0.300620645 0.733320296 0.552919149 0.427069038 0.369739354 + 0.327195585 0.769104838 0.639453471 0.485743105 0.429346979 0.410008818 + 0.93111372 0.740395308 0.57068181 0.500938833 0. 2.88649225 2.25996923 + 1.73205018 1.59415972 0. 0. 0. 0. 0. 0. 0.91389358 0.66592288 + 0.522624671 0.459505171 0.385566562 0.855075896 0.613135755 0.47868529 + 0.420349866 0.375151843 0.778170943 0.631133795 0.500190914 0.442139149 + 0.418549389 0.976917207 0.713723481 0.564408362 0.495808989 0.526558042 + 1.04086614 0.78656745 0.611840189 0.55142206 0. 0.996088028 0.795185685 + 0.62321347 0.56619966 0. 0. 0. 0. 0. 0. 1.00978374 0.799944282 + 0.652680993 0.588306248 0.471354604 0.860661805 0.686764061 0.561226904 + 0.50612545 0.437295079 0.81097728 0.717174113 0.565611005 0.499224424 + 0.451245815 0.917899132 0.806328177 0.632253885 0.569642484 0. + 1.04097199 0.891842902 0.69557476 0.618180275 0. 1.42180574 1.14660764 + 0.902868867 0.839307189 0. 0. 0. 0. 0. 0. 1.23229873 1.00659275 + 0.847658038 0.776379824 0.558247507 1.00575781 0.827864051 0.686570644 + 0.644856036 0.514441073 1.05068529 0.86903578 0.714140654 0.626127243 + 0.494978875 1.15984046 0.959481657 0.779940963 0.693699062 0. + 1.41448033 1.11321616 0.910412729 0.796465814 0. 1.81049562 1.4564718 + 1.15355444 1.07779157 0. 0. 0. 0. 0. 0. 1.5427109 1.27788818 + 1.08884215 1.00786948 0.704058468 1.23489153 1.02064288 0.847205102 + 0.786733091 0.652159095 1.28906929 1.02639651 0.878832698 0.813775837 + 0.587547183 1.52096283 1.192963 0.997487247 0.907508492 0. 1.62387109 + 1.35133827 1.08817685 0.981616676 0. 2.223804 1.78628993 1.42155433 0. + 0. 0. 0. 0. 0. 0. 1.90715218 1.5932672 1.37193286 1.24693441 + 0.942341447 1.48922575 1.25192225 1.06651032 0.977277696 0.888866305 + 1.48708928 1.25305688 1.07316673 1.03725183 0. 1.69001722 1.419065 + 1.18123591 1.07846296 0. 2.01414347 1.65076911 1.34130001 1.21510065 + 0. 2.77598238 2.20567799 1.62159419 0. 0. 0. 0. 0. 0. 0. + 2.28507376 1.96908712 1.73341858 1.57859826 0. 1.78433013 1.54228354 + 1.34836221 1.27829087 0. 1.76071846 1.49586463 1.31314254 1.2913903 0. + 1.94214249 1.71171665 1.44459713 1.34031343 0. 2.43291807 2.04723072 + 1.68953252 1.48105359 0. 3.04294157 2.31393147 0. 0. 0. 0. 0. 0. + 0. 0. 2.71437812 2.43692803 2.13493514 2.00914931 0. 2.09878445 + 1.91561031 1.72053528 1.67148519 0. 2.12750864 1.86578143 1.67183161 + 1.61347067 0. 2.43883467 2.07407069 1.84017408 1.7822547 0. 2.92028332 + 2.45837116 2.02970743 1.72839952 0. 3.14624071 2.32815313 0. 0. 0. + 0. 0. 0. 0. 0. 3.24822378 2.96178889 2.71589255 2.61758161 0. + 2.49844432 2.34611607 2.17857385 2.21295643 0. 2.5553968 2.34421062 + 2.15954232 2.1985867 0. 2.97229171 2.58867526 2.37195802 2.49355936 0. + 3.42047071 2.83999014 2.30005169 2.03520632 0. 3.20880699 2.35826325 + 0. 0. 0. 0. 0. 0. 0. 0. 3.99888444 3.64754081 3.41942763 + 3.39678073 0. 3.01528072 2.84452319 2.8733573 3.0485754 0. 3.08592105 + 2.93068147 2.96639991 3.39507365 0. 3.56962037 3.30596685 3.31789088 + 3.39687824 0. 3.88963318 3.19638729 2.62296915 0. 0. 3.2825892 0. 0. + 0. 0. 0. 0. 0. 0. 0. 4.70083475 4.54393482 4.59530449 5.22524643 + 0. 3.67943287 3.5248003 3.74107265 5.02433014 0. 3.78135085 3.63141537 + 4.23273993 5.39946795 0. 4.37431526 4.23598623 4.39338779 0. 0. + 4.29589939 3.52388716 2.882236 0. 0. 3.54659295 0. 0. 0. 0. 0. 0. + 0. 0. 0. 5.63535261 5.3277607 6.20091248 7.37061834 0. 4.4930687 + 4.39824772 5.62699461 6.40350533 0. 4.64669895 5.00355577 6.43340063 + 5.44029951 0. 5.59780741 5.48272991 4.57941961 0. 0. 4.71777964 + 3.77410555 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 6.61348915 + 6.89975166 9.15832806 8.16424942 0. 5.36475706 6.0949235 7.96684599 + 7.1818223 0. 6.30562115 7.53274775 6.452878 0. 0. 7.05909586 + 5.94129896 0. 0. 0. 4.97391796 3.82818747 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 7.70525885 9.80926323 8.83789158 0. 0. + 6.97918797 9.13733864 7.71865797 0. 0. 9.06696129 8.39423656 + 6.48962069 0. 0. 7.40893841 5.46171761 0. 0. 0. 4.96949959 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 10.8901453 12.0503206 + 9.82163143 0. 0. 9.67294025 10.0293036 8.60696411 0. 0. 11.012969 + 7.81186914 0. 0. 0. 7.00524521 4.8294158 0. 0. 0. 5.05639553 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 15.7084112 11.6018305 0. + 0. 0. 14.0258932 9.64515305 0. 0. 0. 9.5028038 7.19722223 0. 0. 0. + 6.34682941 4.45264292 0. 0. 0. 5.02281952 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 14.873394 11.3339014 0. 0. 0. 11.6940851 + 9.20872688 0. 0. 0. 8.63201618 6.65854073 0. 0. 0. 5.8076272 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 13.3579006 10.8810291 0. 0. 0. 10.891717 9.33057594 0. 0. 0. + 8.42234707 6.10023737 0. 0. 0. 5.40362835 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 12.6860638 10.669611 0. 0. + 0. 10.6731949 8.81359291 0. 0. 0. 7.82947493 0. 0. 0. 0. + 5.19714403 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 12.7735062 0. 0. 0. 0. 10.6698627 0. 0. 0. 0. + 7.14198971 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 12.4414873 0. 0. 0. 0. 10.0690231 0. + 0. 0. 0. 6.60324526 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 11.4918957 0. 0. 0. 0. + 9.40119171 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 10.956027 0. 0. 0. 0. + 8.84656429 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.0254520774 -0.0798276514 + -0.0952663496 -0.105490975 -0.08433339 0.0622433499 -0.0816000104 + -0.0939335674 -0.102701955 -0.0903835967 0.0802394599 -0.0808579326 + -0.100461036 -0.105166949 -0.105605766 -0.0520574674 -0.0943886936 + -0.117890306 -0.122965798 -0.139127776 -0.0362474471 -0.115332164 -0.135877803 + -0.150317937 0. -0.0765039772 -0.377600551 -0.480346978 -0.557698131 0. 0. + 0. 0. 0. 0. 0.0867718086 -0.0789151862 -0.117925309 -0.103918634 + -0.110283032 0.0134358825 -0.0746609271 -0.122122243 -0.107973352 + -0.114971511 -0.196229964 -0.10315454 -0.122947946 -0.136369392 -0.130989656 + -0.0416207798 -0.0937444642 -0.137854189 -0.141539514 -0.192608178 + -0.0225889739 -0.099901326 -0.150758877 -0.144080281 0. -0.0341244414 + -0.127064392 -0.159836233 -0.179470584 0. 0. 0. 0. 0. 0. -0.122388922 + -0.0825440735 -0.148802593 -0.116756856 -0.0944318622 -0.164918587 + -0.0963205472 -0.147100404 -0.126395628 -0.0901731774 0.0695710406 + -0.115075827 -0.0792584345 -0.127567634 -0.108953133 -0.112912804 -0.134229451 + -0.133325428 -0.138591558 0. -0.0314122215 -0.153099045 -0.151414827 + -0.166455746 0. -0.0336235538 -0.191285819 -0.251419842 -0.304659486 0. 0. + 0. 0. 0. 0. -0.114013717 -0.104239255 -0.157473162 -0.140926376 + -0.109454088 -0.129483104 -0.103092112 -0.143928632 -0.157039553 -0.115758792 + 0.126767248 -0.0958528221 -0.0859182552 -0.107814744 -0.130737677 + 0.171003118 -0.11681015 -0.11284259 -0.140839681 0. 0.0676248744 + -0.0769725889 -0.131908432 -0.170268789 0. -0.0604845956 -0.226068348 + -0.316277266 -0.386135161 0. 0. 0. 0. 0. 0. -0.0867183581 -0.106118724 + -0.147219136 -0.174744233 -0.144894838 -0.118051581 -0.115215488 -0.108518839 + -0.128582925 -0.143768519 0.131282091 -0.0243024975 -0.0949505717 + -0.115077645 -0.172791317 0.0354196392 -0.0395622589 -0.119891144 + -0.133176982 0. -0.175683498 -0.198486224 -0.213115975 -0.23612611 0. + -0.0227325521 -0.305525899 -0.358896643 0. 0. 0. 0. 0. 0. 0. + -0.0664380565 -0.0946843773 -0.0952810794 -0.111960262 -0.186975449 + -0.104466327 -0.121954374 -0.0938784629 -0.102908149 -0.187859699 + 0.00591841666 -0.0252307318 -0.143975809 -0.130381256 0. -0.284279704 + -0.171426564 -0.182072967 -0.170119539 0. 0.0762160793 -0.218629494 + -0.301062673 -0.327932447 0. -0.114655785 -0.344096243 -0.420005381 0. 0. + 0. 0. 0. 0. 0. -0.0272145774 -0.100453399 -0.072951436 -0.129915759 0. + -0.102804586 -0.157123804 -0.0975163728 -0.136794671 0. -0.0913172588 + -0.0974209085 -0.186333418 -0.0930971578 0. -0.037317846 -0.241193473 + -0.26212135 -0.349959493 0. -0.105068229 -0.248844445 -0.349720865 + -0.305065244 0. -0.0645401329 -0.365601808 0. 0. 0. 0. 0. 0. 0. 0. + -0.00101780752 -0.169652611 -0.194001213 -0.246107116 0. -0.0410654955 + -0.218129814 -0.153310806 -0.242737576 0. -0.199226677 -0.188194215 + -0.251301199 -0.248833477 0. 0.109109089 -0.226854458 -0.381783098 + -0.549496531 0. -0.0827298462 -0.315161288 -0.351887882 -0.41754204 0. + -0.0906529725 -0.392484665 0. 0. 0. 0. 0. 0. 0. 0. -0.0436162874 + -0.370049417 -0.33487761 -0.470850229 0. 0.0180398393 -0.236304566 + -0.326013923 -0.517132103 0. -0.23112306 -0.312206596 -0.356586754 + -0.701403022 0. -0.0525991805 -0.308893263 -0.562705338 -0.646888971 0. + -0.0461820252 -0.346011102 -0.454538196 -0.567117274 0. -0.0885891914 + -0.401925325 0. 0. 0. 0. 0. 0. 0. 0. -0.0985032991 -0.465099603 + -0.455487847 -0.822940171 0. 0.0643765703 -0.261743188 -0.660612404 + -1.13763046 0. -0.103768557 -0.446586162 -0.844204783 -1.62193763 0. + -0.229163527 -0.501428545 -0.921533942 -0.955459476 0. -0.100504674 + -0.409303963 -0.549087822 0. 0. -0.106519341 0. 0. 0. 0. 0. 0. 0. 0. + 0. -0.129046455 -0.489281267 -1.02522743 -2.25993538 0. 0.0752805471 + -0.365914106 -1.02812195 -2.30860591 0. -0.0668756589 -0.504460394 + -1.77559507 -1.49255252 0. 0.0773647055 -0.871572614 -1.1151731 0. 0. + -0.0730020478 -0.497833997 -0.475073427 0. 0. -0.123947129 0. 0. 0. 0. + 0. 0. 0. 0. 0. -0.0821590498 -0.443432152 -2.2252841 -1.96204352 0. + 0.0444523878 -0.552868307 -2.29008222 -1.05756032 0. 0.0772546232 + -1.50959051 -2.01264429 1.84837174 0. -0.282033503 -0.832402587 -0.082486257 + 0. 0. -0.123552196 -0.462734967 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. -0.101717249 -1.20087969 -2.5860939 3.42123342 0. 0.0356330276 + -1.78147018 -2.25820351 3.68774319 0. -0.525064468 -1.83181083 0.162405446 + 0. 0. -0.212802559 -0.580301523 0. 0. 0. -0.153228104 -0.429683208 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. -0.180227309 -2.81193185 + -0.594926059 0. 0. -0.0173117593 -2.34820771 0.0847059712 0. 0. + -0.346471339 -0.551847041 1.84384322 0. 0. -0.093470037 0.129941791 0. + 0. 0. -0.0693769902 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + -0.469221354 -1.33648026 2.69456363 0. 0. -1.12950742 -0.73125875 + 2.75440121 0. 0. -0.0958218575 0.713250756 0. 0. 0. -0.0490452386 + 0.0347795822 0. 0. 0. -0.131622061 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. -0.746921241 0.728244364 0. 0. 0. -0.167556152 + 0.872209191 0. 0. 0. 0.266262621 0.344239771 0. 0. 0. -0.0257333033 + -0.114646733 0. 0. 0. -0.0590049699 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0.74794364 1.32607698 0. 0. 0. 0.203514397 0.35266766 + 0. 0. 0. -0.0688792467 0.764736295 0. 0. 0. -0.0535879508 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. -0.0593019128 + 0.911768675 0. 0. 0. -0.0210431721 1.38586783 0. 0. 0. -0.00683018239 + 0.68025291 0. 0. 0. -0.0392546579 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. -0.00984544586 2.28318691 0. 0. 0. + -0.0546456464 1.61050558 0. 0. 0. 0.104084916 0. 0. 0. 0. + 0.00014801581 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0.0318741724 0. 0. 0. 0. 0.197972938 0. 0. 0. 0. + 0.0201082006 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0.341605425 0. 0. 0. 0. 0.225977138 0. + 0. 0. 0. 0.10241013 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.320821404 0. 0. 0. 0. + 0.214903325 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0.206997305 0. 0. 0. + 0. 0.236804411 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. diff --git a/modules/epos/epos.inics.lhc b/modules/epos/epos.inics.lhc new file mode 100644 index 0000000000000000000000000000000000000000..cf0d6033bd27e77f19e3070199fd3d82bb1a5584 --- /dev/null +++ b/modules/epos/epos.inics.lhc @@ -0,0 +1,3 @@ + 0.77499998 0.69999999 1.0000000 0.69999999 1.0000000 1.0750000 0.18000001 0.44257557 1.0000000 0.37820095 2.11779326E-02 1.0000000 0.85000002 0.69999999 0.0000000 1.0000000 1.0000000 1.0000000 1.0000000 3.99999991E-02 4.0000000 0.25000000 0.25000000 0.10000000 3 2.0000000 0.0000000 + 3 1 3 2 2 1 99 1.5000000 2000000.0 1 3.0000000 0.30000001 1.2500000 + 2.8841138 3.0764577 3.3310101 3.6772399 4.1428919 4.5129042 4.7908049 3.1744106 3.4514906 3.6977494 4.0043077 4.3923721 4.7068415 4.9510241 2.6527724 2.8973579 3.1207602 3.5142689 3.9961832 4.3727098 4.6624908 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 3.7230940 3.9133270 4.1649008 4.5055842 4.9670382 5.3334861 5.6080165 4.0130978 4.2880216 4.5316281 4.8337450 5.2172523 5.5275607 5.7677679 3.4920373 3.7347584 3.9551551 4.3432269 4.8211508 5.1943269 5.4808555 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 4.1692834 4.3350391 4.5489278 4.8240318 5.2028613 5.4998803 5.7197509 4.4258380 4.6633701 4.8663721 5.1081514 5.4153209 5.6627941 5.8549438 3.9575355 4.1733465 4.3609376 4.6815915 5.0801940 5.3866086 5.6166615 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 4.7552772 4.9047599 5.0937905 5.3297462 5.6551576 5.9099336 6.0997586 4.9840498 5.1949239 5.3712063 5.5771594 5.8391643 6.0518308 6.2191744 4.5607295 4.7575250 4.9244084 5.2039146 5.5487199 5.8125539 6.0102034 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 5.3285308 5.4563031 5.6167431 5.8124075 6.0883489 6.3057351 6.4692793 5.5288649 5.7084093 5.8561239 6.0265484 6.2468772 6.4281564 6.5730724 5.1535130 5.3254957 5.4671335 5.7023158 5.9967985 6.2225986 6.3921165 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 5.8805285 5.9864683 6.1192126 6.2794151 6.5096049 6.6919980 6.8309050 6.0505371 6.1990790 6.3200698 6.4593005 6.6426125 6.7958732 6.9202113 5.7275658 5.8735428 5.9907093 6.1853223 6.4330382 6.6219854 6.7652531 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 6.4120584 6.4976416 6.6051250 6.7353368 6.9230981 7.0743284 7.1917648 6.5517979 6.6718984 6.7693214 6.8822293 7.0332084 7.1618567 7.2679882 6.2823730 6.4028678 6.4975605 6.6574407 6.8601308 7.0159988 7.1361036 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 6.9246593 6.9924188 7.0781188 7.1821747 7.3330436 7.4578342 7.5565772 7.0359001 7.1314230 7.2091045 7.3000178 7.4235854 7.5310884 7.6211586 6.8182216 6.9151254 6.9902849 7.1194997 7.2818274 7.4093232 7.5095878 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 2.8334212 3.0364037 3.2940376 3.6454318 4.1156030 4.4871683 4.7660799 3.0922186 3.3843031 3.6355093 3.9457595 4.3376322 4.6542411 4.8999467 2.6025357 2.8580279 3.0827374 3.4821875 3.9690518 4.3472080 4.6381650 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 3.6724291 3.8733687 4.1280632 4.4738078 4.9397869 5.3078704 5.5835023 3.9309649 4.2210183 4.4696679 4.7754054 5.1627283 5.4752970 5.7171922 3.4528062 3.7040617 3.9255009 4.3181200 4.7999139 5.1744328 5.4619522 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 4.1202722 4.2974558 4.5148258 4.7943912 5.1777105 5.4763088 5.6969328 4.3479233 4.6017942 4.8105073 5.0553880 5.3659964 5.6152334 5.8082552 3.9228706 4.1469460 4.3356695 4.6600623 5.0622401 5.3699408 5.6007400 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 4.7078662 4.8692241 5.0619826 5.3022184 5.6319914 5.8881097 6.0783544 4.9100933 5.1379442 5.3202229 5.5290766 5.7940845 6.0079093 6.1754589 4.5301762 4.7347651 4.9028072 5.1856265 5.5336652 5.7985754 5.9967132 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 5.2831120 5.4234028 5.5878520 5.7874188 6.0675573 6.2861762 6.4499359 5.4596801 5.6570482 5.8110189 5.9839678 6.2067871 6.3887911 6.5335045 5.1271615 5.3065038 5.4493299 5.6872931 5.9846373 6.2114077 6.3812609 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 5.8376384 5.9566879 6.0936484 6.2573991 6.4915376 6.6748657 6.8137259 5.9871864 6.1540642 6.2812772 6.4225950 6.6078005 6.7612352 6.8849549 5.7055702 5.8583345 5.9766665 6.1735702 6.4237475 6.6134362 6.7568579 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 6.3722448 6.4713511 6.5831079 6.7165160 6.9077463 7.0595331 7.1766934 6.4952035 6.6335649 6.7368169 6.8513107 7.0034537 7.1317582 7.2369413 6.2647643 6.3912892 6.4870520 6.6487651 6.8534093 7.0097485 7.1298671 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 6.8884702 6.9698482 7.0596728 7.1665230 7.3201966 7.4451771 7.5434847 6.9867706 7.0996966 7.1824622 7.2744184 7.3984284 7.5051794 7.5940924 6.8048468 6.9068341 6.9828954 7.1134996 7.2772236 7.4049573 7.5051584 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 3.0549726 3.0830681 3.3388345 3.6775632 4.1473007 4.5107617 4.8009281 3.4222066 3.4570658 3.7034962 4.0095258 4.4049687 4.7195134 4.9497213 2.8602715 2.9058595 3.1201468 3.5188773 4.0006781 4.3924737 4.6558232 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 3.6779099 3.7091734 3.9495242 4.2561479 4.7034030 5.0413070 5.2960954 4.0278039 4.0652122 4.2984076 4.5779734 4.9396186 5.2254157 5.4533277 3.4956677 3.5342827 3.7374439 4.0995579 4.5655842 4.9145665 5.1785412 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 4.2362342 4.2605767 4.4825063 4.7570844 5.1467357 5.4427161 5.6712799 4.5604930 4.5928078 4.7954936 5.0406880 5.3549991 5.6098270 5.8084140 4.0596948 4.1024904 4.2832928 4.6148152 5.0216160 5.3371091 5.5716529 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 4.7900095 4.8165708 5.0229197 5.2616329 5.6086020 5.8703933 6.0687270 5.0940223 5.1211724 5.3030839 5.5185919 5.7899780 6.0139375 6.1849608 4.6310873 4.6746173 4.8405495 5.1328278 5.4957747 5.7747631 5.9758320 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 5.3658338 5.3958282 5.5777516 5.7883272 6.0820937 6.2987132 6.4678321 5.6468530 5.6633387 5.8247066 6.0048680 6.2364869 6.4219522 6.5681005 5.2317219 5.2650118 5.4178591 5.6719356 5.9840717 6.2207680 6.3936205 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 5.8907089 5.9241700 6.0843740 6.2606521 6.5028529 6.6852312 6.8319345 6.1341953 6.1588011 6.2961292 6.4392691 6.6300979 6.7894425 6.9157290 5.7684550 5.8062677 5.9485717 6.1664028 6.4253035 6.6215396 6.7641172 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 6.4046597 6.4429431 6.5806355 6.7256613 6.9189019 7.0675735 7.1917067 6.6149993 6.6355114 6.7475567 6.8699350 7.0245004 7.1546769 7.2615047 6.3005376 6.3451214 6.4641480 6.6474309 6.8555737 7.0117574 7.1355672 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 6.9080424 6.9482694 7.0624857 7.1749406 7.3317890 7.4534535 7.5563369 7.0819240 7.1031337 7.1944690 7.2888293 7.4154692 7.5270929 7.6171417 6.8179278 6.8640251 6.9693217 7.1142554 7.2790070 7.4070573 7.5090985 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 3.0549726 3.0830681 3.3388345 3.6775632 4.1473007 4.5107617 4.8009281 3.4222066 3.4570658 3.7034962 4.0095258 4.4049687 4.7195134 4.9497213 2.8602715 2.9058595 3.1201468 3.5188773 4.0006781 4.3924737 4.6558232 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 3.6779099 3.7091734 3.9495242 4.2561479 4.7034030 5.0413070 5.2960954 4.0278039 4.0652122 4.2984076 4.5779734 4.9396186 5.2254157 5.4533277 3.4956677 3.5342827 3.7374439 4.0995579 4.5655842 4.9145665 5.1785412 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 4.2362342 4.2605767 4.4825063 4.7570844 5.1467357 5.4427161 5.6712799 4.5604930 4.5928078 4.7954936 5.0406880 5.3549991 5.6098270 5.8084140 4.0596948 4.1024904 4.2832928 4.6148152 5.0216160 5.3371091 5.5716529 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 4.7900095 4.8165708 5.0229197 5.2616329 5.6086020 5.8703933 6.0687270 5.0940223 5.1211724 5.3030839 5.5185919 5.7899780 6.0139375 6.1849608 4.6310873 4.6746173 4.8405495 5.1328278 5.4957747 5.7747631 5.9758320 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 5.3658338 5.3958282 5.5777516 5.7883272 6.0820937 6.2987132 6.4678321 5.6468530 5.6633387 5.8247066 6.0048680 6.2364869 6.4219522 6.5681005 5.2317219 5.2650118 5.4178591 5.6719356 5.9840717 6.2207680 6.3936205 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 5.8907089 5.9241700 6.0843740 6.2606521 6.5028529 6.6852312 6.8319345 6.1341953 6.1588011 6.2961292 6.4392691 6.6300979 6.7894425 6.9157290 5.7684550 5.8062677 5.9485717 6.1664028 6.4253035 6.6215396 6.7641172 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 6.4046597 6.4429431 6.5806355 6.7256613 6.9189019 7.0675735 7.1917067 6.6149993 6.6355114 6.7475567 6.8699350 7.0245004 7.1546769 7.2615047 6.3005376 6.3451214 6.4641480 6.6474309 6.8555737 7.0117574 7.1355672 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 6.9080424 6.9482694 7.0624857 7.1749406 7.3317890 7.4534535 7.5563369 7.0819240 7.1031337 7.1944690 7.2888293 7.4154692 7.5270929 7.6171417 6.8179278 6.8640251 6.9693217 7.1142554 7.2790070 7.4070573 7.5090985 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 3.1744106 3.4514906 3.6977494 4.0043077 4.3923721 4.7068415 4.9510241 4.0130978 4.2880216 4.5316281 4.8337450 5.2172523 5.5275607 5.7677679 4.4258380 4.6633701 4.8663721 5.1081514 5.4153209 5.6627941 5.8549438 4.9840498 5.1949239 5.3712063 5.5771594 5.8391643 6.0518308 6.2191744 5.5288649 5.7084093 5.8561239 6.0265484 6.2468772 6.4281564 6.5730724 6.0505371 6.1990790 6.3200698 6.4593005 6.6426125 6.7958732 6.9202113 6.5517979 6.6718984 6.7693214 6.8822293 7.0332084 7.1618567 7.2679882 7.0359001 7.1314230 7.2091045 7.3000178 7.4235854 7.5310884 7.6211586 4.0130978 4.2880216 4.5316281 4.8337450 5.2172523 5.5275607 5.7677679 1.8631201 2.3499029 2.7316854 3.1488461 3.6777606 4.1119657 4.4503436 2.4364924 2.9039888 3.2719047 3.6724024 4.1920571 4.6265807 4.9681215 3.1183846 3.5719111 3.9278128 4.3112202 4.8187881 5.2436395 5.5751591 3.7944458 4.2241821 4.5600305 4.9209361 5.4137940 5.8241825 6.1390848 4.4642229 4.8662028 5.1785064 5.5254259 6.0018225 6.3881168 6.6770959 5.1265216 5.4983668 5.7868609 6.1330872 6.5740271 6.9174328 7.1665859 5.7794800 6.1196356 6.3978295 6.7237525 7.1157126 7.4084749 7.6140828 4.4258380 4.6633701 4.8663721 5.1081514 5.4153209 5.6627941 5.8549438 4.9360399 5.2329164 5.4610028 5.7029014 6.0218806 6.2834873 6.4841518 5.3591208 5.6074519 5.7954192 5.9897771 6.2438369 6.4500971 6.6077189 5.8831229 6.0953856 6.2536173 6.4141674 6.6246705 6.7951751 6.9268131 6.3669577 6.5384350 6.6654010 6.7940297 6.9678235 7.1110964 7.2233953 6.8071675 6.9418283 7.0418258 7.1478114 7.2950830 7.4176435 7.5149965 7.2159553 7.3210416 7.4002337 7.4936481 7.6165323 7.7198849 7.8031936 7.6060133 7.6885934 7.7556815 7.8346152 7.9369459 8.0242434 8.0955048 4.9840498 5.1949239 5.3712063 5.5771594 5.8391643 6.0518308 6.2191744 5.4286036 5.7251339 5.9462786 6.1725993 6.4645081 6.6968646 6.8716536 5.7538705 5.9889722 6.1613364 6.3343320 6.5517201 6.7248898 6.8579593 6.2054682 6.4007955 6.5431294 6.6850595 6.8646002 7.0101972 7.1243353 6.6231561 6.7804465 6.8958273 7.0112906 7.1616578 7.2865162 7.3863363 7.0064712 7.1326566 7.2262425 7.3227158 7.4532247 7.5626245 7.6504731 7.3707094 7.4725375 7.5489969 7.6351895 7.7463279 7.8402557 7.9165373 7.7271528 7.8098922 7.8756104 7.9496603 8.0439148 8.1244297 8.1904669 5.5288649 5.7084093 5.8561239 6.0265484 6.2468772 6.4281564 6.5730724 5.7832093 6.0870986 6.3083258 6.5291195 6.8017974 7.0115614 7.1667004 6.0103731 6.2403393 6.4056063 6.5683146 6.7634935 6.9177079 7.0369539 6.4048619 6.5950861 6.7326231 6.8684511 7.0332303 7.1661081 7.2708468 6.7789741 6.9349232 7.0492983 7.1628923 7.3036156 7.4190774 7.5120645 7.1288881 7.2572088 7.3526349 7.4490628 7.5725298 7.6747093 7.7571721 7.4679594 7.5740490 7.6538916 7.7398019 7.8462434 7.9350100 8.0073662 7.8051448 7.8931184 7.9620481 8.0363350 8.1276741 8.2045279 8.2677107 6.0505371 6.1990790 6.3200698 6.4593005 6.6426125 6.7958732 6.9202113 6.0209622 6.3220749 6.5387983 6.7557669 7.0080018 7.1983232 7.3406816 6.1641192 6.3849268 6.5430555 6.6994801 6.8811116 7.0240188 7.1352124 6.5210123 6.7053881 6.8390961 6.9722953 7.1293855 7.2551031 7.3539925 6.8698916 7.0237384 7.1370926 7.2508826 7.3874741 7.4982467 7.5865102 7.2011371 7.3299642 7.4263082 7.5242934 7.6446934 7.7430320 7.8214645 7.5260639 7.6342063 7.7161641 7.8028359 7.9075098 7.9937510 8.0630064 7.8522515 7.9430885 8.0140057 8.0890579 8.1796808 8.2549448 8.3157558 6.5517979 6.6718984 6.7693214 6.8822293 7.0332084 7.1618567 7.2679882 6.1610947 6.4485941 6.6539664 6.8610239 7.0844231 7.2553120 7.3873658 6.2465286 6.4554610 6.6051393 6.7555823 6.9216905 7.0541329 7.1593752 6.5827680 6.7593799 6.8876653 7.0177393 7.1635504 7.2813349 7.3755655 6.9185667 7.0678587 7.1779623 7.2905746 7.4187655 7.5233269 7.6074271 7.2401123 7.3666878 7.4613500 7.5591965 7.6724329 7.7652111 7.8400373 7.5576782 7.6650596 7.7463522 7.8323765 7.9314113 8.0131865 8.0794754 7.8779621 7.9690533 8.0395269 8.1139870 8.2002106 8.2719183 8.3302679 7.0359001 7.1314230 7.2091045 7.3000178 7.4235854 7.5310884 7.6211586 6.2352152 6.5077949 6.7027197 6.8936663 7.0984497 7.2615762 7.3908930 6.2873921 6.4863911 6.6297398 6.7718167 6.9285398 7.0570302 7.1608500 6.6133900 6.7832375 6.9071555 7.0311189 7.1695800 7.2840629 7.3770099 6.9428225 7.0877109 7.1947289 7.3027749 7.4248452 7.5262899 7.6090140 7.2597804 7.3834863 7.4759974 7.5704484 7.6781054 7.7679167 7.8415518 7.5735235 7.6792731 7.7595081 7.8420596 7.9362803 8.0157280 8.0808849 7.8914275 7.9816098 8.0501499 8.1220388 8.2048855 8.2739687 8.3313942 3.0922186 3.3843031 3.6355093 3.9457595 4.3376322 4.6542411 4.8999467 3.9912086 4.2700658 4.5149932 4.8180614 5.2025743 5.5134797 5.7541332 4.4104533 4.6511321 4.8552442 5.0976281 5.4054704 5.6532888 5.8456097 4.9739480 5.1870837 5.3641734 5.5705185 5.8329301 6.0457540 6.2131252 5.5228543 5.7039113 5.8521624 6.0228043 6.2433481 6.4246902 6.5695882 6.0473809 6.1968164 6.3181143 6.4574485 6.6408548 6.7941236 6.9184313 6.5503745 6.6709261 6.7684946 6.8814425 7.0324502 7.1610899 7.2671976 7.0353680 7.1310763 7.2088127 7.2997370 7.4233093 7.5308046 7.6208620 3.9912086 4.2700658 4.5149932 4.8180614 5.2025743 5.5134797 5.7541332 1.8571951 2.3452187 2.7274628 3.1447923 3.6739578 4.1084137 4.4470367 2.4332552 2.9014781 3.2696719 3.6702542 4.1900430 4.6247053 4.9663792 3.1168416 3.5707319 3.9267774 4.3102269 4.8178582 5.2427807 5.5743713 3.7938266 4.2237215 4.5596356 4.9205589 5.4134407 5.8238602 6.1387949 4.4640217 4.8660583 5.1783867 5.5253110 6.0017152 6.3880205 6.6770115 5.1264715 5.4983315 5.7868333 6.1330600 6.5740018 6.9174113 7.1665678 5.7794709 6.1196299 6.3978248 6.7237477 7.1157084 7.4084721 7.6140800 4.4104533 4.6511321 4.8552442 5.0976281 5.4054704 5.6532888 5.8456097 4.9305291 5.2288275 5.4574347 5.6994801 6.0186801 6.2804985 6.4813514 5.3563194 5.6055112 5.7937961 5.9882455 6.2424345 6.4488025 6.6065025 5.8818874 6.0945797 6.2529669 6.4135618 6.6241207 6.7946668 6.9263301 6.3665123 6.5381670 6.6651936 6.7938375 6.9676476 7.1109314 7.2232361 6.8070421 6.9417591 7.0417743 7.1477633 7.2950373 7.4175987 7.5149527 7.2159290 7.3210278 7.4002242 7.4936380 7.6165228 7.7198753 7.8031840 7.6060095 7.6885915 7.7556801 7.8346138 7.9369445 8.0242414 8.0955029 4.9739480 5.1870837 5.3641734 5.5705185 5.8329301 6.0457540 6.2131252 5.4233999 5.7214456 5.9431520 6.1696463 6.4618020 6.6943789 6.8693385 5.7513738 5.9873729 6.1600556 6.3331485 6.5506597 6.7239122 6.8570285 6.2044249 6.4001760 6.5426493 6.6846175 6.8641992 7.0098195 7.1239686 6.6228008 6.7802510 6.8956804 7.0111537 7.1615295 7.2863932 7.3862152 7.0063767 7.1326075 7.2262063 7.3226810 7.4531913 7.5625911 7.6504402 7.3706903 7.4725280 7.5489898 7.6351829 7.7463207 7.8402486 7.9165306 7.7271504 7.8098907 7.8756094 7.9496593 8.0439138 8.1244287 8.1904659 5.5228543 5.7039113 5.8521624 6.0228043 6.2433481 6.4246902 6.5695882 5.7784181 6.0839624 6.3058248 6.5268393 6.7998285 7.0098467 7.1651516 6.0082431 6.2391329 6.4047155 6.5675297 6.7628312 6.9171190 7.0364008 6.4040198 6.5946450 6.7323050 6.8681688 7.0329843 7.1658831 7.2706318 6.7786989 6.9347873 7.0492015 7.1628051 7.3035369 7.4190044 7.5119934 7.1288166 7.2571745 7.3526111 7.4490409 7.5725093 7.6746893 7.7571526 7.4679451 7.5740418 7.6538868 7.7397976 7.8462391 7.9350057 8.0073614 7.8051424 7.8931174 7.9620476 8.0363340 8.1276731 8.2045269 8.2677097 6.0473809 6.1968164 6.3181143 6.4574485 6.6408548 6.7941236 6.9184313 6.0167298 6.3196001 6.5370102 6.7542429 7.0068698 7.1974783 7.3399935 6.1623993 6.3840890 6.5425043 6.6990323 6.8807840 7.0237656 7.1349969 6.5203624 6.7050900 6.8389020 6.9721351 7.1292634 7.2550054 7.3539081 6.8696837 7.0236464 7.1370330 7.2508330 7.3874345 7.4982142 7.5864816 7.2010832 7.3299408 7.4262934 7.5242810 7.6446829 7.7430234 7.8214569 7.5260530 7.6342020 7.7161613 7.8028336 7.9075079 7.9937491 8.0630045 7.8522496 7.9430881 8.0140057 8.0890579 8.1796799 8.2549448 8.3157549 6.5503745 6.6709261 6.7684946 6.8814425 7.0324502 7.1610899 7.2671976 6.1575680 6.4468293 6.6528535 6.8601699 7.0839653 7.2550883 7.3872428 6.2452202 6.4549236 6.6048312 6.7553568 6.9215717 7.0540729 7.1593409 6.5822878 6.7591896 6.8875566 7.0176578 7.1635051 7.2813110 7.3755512 6.9184141 7.0677996 7.1779284 7.2905488 7.4187503 7.5233183 7.6074219 7.2400723 7.3666730 7.4613414 7.5591898 7.6724286 7.7652087 7.8400359 7.5576706 7.6650562 7.7463503 7.8323750 7.9314103 8.0131865 8.0794744 7.8779612 7.9690528 8.0395260 8.1139860 8.2002106 8.2719183 8.3302679 7.0353680 7.1310763 7.2088127 7.2997370 7.4233093 7.5308046 7.6208620 6.2324977 6.5066934 6.7021275 6.8932886 7.0983238 7.2615452 7.3908854 6.2864652 6.4860802 6.6295862 6.7717223 6.9285092 7.0570226 7.1608486 6.6130552 6.7831273 6.9071007 7.0310845 7.1695681 7.2840600 7.3770089 6.9427161 7.0876760 7.1947117 7.3027639 7.4248409 7.5262890 7.6090136 7.2597523 7.3834772 7.4759932 7.5704455 7.6781044 7.7679162 7.8415518 7.5735178 7.6792712 7.7595072 7.8420591 7.9362798 8.0157280 8.0808849 7.8914270 7.9816093 8.0501499 8.1220388 8.2048855 8.2739687 8.3313942 3.4222739 3.4571228 3.7034194 4.0096951 4.4048882 4.7193255 4.9497924 4.0261588 4.0590887 4.2850718 4.5792775 4.9359255 5.2210441 5.4485908 4.5536990 4.5836501 4.8008132 5.0381308 5.3580775 5.6097846 5.8135743 5.0961461 5.1272154 5.3136883 5.5157819 5.7891512 6.0080791 6.1822624 5.6416020 5.6683989 5.8285699 6.0033727 6.2337961 6.4160986 6.5669255 6.1396689 6.1521940 6.2884631 6.4441285 6.6263232 6.7852559 6.9116259 6.6109204 6.6372952 6.7512155 6.8648224 7.0202198 7.1553631 7.2621613 7.0812497 7.1063714 7.1935301 7.2904243 7.4184136 7.5294023 7.6155667 4.0263166 4.0585794 4.2849302 4.5770903 4.9360847 5.2272367 5.4523172 4.6253009 4.6389890 4.8614020 5.1260600 5.4540687 5.7042627 5.8981524 5.1063223 5.1502132 5.3317890 5.5457897 5.8293891 6.0398688 6.2143354 5.6062126 5.6446309 5.7985258 5.9775229 6.2131796 6.3983941 6.5482001 6.1050949 6.1225739 6.2517071 6.4046979 6.5958910 6.7644286 6.8855062 6.5325832 6.5553012 6.6618185 6.7794242 6.9391217 7.0742865 7.2028069 6.9567404 6.9794259 7.0629196 7.1543694 7.2884917 7.4088287 7.5064359 7.3657284 7.3803678 7.4500222 7.5332255 7.6453190 7.7423282 7.8269510 4.5726743 4.5863833 4.8004084 5.0394087 5.3640695 5.6056528 5.8040318 5.1143370 5.1395893 5.3337293 5.5518694 5.8138885 6.0437789 6.2198687 5.5632682 5.5849595 5.7383218 5.9144158 6.1344023 6.3210077 6.4732137 5.9904509 6.0087194 6.1309967 6.2709055 6.4668498 6.6363730 6.7746964 6.4014773 6.4203939 6.5319300 6.6420608 6.8116741 6.9589252 7.0763097 6.7797627 6.8002181 6.8819013 6.9884558 7.1268492 7.2478471 7.3497486 7.1470098 7.1636066 7.2346654 7.3208342 7.4406424 7.5481510 7.6455889 7.5297189 7.5390315 7.5964322 7.6665087 7.7656088 7.8577461 7.9423599 5.0934300 5.1203971 5.3053350 5.5171065 5.7901788 6.0088053 6.1806703 5.6093817 5.6417017 5.8015828 5.9767213 6.2084861 6.4000597 6.5549421 5.9863300 6.0103264 6.1365247 6.2683301 6.4673610 6.6369982 6.7728138 6.3597131 6.3748307 6.4777212 6.5975122 6.7646770 6.9023600 7.0296440 6.7208314 6.7344327 6.8203969 6.9242735 7.0624657 7.1967030 7.2989407 7.0454259 7.0580192 7.1355429 7.2279835 7.3450499 7.4629507 7.5557618 7.3825464 7.3903461 7.4529691 7.5215993 7.6370349 7.7335830 7.8193574 7.7166085 7.7269621 7.7818670 7.8428264 7.9363270 8.0212355 8.0957651 5.6316724 5.6690125 5.8198304 6.0000877 6.2346706 6.4264135 6.5732617 6.0983849 6.1168299 6.2526298 6.4049945 6.5924597 6.7573886 6.8889036 6.4022970 6.4200935 6.5224237 6.6437392 6.8109174 6.9527731 7.0749564 6.7189608 6.7357364 6.8212576 6.9282084 7.0727315 7.1981788 7.3028646 7.0348554 7.0515032 7.1232767 7.2105613 7.3394227 7.4505939 7.5454178 7.3213830 7.3294945 7.3992701 7.4751883 7.5882697 7.6874595 7.7689900 7.6144576 7.6262918 7.6784096 7.7423277 7.8447218 7.9303322 8.0139370 7.9187927 7.9234266 7.9735341 8.0339441 8.1170321 8.1945353 8.2620592 6.1397743 6.1506324 6.2869778 6.4452209 6.6311917 6.7926135 6.9170732 6.5289583 6.5466003 6.6679487 6.7859483 6.9425673 7.0821424 7.1958423 6.7770243 6.7931800 6.8867660 6.9815202 7.1245036 7.2488270 7.3543577 7.0468626 7.0606847 7.1329589 7.2228494 7.3531232 7.4607100 7.5573034 7.3244839 7.3272457 7.3961172 7.4731302 7.5856404 7.6846709 7.7698631 7.5719876 7.5850096 7.6400671 7.7077665 7.8060584 7.9008822 7.9769425 7.8397045 7.8463597 7.8952174 7.9494872 8.0381622 8.1255093 8.1925726 8.1132288 8.1193199 8.1665344 8.2145491 8.2948704 8.3623791 8.4286242 6.6166325 6.6372485 6.7462544 6.8733435 7.0257382 7.1545587 7.2617841 6.9557714 6.9645309 7.0616088 7.1521635 7.2904477 7.4101620 7.5063033 7.1537523 7.1640377 7.2376852 7.3215966 7.4392228 7.5463848 7.6355400 7.3778787 7.3938713 7.4512348 7.5306463 7.6379781 7.7355871 7.8181343 7.6141324 7.6223607 7.6788259 7.7486868 7.8470359 7.9312878 8.0115328 7.8356924 7.8450642 7.8943052 7.9582810 8.0430994 8.1268139 8.1956844 8.0668011 8.0736408 8.1202908 8.1737528 8.2555771 8.3261805 8.3940725 8.3145790 8.3227119 8.3615847 8.4093132 8.4799471 8.5487499 8.6070614 7.0878248 7.1034193 7.1952004 7.2899623 7.4176226 7.5260744 7.6175747 7.3622742 7.3827124 7.4477501 7.5321107 7.6436558 7.7395811 7.8253322 7.5280437 7.5326104 7.5943155 7.6703448 7.7701397 7.8602581 7.9427309 7.7128477 7.7282929 7.7788563 7.8428264 7.9360900 8.0215492 8.0970488 7.9176936 7.9246664 7.9753180 8.0254507 8.1158161 8.1941519 8.2689867 8.1117716 8.1182709 8.1601563 8.2177362 8.2932949 8.3659735 8.4285097 8.3175325 8.3234749 8.3649015 8.4107151 8.4811392 8.5472736 8.6068077 8.5395517 8.5400076 8.5791044 8.6181631 8.6834364 8.7479296 8.8001413 3.4222739 3.4571228 3.7034194 4.0096951 4.4048882 4.7193255 4.9497924 4.0261588 4.0590887 4.2850718 4.5792775 4.9359255 5.2210441 5.4485908 4.5536990 4.5836501 4.8008132 5.0381308 5.3580775 5.6097846 5.8135743 5.0961461 5.1272154 5.3136883 5.5157819 5.7891512 6.0080791 6.1822624 5.6416020 5.6683989 5.8285699 6.0033727 6.2337961 6.4160986 6.5669255 6.1396689 6.1521940 6.2884631 6.4441285 6.6263232 6.7852559 6.9116259 6.6109204 6.6372952 6.7512155 6.8648224 7.0202198 7.1553631 7.2621613 7.0812497 7.1063714 7.1935301 7.2904243 7.4184136 7.5294023 7.6155667 4.0263166 4.0585794 4.2849302 4.5770903 4.9360847 5.2272367 5.4523172 4.6253009 4.6389890 4.8614020 5.1260600 5.4540687 5.7042627 5.8981524 5.1063223 5.1502132 5.3317890 5.5457897 5.8293891 6.0398688 6.2143354 5.6062126 5.6446309 5.7985258 5.9775229 6.2131796 6.3983941 6.5482001 6.1050949 6.1225739 6.2517071 6.4046979 6.5958910 6.7644286 6.8855062 6.5325832 6.5553012 6.6618185 6.7794242 6.9391217 7.0742865 7.2028069 6.9567404 6.9794259 7.0629196 7.1543694 7.2884917 7.4088287 7.5064359 7.3657284 7.3803678 7.4500222 7.5332255 7.6453190 7.7423282 7.8269510 4.5726743 4.5863833 4.8004084 5.0394087 5.3640695 5.6056528 5.8040318 5.1143370 5.1395893 5.3337293 5.5518694 5.8138885 6.0437789 6.2198687 5.5632682 5.5849595 5.7383218 5.9144158 6.1344023 6.3210077 6.4732137 5.9904509 6.0087194 6.1309967 6.2709055 6.4668498 6.6363730 6.7746964 6.4014773 6.4203939 6.5319300 6.6420608 6.8116741 6.9589252 7.0763097 6.7797627 6.8002181 6.8819013 6.9884558 7.1268492 7.2478471 7.3497486 7.1470098 7.1636066 7.2346654 7.3208342 7.4406424 7.5481510 7.6455889 7.5297189 7.5390315 7.5964322 7.6665087 7.7656088 7.8577461 7.9423599 5.0934300 5.1203971 5.3053350 5.5171065 5.7901788 6.0088053 6.1806703 5.6093817 5.6417017 5.8015828 5.9767213 6.2084861 6.4000597 6.5549421 5.9863300 6.0103264 6.1365247 6.2683301 6.4673610 6.6369982 6.7728138 6.3597131 6.3748307 6.4777212 6.5975122 6.7646770 6.9023600 7.0296440 6.7208314 6.7344327 6.8203969 6.9242735 7.0624657 7.1967030 7.2989407 7.0454259 7.0580192 7.1355429 7.2279835 7.3450499 7.4629507 7.5557618 7.3825464 7.3903461 7.4529691 7.5215993 7.6370349 7.7335830 7.8193574 7.7166085 7.7269621 7.7818670 7.8428264 7.9363270 8.0212355 8.0957651 5.6316724 5.6690125 5.8198304 6.0000877 6.2346706 6.4264135 6.5732617 6.0983849 6.1168299 6.2526298 6.4049945 6.5924597 6.7573886 6.8889036 6.4022970 6.4200935 6.5224237 6.6437392 6.8109174 6.9527731 7.0749564 6.7189608 6.7357364 6.8212576 6.9282084 7.0727315 7.1981788 7.3028646 7.0348554 7.0515032 7.1232767 7.2105613 7.3394227 7.4505939 7.5454178 7.3213830 7.3294945 7.3992701 7.4751883 7.5882697 7.6874595 7.7689900 7.6144576 7.6262918 7.6784096 7.7423277 7.8447218 7.9303322 8.0139370 7.9187927 7.9234266 7.9735341 8.0339441 8.1170321 8.1945353 8.2620592 6.1397743 6.1506324 6.2869778 6.4452209 6.6311917 6.7926135 6.9170732 6.5289583 6.5466003 6.6679487 6.7859483 6.9425673 7.0821424 7.1958423 6.7770243 6.7931800 6.8867660 6.9815202 7.1245036 7.2488270 7.3543577 7.0468626 7.0606847 7.1329589 7.2228494 7.3531232 7.4607100 7.5573034 7.3244839 7.3272457 7.3961172 7.4731302 7.5856404 7.6846709 7.7698631 7.5719876 7.5850096 7.6400671 7.7077665 7.8060584 7.9008822 7.9769425 7.8397045 7.8463597 7.8952174 7.9494872 8.0381622 8.1255093 8.1925726 8.1132288 8.1193199 8.1665344 8.2145491 8.2948704 8.3623791 8.4286242 6.6166325 6.6372485 6.7462544 6.8733435 7.0257382 7.1545587 7.2617841 6.9557714 6.9645309 7.0616088 7.1521635 7.2904477 7.4101620 7.5063033 7.1537523 7.1640377 7.2376852 7.3215966 7.4392228 7.5463848 7.6355400 7.3778787 7.3938713 7.4512348 7.5306463 7.6379781 7.7355871 7.8181343 7.6141324 7.6223607 7.6788259 7.7486868 7.8470359 7.9312878 8.0115328 7.8356924 7.8450642 7.8943052 7.9582810 8.0430994 8.1268139 8.1956844 8.0668011 8.0736408 8.1202908 8.1737528 8.2555771 8.3261805 8.3940725 8.3145790 8.3227119 8.3615847 8.4093132 8.4799471 8.5487499 8.6070614 7.0878248 7.1034193 7.1952004 7.2899623 7.4176226 7.5260744 7.6175747 7.3622742 7.3827124 7.4477501 7.5321107 7.6436558 7.7395811 7.8253322 7.5280437 7.5326104 7.5943155 7.6703448 7.7701397 7.8602581 7.9427309 7.7128477 7.7282929 7.7788563 7.8428264 7.9360900 8.0215492 8.0970488 7.9176936 7.9246664 7.9753180 8.0254507 8.1158161 8.1941519 8.2689867 8.1117716 8.1182709 8.1601563 8.2177362 8.2932949 8.3659735 8.4285097 8.3175325 8.3234749 8.3649015 8.4107151 8.4811392 8.5472736 8.6068077 8.5395517 8.5400076 8.5791044 8.6181631 8.6834364 8.7479296 8.8001413 diff --git a/modules/epos/epos.iniev b/modules/epos/epos.iniev new file mode 100644 index 0000000000000000000000000000000000000000..d2ddc271a4e0c1cce0f81e3a3f001ea248f58055 --- /dev/null +++ b/modules/epos/epos.iniev @@ -0,0 +1,2 @@ + 3.9999999E-02 4.000000 0.2500000 3 1.0000000E+12 + 0.000000 0.4696323 1.208617 2.203873 3.422099 4.825604 6.382537 8.069034 9.867649 11.76526 13.75166 15.81864 17.95949 20.16854 22.44100 24.77271 27.16005 29.59986 32.08936 34.62603 37.20760 0.000000 0.4466415 1.150649 2.101769 3.270671 4.622427 6.126462 7.759326 9.503679 11.34644 13.27741 15.28842 17.37276 19.52476 21.73966 24.01328 26.34204 28.72278 31.15271 33.62933 36.15037 0.000000 0.4235427 1.091940 1.997226 3.113832 4.409669 5.855585 7.428665 9.111727 10.89175 12.75859 14.70410 16.72161 18.80548 20.95096 23.15393 25.41082 27.71849 30.07417 32.47540 34.91993 0.000000 0.4003465 1.032562 1.890463 2.951971 4.187922 5.570780 7.078292 8.693527 10.40357 12.19838 14.06986 16.01140 18.01746 20.08332 22.20492 24.37874 26.60171 28.87111 31.18449 33.53968 0.000000 0.3770608 0.9725908 1.781701 2.785521 3.957881 5.273051 6.709624 8.251027 9.884529 11.60021 13.39011 15.24771 17.16757 19.14507 21.17624 23.25762 25.38623 27.55941 29.77479 32.03025 0.000000 0.3536964 0.9121037 1.671182 2.614966 3.720310 4.963499 6.324172 7.786246 9.337260 10.96748 12.66910 14.43577 16.26215 18.14376 20.07672 22.05770 24.08378 26.15240 28.26126 30.40832 0.000000 0.3302620 0.8511789 1.559165 2.440823 3.476036 4.643292 5.923504 7.301230 8.764370 10.30344 11.91083 13.58037 15.30687 17.08600 18.91400 20.78765 22.70414 24.66099 26.65601 28.68721 0.000000 0.3067673 0.7898996 1.445923 2.263661 3.225952 4.313684 5.509253 6.798041 8.168411 9.611185 11.11900 12.68587 14.30679 15.97758 17.69463 19.45483 21.25549 23.09425 24.96899 26.87782 0.000000 0.2832215 0.7283498 1.331738 2.084070 2.971018 3.976003 5.083127 6.278783 7.551916 8.893716 10.29709 11.75628 13.26648 14.82367 16.42438 18.06565 19.74492 21.45992 23.20865 24.98931 0.000000 0.2596332 0.6666171 1.216907 1.902695 2.712280 3.631690 4.646945 5.745645 6.917446 8.153984 9.448482 10.79542 12.19020 13.62899 15.10849 16.62587 18.17871 19.76485 21.38242 23.02971 0.000000 0.2360110 0.6047859 1.101735 1.720202 2.450856 3.282314 4.202685 5.200967 6.267685 7.395014 8.576540 9.807017 11.08208 12.39808 13.75190 15.14087 16.56268 18.01534 19.49705 21.00623 0.000000 0.2123645 0.5429448 0.9865291 1.537305 2.187969 2.929617 3.752545 4.647338 5.605562 6.620048 7.684821 8.794950 9.946318 11.13549 12.35951 13.61589 14.90248 16.21739 17.55896 18.92572 0.000000 0.1887031 0.4811787 0.8716109 1.354741 1.924939 2.575537 3.299023 4.087719 4.934414 5.832748 6.777281 7.763457 8.787442 9.846024 10.93646 12.05641 13.20387 14.37711 15.57459 16.79494 0.000000 0.1650364 0.4195779 0.7572958 1.173286 1.663188 2.222253 2.845016 3.525615 4.258230 5.037483 5.858607 6.717511 7.610694 8.535205 9.488506 10.46845 11.47318 12.50111 13.55083 14.62108 0.000000 0.1413736 0.3582284 0.6439041 0.9937271 1.404243 1.872194 2.393904 2.965264 3.581951 4.239743 4.934711 5.663357 6.422605 7.209816 8.022697 8.859296 9.717936 10.59717 11.49571 12.41242 0.000000 0.1177241 0.2972134 0.5317546 0.8168709 1.149709 1.528057 1.949631 2.411856 2.911876 3.446732 4.013496 4.609430 5.232016 5.879023 6.548467 7.238637 7.948047 8.675412 9.419591 10.17956 0.000000 9.4096996E-02 0.2366145 0.4211515 0.6435134 0.9012415 1.192764 1.516725 1.871703 2.256088 2.668135 3.105994 3.567828 4.051838 4.556351 5.079810 5.620826 6.178169 6.750756 7.337606 7.937829 0.000000 7.0501857E-02 0.1765181 0.3124009 0.4744409 0.6605081 0.8693829 1.100210 1.352257 1.624761 1.916911 2.227806 2.556505 2.902015 3.263354 3.639537 4.029645 4.432823 4.848279 5.275257 5.713050 0.000000 4.6948172E-02 0.1170029 0.2057849 0.3103889 0.4291120 0.5609756 0.7053527 0.8618109 1.029989 1.209571 1.400235 1.601663 1.813502 2.035399 2.266968 2.507833 2.757621 3.015952 3.282427 3.556656 0.000000 2.3444591E-02 5.8142666E-02 0.1015656 0.1520458 0.2085233 0.2703867 0.3372054 0.4086977 0.4846432 0.5648846 0.6492854 0.7377474 0.8301750 0.9264929 1.026623 1.130509 1.238090 1.349308 1.464088 1.582359 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4696324 1.208617 2.203874 3.422099 4.825604 6.382537 8.069034 9.867649 11.76526 13.75166 15.81864 17.95949 20.16854 22.44100 24.77271 27.16005 29.59986 32.08936 34.62603 37.20760 0.000000 0.4466415 1.150649 2.101769 3.270671 4.622427 6.126462 7.759326 9.503679 11.34644 13.27741 15.28842 17.37276 19.52476 21.73966 24.01328 26.34204 28.72278 31.15271 33.62933 36.15037 0.000000 0.4235427 1.091940 1.997226 3.113832 4.409669 5.855585 7.428665 9.111727 10.89175 12.75859 14.70410 16.72161 18.80548 20.95096 23.15393 25.41082 27.71849 30.07417 32.47540 34.91993 0.000000 0.4003465 1.032562 1.890463 2.951971 4.187922 5.570781 7.078292 8.693527 10.40357 12.19838 14.06986 16.01140 18.01746 20.08332 22.20492 24.37874 26.60171 28.87111 31.18449 33.53968 0.000000 0.3770608 0.9725908 1.781701 2.785521 3.957881 5.273051 6.709624 8.251027 9.884529 11.60021 13.39011 15.24771 17.16757 19.14507 21.17624 23.25762 25.38623 27.55941 29.77479 32.03025 0.000000 0.3536964 0.9121037 1.671182 2.614966 3.720310 4.963499 6.324172 7.786246 9.337260 10.96748 12.66910 14.43577 16.26215 18.14376 20.07672 22.05770 24.08378 26.15240 28.26126 30.40832 0.000000 0.3302620 0.8511790 1.559165 2.440823 3.476036 4.643292 5.923504 7.301230 8.764370 10.30344 11.91083 13.58037 15.30687 17.08600 18.91400 20.78765 22.70414 24.66099 26.65601 28.68721 0.000000 0.3067673 0.7898996 1.445923 2.263661 3.225952 4.313684 5.509253 6.798041 8.168411 9.611185 11.11900 12.68587 14.30679 15.97758 17.69463 19.45483 21.25549 23.09425 24.96899 26.87782 0.000000 0.2832215 0.7283498 1.331738 2.084070 2.971018 3.976003 5.083127 6.278783 7.551916 8.893716 10.29709 11.75628 13.26648 14.82367 16.42438 18.06565 19.74492 21.45992 23.20865 24.98931 0.000000 0.2596332 0.6666171 1.216907 1.902695 2.712280 3.631690 4.646945 5.745645 6.917446 8.153984 9.448482 10.79542 12.19020 13.62899 15.10849 16.62587 18.17871 19.76485 21.38242 23.02971 0.000000 0.2360110 0.6047859 1.101735 1.720202 2.450856 3.282314 4.202685 5.200967 6.267685 7.395014 8.576540 9.807017 11.08208 12.39808 13.75190 15.14087 16.56268 18.01534 19.49705 21.00623 0.000000 0.2123645 0.5429448 0.9865291 1.537305 2.187969 2.929617 3.752545 4.647338 5.605562 6.620048 7.684821 8.794950 9.946318 11.13549 12.35951 13.61589 14.90248 16.21739 17.55896 18.92572 0.000000 0.1887031 0.4811787 0.8716109 1.354741 1.924939 2.575537 3.299023 4.087719 4.934414 5.832748 6.777281 7.763457 8.787442 9.846024 10.93646 12.05641 13.20387 14.37711 15.57459 16.79494 0.000000 0.1650364 0.4195779 0.7572958 1.173286 1.663188 2.222253 2.845016 3.525615 4.258230 5.037483 5.858607 6.717511 7.610694 8.535205 9.488506 10.46845 11.47318 12.50111 13.55083 14.62108 0.000000 0.1413736 0.3582284 0.6439041 0.9937271 1.404243 1.872194 2.393904 2.965264 3.581951 4.239743 4.934711 5.663357 6.422605 7.209816 8.022697 8.859296 9.717936 10.59717 11.49571 12.41242 0.000000 0.1177241 0.2972134 0.5317546 0.8168709 1.149709 1.528057 1.949631 2.411856 2.911876 3.446732 4.013496 4.609430 5.232016 5.879023 6.548467 7.238637 7.948047 8.675412 9.419591 10.17956 0.000000 9.4096996E-02 0.2366145 0.4211515 0.6435134 0.9012415 1.192764 1.516725 1.871703 2.256088 2.668135 3.105994 3.567828 4.051838 4.556351 5.079810 5.620826 6.178169 6.750756 7.337606 7.937829 0.000000 7.0501857E-02 0.1765181 0.3124009 0.4744409 0.6605081 0.8693829 1.100210 1.352257 1.624761 1.916911 2.227806 2.556505 2.902015 3.263354 3.639537 4.029645 4.432823 4.848279 5.275257 5.713050 0.000000 4.6948172E-02 0.1170029 0.2057849 0.3103889 0.4291120 0.5609756 0.7053527 0.8618109 1.029989 1.209571 1.400235 1.601663 1.813502 2.035399 2.266968 2.507833 2.757621 3.015952 3.282427 3.556656 0.000000 2.3444591E-02 5.8142666E-02 0.1015656 0.1520458 0.2085233 0.2703867 0.3372054 0.4086977 0.4846432 0.5648846 0.6492854 0.7377474 0.8301750 0.9264929 1.026623 1.130509 1.238090 1.349308 1.464088 1.582359 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4696324 1.208617 2.203874 3.422099 4.825604 6.382537 8.069034 9.867649 11.76526 13.75166 15.81864 17.95949 20.16854 22.44100 24.77271 27.16005 29.59986 32.08936 34.62603 37.20760 0.000000 0.4466415 1.150649 2.101769 3.270671 4.622427 6.126463 7.759326 9.503679 11.34644 13.27741 15.28843 17.37276 19.52476 21.73966 24.01328 26.34204 28.72278 31.15271 33.62933 36.15037 0.000000 0.4235427 1.091940 1.997226 3.113832 4.409669 5.855585 7.428665 9.111727 10.89175 12.75859 14.70410 16.72161 18.80548 20.95096 23.15393 25.41082 27.71849 30.07417 32.47540 34.91993 0.000000 0.4003465 1.032562 1.890463 2.951971 4.187922 5.570781 7.078292 8.693527 10.40357 12.19838 14.06986 16.01140 18.01746 20.08332 22.20492 24.37874 26.60171 28.87111 31.18449 33.53968 0.000000 0.3770608 0.9725908 1.781701 2.785521 3.957881 5.273051 6.709624 8.251027 9.884529 11.60021 13.39011 15.24771 17.16757 19.14507 21.17624 23.25762 25.38623 27.55941 29.77479 32.03025 0.000000 0.3536964 0.9121037 1.671182 2.614966 3.720310 4.963499 6.324172 7.786246 9.337261 10.96748 12.66910 14.43577 16.26215 18.14376 20.07672 22.05770 24.08378 26.15240 28.26126 30.40832 0.000000 0.3302620 0.8511790 1.559165 2.440823 3.476036 4.643292 5.923504 7.301230 8.764370 10.30344 11.91083 13.58037 15.30687 17.08600 18.91400 20.78765 22.70414 24.66099 26.65601 28.68721 0.000000 0.3067673 0.7898996 1.445923 2.263661 3.225952 4.313685 5.509253 6.798041 8.168411 9.611185 11.11900 12.68587 14.30679 15.97758 17.69463 19.45483 21.25549 23.09425 24.96899 26.87782 0.000000 0.2832215 0.7283498 1.331738 2.084070 2.971018 3.976003 5.083127 6.278783 7.551916 8.893716 10.29709 11.75628 13.26648 14.82367 16.42438 18.06565 19.74492 21.45992 23.20865 24.98931 0.000000 0.2596333 0.6666171 1.216907 1.902695 2.712280 3.631690 4.646945 5.745645 6.917446 8.153984 9.448482 10.79542 12.19020 13.62899 15.10849 16.62587 18.17871 19.76485 21.38242 23.02971 0.000000 0.2360110 0.6047859 1.101735 1.720202 2.450856 3.282314 4.202686 5.200967 6.267685 7.395014 8.576540 9.807017 11.08208 12.39808 13.75190 15.14087 16.56268 18.01534 19.49705 21.00623 0.000000 0.2123645 0.5429448 0.9865291 1.537305 2.187969 2.929617 3.752545 4.647338 5.605562 6.620048 7.684821 8.794950 9.946318 11.13549 12.35951 13.61589 14.90248 16.21739 17.55896 18.92572 0.000000 0.1887031 0.4811787 0.8716110 1.354741 1.924939 2.575537 3.299023 4.087719 4.934414 5.832748 6.777281 7.763457 8.787442 9.846024 10.93646 12.05641 13.20387 14.37711 15.57459 16.79494 0.000000 0.1650364 0.4195779 0.7572958 1.173286 1.663188 2.222253 2.845016 3.525615 4.258230 5.037483 5.858607 6.717511 7.610694 8.535205 9.488506 10.46845 11.47318 12.50111 13.55083 14.62108 0.000000 0.1413736 0.3582284 0.6439041 0.9937271 1.404243 1.872194 2.393904 2.965264 3.581951 4.239743 4.934711 5.663357 6.422605 7.209816 8.022697 8.859296 9.717936 10.59717 11.49571 12.41242 0.000000 0.1177241 0.2972134 0.5317546 0.8168709 1.149709 1.528057 1.949631 2.411856 2.911876 3.446732 4.013497 4.609430 5.232016 5.879023 6.548467 7.238637 7.948047 8.675413 9.419591 10.17956 0.000000 9.4096996E-02 0.2366145 0.4211515 0.6435134 0.9012415 1.192764 1.516725 1.871703 2.256088 2.668135 3.105994 3.567828 4.051838 4.556351 5.079810 5.620826 6.178169 6.750756 7.337606 7.937829 0.000000 7.0501857E-02 0.1765181 0.3124009 0.4744409 0.6605081 0.8693829 1.100210 1.352257 1.624761 1.916911 2.227806 2.556505 2.902015 3.263354 3.639537 4.029645 4.432823 4.848279 5.275257 5.713050 0.000000 4.6948172E-02 0.1170029 0.2057849 0.3103889 0.4291120 0.5609756 0.7053527 0.8618109 1.029989 1.209571 1.400235 1.601663 1.813502 2.035399 2.266968 2.507833 2.757621 3.015952 3.282427 3.556656 0.000000 2.3444591E-02 5.8142666E-02 0.1015656 0.1520458 0.2085233 0.2703867 0.3372054 0.4086977 0.4846432 0.5648846 0.6492854 0.7377474 0.8301750 0.9264929 1.026623 1.130509 1.238090 1.349308 1.464088 1.582359 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4696324 1.208617 2.203874 3.422099 4.825604 6.382537 8.069035 9.867649 11.76526 13.75166 15.81864 17.95949 20.16854 22.44100 24.77271 27.16005 29.59987 32.08936 34.62603 37.20760 0.000000 0.4466416 1.150649 2.101769 3.270671 4.622427 6.126463 7.759326 9.503680 11.34644 13.27741 15.28843 17.37276 19.52476 21.73966 24.01328 26.34204 28.72278 31.15271 33.62933 36.15037 0.000000 0.4235427 1.091940 1.997226 3.113833 4.409669 5.855586 7.428665 9.111727 10.89175 12.75859 14.70411 16.72161 18.80548 20.95096 23.15393 25.41082 27.71849 30.07417 32.47540 34.91993 0.000000 0.4003465 1.032562 1.890463 2.951971 4.187922 5.570781 7.078293 8.693527 10.40357 12.19838 14.06986 16.01140 18.01746 20.08332 22.20492 24.37875 26.60171 28.87111 31.18449 33.53968 0.000000 0.3770608 0.9725909 1.781701 2.785521 3.957881 5.273051 6.709625 8.251027 9.884529 11.60021 13.39011 15.24771 17.16757 19.14507 21.17624 23.25762 25.38623 27.55941 29.77479 32.03025 0.000000 0.3536964 0.9121038 1.671183 2.614966 3.720311 4.963499 6.324172 7.786247 9.337261 10.96748 12.66911 14.43577 16.26215 18.14376 20.07673 22.05770 24.08378 26.15240 28.26127 30.40832 0.000000 0.3302621 0.8511790 1.559165 2.440823 3.476036 4.643292 5.923504 7.301230 8.764370 10.30344 11.91083 13.58037 15.30687 17.08600 18.91400 20.78765 22.70414 24.66099 26.65601 28.68721 0.000000 0.3067673 0.7898998 1.445923 2.263661 3.225952 4.313685 5.509253 6.798041 8.168411 9.611185 11.11900 12.68587 14.30679 15.97758 17.69463 19.45483 21.25549 23.09425 24.96899 26.87782 0.000000 0.2832215 0.7283498 1.331738 2.084071 2.971019 3.976003 5.083127 6.278783 7.551916 8.893716 10.29709 11.75628 13.26648 14.82367 16.42438 18.06565 19.74492 21.45992 23.20865 24.98931 0.000000 0.2596333 0.6666172 1.216907 1.902695 2.712280 3.631690 4.646945 5.745645 6.917446 8.153984 9.448483 10.79542 12.19020 13.62899 15.10849 16.62587 18.17871 19.76485 21.38242 23.02971 0.000000 0.2360110 0.6047860 1.101735 1.720202 2.450856 3.282315 4.202686 5.200967 6.267686 7.395015 8.576540 9.807017 11.08208 12.39808 13.75190 15.14087 16.56268 18.01534 19.49705 21.00624 0.000000 0.2123645 0.5429449 0.9865291 1.537305 2.187969 2.929617 3.752545 4.647338 5.605562 6.620048 7.684821 8.794950 9.946318 11.13549 12.35951 13.61589 14.90248 16.21739 17.55896 18.92572 0.000000 0.1887031 0.4811787 0.8716110 1.354741 1.924939 2.575537 3.299023 4.087719 4.934414 5.832748 6.777281 7.763457 8.787442 9.846024 10.93646 12.05641 13.20387 14.37711 15.57459 16.79494 0.000000 0.1650364 0.4195779 0.7572958 1.173286 1.663188 2.222253 2.845016 3.525615 4.258230 5.037483 5.858607 6.717511 7.610694 8.535205 9.488506 10.46845 11.47318 12.50111 13.55083 14.62108 0.000000 0.1413736 0.3582284 0.6439041 0.9937271 1.404243 1.872194 2.393904 2.965264 3.581951 4.239743 4.934711 5.663357 6.422605 7.209816 8.022697 8.859296 9.717936 10.59717 11.49571 12.41242 0.000000 0.1177241 0.2972135 0.5317546 0.8168709 1.149709 1.528057 1.949631 2.411856 2.911876 3.446732 4.013497 4.609430 5.232016 5.879023 6.548467 7.238637 7.948048 8.675413 9.419591 10.17956 0.000000 9.4096996E-02 0.2366145 0.4211515 0.6435135 0.9012415 1.192764 1.516725 1.871703 2.256088 2.668135 3.105994 3.567828 4.051838 4.556352 5.079810 5.620826 6.178169 6.750756 7.337606 7.937829 0.000000 7.0501857E-02 0.1765181 0.3124009 0.4744409 0.6605081 0.8693829 1.100210 1.352257 1.624761 1.916911 2.227806 2.556505 2.902015 3.263354 3.639537 4.029645 4.432823 4.848279 5.275257 5.713050 0.000000 4.6948172E-02 0.1170029 0.2057849 0.3103889 0.4291120 0.5609756 0.7053527 0.8618109 1.029989 1.209571 1.400235 1.601663 1.813502 2.035399 2.266968 2.507833 2.757621 3.015952 3.282427 3.556656 0.000000 2.3444591E-02 5.8142666E-02 0.1015656 0.1520458 0.2085233 0.2703867 0.3372054 0.4086977 0.4846432 0.5648846 0.6492854 0.7377474 0.8301750 0.9264929 1.026623 1.130509 1.238090 1.349308 1.464088 1.582359 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4696325 1.208617 2.203874 3.422100 4.825605 6.382538 8.069036 9.867650 11.76526 13.75166 15.81864 17.95949 20.16855 22.44101 24.77271 27.16005 29.59987 32.08936 34.62603 37.20760 0.000000 0.4466416 1.150649 2.101769 3.270672 4.622428 6.126464 7.759327 9.503681 11.34644 13.27742 15.28843 17.37276 19.52477 21.73966 24.01328 26.34204 28.72278 31.15271 33.62933 36.15037 0.000000 0.4235428 1.091940 1.997227 3.113833 4.409670 5.855586 7.428666 9.111728 10.89175 12.75859 14.70411 16.72161 18.80548 20.95096 23.15393 25.41082 27.71849 30.07417 32.47541 34.91994 0.000000 0.4003465 1.032562 1.890463 2.951971 4.187922 5.570782 7.078293 8.693528 10.40357 12.19838 14.06986 16.01141 18.01746 20.08332 22.20492 24.37875 26.60171 28.87111 31.18449 33.53968 0.000000 0.3770609 0.9725910 1.781702 2.785521 3.957881 5.273052 6.709625 8.251028 9.884530 11.60021 13.39011 15.24771 17.16757 19.14507 21.17624 23.25762 25.38623 27.55941 29.77479 32.03025 0.000000 0.3536965 0.9121040 1.671183 2.614966 3.720311 4.963499 6.324172 7.786247 9.337261 10.96748 12.66911 14.43577 16.26215 18.14376 20.07673 22.05770 24.08378 26.15240 28.26127 30.40832 0.000000 0.3302621 0.8511791 1.559165 2.440823 3.476037 4.643293 5.923504 7.301231 8.764371 10.30344 11.91083 13.58037 15.30687 17.08600 18.91400 20.78765 22.70414 24.66099 26.65601 28.68721 0.000000 0.3067673 0.7898998 1.445923 2.263661 3.225952 4.313685 5.509254 6.798042 8.168412 9.611185 11.11900 12.68587 14.30679 15.97758 17.69463 19.45483 21.25549 23.09425 24.96899 26.87782 0.000000 0.2832216 0.7283499 1.331738 2.084071 2.971019 3.976003 5.083127 6.278783 7.551916 8.893716 10.29709 11.75628 13.26648 14.82367 16.42438 18.06565 19.74492 21.45992 23.20865 24.98931 0.000000 0.2596333 0.6666172 1.216907 1.902695 2.712280 3.631690 4.646946 5.745645 6.917447 8.153984 9.448483 10.79542 12.19020 13.62899 15.10849 16.62587 18.17871 19.76485 21.38242 23.02971 0.000000 0.2360111 0.6047861 1.101735 1.720203 2.450856 3.282315 4.202686 5.200967 6.267686 7.395015 8.576540 9.807018 11.08208 12.39808 13.75190 15.14087 16.56268 18.01534 19.49705 21.00624 0.000000 0.2123645 0.5429449 0.9865292 1.537305 2.187969 2.929617 3.752545 4.647338 5.605562 6.620049 7.684821 8.794950 9.946318 11.13549 12.35951 13.61589 14.90248 16.21739 17.55897 18.92572 0.000000 0.1887031 0.4811788 0.8716110 1.354741 1.924939 2.575537 3.299023 4.087719 4.934414 5.832748 6.777281 7.763457 8.787442 9.846025 10.93646 12.05641 13.20387 14.37711 15.57459 16.79494 0.000000 0.1650364 0.4195780 0.7572958 1.173286 1.663188 2.222253 2.845016 3.525616 4.258230 5.037483 5.858607 6.717511 7.610695 8.535205 9.488506 10.46845 11.47318 12.50111 13.55083 14.62108 0.000000 0.1413736 0.3582284 0.6439041 0.9937272 1.404243 1.872194 2.393904 2.965265 3.581951 4.239743 4.934711 5.663357 6.422605 7.209816 8.022697 8.859296 9.717936 10.59717 11.49571 12.41243 0.000000 0.1177241 0.2972135 0.5317547 0.8168710 1.149709 1.528057 1.949631 2.411856 2.911876 3.446732 4.013497 4.609430 5.232016 5.879023 6.548467 7.238637 7.948048 8.675413 9.419591 10.17956 0.000000 9.4096996E-02 0.2366145 0.4211515 0.6435135 0.9012416 1.192764 1.516725 1.871703 2.256088 2.668135 3.105994 3.567828 4.051838 4.556352 5.079810 5.620826 6.178170 6.750756 7.337606 7.937829 0.000000 7.0501857E-02 0.1765181 0.3124009 0.4744409 0.6605081 0.8693829 1.100210 1.352257 1.624761 1.916911 2.227806 2.556505 2.902015 3.263355 3.639537 4.029645 4.432823 4.848279 5.275257 5.713050 0.000000 4.6948172E-02 0.1170029 0.2057849 0.3103889 0.4291120 0.5609756 0.7053527 0.8618110 1.029989 1.209571 1.400235 1.601663 1.813502 2.035399 2.266968 2.507833 2.757621 3.015952 3.282427 3.556656 0.000000 2.3444591E-02 5.8142666E-02 0.1015656 0.1520458 0.2085233 0.2703867 0.3372054 0.4086977 0.4846432 0.5648846 0.6492854 0.7377474 0.8301750 0.9264929 1.026623 1.130509 1.238090 1.349308 1.464088 1.582359 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4696326 1.208618 2.203875 3.422101 4.825607 6.382541 8.069038 9.867654 11.76526 13.75166 15.81865 17.95950 20.16855 22.44101 24.77271 27.16006 29.59987 32.08937 34.62604 37.20761 0.000000 0.4466418 1.150650 2.101770 3.270673 4.622430 6.126466 7.759330 9.503684 11.34644 13.27742 15.28843 17.37276 19.52477 21.73966 24.01329 26.34205 28.72279 31.15272 33.62933 36.15037 0.000000 0.4235429 1.091940 1.997228 3.113834 4.409671 5.855588 7.428668 9.111730 10.89175 12.75859 14.70411 16.72161 18.80548 20.95097 23.15394 25.41082 27.71849 30.07418 32.47541 34.91994 0.000000 0.4003467 1.032563 1.890464 2.951972 4.187924 5.570783 7.078295 8.693530 10.40358 12.19838 14.06986 16.01141 18.01746 20.08332 22.20493 24.37875 26.60172 28.87111 31.18450 33.53968 0.000000 0.3770609 0.9725915 1.781702 2.785522 3.957883 5.273053 6.709627 8.251030 9.884532 11.60021 13.39011 15.24772 17.16757 19.14508 21.17624 23.25763 25.38623 27.55941 29.77480 32.03025 0.000000 0.3536966 0.9121042 1.671183 2.614967 3.720312 4.963500 6.324174 7.786249 9.337263 10.96748 12.66911 14.43577 16.26215 18.14376 20.07673 22.05770 24.08378 26.15240 28.26127 30.40832 0.000000 0.3302622 0.8511794 1.559165 2.440824 3.476038 4.643294 5.923506 7.301232 8.764372 10.30344 11.91083 13.58037 15.30687 17.08600 18.91400 20.78765 22.70414 24.66099 26.65601 28.68721 0.000000 0.3067673 0.7899001 1.445924 2.263662 3.225953 4.313686 5.509254 6.798043 8.168413 9.611187 11.11900 12.68587 14.30679 15.97759 17.69463 19.45483 21.25550 23.09425 24.96899 26.87782 0.000000 0.2832216 0.7283501 1.331738 2.084071 2.971020 3.976004 5.083128 6.278785 7.551917 8.893717 10.29709 11.75628 13.26648 14.82367 16.42438 18.06565 19.74492 21.45992 23.20865 24.98932 0.000000 0.2596333 0.6666174 1.216908 1.902696 2.712281 3.631691 4.646946 5.745646 6.917448 8.153985 9.448483 10.79542 12.19021 13.62899 15.10849 16.62587 18.17871 19.76485 21.38242 23.02971 0.000000 0.2360111 0.6047862 1.101735 1.720203 2.450857 3.282315 4.202687 5.200968 6.267687 7.395016 8.576541 9.807018 11.08208 12.39809 13.75190 15.14087 16.56268 18.01534 19.49705 21.00624 0.000000 0.2123646 0.5429450 0.9865294 1.537306 2.187970 2.929618 3.752546 4.647338 5.605563 6.620049 7.684822 8.794950 9.946319 11.13549 12.35951 13.61590 14.90248 16.21739 17.55897 18.92572 0.000000 0.1887032 0.4811788 0.8716112 1.354741 1.924939 2.575538 3.299024 4.087720 4.934415 5.832748 6.777282 7.763458 8.787443 9.846025 10.93646 12.05641 13.20387 14.37711 15.57459 16.79494 0.000000 0.1650364 0.4195780 0.7572961 1.173286 1.663189 2.222253 2.845017 3.525616 4.258230 5.037483 5.858608 6.717512 7.610695 8.535205 9.488507 10.46845 11.47318 12.50111 13.55083 14.62108 0.000000 0.1413736 0.3582285 0.6439043 0.9937274 1.404244 1.872194 2.393904 2.965265 3.581951 4.239744 4.934711 5.663357 6.422605 7.209816 8.022697 8.859297 9.717936 10.59717 11.49571 12.41243 0.000000 0.1177241 0.2972135 0.5317547 0.8168711 1.149709 1.528057 1.949631 2.411856 2.911876 3.446732 4.013497 4.609430 5.232016 5.879023 6.548468 7.238637 7.948048 8.675413 9.419591 10.17956 0.000000 9.4096996E-02 0.2366145 0.4211516 0.6435136 0.9012417 1.192764 1.516725 1.871703 2.256088 2.668135 3.105995 3.567828 4.051839 4.556352 5.079810 5.620826 6.178170 6.750757 7.337606 7.937829 0.000000 7.0501857E-02 0.1765181 0.3124010 0.4744410 0.6605082 0.8693830 1.100210 1.352257 1.624761 1.916911 2.227806 2.556505 2.902015 3.263355 3.639537 4.029645 4.432823 4.848279 5.275257 5.713050 0.000000 4.6948172E-02 0.1170029 0.2057849 0.3103890 0.4291120 0.5609757 0.7053528 0.8618110 1.029989 1.209571 1.400235 1.601663 1.813502 2.035399 2.266968 2.507833 2.757621 3.015952 3.282427 3.556656 0.000000 2.3444591E-02 5.8142666E-02 0.1015656 0.1520458 0.2085233 0.2703867 0.3372054 0.4086977 0.4846432 0.5648846 0.6492854 0.7377474 0.8301750 0.9264930 1.026623 1.130509 1.238090 1.349308 1.464088 1.582359 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4696331 1.208619 2.203878 3.422106 4.825613 6.382548 8.069046 9.867661 11.76527 13.75167 15.81866 17.95951 20.16856 22.44102 24.77273 27.16007 29.59988 32.08938 34.62605 37.20762 0.000000 0.4466422 1.150651 2.101773 3.270677 4.622435 6.126472 7.759336 9.503691 11.34645 13.27743 15.28844 17.37277 19.52478 21.73967 24.01330 26.34206 28.72280 31.15273 33.62934 36.15038 0.000000 0.4235433 1.091942 1.997230 3.113838 4.409676 5.855594 7.428674 9.111736 10.89176 12.75860 14.70412 16.72162 18.80549 20.95097 23.15395 25.41083 27.71850 30.07419 32.47542 34.91995 0.000000 0.4003470 1.032564 1.890466 2.951976 4.187928 5.570788 7.078300 8.693536 10.40358 12.19839 14.06987 16.01141 18.01747 20.08333 22.20493 24.37876 26.60172 28.87111 31.18450 33.53969 0.000000 0.3770612 0.9725925 1.781704 2.785525 3.957886 5.273057 6.709631 8.251035 9.884537 11.60022 13.39012 15.24772 17.16758 19.14508 21.17624 23.25763 25.38624 27.55942 29.77480 32.03026 0.000000 0.3536969 0.9121052 1.671185 2.614969 3.720315 4.963504 6.324178 7.786253 9.337268 10.96749 12.66911 14.43578 16.26216 18.14377 20.07673 22.05771 24.08379 26.15241 28.26127 30.40832 0.000000 0.3302625 0.8511803 1.559167 2.440826 3.476040 4.643297 5.923509 7.301236 8.764376 10.30344 11.91084 13.58037 15.30688 17.08601 18.91401 20.78765 22.70414 24.66100 26.65602 28.68722 0.000000 0.3067675 0.7899007 1.445925 2.263664 3.225955 4.313689 5.509257 6.798046 8.168416 9.611190 11.11900 12.68587 14.30680 15.97759 17.69464 19.45484 21.25550 23.09425 24.96899 26.87782 0.000000 0.2832218 0.7283507 1.331740 2.084073 2.971021 3.976007 5.083131 6.278787 7.551920 8.893720 10.29710 11.75629 13.26649 14.82367 16.42439 18.06566 19.74492 21.45992 23.20865 24.98932 0.000000 0.2596335 0.6666179 1.216909 1.902697 2.712283 3.631693 4.646949 5.745648 6.917450 8.153988 9.448485 10.79542 12.19021 13.62900 15.10849 16.62588 18.17871 19.76486 21.38243 23.02971 0.000000 0.2360112 0.6047866 1.101736 1.720204 2.450858 3.282317 4.202688 5.200970 6.267689 7.395018 8.576543 9.807020 11.08208 12.39809 13.75190 15.14087 16.56268 18.01534 19.49706 21.00624 0.000000 0.2123646 0.5429454 0.9865301 1.537307 2.187971 2.929619 3.752547 4.647340 5.605564 6.620050 7.684824 8.794952 9.946320 11.13549 12.35951 13.61590 14.90248 16.21739 17.55897 18.92572 0.000000 0.1887032 0.4811791 0.8716117 1.354742 1.924940 2.575539 3.299025 4.087721 4.934416 5.832750 6.777283 7.763459 8.787444 9.846026 10.93646 12.05641 13.20387 14.37712 15.57459 16.79494 0.000000 0.1650365 0.4195782 0.7572964 1.173287 1.663189 2.222254 2.845018 3.525617 4.258231 5.037485 5.858609 6.717513 7.610696 8.535206 9.488508 10.46845 11.47318 12.50112 13.55083 14.62108 0.000000 0.1413737 0.3582287 0.6439045 0.9937277 1.404244 1.872195 2.393905 2.965266 3.581952 4.239744 4.934712 5.663358 6.422606 7.209816 8.022698 8.859298 9.717937 10.59717 11.49571 12.41243 0.000000 0.1177241 0.2972135 0.5317549 0.8168713 1.149709 1.528057 1.949632 2.411857 2.911877 3.446733 4.013498 4.609431 5.232017 5.879024 6.548468 7.238638 7.948049 8.675414 9.419592 10.17957 0.000000 9.4096996E-02 0.2366146 0.4211517 0.6435138 0.9012419 1.192764 1.516726 1.871703 2.256089 2.668135 3.105995 3.567829 4.051839 4.556352 5.079811 5.620827 6.178170 6.750757 7.337607 7.937829 0.000000 7.0501857E-02 0.1765181 0.3124010 0.4744410 0.6605083 0.8693832 1.100211 1.352257 1.624761 1.916911 2.227806 2.556505 2.902016 3.263355 3.639538 4.029646 4.432824 4.848280 5.275257 5.713051 0.000000 4.6948172E-02 0.1170029 0.2057849 0.3103890 0.4291120 0.5609757 0.7053528 0.8618111 1.029989 1.209571 1.400235 1.601663 1.813502 2.035399 2.266968 2.507833 2.757621 3.015952 3.282427 3.556656 0.000000 2.3444591E-02 5.8142666E-02 0.1015656 0.1520458 0.2085233 0.2703868 0.3372054 0.4086978 0.4846433 0.5648847 0.6492854 0.7377474 0.8301750 0.9264930 1.026623 1.130509 1.238090 1.349308 1.464088 1.582359 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4696344 1.208624 2.203887 3.422118 4.825629 6.382566 8.069067 9.867684 11.76530 13.75170 15.81869 17.95954 20.16859 22.44105 24.77276 27.16010 29.59992 32.08942 34.62608 37.20766 0.000000 0.4466434 1.150655 2.101781 3.270688 4.622449 6.126488 7.759355 9.503711 11.34647 13.27745 15.28846 17.37280 19.52480 21.73970 24.01332 26.34208 28.72283 31.15275 33.62937 36.15041 0.000000 0.4235443 1.091945 1.997237 3.113848 4.409688 5.855608 7.428690 9.111753 10.89178 12.75862 14.70414 16.72164 18.80551 20.95099 23.15397 25.41085 27.71852 30.07421 32.47544 34.91997 0.000000 0.4003480 1.032567 1.890472 2.951984 4.187939 5.570801 7.078315 8.693551 10.40360 12.19841 14.06989 16.01143 18.01749 20.08335 22.20495 24.37877 26.60174 28.87113 31.18452 33.53971 0.000000 0.3770621 0.9725953 1.781710 2.785533 3.957896 5.273068 6.709644 8.251047 9.884551 11.60023 13.39013 15.24774 17.16759 19.14510 21.17626 23.25765 25.38625 27.55943 29.77482 32.03027 0.000000 0.3536976 0.9121076 1.671190 2.614976 3.720324 4.963514 6.324188 7.786264 9.337279 10.96750 12.66912 14.43579 16.26217 18.14378 20.07674 22.05772 24.08380 26.15242 28.26129 30.40834 0.000000 0.3302630 0.8511824 1.559171 2.440832 3.476048 4.643306 5.923519 7.301246 8.764386 10.30345 11.91085 13.58038 15.30689 17.08602 18.91402 20.78767 22.70415 24.66101 26.65602 28.68723 0.000000 0.3067681 0.7899026 1.445929 2.263669 3.225962 4.313696 5.509265 6.798055 8.168426 9.611199 11.11901 12.68588 14.30681 15.97760 17.69464 19.45485 21.25551 23.09426 24.96900 26.87783 0.000000 0.2832222 0.7283523 1.331743 2.084077 2.971027 3.976013 5.083138 6.278794 7.551928 8.893727 10.29710 11.75629 13.26649 14.82368 16.42439 18.06567 19.74493 21.45993 23.20866 24.98932 0.000000 0.2596338 0.6666191 1.216911 1.902701 2.712287 3.631698 4.646955 5.745655 6.917456 8.153995 9.448492 10.79543 12.19021 13.62900 15.10850 16.62588 18.17872 19.76486 21.38243 23.02972 0.000000 0.2360116 0.6047877 1.101738 1.720207 2.450862 3.282321 4.202693 5.200975 6.267694 7.395023 8.576549 9.807026 11.08209 12.39809 13.75191 15.14087 16.56269 18.01534 19.49706 21.00624 0.000000 0.2123648 0.5429462 0.9865316 1.537309 2.187974 2.929623 3.752551 4.647345 5.605569 6.620055 7.684828 8.794956 9.946324 11.13549 12.35952 13.61590 14.90249 16.21740 17.55897 18.92572 0.000000 0.1887034 0.4811798 0.8716130 1.354744 1.924943 2.575542 3.299028 4.087725 4.934420 5.832754 6.777287 7.763463 8.787448 9.846029 10.93646 12.05641 13.20388 14.37712 15.57460 16.79494 0.000000 0.1650366 0.4195788 0.7572975 1.173288 1.663191 2.222256 2.845020 3.525620 4.258234 5.037488 5.858612 6.717516 7.610699 8.535209 9.488511 10.46845 11.47319 12.50112 13.55084 14.62108 0.000000 0.1413738 0.3582290 0.6439052 0.9937289 1.404245 1.872197 2.393907 2.965268 3.581954 4.239747 4.934715 5.663361 6.422608 7.209819 8.022700 8.859300 9.717938 10.59717 11.49571 12.41243 0.000000 0.1177242 0.2972138 0.5317554 0.8168721 1.149710 1.528058 1.949633 2.411859 2.911878 3.446734 4.013499 4.609433 5.232018 5.879025 6.548470 7.238640 7.948050 8.675415 9.419593 10.17957 0.000000 9.4097108E-02 0.2366148 0.4211521 0.6435142 0.9012425 1.192765 1.516726 1.871704 2.256090 2.668136 3.105996 3.567830 4.051840 4.556353 5.079812 5.620828 6.178171 6.750758 7.337608 7.937831 0.000000 7.0501857E-02 0.1765182 0.3124012 0.4744413 0.6605086 0.8693836 1.100211 1.352258 1.624762 1.916912 2.227807 2.556506 2.902016 3.263355 3.639539 4.029646 4.432825 4.848280 5.275258 5.713052 0.000000 4.6948172E-02 0.1170031 0.2057850 0.3103891 0.4291122 0.5609760 0.7053531 0.8618113 1.029989 1.209572 1.400235 1.601663 1.813502 2.035400 2.266969 2.507834 2.757622 3.015953 3.282427 3.556657 0.000000 2.3444591E-02 5.8142666E-02 0.1015657 0.1520458 0.2085233 0.2703868 0.3372055 0.4086978 0.4846433 0.5648848 0.6492855 0.7377475 0.8301752 0.9264931 1.026623 1.130509 1.238091 1.349308 1.464088 1.582359 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4696380 1.208636 2.203910 3.422152 4.825671 6.382616 8.069123 9.867746 11.76536 13.75177 15.81876 17.95962 20.16867 22.44114 24.77284 27.16019 29.60001 32.08951 34.62618 37.20775 0.000000 0.4466466 1.150666 2.101802 3.270718 4.622487 6.126533 7.759404 9.503765 11.34653 13.27751 15.28853 17.37286 19.52487 21.73977 24.01340 26.34216 28.72290 31.15283 33.62944 36.15049 0.000000 0.4235472 1.091955 1.997256 3.113875 4.409722 5.855647 7.428734 9.111801 10.89183 12.75867 14.70419 16.72169 18.80557 20.95105 23.15403 25.41091 27.71858 30.07427 32.47550 34.92003 0.000000 0.4003505 1.032576 1.890489 2.952008 4.187969 5.570835 7.078353 8.693592 10.40364 12.19845 14.06993 16.01148 18.01753 20.08340 22.20500 24.37882 26.60179 28.87118 31.18457 33.53976 0.000000 0.3770644 0.9726032 1.781724 2.785554 3.957922 5.273099 6.709677 8.251083 9.884588 11.60027 13.39017 15.24778 17.16763 19.14514 21.17630 23.25769 25.38629 27.55947 29.77486 32.03031 0.000000 0.3536995 0.9121146 1.671203 2.614995 3.720347 4.963541 6.324218 7.786295 9.337312 10.96753 12.66916 14.43582 16.26221 18.14382 20.07678 22.05776 24.08384 26.15245 28.26132 30.40837 0.000000 0.3302647 0.8511884 1.559182 2.440848 3.476068 4.643329 5.923544 7.301272 8.764414 10.30348 11.91088 13.58041 15.30692 17.08605 18.91405 20.78769 22.70418 24.66104 26.65605 28.68725 0.000000 0.3067695 0.7899078 1.445938 2.263683 3.225979 4.313716 5.509287 6.798078 8.168449 9.611223 11.11904 12.68590 14.30683 15.97762 17.69467 19.45487 21.25553 23.09428 24.96902 26.87785 0.000000 0.2832235 0.7283565 1.331751 2.084089 2.971042 3.976030 5.083157 6.278814 7.551948 8.893748 10.29713 11.75632 13.26652 14.82370 16.42441 18.06569 19.74495 21.45995 23.20868 24.98934 0.000000 0.2596349 0.6666228 1.216918 1.902711 2.712300 3.631713 4.646970 5.745671 6.917474 8.154012 9.448510 10.79545 12.19023 13.62902 15.10852 16.62590 18.17873 19.76488 21.38245 23.02973 0.000000 0.2360124 0.6047907 1.101744 1.720215 2.450873 3.282333 4.202707 5.200989 6.267709 7.395038 8.576563 9.807041 11.08211 12.39811 13.75192 15.14089 16.56270 18.01536 19.49707 21.00625 0.000000 0.2123656 0.5429487 0.9865362 1.537316 2.187982 2.929633 3.752562 4.647356 5.605581 6.620068 7.684840 8.794969 9.946337 11.13550 12.35953 13.61591 14.90250 16.21741 17.55898 18.92574 0.000000 0.1887040 0.4811816 0.8716165 1.354749 1.924949 2.575550 3.299037 4.087734 4.934430 5.832764 6.777297 7.763473 8.787458 9.846040 10.93647 12.05642 13.20389 14.37713 15.57461 16.79495 0.000000 0.1650370 0.4195802 0.7573001 1.173292 1.663197 2.222263 2.845027 3.525627 4.258242 5.037496 5.858620 6.717524 7.610707 8.535217 9.488519 10.46846 11.47319 12.50113 13.55084 14.62109 0.000000 0.1413741 0.3582301 0.6439072 0.9937318 1.404249 1.872201 2.393912 2.965273 3.581960 4.239753 4.934721 5.663367 6.422615 7.209826 8.022707 8.859305 9.717945 10.59718 11.49572 12.41243 0.000000 0.1177244 0.2972145 0.5317568 0.8168741 1.149713 1.528062 1.949637 2.411863 2.911883 3.446739 4.013504 4.609437 5.232023 5.879030 6.548474 7.238644 7.948055 8.675420 9.419598 10.17957 0.000000 9.4097219E-02 0.2366153 0.4211529 0.6435155 0.9012442 1.192767 1.516729 1.871707 2.256093 2.668139 3.105999 3.567833 4.051844 4.556356 5.079815 5.620831 6.178174 6.750762 7.337611 7.937834 0.000000 7.0501968E-02 0.1765185 0.3124017 0.4744420 0.6605096 0.8693848 1.100212 1.352259 1.624763 1.916914 2.227809 2.556508 2.902019 3.263358 3.639540 4.029649 4.432827 4.848283 5.275260 5.713054 0.000000 4.6948172E-02 0.1170032 0.2057852 0.3103895 0.4291126 0.5609764 0.7053537 0.8618120 1.029990 1.209573 1.400236 1.601664 1.813503 2.035401 2.266970 2.507835 2.757623 3.015954 3.282429 3.556658 0.000000 2.3444591E-02 5.8142778E-02 0.1015657 0.1520459 0.2085234 0.2703868 0.3372057 0.4086980 0.4846435 0.5648850 0.6492857 0.7377477 0.8301755 0.9264933 1.026623 1.130509 1.238091 1.349309 1.464089 1.582359 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4696477 1.208670 2.203973 3.422243 4.825787 6.382752 8.069277 9.867916 11.76554 13.75196 15.81897 17.95983 20.16889 22.44137 24.77308 27.16043 29.60026 32.08976 34.62644 37.20802 0.000000 0.4466554 1.150697 2.101858 3.270800 4.622590 6.126654 7.759540 9.503912 11.34669 13.27768 15.28870 17.37304 19.52505 21.73996 24.01359 26.34235 28.72310 31.15303 33.62965 36.15069 0.000000 0.4235551 1.091983 1.997306 3.113948 4.409814 5.855754 7.428853 9.111930 10.89196 12.75881 14.70434 16.72185 18.80572 20.95121 23.15419 25.41107 27.71874 30.07443 32.47566 34.92019 0.000000 0.4003575 1.032600 1.890534 2.952073 4.188050 5.570930 7.078457 8.693705 10.40376 12.19857 14.07006 16.01161 18.01766 20.08353 22.20513 24.37896 26.60192 28.87132 31.18470 33.53989 0.000000 0.3770705 0.9726245 1.781764 2.785611 3.957994 5.273182 6.709769 8.251181 9.884690 11.60038 13.39028 15.24789 17.16775 19.14525 21.17641 23.25780 25.38640 27.55958 29.77497 32.03042 0.000000 0.3537050 0.9121332 1.671237 2.615045 3.720410 4.963613 6.324297 7.786380 9.337400 10.96762 12.66925 14.43592 16.26230 18.14391 20.07687 22.05785 24.08393 26.15254 28.26141 30.40846 0.000000 0.3302695 0.8512046 1.559213 2.440892 3.476122 4.643392 5.923613 7.301346 8.764490 10.30356 11.91096 13.58049 15.30700 17.08613 18.91413 20.78777 22.70426 24.66111 26.65613 28.68733 0.000000 0.3067737 0.7899216 1.445964 2.263721 3.226026 4.313771 5.509347 6.798141 8.168515 9.611290 11.11911 12.68597 14.30690 15.97769 17.69474 19.45494 21.25560 23.09435 24.96909 26.87792 0.000000 0.2832270 0.7283684 1.331773 2.084121 2.971082 3.976077 5.083208 6.278869 7.552004 8.893806 10.29718 11.75637 13.26657 14.82376 16.42447 18.06574 19.74500 21.46000 23.20873 24.98940 0.000000 0.2596378 0.6666327 1.216936 1.902738 2.712334 3.631752 4.647014 5.745717 6.917521 8.154060 9.448559 10.79550 12.19028 13.62907 15.10856 16.62595 18.17878 19.76493 21.38249 23.02978 0.000000 0.2360148 0.6047988 1.101759 1.720238 2.450901 3.282367 4.202743 5.201028 6.267748 7.395079 8.576604 9.807082 11.08215 12.39815 13.75196 15.14093 16.56274 18.01540 19.49711 21.00629 0.000000 0.2123674 0.5429552 0.9865485 1.537334 2.188005 2.929660 3.752592 4.647388 5.605614 6.620101 7.684874 8.795003 9.946370 11.13554 12.35956 13.61595 14.90253 16.21744 17.55901 18.92576 0.000000 0.1887055 0.4811868 0.8716263 1.354763 1.924968 2.575571 3.299061 4.087760 4.934456 5.832791 6.777325 7.763501 8.787486 9.846067 10.93650 12.05645 13.20391 14.37715 15.57463 16.79497 0.000000 0.1650383 0.4195841 0.7573075 1.173303 1.663211 2.222279 2.845046 3.525647 4.258263 5.037518 5.858642 6.717546 7.610729 8.535239 9.488541 10.46848 11.47322 12.50115 13.55086 14.62111 0.000000 0.1413749 0.3582329 0.6439126 0.9937398 1.404260 1.872214 2.393926 2.965289 3.581976 4.239769 4.934738 5.663384 6.422632 7.209843 8.022724 8.859323 9.717961 10.59719 11.49573 12.41245 0.000000 0.1177250 0.2972166 0.5317605 0.8168796 1.149720 1.528070 1.949647 2.411874 2.911895 3.446751 4.013516 4.609450 5.232036 5.879043 6.548487 7.238657 7.948067 8.675432 9.419610 10.17958 0.000000 9.4097540E-02 0.2366165 0.4211553 0.6435191 0.9012489 1.192773 1.516735 1.871714 2.256101 2.668148 3.106008 3.567842 4.051853 4.556365 5.079824 5.620840 6.178184 6.750770 7.337620 7.937842 0.000000 7.0502192E-02 0.1765192 0.3124031 0.4744440 0.6605122 0.8693880 1.100216 1.352263 1.624768 1.916919 2.227814 2.556514 2.902024 3.263363 3.639546 4.029655 4.432832 4.848289 5.275266 5.713059 0.000000 4.6948288E-02 0.1170035 0.2057858 0.3103903 0.4291137 0.5609779 0.7053555 0.8618139 1.029992 1.209575 1.400239 1.601667 1.813506 2.035403 2.266973 2.507838 2.757626 3.015957 3.282432 3.556661 0.000000 2.3444591E-02 5.8142778E-02 0.1015658 0.1520461 0.2085237 0.2703872 0.3372060 0.4086985 0.4846441 0.5648856 0.6492864 0.7377484 0.8301762 0.9264941 1.026624 1.130510 1.238092 1.349310 1.464090 1.582360 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4696745 1.208763 2.204146 3.422493 4.826104 6.383126 8.069698 9.868379 11.76604 13.75249 15.81952 17.96041 20.16950 22.44199 24.77373 27.16110 29.60094 32.09046 34.62715 37.20874 0.000000 0.4466795 1.150780 2.102014 3.271024 4.622873 6.126985 7.759911 9.504316 11.34712 13.27813 15.28917 17.37353 19.52556 21.74047 24.01412 26.34289 28.72364 31.15358 33.63021 36.15126 0.000000 0.4235766 1.092057 1.997445 3.114148 4.410066 5.856047 7.429179 9.112282 10.89234 12.75920 14.70474 16.72226 18.80615 20.95164 23.15462 25.41151 27.71919 30.07488 32.47611 34.92064 0.000000 0.4003766 1.032666 1.890657 2.952251 4.188273 5.571188 7.078743 8.694012 10.40408 12.19891 14.07041 16.01196 18.01802 20.08389 22.20550 24.37932 26.60229 28.87168 31.18507 33.54026 0.000000 0.3770875 0.9726829 1.781873 2.785768 3.958191 5.273409 6.710019 8.251449 9.884971 11.60067 13.39058 15.24819 17.16805 19.14555 21.17672 23.25810 25.38671 27.55989 29.77527 32.03072 0.000000 0.3537198 0.9121844 1.671333 2.615183 3.720582 4.963812 6.324516 7.786613 9.337643 10.96787 12.66950 14.43617 16.26256 18.14417 20.07713 22.05811 24.08418 26.15280 28.26166 30.40871 0.000000 0.3302823 0.8512490 1.559296 2.441012 3.476273 4.643565 5.923802 7.301547 8.764699 10.30377 11.91117 13.58071 15.30722 17.08635 18.91434 20.78799 22.70447 24.66132 26.65634 28.68753 0.000000 0.3067847 0.7899597 1.446036 2.263824 3.226156 4.313920 5.509511 6.798314 8.168694 9.611474 11.11929 12.68616 14.30709 15.97787 17.69492 19.45512 21.25578 23.09453 24.96926 26.87809 0.000000 0.2832363 0.7284008 1.331833 2.084209 2.971193 3.976204 5.083348 6.279016 7.552157 8.893962 10.29734 11.75653 13.26673 14.82391 16.42462 18.06590 19.74516 21.46015 23.20888 24.98954 0.000000 0.2596457 0.6666597 1.216987 1.902812 2.712427 3.631860 4.647132 5.745843 6.917651 8.154193 9.448692 10.79563 12.19041 13.62920 15.10869 16.62608 18.17891 19.76505 21.38261 23.02990 0.000000 0.2360213 0.6048210 1.101801 1.720299 2.450979 3.282457 4.202842 5.201133 6.267858 7.395190 8.576716 9.807194 11.08226 12.39826 13.75207 15.14103 16.56285 18.01550 19.49721 21.00639 0.000000 0.2123728 0.5429731 0.9865823 1.537384 2.188069 2.929734 3.752674 4.647475 5.605704 6.620193 7.684967 8.795095 9.946463 11.13563 12.35965 13.61603 14.90262 16.21752 17.55910 18.92585 0.000000 0.1887096 0.4812008 0.8716528 1.354803 1.925018 2.575631 3.299127 4.087831 4.934530 5.832866 6.777400 7.763577 8.787561 9.846142 10.93657 12.05652 13.20398 14.37722 15.57470 16.79504 0.000000 0.1650414 0.4195948 0.7573279 1.173333 1.663249 2.222325 2.845098 3.525703 4.258321 5.037577 5.858703 6.717607 7.610790 8.535299 9.488600 10.46854 11.47327 12.50120 13.55092 14.62116 0.000000 0.1413772 0.3582408 0.6439275 0.9937618 1.404289 1.872248 2.393965 2.965331 3.582021 4.239816 4.934785 5.663431 6.422679 7.209889 8.022770 8.859368 9.718006 10.59724 11.49578 12.41249 0.000000 0.1177266 0.2972220 0.5317707 0.8168949 1.149740 1.528095 1.949674 2.411904 2.911927 3.446785 4.013551 4.609485 5.232071 5.879078 6.548522 7.238692 7.948101 8.675466 9.419642 10.17962 0.000000 9.4098628E-02 0.2366200 0.4211618 0.6435288 0.9012616 1.192788 1.516753 1.871734 2.256122 2.668171 3.106032 3.567866 4.051877 4.556390 5.079849 5.620865 6.178208 6.750794 7.337644 7.937866 0.000000 7.0502751E-02 0.1765211 0.3124067 0.4744494 0.6605194 0.8693968 1.100226 1.352275 1.624781 1.916932 2.227829 2.556528 2.902039 3.263379 3.639562 4.029670 4.432848 4.848304 5.275281 5.713075 0.000000 4.6948515E-02 0.1170043 0.2057874 0.3103927 0.4291169 0.5609818 0.7053601 0.8618191 1.029998 1.209581 1.400245 1.601674 1.813513 2.035411 2.266980 2.507846 2.757634 3.015965 3.282440 3.556669 0.000000 2.3444591E-02 5.8143001E-02 0.1015662 0.1520467 0.2085246 0.2703882 0.3372072 0.4086998 0.4846455 0.5648871 0.6492881 0.7377502 0.8301782 0.9264962 1.026626 1.130512 1.238094 1.349312 1.464092 1.582363 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4697489 1.209020 2.204627 3.423187 4.826983 6.384162 8.070868 9.869664 11.76743 13.75397 15.82108 17.96204 20.17119 22.44374 24.77553 27.16294 29.60283 32.09239 34.62912 37.21075 0.000000 0.4467464 1.151011 2.102445 3.271646 4.623658 6.127903 7.760940 9.505437 11.34831 13.27939 15.29049 17.37490 19.52696 21.74191 24.01558 26.34439 28.72516 31.15512 33.63176 36.15282 0.000000 0.4236366 1.092264 1.997831 3.114703 4.410763 5.856860 7.430083 9.113259 10.89337 12.76029 14.70586 16.72341 18.80732 20.95284 23.15583 25.41274 27.72042 30.07612 32.47736 34.92189 0.000000 0.4004300 1.032850 1.891000 2.952744 4.188891 5.571905 7.079536 8.694863 10.40498 12.19984 14.07136 16.01294 18.01901 20.08489 22.20650 24.38033 26.60330 28.87270 31.18608 33.54126 0.000000 0.3771345 0.9728451 1.782176 2.786204 3.958736 5.274039 6.710713 8.252190 9.885747 11.60147 13.39140 15.24902 17.16889 19.14640 21.17756 23.25895 25.38755 27.56072 29.77610 32.03154 0.000000 0.3537610 0.9123264 1.671598 2.615565 3.721060 4.964363 6.325120 7.787256 9.338314 10.96856 12.67021 14.43688 16.26327 18.14488 20.07784 22.05881 24.08489 26.15349 28.26235 30.40939 0.000000 0.3303181 0.8513721 1.559526 2.441344 3.476689 4.644044 5.924327 7.302104 8.765278 10.30437 11.91177 13.58132 15.30782 17.08695 18.91494 20.78858 22.70506 24.66191 26.65691 28.68810 0.000000 0.3068155 0.7900655 1.446234 2.264110 3.226515 4.314334 5.509964 6.798794 8.169191 9.611981 11.11980 12.68667 14.30760 15.97839 17.69543 19.45562 21.25627 23.09501 24.96974 26.87856 0.000000 0.2832624 0.7284905 1.332002 2.084453 2.971500 3.976559 5.083735 6.279427 7.552582 8.894394 10.29778 11.75697 13.26717 14.82435 16.42505 18.06632 19.74557 21.46056 23.20928 24.98993 0.000000 0.2596676 0.6667348 1.217128 1.903017 2.712686 3.632160 4.647461 5.746191 6.918011 8.154559 9.449061 10.79600 12.19078 13.62956 15.10905 16.62643 18.17925 19.76539 21.38295 23.03023 0.000000 0.2360393 0.6048828 1.101917 1.720469 2.451194 3.282707 4.203117 5.201425 6.268159 7.395497 8.577025 9.807503 11.08256 12.39856 13.75237 15.14133 16.56314 18.01579 19.49749 21.00667 0.000000 0.2123873 0.5430229 0.9866761 1.537521 2.188244 2.929939 3.752900 4.647716 5.605954 6.620448 7.685224 8.795352 9.946717 11.13588 12.35990 13.61628 14.90286 16.21776 17.55933 18.92607 0.000000 0.1887211 0.4812400 0.8717266 1.354911 1.925158 2.575795 3.299310 4.088026 4.934733 5.833074 6.777610 7.763787 8.787770 9.846348 10.93678 12.05672 13.20418 14.37742 15.57489 16.79523 0.000000 0.1650501 0.4196246 0.7573839 1.173417 1.663357 2.222453 2.845241 3.525857 4.258482 5.037743 5.858870 6.717775 7.610957 8.535465 9.488764 10.46870 11.47343 12.50136 13.55107 14.62131 0.000000 0.1413836 0.3582625 0.6439685 0.9938229 1.404368 1.872343 2.394073 2.965447 3.582144 4.239943 4.934915 5.663562 6.422810 7.210019 8.022899 8.859495 9.718131 10.59736 11.49590 12.41261 0.000000 0.1177310 0.2972369 0.5317991 0.8169371 1.149795 1.528161 1.949751 2.411988 2.912016 3.446878 4.013647 4.609582 5.232169 5.879176 6.548619 7.238787 7.948196 8.675559 9.419734 10.17971 0.000000 9.4101451E-02 0.2366295 0.4211798 0.6435557 0.9012971 1.192831 1.516803 1.871789 2.256182 2.668234 3.106097 3.567933 4.051945 4.556459 5.079917 5.620933 6.178276 6.750861 7.337709 7.937931 0.000000 7.0504300E-02 0.1765264 0.3124167 0.4744645 0.6605393 0.8694212 1.100255 1.352307 1.624816 1.916970 2.227868 2.556569 2.902081 3.263422 3.639605 4.029714 4.432891 4.848347 5.275324 5.713117 0.000000 4.6949197E-02 0.1170067 0.2057918 0.3103993 0.4291257 0.5609926 0.7053728 0.8618337 1.030014 1.209598 1.400264 1.601693 1.813534 2.035432 2.267002 2.507868 2.757656 3.015987 3.282463 3.556692 0.000000 2.3444824E-02 5.8143564E-02 0.1015673 0.1520483 0.2085267 0.2703909 0.3372104 0.4087034 0.4846496 0.5648916 0.6492929 0.7377554 0.8301836 0.9265019 1.026632 1.130518 1.238100 1.349319 1.464099 1.582369 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4699644 1.209764 2.206014 3.425190 4.829520 6.387151 8.074241 9.873365 11.77142 13.75821 15.82555 17.96671 20.17604 22.44876 24.78069 27.16825 29.60827 32.09795 34.63479 37.21652 0.000000 0.4469403 1.151680 2.103691 3.273441 4.625920 6.130550 7.763903 9.508661 11.35176 13.28302 15.29428 17.37881 19.53100 21.74604 24.01980 26.34867 28.72951 31.15952 33.63621 36.15731 0.000000 0.4238101 1.092862 1.998945 3.116304 4.412774 5.859200 7.432684 9.116070 10.89635 12.76340 14.70909 16.72672 18.81070 20.95627 23.15931 25.41625 27.72396 30.07967 32.48092 34.92546 0.000000 0.4005842 1.033381 1.891990 2.954166 4.190672 5.573967 7.081817 8.697311 10.40756 12.20252 14.07411 16.01575 18.02186 20.08777 22.20940 24.38324 26.60621 28.87560 31.18898 33.54415 0.000000 0.3772708 0.9733137 1.783049 2.787459 3.960305 5.275851 6.712708 8.254319 9.887977 11.60377 13.39375 15.25141 17.17130 19.14882 21.17999 23.26137 25.38996 27.56312 29.77848 32.03391 0.000000 0.3538804 0.9127365 1.672364 2.616665 3.722435 4.965948 6.326859 7.789105 9.340240 10.97054 12.67222 14.43892 16.26531 18.14692 20.07988 22.06084 24.08690 26.15549 28.26433 30.41134 0.000000 0.3304218 0.8517280 1.560191 2.442301 3.477886 4.645422 5.925836 7.303703 8.766938 10.30607 11.91350 13.58305 15.30956 17.08868 18.91666 20.79029 22.70675 24.66357 26.65856 28.68973 0.000000 0.3069045 0.7903710 1.446805 2.264935 3.227548 4.315524 5.511264 6.800170 8.170616 9.613436 11.12127 12.68815 14.30907 15.97985 17.69688 19.45706 21.25769 23.09641 24.97112 26.87992 0.000000 0.2833381 0.7287496 1.332487 2.085156 2.972383 3.977577 5.084849 6.280604 7.553799 8.895635 10.29903 11.75822 13.26841 14.82558 16.42628 18.06752 19.74676 21.46173 23.21044 24.99107 0.000000 0.2597309 0.6669515 1.217535 1.903607 2.713431 3.633022 4.648405 5.747189 6.919043 8.155609 9.450119 10.79706 12.19183 13.63060 15.11008 16.62744 18.18025 19.76637 21.38391 23.03117 0.000000 0.2360915 0.6050610 1.102252 1.720957 2.451813 3.283426 4.203907 5.202261 6.269025 7.396378 8.577912 9.808390 11.08344 12.39943 13.75323 15.14218 16.56397 18.01660 19.49829 21.00745 0.000000 0.2124294 0.5431665 0.9869463 1.537917 2.188748 2.930528 3.753551 4.648407 5.606671 6.621179 7.685959 8.796087 9.947448 11.13660 12.36061 13.61698 14.90355 16.21844 17.55999 18.92672 0.000000 0.1887543 0.4813528 0.8719392 1.355224 1.925558 2.576266 3.299833 4.088585 4.935316 5.833669 6.778211 7.764387 8.788367 9.846939 10.93736 12.05729 13.20474 14.37797 15.57543 16.79576 0.000000 0.1650753 0.4197105 0.7575459 1.173656 1.663666 2.222819 2.845650 3.526298 4.258944 5.038216 5.859350 6.718256 7.611436 8.535939 9.489232 10.46916 11.47388 12.50180 13.55151 14.62174 0.000000 0.1414021 0.3583253 0.6440868 0.9939982 1.404596 1.872615 2.394380 2.965782 3.582497 4.240307 4.935286 5.663936 6.423183 7.210390 8.023266 8.859857 9.718488 10.59771 11.49624 12.41295 0.000000 0.1177438 0.2972801 0.5318807 0.8170586 1.149954 1.528353 1.949969 2.412227 2.912272 3.447145 4.013920 4.609859 5.232448 5.879454 6.548895 7.239061 7.948465 8.675824 9.419995 10.17996 0.000000 9.4109587E-02 0.2366569 0.4212316 0.6436330 0.9013988 1.192955 1.516946 1.871948 2.256353 2.668414 3.106284 3.568125 4.052139 4.556654 5.080113 5.621127 6.178468 6.751051 7.337897 7.938116 0.000000 7.0508860E-02 0.1765417 0.3124456 0.4745076 0.6605963 0.8694912 1.100336 1.352398 1.624916 1.917077 2.227980 2.556686 2.902201 3.263544 3.639728 4.029838 4.433015 4.848471 5.275447 5.713239 0.000000 4.6951242E-02 0.1170134 0.2058045 0.3104184 0.4291509 0.5610237 0.7054092 0.8618751 1.030060 1.209648 1.400317 1.601749 1.813592 2.035492 2.267064 2.507931 2.757720 3.016052 3.282527 3.556757 0.000000 2.3445290E-02 5.8145251E-02 0.1015704 0.1520531 0.2085329 0.2703986 0.3372195 0.4087138 0.4846611 0.5649043 0.6493066 0.7377700 0.8301991 0.9265182 1.026649 1.130536 1.238119 1.349337 1.464118 1.582389 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4703522 1.211098 2.208496 3.428767 4.834044 6.392476 8.080244 9.879953 11.77851 13.76575 15.83349 17.97500 20.18466 22.45767 24.78987 27.17768 29.61792 32.10781 34.64484 37.22676 0.000000 0.4472893 1.152879 2.105919 3.276643 4.629950 6.135261 7.769171 9.514391 11.35787 13.28946 15.30099 17.38576 19.53814 21.75336 24.02726 26.35626 28.73721 31.16731 33.64408 36.16525 0.000000 0.4241222 1.093933 2.000935 3.119159 4.416354 5.863359 7.437304 9.121057 10.90163 12.76892 14.71479 16.73258 18.81668 20.96234 23.16546 25.42245 27.73020 30.08594 32.48721 34.93176 0.000000 0.4008618 1.034333 1.893757 2.956699 4.193839 5.577631 7.085863 8.701650 10.41212 12.20725 14.07898 16.02070 18.02689 20.09284 22.21450 24.38836 26.61133 28.88072 31.19408 33.54924 0.000000 0.3775158 0.9741529 1.784608 2.789693 3.963094 5.279067 6.716242 8.258090 9.891919 11.60784 13.39790 15.25562 17.17555 19.15308 21.18426 23.26563 25.39421 27.56734 29.78267 32.03807 0.000000 0.3540950 0.9134707 1.673729 2.618623 3.724878 4.968758 6.329937 7.792374 9.343643 10.97404 12.67577 14.44250 16.26891 18.15052 20.08347 22.06441 24.09044 26.15900 28.26780 30.41478 0.000000 0.3306081 0.8523646 1.561375 2.444003 3.480010 4.647864 5.928504 7.306528 8.769869 10.30906 11.91653 13.58610 15.31261 17.09172 18.91969 20.79329 22.70971 24.66650 26.66145 28.69258 0.000000 0.3070647 0.7909173 1.447823 2.266401 3.229381 4.317630 5.513564 6.802600 8.173131 9.616000 11.12386 12.69075 14.31166 15.98242 17.69943 19.45958 21.26018 23.09887 24.97354 26.88229 0.000000 0.2834740 0.7292129 1.333352 2.086404 2.973947 3.979378 5.086816 6.282681 7.555944 8.897819 10.30123 11.76042 13.27060 14.82776 16.42842 18.06964 19.74885 21.46379 23.21246 24.99305 0.000000 0.2598446 0.6673388 1.218259 1.904656 2.714750 3.634545 4.650071 5.748949 6.920860 8.157457 9.451979 10.79891 12.19368 13.63243 15.11189 16.62922 18.18200 19.76809 21.38560 23.03283 0.000000 0.2361852 0.6053794 1.102848 1.721823 2.452908 3.284696 4.205301 5.203737 6.270549 7.397928 8.579472 9.809946 11.08499 12.40096 13.75474 15.14366 16.56543 18.01803 19.49970 21.00883 0.000000 0.2125050 0.5434229 0.9874269 1.538619 2.189641 2.931568 3.754698 4.649625 5.607932 6.622463 7.687252 8.797378 9.948729 11.13787 12.36186 13.61821 14.90475 16.21962 17.56115 18.92786 0.000000 0.1888138 0.4815543 0.8723172 1.355778 1.926267 2.577099 3.300757 4.089571 4.936340 5.834715 6.779265 7.765441 8.789414 9.847975 10.93838 12.05830 13.20573 14.37894 15.57638 16.79669 0.000000 0.1651207 0.4198637 0.7578338 1.174080 1.664212 2.223465 2.846372 3.527074 4.259756 5.039049 5.860192 6.719100 7.612276 8.536771 9.490053 10.46997 11.47468 12.50258 13.55227 14.62249 0.000000 0.1414354 0.3584372 0.6442971 0.9943091 1.404999 1.873096 2.394923 2.966370 3.583117 4.240948 4.935937 5.664591 6.423838 7.211040 8.023909 8.860491 9.719110 10.59832 11.49684 12.41354 0.000000 0.1177667 0.2973574 0.5320257 0.8172737 1.150235 1.528691 1.950354 2.412650 2.912721 3.447613 4.014400 4.610346 5.232936 5.879941 6.549379 7.239540 7.948937 8.676290 9.420452 10.18041 0.000000 9.4124235E-02 0.2367060 0.4213236 0.6437700 0.9015785 1.193173 1.517197 1.872227 2.256653 2.668731 3.106613 3.568461 4.052480 4.556996 5.080455 5.621468 6.178805 6.751385 7.338226 7.938439 0.000000 7.0517078E-02 0.1765691 0.3124970 0.4745841 0.6606972 0.8696145 1.100480 1.352559 1.625091 1.917264 2.228178 2.556891 2.902411 3.263757 3.639944 4.030054 4.433232 4.848686 5.275661 5.713451 0.000000 4.6954881E-02 0.1170254 0.2058271 0.3104520 0.4291954 0.5610784 0.7054734 0.8619478 1.030140 1.209735 1.400410 1.601847 1.813694 2.035598 2.267172 2.508041 2.757832 3.016165 3.282641 3.556870 0.000000 2.3446221E-02 5.8148287E-02 0.1015760 0.1520613 0.2085439 0.2704121 0.3372355 0.4087320 0.4846815 0.5649266 0.6493306 0.7377957 0.8302262 0.9265466 1.026679 1.130567 1.238150 1.349370 1.464151 1.582423 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4708147 1.212682 2.211432 3.432987 4.839374 6.398738 8.087298 9.887687 11.78684 13.77459 15.84279 17.98472 20.19475 22.46810 24.80061 27.18870 29.62920 32.11934 34.65660 37.23872 0.000000 0.4477051 1.154301 2.108552 3.280417 4.634690 6.140791 7.775347 9.521101 11.36503 13.29699 15.30883 17.39387 19.54648 21.76189 24.03596 26.36510 28.74617 31.17638 33.65323 36.17448 0.000000 0.4244942 1.095203 2.003284 3.122520 4.420557 5.868235 7.442711 9.126884 10.90779 12.77535 14.72143 16.73939 18.82363 20.96940 23.17260 25.42965 27.73744 30.09321 32.49450 34.93906 0.000000 0.4011924 1.035460 1.895841 2.959677 4.197553 5.581919 7.090590 8.706713 10.41744 12.21276 14.08463 16.02646 18.03272 20.09873 22.22042 24.39429 26.61727 28.88664 31.19999 33.55511 0.000000 0.3778076 0.9751461 1.786446 2.792318 3.966362 5.282825 6.720366 8.262484 9.896507 11.61257 13.40273 15.26051 17.18047 19.15802 21.18920 23.27056 25.39911 27.57222 29.78751 32.04287 0.000000 0.3543504 0.9143394 1.675336 2.620921 3.727736 4.972039 6.333524 7.796179 9.347598 10.97809 12.67989 14.44666 16.27308 18.15469 20.08761 22.06853 24.09452 26.16304 28.27180 30.41873 0.000000 0.3308298 0.8531175 1.562770 2.445999 3.482494 4.650712 5.931611 7.309813 8.773271 10.31254 11.92005 13.58963 15.31614 17.09524 18.92318 20.79674 22.71313 24.66988 26.66478 28.69586 0.000000 0.3072550 0.7915630 1.449021 2.268118 3.231522 4.320086 5.516239 6.805422 8.176046 9.618970 11.12686 12.69375 14.31465 15.98539 17.70237 19.46248 21.26304 23.10169 24.97631 26.88503 0.000000 0.2836357 0.7297602 1.334368 2.087866 2.975774 3.981476 5.089103 6.285091 7.558430 8.900346 10.30377 11.76296 13.27313 14.83026 16.43090 18.07208 19.75125 21.46615 23.21478 24.99533 0.000000 0.2599800 0.6677961 1.219109 1.905883 2.716290 3.636318 4.652007 5.750990 6.922964 8.159594 9.454126 10.80106 12.19581 13.63454 15.11396 16.63127 18.18401 19.77007 21.38754 23.03473 0.000000 0.2362965 0.6057552 1.103547 1.722837 2.454185 3.286174 4.206919 5.205446 6.272313 7.399719 8.581271 9.811740 11.08677 12.40272 13.75647 15.14536 16.56710 18.01967 19.50131 21.01041 0.000000 0.2125948 0.5437255 0.9879909 1.539439 2.190680 2.932777 3.756028 4.651035 5.609390 6.623945 7.688743 8.798864 9.950203 11.13933 12.36330 13.61962 14.90614 16.22098 17.56248 18.92916 0.000000 0.1888844 0.4817918 0.8727605 1.356426 1.927093 2.578066 3.301827 4.090711 4.937524 5.835922 6.780481 7.766655 8.790619 9.849166 10.93955 12.05945 13.20686 14.38005 15.57747 16.79775 0.000000 0.1651746 0.4200444 0.7581713 1.174575 1.664847 2.224215 2.847209 3.527971 4.260693 5.040009 5.861162 6.720071 7.613242 8.537726 9.490995 10.47090 11.47559 12.50348 13.55315 14.62334 0.000000 0.1414748 0.3585689 0.6445434 0.9946718 1.405468 1.873654 2.395551 2.967050 3.583833 4.241685 4.936687 5.665345 6.424590 7.211786 8.024646 8.861217 9.719826 10.59902 11.49753 12.41421 0.000000 0.1177941 0.2974482 0.5321955 0.8175246 1.150561 1.529083 1.950800 2.413137 2.913239 3.448153 4.014954 4.610906 5.233498 5.880501 6.549934 7.240088 7.949479 8.676822 9.420976 10.18092 0.000000 9.4141595E-02 0.2367636 0.4214315 0.6439297 0.9017875 1.193426 1.517488 1.872548 2.256999 2.669096 3.106991 3.568847 4.052871 4.557389 5.080847 5.621857 6.179192 6.751766 7.338602 7.938809 0.000000 7.0526741E-02 0.1766013 0.3125570 0.4746732 0.6608143 0.8697575 1.100646 1.352745 1.625294 1.917481 2.228405 2.557126 2.902653 3.264003 3.640192 4.030303 4.433480 4.848933 5.275906 5.713694 0.000000 4.6959206E-02 0.1170396 0.2058535 0.3104912 0.4292471 0.5611418 0.7055476 0.8620318 1.030233 1.209836 1.400517 1.601960 1.813811 2.035719 2.267296 2.508168 2.757960 3.016294 3.282770 3.557000 0.000000 2.3447270E-02 5.8151774E-02 0.1015826 0.1520710 0.2085567 0.2704279 0.3372539 0.4087530 0.4847049 0.5649522 0.6493582 0.7378251 0.8302574 0.9265793 1.026713 1.130602 1.238187 1.349407 1.464190 1.582462 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4713814 1.214611 2.214993 3.438093 4.845806 6.406286 8.095789 9.896985 11.79684 13.78521 15.85395 17.99637 20.20685 22.48059 24.81347 27.20190 29.64271 32.13313 34.67066 37.25303 0.000000 0.4482146 1.156032 2.111742 3.284974 4.640400 6.147441 7.782763 9.529147 11.37359 13.30599 15.31820 17.40355 19.55643 21.77207 24.04633 26.37564 28.75684 31.18717 33.66412 36.18545 0.000000 0.4249495 1.096747 2.006128 3.126573 4.425613 5.874086 7.449189 9.133857 10.91516 12.78302 14.72936 16.74751 18.83190 20.97779 23.18108 25.43819 27.74603 30.10184 32.50314 34.94770 0.000000 0.4015968 1.036829 1.898362 2.963265 4.202014 5.587058 7.096243 8.712756 10.42378 12.21932 14.09136 16.03331 18.03965 20.10571 22.22743 24.40131 26.62428 28.89364 31.20696 33.56205 0.000000 0.3781644 0.9763525 1.788666 2.795476 3.970281 5.287323 6.725291 8.267719 9.901967 11.61818 13.40845 15.26630 17.18630 19.16387 21.19504 23.27638 25.40490 27.57797 29.79321 32.04852 0.000000 0.3546628 0.9153937 1.677277 2.623683 3.731161 4.975959 6.337801 7.800706 9.352297 10.98290 12.68477 14.45157 16.27800 18.15960 20.09250 22.07338 24.09934 26.16780 28.27650 30.42338 0.000000 0.3311007 0.8540305 1.564452 2.448396 3.485467 4.654111 5.935310 7.313715 8.777307 10.31666 11.92421 13.59381 15.32031 17.09938 18.92729 20.80081 22.71715 24.67384 26.66869 28.69971 0.000000 0.3074877 0.7923458 1.450464 2.270179 3.234081 4.323012 5.519421 6.808773 8.179502 9.622484 11.13040 12.69729 14.31818 15.98889 17.70583 19.46589 21.26641 23.10500 24.97957 26.88823 0.000000 0.2838331 0.7304231 1.335591 2.089617 2.977955 3.983975 5.091819 6.287949 7.561373 8.903333 10.30678 11.76596 13.27611 14.83321 16.43381 18.07495 19.75407 21.46892 23.21750 24.99800 0.000000 0.2601450 0.6683497 1.220132 1.907353 2.718126 3.638428 4.654304 5.753407 6.925452 8.162117 9.456659 10.80358 12.19831 13.63701 15.11640 16.63367 18.18637 19.77238 21.38981 23.03695 0.000000 0.2364323 0.6062098 1.104389 1.724050 2.455708 3.287930 4.208837 5.207469 6.274396 7.401832 8.583391 9.813852 11.08886 12.40479 13.75851 15.14736 16.56906 18.02160 19.50319 21.01225 0.000000 0.2127044 0.5440913 0.9886688 1.540420 2.191919 2.934214 3.757604 4.652703 5.611112 6.625693 7.690498 8.800613 9.951936 11.14104 12.36498 13.62127 14.90776 16.22256 17.56404 18.93069 0.000000 0.1889706 0.4820789 0.8732930 1.357200 1.928077 2.579214 3.303095 4.092059 4.938920 5.837345 6.781912 7.768083 8.792034 9.850563 10.94093 12.06080 13.20819 14.38134 15.57874 16.79899 0.000000 0.1652403 0.4202627 0.7585764 1.175166 1.665603 2.225104 2.848199 3.529032 4.261797 5.041139 5.862303 6.721212 7.614375 8.538847 9.492099 10.47198 11.47665 12.50452 13.55417 14.62434 0.000000 0.1415228 0.3587281 0.6448389 0.9951049 1.406025 1.874316 2.396294 2.967853 3.584676 4.242554 4.937568 5.666230 6.425472 7.212661 8.025510 8.862068 9.720661 10.59984 11.49833 12.41500 0.000000 0.1178272 0.2975579 0.5323991 0.8178240 1.150949 1.529547 1.951327 2.413713 2.913850 3.448787 4.015603 4.611562 5.234156 5.881157 6.550584 7.240730 7.950111 8.677444 9.421586 10.18152 0.000000 9.4162747E-02 0.2368333 0.4215606 0.6441201 0.9020358 1.193726 1.517832 1.872928 2.257407 2.669524 3.107434 3.569300 4.053329 4.557849 5.081306 5.622313 6.179643 6.752212 7.339041 7.939241 0.000000 7.0538633E-02 0.1766401 0.3126289 0.4747795 0.6609534 0.8699267 1.100842 1.352964 1.625533 1.917735 2.228672 2.557402 2.902935 3.264290 3.640481 4.030593 4.433770 4.849222 5.276192 5.713976 0.000000 4.6964437E-02 0.1170567 0.2058851 0.3105379 0.4293084 0.5612170 0.7056352 0.8621307 1.030342 1.209953 1.400642 1.602092 1.813948 2.035861 2.267441 2.508315 2.758109 3.016445 3.282922 3.557152 0.000000 2.3448549E-02 5.8156047E-02 0.1015903 0.1520825 0.2085718 0.2704464 0.3372757 0.4087778 0.4847324 0.5649822 0.6493907 0.7378597 0.8302938 0.9266175 1.026753 1.130643 1.238229 1.349451 1.464234 1.582508 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4721017 1.217046 2.219466 3.444481 4.853835 6.415688 8.106350 9.908537 11.80925 13.79838 15.86779 18.01081 20.22182 22.49605 24.82938 27.21821 29.65940 32.15018 34.68803 37.27070 0.000000 0.4488617 1.158214 2.115743 3.290667 4.647511 6.155702 7.791959 9.539106 11.38419 13.31711 15.32977 17.41549 19.56868 21.78459 24.05908 26.38857 28.76994 31.20040 33.67747 36.19889 0.000000 0.4255277 1.098693 2.009689 3.131626 4.431896 5.881339 7.457200 9.142462 10.92423 12.79247 14.73909 16.75747 18.84204 20.98807 23.19145 25.44864 27.75653 30.11236 32.51368 34.95823 0.000000 0.4021102 1.038553 1.901515 2.967731 4.207548 5.593412 7.103218 8.720198 10.43157 12.22737 14.09960 16.04168 18.04812 20.11423 22.23598 24.40987 26.63283 28.90216 31.21544 33.57048 0.000000 0.3786170 0.9778693 1.791439 2.799402 3.975134 5.292875 6.731354 8.274152 9.908663 11.62506 13.41545 15.27337 17.19341 19.17099 21.20214 23.28345 25.41193 27.58494 29.80013 32.05536 0.000000 0.3550588 0.9167180 1.679698 2.627112 3.735395 4.980790 6.343058 7.806258 9.358048 10.98878 12.69073 14.45756 16.28400 18.16558 20.09844 22.07927 24.10517 26.17357 28.28220 30.42900 0.000000 0.3314440 0.8551766 1.566548 2.451368 3.489137 4.658294 5.939849 7.318494 8.782238 10.32168 11.92927 13.59888 15.32537 17.10441 18.93227 20.80574 22.72201 24.67864 26.67341 28.70436 0.000000 0.3077824 0.7933275 1.452261 2.272730 3.237237 4.326609 5.523320 6.812868 8.183717 9.626764 11.13470 12.70159 14.32245 15.99313 17.71001 19.47002 21.27047 23.10900 24.98351 26.89209 0.000000 0.2840829 0.7312539 1.337114 2.091785 2.980643 3.987041 5.095144 6.291438 7.564959 8.906966 10.31042 11.76960 13.27972 14.83677 16.43732 18.07841 19.75747 21.47226 23.22078 25.00122 0.000000 0.2603540 0.6690431 1.221404 1.909169 2.720387 3.641015 4.657113 5.756356 6.928481 8.165183 9.459732 10.80664 12.20134 13.64000 15.11935 16.63656 18.18921 19.77517 21.39254 23.03963 0.000000 0.2366042 0.6067788 1.105433 1.725548 2.457581 3.290082 4.211181 5.209933 6.276930 7.404397 8.585961 9.816408 11.09139 12.40728 13.76096 15.14977 16.57143 18.02391 19.50546 21.01447 0.000000 0.2128429 0.5445489 0.9895100 1.541631 2.193441 2.935972 3.759528 4.654733 5.613203 6.627813 7.692623 8.802728 9.954028 11.14310 12.36701 13.62326 14.90971 16.22448 17.56591 18.93251 0.000000 0.1890795 0.4824378 0.8739534 1.358154 1.929283 2.580618 3.304640 4.093699 4.940616 5.839068 6.783643 7.769807 8.793741 9.852246 10.94258 12.06243 13.20978 14.38290 15.58026 16.80049 0.000000 0.1653232 0.4205353 0.7590785 1.175895 1.666530 2.226192 2.849406 3.530320 4.263138 5.042507 5.863682 6.722589 7.615742 8.540197 9.493428 10.47329 11.47793 12.50577 13.55540 14.62554 0.000000 0.1415834 0.3589267 0.6452050 0.9956381 1.406708 1.875124 2.397199 2.968828 3.585698 4.243605 4.938633 5.667298 6.426536 7.213715 8.026549 8.863091 9.721665 10.60083 11.49930 12.41594 0.000000 0.1178691 0.2976947 0.5326512 0.8181924 1.151425 1.530114 1.951969 2.414411 2.914590 3.449555 4.016387 4.612354 5.234949 5.881946 6.551366 7.241501 7.950871 8.678189 9.422318 10.18224 0.000000 9.4189331E-02 0.2369201 0.4217204 0.6443543 0.9023396 1.194092 1.518250 1.873389 2.257901 2.670043 3.107970 3.569847 4.053881 4.558403 5.081858 5.622860 6.180184 6.752746 7.339567 7.939759 0.000000 7.0553519E-02 0.1766884 0.3127179 0.4749100 0.6611236 0.8701330 1.101080 1.353230 1.625821 1.918042 2.228993 2.557735 2.903275 3.264635 3.640829 4.030941 4.434118 4.849567 5.276535 5.714315 0.000000 4.6971034E-02 0.1170780 0.2059242 0.3105953 0.4293835 0.5613084 0.7057418 0.8622507 1.030474 1.210096 1.400793 1.602250 1.814113 2.036031 2.267615 2.508492 2.758289 3.016625 3.283103 3.557333 0.000000 2.3450181E-02 5.8161221E-02 0.1016000 0.1520967 0.2085904 0.2704691 0.3373022 0.4088079 0.4847657 0.5650185 0.6494297 0.7379013 0.8303376 0.9266635 1.026801 1.130693 1.238280 1.349503 1.464288 1.582562 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4730670 1.220279 2.225367 3.452871 4.864343 6.427965 8.120114 9.923571 11.82538 13.81547 15.88573 18.02951 20.24121 22.51607 24.84996 27.23931 29.68098 32.17220 34.71046 37.29352 0.000000 0.4497281 1.161108 2.121010 3.298123 4.656789 6.166451 7.803894 9.552009 11.39788 13.33147 15.34467 17.43086 19.58444 21.80067 24.07544 26.40516 28.78673 31.21735 33.69455 36.21608 0.000000 0.4263012 1.101269 2.014369 3.138231 4.440072 5.890745 7.467561 9.153566 10.93592 12.80461 14.75159 16.77024 18.85502 21.00120 23.20470 25.46197 27.76991 30.12576 32.52708 34.97162 0.000000 0.4027965 1.040833 1.905650 2.973556 4.214732 5.601631 7.112213 8.729770 10.44157 12.23768 14.11013 16.05237 18.05891 20.12508 22.24685 24.42073 26.64366 28.91295 31.22617 33.58114 0.000000 0.3792217 0.9798728 1.795071 2.804513 3.981421 5.300039 6.739153 8.282403 9.917230 11.63384 13.42437 15.28237 17.20244 19.18002 21.21114 23.29241 25.42082 27.59376 29.80885 32.06399 0.000000 0.3555874 0.9184654 1.682866 2.631567 3.740870 4.987012 6.349804 7.813363 9.365390 10.99627 12.69829 14.46516 16.29159 18.17314 20.10595 22.08671 24.11252 26.18083 28.28937 30.43606 0.000000 0.3319021 0.8566871 1.569287 2.455223 3.493875 4.663670 5.945664 7.324597 8.788521 10.32806 11.93570 13.60531 15.33177 17.11076 18.93855 20.81194 22.72813 24.68466 26.67934 28.71019 0.000000 0.3081752 0.7946200 1.454605 2.276037 3.241304 4.331224 5.528306 6.818089 8.189077 9.632195 11.14016 12.70702 14.32785 15.99847 17.71528 19.47522 21.27558 23.11402 24.98843 26.89693 0.000000 0.2844158 0.7323468 1.339097 2.094589 2.984101 3.990971 5.099389 6.295879 7.569510 8.911568 10.31503 11.77418 13.28426 14.84126 16.44174 18.08276 19.76174 21.47645 23.22488 25.00524 0.000000 0.2606323 0.6699542 1.223059 1.911517 2.723291 3.644324 4.660693 5.760104 6.932320 8.169061 9.463612 10.81050 12.20515 13.64376 15.12304 16.64019 18.19277 19.77865 21.39595 23.04297 0.000000 0.2368329 0.6075259 1.106792 1.727481 2.459984 3.292831 4.214164 5.213062 6.280138 7.407637 8.589201 9.819625 11.09457 12.41041 13.76404 15.15279 16.57438 18.02681 19.50829 21.01724 0.000000 0.2130271 0.5451493 0.9906027 1.543192 2.195392 2.938217 3.761974 4.657307 5.615848 6.630488 7.695300 8.805386 9.956655 11.14569 12.36955 13.62575 14.91215 16.22686 17.56824 18.93479 0.000000 0.1892243 0.4829082 0.8748104 1.359384 1.930829 2.582408 3.306604 4.095775 4.942758 5.841240 6.785821 7.771973 8.795883 9.854356 10.94466 12.06446 13.21177 14.38485 15.58217 16.80235 0.000000 0.1654335 0.4208924 0.7597295 1.176832 1.667717 2.227577 2.850937 3.531951 4.264830 5.044231 5.865416 6.724318 7.617455 8.541886 9.495090 10.47492 11.47953 12.50734 13.55692 14.62704 0.000000 0.1416639 0.3591868 0.6456792 0.9963238 1.407582 1.876153 2.398347 2.970061 3.586987 4.244927 4.939971 5.668638 6.427868 7.215032 8.027847 8.864367 9.722917 10.60205 11.50050 12.41711 0.000000 0.1179247 0.2978736 0.5329775 0.8186658 1.152032 1.530835 1.952781 2.415294 2.915523 3.450520 4.017371 4.613347 5.235941 5.882932 6.552341 7.242463 7.951817 8.679118 9.423228 10.18313 0.000000 9.4224699E-02 0.2370335 0.4219271 0.6446549 0.9027274 1.194556 1.518779 1.873970 2.258523 2.670694 3.108641 3.570531 4.054571 4.559094 5.082546 5.623543 6.180859 6.753411 7.340221 7.940402 0.000000 7.0573293E-02 0.1767517 0.3128329 0.4750775 0.6613407 0.8703951 1.101382 1.353565 1.626184 1.918428 2.229397 2.558151 2.903701 3.265066 3.641263 4.031376 4.434550 4.849998 5.276960 5.714736 0.000000 4.6979792E-02 0.1171058 0.2059747 0.3106688 0.4294791 0.5614245 0.7058764 0.8624019 1.030640 1.210274 1.400983 1.602449 1.814320 2.036243 2.267832 2.508713 2.758512 3.016850 3.283328 3.557558 0.000000 2.3452394E-02 5.8168195E-02 0.1016124 0.1521148 0.2086139 0.2704978 0.3373357 0.4088457 0.4848076 0.5650641 0.6494786 0.7379532 0.8303924 0.9267207 1.026860 1.130754 1.238344 1.349568 1.464354 1.582630 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4744708 1.224922 2.233768 3.464742 4.879149 6.445207 8.139397 9.944591 11.84790 13.83930 15.91072 18.05554 20.26816 22.54386 24.87852 27.26858 29.71090 32.20271 34.74152 37.32510 0.000000 0.4509870 1.165255 2.128488 3.308636 4.669805 6.181468 7.820516 9.569928 11.41687 13.35132 15.36525 17.45204 19.60613 21.82278 24.09789 26.42791 28.80972 31.24053 33.71790 36.23956 0.000000 0.4274239 1.104954 2.020996 3.147513 4.451498 5.903830 7.481921 9.168908 10.95202 12.82129 14.76872 16.78772 18.87275 21.01912 23.22275 25.48010 27.78807 30.14394 32.54523 34.98973 0.000000 0.4037916 1.044088 1.911494 2.981719 4.224737 5.613023 7.124628 8.742935 10.45528 12.25179 14.12451 16.06693 18.07357 20.13979 22.26157 24.43542 26.65830 28.92750 31.24062 33.59548 0.000000 0.3800977 0.9827296 1.800193 2.811656 3.990152 5.309936 6.749880 8.293710 9.928933 11.64581 13.43649 15.29457 17.21466 19.19221 21.22328 23.30446 25.43277 27.60558 29.82055 32.07555 0.000000 0.3563525 0.9209530 1.687322 2.637781 3.748453 4.995582 6.359055 7.823069 9.375385 11.00644 12.70854 14.47543 16.30183 18.18331 20.11603 22.09668 24.12237 26.19055 28.29894 30.44549 0.000000 0.3325644 0.8588345 1.573133 2.460589 3.500420 4.671056 5.953616 7.332911 8.797050 10.33670 11.94438 13.61397 15.34037 17.11928 18.94697 20.82024 22.73630 24.69270 26.68724 28.71795 0.000000 0.3087426 0.7964547 1.457892 2.280629 3.246912 4.337552 5.535107 6.825185 8.196337 9.639527 11.14750 12.71433 14.33509 16.00561 17.72232 19.48214 21.28238 23.12070 24.99498 26.90335 0.000000 0.2848963 0.7338960 1.341874 2.098477 2.988859 3.996346 5.105168 6.301902 7.575662 8.917769 10.32123 11.78034 13.29034 14.84725 16.44764 18.08854 19.76741 21.48201 23.23032 25.01057 0.000000 0.2610334 0.6712443 1.225373 1.914766 2.727282 3.648844 4.665559 5.765176 6.937499 8.174276 9.468816 10.81565 12.21025 13.64877 15.12796 16.64501 18.19749 19.78328 21.40047 23.04739 0.000000 0.2371624 0.6085824 1.108688 1.730153 2.463280 3.296580 4.218212 5.217289 6.284457 7.411987 8.593540 9.823924 11.09881 12.41458 13.76813 15.15680 16.57830 18.03064 19.51204 21.02090 0.000000 0.2132923 0.5459970 0.9921256 1.545346 2.198063 2.941272 3.765288 4.660779 5.619404 6.634075 7.698879 8.808933 9.960154 11.14912 12.37292 13.62905 14.91537 16.23002 17.57132 18.93780 0.000000 0.1894324 0.4835717 0.8760032 1.361078 1.932943 2.584841 3.309260 4.098573 4.945634 5.844149 6.788730 7.774859 8.798732 9.857158 10.94740 12.06715 13.21440 14.38742 15.58468 16.80480 0.000000 0.1655919 0.4213955 0.7606344 1.178123 1.669338 2.229457 2.853005 3.534145 4.267099 5.046536 5.867729 6.726619 7.619730 8.544127 9.497290 10.47707 11.48164 12.50940 13.55894 14.62901 0.000000 0.1417795 0.3595528 0.6463376 0.9972664 1.408774 1.877547 2.399895 2.971718 3.588715 4.246694 4.941754 5.670420 6.429636 7.216778 8.029565 8.866053 9.724568 10.60367 11.50208 12.41866 0.000000 0.1180045 0.2981252 0.5334299 0.8193157 1.152859 1.531812 1.953877 2.416479 2.916770 3.451808 4.018682 4.614666 5.237257 5.884238 6.553631 7.243733 7.953064 8.680342 9.424428 10.18431 0.000000 9.4275475E-02 0.2371928 0.4222135 0.6450673 0.9032555 1.195185 1.519492 1.874750 2.259355 2.671563 3.109535 3.571439 4.055486 4.560008 5.083455 5.624444 6.181747 6.754286 7.341082 7.941247 0.000000 7.0601620E-02 0.1768403 0.3129920 0.4753070 0.6616360 0.8707494 1.101787 1.354014 1.626670 1.918942 2.229933 2.558703 2.904264 3.265635 3.641836 4.031948 4.435121 4.850563 5.277521 5.715290 0.000000 4.6992302E-02 0.1171448 0.2060444 0.3107696 0.4296090 0.5615813 0.7060574 0.8626044 1.030861 1.210512 1.401235 1.602712 1.814593 2.036524 2.268119 2.509003 2.758805 3.017145 3.283624 3.557854 0.000000 2.3455536E-02 5.8177754E-02 0.1016296 0.1521396 0.2086459 0.2705366 0.3373806 0.4088963 0.4848634 0.5651248 0.6495435 0.7380221 0.8304648 0.9267963 1.026939 1.130836 1.238427 1.349654 1.464441 1.582718 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4768332 1.232584 2.247449 3.483901 4.902892 6.472725 8.170063 9.977922 11.88353 13.87693 15.95011 18.09650 20.31053 22.58751 24.92333 27.31445 29.75774 32.25046 34.79011 37.37447 0.000000 0.4531019 1.172078 2.140612 3.325506 4.690531 6.205242 7.846704 9.598050 11.44655 13.38228 15.39726 17.48491 19.63969 21.85693 24.13251 26.46292 28.84503 31.27610 33.75365 36.27546 0.000000 0.4293068 1.110999 2.031698 3.162332 4.469583 5.924403 7.504374 9.192784 10.97697 12.84706 14.79510 16.81455 18.89990 21.04648 23.25024 25.50766 27.81564 30.17147 32.57269 35.01708 0.000000 0.4054578 1.049413 1.920895 2.994692 4.240491 5.630828 7.143917 8.763286 10.47638 12.27340 14.14646 16.08909 18.09583 20.16207 22.28381 24.45756 26.68031 28.94935 31.26228 33.61693 0.000000 0.3815620 0.9873900 1.808403 2.822963 4.003836 5.325326 6.766457 8.311090 9.946837 11.66403 13.45489 15.31303 17.23310 19.21056 21.24150 23.32251 25.45062 27.62322 29.83796 32.09272 0.000000 0.3576294 0.9250013 1.694445 2.647581 3.760289 5.008851 6.373285 7.837914 9.390602 11.02185 12.72402 14.49088 16.31719 18.19854 20.13108 22.11154 24.13701 26.20496 28.31312 30.45944 0.000000 0.3336681 0.8623207 1.579261 2.469023 3.510601 4.682449 5.965798 7.345575 8.809979 10.34974 11.95743 13.62695 15.35323 17.13198 18.95948 20.83255 22.74840 24.70458 26.69889 28.72938 0.000000 0.3096870 0.7994269 1.463115 2.287825 3.255606 4.347277 5.545491 6.835955 8.207302 9.650556 11.15850 12.72524 14.34587 16.01623 17.73276 19.49238 21.29242 23.13053 25.00462 26.91278 0.000000 0.2856947 0.7364004 1.346276 2.104553 2.996215 4.004584 5.113963 6.311014 7.584925 8.927068 10.33048 11.78949 13.29937 14.85613 16.45634 18.09707 19.77576 21.49017 23.23831 25.01837 0.000000 0.2616993 0.6733254 1.229032 1.919830 2.733433 3.655751 4.672943 5.772830 6.945275 8.182075 9.476568 10.82332 12.21779 13.65618 15.13522 16.65211 18.20443 19.79005 21.40709 23.05385 0.000000 0.2377085 0.6102833 1.111681 1.734309 2.468350 3.302294 4.224340 5.223651 6.290926 7.418476 8.599989 9.830295 11.10508 12.42073 13.77414 15.16267 16.58404 18.03624 19.51750 21.02623 0.000000 0.2137313 0.5473595 0.9945241 1.548689 2.202164 2.945919 3.770294 4.665995 5.624720 6.639413 7.704188 8.814178 9.965313 11.15418 12.37787 13.63389 14.92010 16.23462 17.57581 18.94218 0.000000 0.1897766 0.4846362 0.8778782 1.363702 1.936181 2.588536 3.313265 4.102767 4.949925 5.848471 6.793036 7.779119 8.802925 9.861271 10.95143 12.07108 13.21824 14.39117 15.58833 16.80836 0.000000 0.1658534 0.4222014 0.7620542 1.180118 1.671816 2.232307 2.856119 3.537428 4.270478 5.049955 5.871148 6.730011 7.623075 8.547414 9.500509 10.48022 11.48472 12.51240 13.56187 14.63186 0.000000 0.1419701 0.3601381 0.6473689 0.9987209 1.410593 1.879657 2.402222 2.974194 3.591283 4.249310 4.944385 5.673041 6.432230 7.219334 8.032076 8.868512 9.726974 10.60602 11.50437 12.42090 0.000000 0.1181358 0.2985269 0.5341375 0.8203170 1.154119 1.533287 1.955521 2.418246 2.918623 3.453713 4.020613 4.616603 5.239187 5.886147 6.555514 7.245584 7.954879 8.682119 9.426167 10.18601 0.000000 9.4358891E-02 0.2374469 0.4226605 0.6457016 0.9040587 1.196133 1.520560 1.875913 2.260588 2.672846 3.110851 3.572772 4.056825 4.561344 5.084781 5.625754 6.183039 6.755557 7.342329 7.942470 0.000000 7.0648268E-02 0.1769814 0.3132400 0.4756596 0.6620846 0.8712831 1.102394 1.354683 1.627388 1.919700 2.230721 2.559513 2.905088 3.266467 3.642670 4.032781 4.435948 4.851384 5.278331 5.716089 0.000000 4.7012776E-02 0.1172067 0.2061531 0.3109240 0.4298062 0.5618172 0.7063279 0.8629056 1.031189 1.210863 1.401605 1.603098 1.814992 2.036933 2.268536 2.509426 2.759231 3.017573 3.284052 3.558281 0.000000 2.3460545E-02 5.8193050E-02 0.1016563 0.1521776 0.2086945 0.2705948 0.3374477 0.4089716 0.4849461 0.5652140 0.6496389 0.7381229 0.8305706 0.9269066 1.027053 1.130953 1.238548 1.349777 1.464567 1.582847 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4824185 1.250007 2.277782 3.525665 4.954045 6.531515 8.235155 10.04832 11.95846 13.95580 16.03244 18.18190 20.39868 22.67814 25.01621 27.40939 29.85458 32.34904 34.89031 37.47618 0.000000 0.4580829 1.187486 2.167235 3.361829 4.734522 6.255150 7.901198 9.656138 11.50748 13.44548 15.46226 17.55135 19.70729 21.92543 24.20173 26.53268 28.91520 31.34655 33.82429 36.34620 0.000000 0.4337253 1.124564 2.054996 3.193901 4.507492 5.966985 7.550372 9.241277 11.02728 12.89867 14.84762 16.86767 18.95339 21.10016 23.30396 25.56129 27.86910 30.22467 32.62558 35.06961 0.000000 0.4093539 1.061293 1.941203 3.022074 4.273165 5.667253 7.182936 8.804067 10.51832 12.31607 14.18952 16.13230 18.13902 20.20509 22.32655 24.49996 26.72229 28.99088 31.30332 33.65746 0.000000 0.3849744 0.9977298 1.826016 2.846633 4.031958 5.356503 6.799641 8.345538 9.982028 11.69959 13.49055 15.34859 17.26843 19.24556 21.27609 23.35665 25.48427 27.65635 29.87056 32.12477 0.000000 0.3605954 0.9339367 1.709626 2.667946 3.784421 5.035502 6.401520 7.867076 9.420234 11.05163 12.75374 14.52038 16.34637 18.22731 20.15941 22.13938 24.16435 26.23179 28.33943 30.48523 0.000000 0.3362237 0.8699781 1.592248 2.486435 3.531214 4.705164 5.989789 7.370261 8.834965 10.37476 11.98229 13.65154 15.37746 17.15580 18.98285 20.85546 22.77083 24.72653 26.72037 28.75039 0.000000 0.3118668 0.8059254 1.474125 2.302595 3.273099 4.366544 5.565806 6.856809 8.228351 9.671570 11.17932 12.74578 14.36605 16.03602 17.75213 19.51132 21.31093 23.14861 25.02226 26.93001 0.000000 0.2875324 0.7418525 1.355507 2.116958 3.010934 4.020812 5.131071 6.328559 7.602605 8.944685 10.34791 11.80664 13.31619 14.87259 16.47242 18.11277 19.79107 21.50510 23.25286 25.03257 0.000000 0.2632272 0.6778377 1.236671 1.930121 2.745682 3.669288 4.687236 5.787493 6.960045 8.196779 9.491095 10.83759 12.23177 13.66984 15.14855 16.66511 18.21709 19.80239 21.41911 23.06556 0.000000 0.2389581 0.6139572 1.117901 1.742715 2.478398 3.313445 4.236148 5.235787 6.303163 7.430660 8.612022 9.842116 11.11665 12.43203 13.78516 15.17341 16.59449 18.04641 19.52740 21.03587 0.000000 0.2147330 0.5502918 0.9994901 1.555425 2.210258 2.954950 3.779902 4.675904 5.634734 6.649400 7.714060 8.823879 9.974810 11.16346 12.38691 13.64269 14.92866 16.24296 17.58392 18.95007 0.000000 0.1905601 0.4869193 0.8817460 1.368968 1.942549 2.595689 3.320923 4.110706 4.957982 5.856528 6.801017 7.786973 8.810621 9.868792 10.95877 12.07823 13.22519 14.39793 15.59491 16.81476 0.000000 0.1664471 0.4239239 0.7649730 1.184108 1.676673 2.237807 2.862053 3.543625 4.276803 5.056311 5.877467 6.736246 7.629198 8.553406 9.506360 10.48593 11.49027 12.51781 13.56713 14.63698 0.000000 0.1424020 0.3613852 0.6494820 1.001621 1.414148 1.883717 2.406644 2.978853 3.596078 4.254162 4.949235 5.677849 6.436969 7.223985 8.036627 8.872957 9.731311 10.61025 11.50849 12.42491 0.000000 0.1184327 0.2993803 0.5355829 0.8223075 1.156575 1.536118 1.958637 2.421565 2.922074 3.457238 4.024166 4.620150 5.242702 5.889615 6.558921 7.248923 7.958145 8.685310 9.429281 10.18904 0.000000 9.4546974E-02 0.2379849 0.4235710 0.6469591 0.9056197 1.197949 1.522580 1.878090 2.262880 2.675215 3.113265 3.575207 4.059261 4.563765 5.087176 5.628115 6.185359 6.757833 7.344559 7.944652 0.000000 7.0752904E-02 0.1772796 0.3137437 0.4763566 0.6629541 0.8723021 1.103540 1.355933 1.628721 1.921098 2.232166 2.560990 2.906584 3.267972 3.644175 4.034278 4.437433 4.852851 5.279779 5.717515 0.000000 4.7058836E-02 0.1173371 0.2063731 0.3112286 0.4301875 0.5622668 0.7068376 0.8634674 1.031796 1.211508 1.402281 1.603801 1.815715 2.037672 2.269286 2.510185 2.759994 3.018337 3.284816 3.559041 0.000000 2.3471955E-02 5.8225218E-02 0.1017103 0.1522522 0.2087881 0.2707056 0.3375739 0.4091116 0.4850987 0.5653780 0.6498131 0.7383063 0.8307621 0.9271055 1.027259 1.131165 1.238764 1.349998 1.464792 1.583075 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.7089728 1.664938 2.816266 4.117411 5.535478 7.048705 8.642654 10.30729 12.03525 13.82082 15.65943 17.54729 19.48119 21.45836 23.47639 25.53317 27.62683 29.75565 31.91813 34.11285 0.000000 0.6695088 1.568460 2.652995 3.883117 5.228522 6.668396 8.188609 9.779238 11.43295 13.14408 14.90807 16.72113 18.58008 20.48215 22.42494 24.40635 26.42449 28.47768 30.56439 32.68322 0.000000 0.6304669 1.473229 2.491525 3.650729 4.923252 6.289330 7.735191 9.251019 10.82951 12.46502 14.15299 15.88963 17.67176 19.49661 21.36178 23.26516 25.20488 27.17923 29.18669 31.22586 0.000000 0.5918453 1.379248 2.331818 3.420053 4.619156 5.910534 7.280819 8.720320 10.22177 11.77952 13.38901 15.04647 16.74870 18.49293 20.27677 22.09810 23.95506 25.84594 27.76922 29.72351 0.000000 0.5536444 1.286525 2.173888 3.191038 4.316021 5.531540 6.824717 8.186019 9.608226 11.08570 12.61390 14.18905 15.80795 17.46786 19.16638 20.90141 22.67109 24.47374 26.30784 28.17201 0.000000 0.5158644 1.195078 2.017792 2.963745 4.013845 5.152228 6.366613 7.647689 8.988312 10.38288 11.82686 13.31650 14.84863 16.42052 18.02979 19.67436 21.35240 23.06224 24.80239 26.57150 0.000000 0.4785047 1.104930 1.863621 2.738324 3.712794 4.772735 5.906594 7.105362 8.362020 9.671026 11.02788 12.42888 13.87088 15.35117 16.86742 18.41759 19.99986 21.61260 23.25436 24.92381 0.000000 0.4415655 1.016114 1.711493 2.515010 3.413182 4.393411 5.445022 6.559413 7.729751 8.950591 10.21750 11.52682 12.87545 14.26075 15.68041 17.13244 18.61508 20.12674 21.66598 23.23154 0.000000 0.4050473 0.9286646 1.561553 2.294099 3.115449 4.014801 4.982510 6.010508 7.092231 8.222378 9.396608 10.61134 11.86353 13.15060 14.47031 15.82072 17.20012 18.60695 20.03986 21.49759 0.000000 0.3689506 0.8426178 1.413964 2.075954 2.820164 3.637639 4.519915 5.459602 6.450504 7.487527 8.566463 9.683822 10.83666 12.02245 13.23904 14.48454 15.75731 17.05585 18.37886 19.72515 0.000000 0.3332766 0.7580132 1.268904 1.860990 2.528015 3.262857 4.058361 4.907963 5.805957 6.747539 7.728682 8.746027 9.796728 10.87836 11.98883 13.12635 14.28932 15.47633 16.68613 17.91758 0.000000 0.2980251 0.6748912 1.126565 1.649676 2.239815 2.891601 3.599268 4.357224 5.160392 6.004355 6.885342 7.800162 8.746099 9.720837 10.72237 11.74900 12.79920 13.87164 14.96513 16.07860 0.000000 0.2631980 0.5932952 0.9871451 1.442518 1.956487 2.525240 3.144406 3.809475 4.516140 5.260501 6.039124 6.849055 7.687743 8.553000 9.442938 10.35594 11.29057 12.24559 13.21986 14.21239 0.000000 0.2287970 0.5132661 0.8508472 1.240057 1.679069 2.165383 2.695938 3.267359 3.876228 4.519293 5.193574 5.896435 6.625547 7.378896 8.154719 8.951512 9.767945 10.60285 11.45517 12.32399 0.000000 0.1948231 0.4348433 0.7178735 1.042855 1.408687 1.813874 2.256474 2.734204 3.244594 3.785157 4.353491 4.947387 5.564827 6.204021 6.863384 7.541545 8.237290 8.949542 9.677345 10.41985 0.000000 0.1612776 0.3580641 0.5884225 0.8514767 1.146537 1.472770 1.829085 2.214128 2.626337 3.064038 3.525512 4.009087 4.513168 5.036282 5.577086 6.134398 6.707150 7.294385 7.895247 8.508964 0.000000 0.1281609 0.2829657 0.4626810 0.6664811 0.8938438 1.144291 1.417268 1.712090 2.027936 2.363870 2.718870 3.091876 3.481810 3.887629 4.308329 4.742997 5.190781 5.650889 6.122596 6.605239 0.000000 9.5474370E-02 0.2095833 0.3408232 0.4883931 0.6518076 0.8307170 1.024817 1.233793 1.457288 1.694901 1.946168 2.210588 2.487615 2.776683 3.077213 3.388659 3.710474 4.042110 4.383052 4.732814 0.000000 6.3218281E-02 0.1379453 0.2230069 0.3176928 0.4215465 0.5342500 0.6555718 0.7853261 0.9233481 1.069489 1.223589 1.385491 1.555012 1.731971 1.916163 2.107401 2.305467 2.510130 2.721156 2.938315 0.000000 3.1393144E-02 6.8077959E-02 0.1093637 0.1547882 0.2040268 0.2568398 0.3130483 0.3725118 0.4351186 0.5007838 0.5694294 0.6410009 0.7154399 0.7927037 0.8727457 0.9555439 1.041056 1.129243 1.220065 1.313490 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.7182232 1.634813 2.700782 3.875678 5.131683 6.451157 7.822941 9.239698 10.69632 12.18904 13.71498 15.27181 16.85762 18.47080 20.10996 21.77390 23.46152 25.17186 26.90406 28.65730 0.000000 0.6778419 1.537825 2.538082 3.643209 4.827845 6.075314 7.374802 8.719093 10.10313 11.52318 12.97637 14.46038 15.97333 17.51360 19.07981 20.67075 22.28535 23.92265 25.58177 27.26191 0.000000 0.6379374 1.442358 2.377909 3.414045 4.527941 5.703987 6.931761 8.204183 9.516235 10.86421 12.24522 13.65697 15.09756 16.56536 18.05900 19.57727 21.11908 22.68347 24.26956 25.87654 0.000000 0.5985070 1.348414 2.220253 3.188076 4.231637 5.336483 6.492640 7.693178 8.933125 10.20878 11.51725 12.85623 14.22380 15.61834 17.03846 18.48294 19.95070 21.44074 22.95221 24.48429 0.000000 0.5595510 1.256001 2.065130 2.965279 3.938781 4.972434 6.056776 7.185064 8.352382 9.555028 10.79012 12.05532 13.34871 14.66866 16.01378 17.38282 18.77471 20.18846 21.62320 23.07810 0.000000 0.5210670 1.165132 1.912585 2.745706 3.649371 4.611711 5.623865 6.679328 7.773260 8.901978 10.06259 11.25277 12.47057 13.71438 14.98277 16.27452 17.58855 18.92386 20.27958 21.65490 0.000000 0.4830552 1.075821 1.762683 2.529469 3.363520 4.254380 5.193882 6.175824 7.195482 8.249211 9.334133 10.44791 11.58862 12.75461 13.94448 15.15702 16.39113 17.64583 18.92025 20.21358 0.000000 0.4455144 0.9880868 1.615505 2.316732 3.081453 3.900677 4.767033 5.674701 6.619130 7.596744 8.604691 9.640649 10.70269 11.78918 12.89873 14.03013 15.18228 16.35423 17.54510 18.75412 0.000000 0.4084437 0.9019483 1.471147 2.107708 2.803491 3.550995 4.343737 5.176376 6.044600 6.944943 7.874611 8.831306 9.813119 10.81844 11.84588 12.89423 13.96244 15.04956 16.15472 17.27717 0.000000 0.3718428 0.8174268 1.329717 1.902648 2.530045 3.205876 3.924624 4.681527 5.472591 6.294522 7.144613 8.020617 8.920660 9.843150 10.78673 11.75021 12.73255 13.73283 14.75020 15.78392 0.000000 0.3357110 0.7345440 1.191328 1.701839 2.261613 2.866014 3.510545 4.191113 4.904133 5.646555 6.415806 7.209726 8.026488 8.864542 9.722561 10.59939 11.49401 12.40551 13.33309 14.27602 0.000000 0.3000476 0.6533217 1.056102 1.505597 1.998769 2.532258 3.102587 3.706409 4.340638 5.002547 5.689767 6.400261 7.132287 7.884349 8.655168 9.443621 10.24872 11.06960 11.90549 12.75566 0.000000 0.2648518 0.5737811 0.9241611 1.314258 1.742160 2.205606 2.702092 3.229045 3.783968 4.364536 4.968658 5.594482 6.240392 6.904977 7.587019 8.285449 8.999325 9.727807 10.47016 11.22570 0.000000 0.2301226 0.4959421 0.7956277 1.128173 1.492489 1.887202 2.310665 2.761067 3.236536 3.735231 4.255419 4.795503 5.354048 5.929774 6.521555 7.128394 7.749403 8.383794 9.030865 9.689977 0.000000 0.1958594 0.4198234 0.6706180 0.9476923 1.250502 1.578316 1.930180 2.304962 2.701405 3.118195 3.554021 4.007619 4.477803 4.963480 5.463665 5.977466 6.504076 7.042770 7.592900 8.153868 0.000000 0.1620612 0.3454410 0.5492453 0.7731645 1.016961 1.280310 1.562749 1.863680 2.182378 2.518036 2.869796 3.236774 3.618103 4.012945 4.420515 4.840077 5.270949 5.712498 6.164149 6.625372 0.000000 0.1287264 0.2728109 0.4316105 0.6049162 0.7926186 0.9945956 1.210664 1.440576 1.684001 1.940538 2.209734 2.491089 2.784078 3.088169 3.402835 3.727559 4.061832 4.405167 4.757112 5.117231 0.000000 9.5854513E-02 0.2019441 0.3178028 0.4432459 0.5781834 0.7225499 0.8762739 1.039274 1.211435 1.392610 1.582625 1.781279 1.988343 2.203566 2.426699 2.657464 2.895577 3.140749 3.392701 3.651149 0.000000 6.3443743E-02 0.1328503 0.2078967 0.2884111 0.3742844 0.4654434 0.5618274 0.6633922 0.7700890 0.8818700 0.9986851 1.120478 1.247189 1.378748 1.515088 1.656123 1.801762 1.951905 2.106452 2.265292 0.000000 3.1492956E-02 6.5534964E-02 0.1019495 0.1406145 0.1814347 0.2243382 0.2692628 0.3161621 0.3649951 0.4157248 0.4683225 0.5227615 0.5790210 0.6370817 0.6969268 0.7585400 0.8219048 0.8870017 0.9538211 1.022341 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.6062260 1.351326 2.204538 3.138361 4.132048 5.171372 6.246926 7.352449 8.483676 9.637584 10.81195 12.00509 13.21565 14.44257 15.68494 16.94201 18.21312 19.49769 20.79522 22.10525 0.000000 0.5725429 1.271724 2.071186 2.947094 3.880906 4.859486 5.873903 6.918094 7.987880 9.080275 10.19308 11.32461 12.47354 13.63880 14.81950 16.01488 17.22429 18.44715 19.68297 20.93128 0.000000 0.5392191 1.193350 1.940034 2.758889 3.633572 4.552097 5.506068 6.489654 7.498771 8.530471 9.582572 10.65339 11.74161 12.84616 13.96615 15.10081 16.24949 17.41161 18.58668 19.77424 0.000000 0.5062543 1.116207 1.811097 2.573745 3.389961 4.248959 5.142932 6.066316 7.015132 7.986478 8.978180 9.988562 11.01630 12.06031 13.11970 14.19371 15.28166 16.38299 17.49719 18.62378 0.000000 0.4736470 1.040302 1.684400 2.391695 3.150072 3.949977 4.784249 5.647623 6.536256 7.447295 8.378583 9.328439 10.29554 11.27879 12.27729 13.29026 14.31704 15.35705 16.40976 17.47471 0.000000 0.4413980 0.9656405 1.559978 2.212805 2.913973 3.655178 4.429952 5.233384 6.061792 6.912392 7.783048 8.672085 9.578169 10.50021 11.43729 12.38862 13.35354 14.33146 15.32186 16.32425 0.000000 0.4095056 0.8922306 1.437873 2.037163 2.681792 3.364692 4.080139 4.823625 5.591671 6.381587 7.191273 8.019066 8.863632 9.723872 10.59887 11.48783 12.39009 13.30505 14.23218 15.17101 0.000000 0.3779688 0.8200806 1.318131 1.864884 2.453710 3.078746 3.735047 4.418562 5.126064 5.854986 6.603290 7.369338 8.151803 8.949587 9.761772 10.58756 11.42628 12.27734 13.14021 14.01440 0.000000 0.3467873 0.7491997 1.200805 1.696101 2.229955 2.797653 3.395047 4.018592 4.665362 5.332959 6.019435 6.723194 7.442931 8.177556 8.926156 9.687936 10.46222 11.24842 12.04600 12.85449 0.000000 0.3159603 0.6795951 1.085950 1.530961 2.010797 2.521809 3.060638 3.624288 4.210182 4.816140 5.440340 6.081256 6.737622 7.408370 8.092595 8.789512 9.498450 10.21882 10.95009 11.69180 0.000000 0.2854874 0.6112755 0.9736185 1.369621 1.796543 2.251685 2.732450 3.236405 3.761378 4.305449 4.866963 5.444503 6.036865 6.643018 7.262082 7.893285 8.535968 9.189547 9.853508 10.52738 0.000000 0.2553670 0.5442484 0.8638707 1.212249 1.587528 1.987823 2.411234 2.855898 3.320062 3.802120 4.300634 4.814330 5.342097 5.882968 6.436105 7.000762 7.576299 8.162146 8.757800 9.362803 0.000000 0.2255982 0.4785210 0.7567584 1.059012 1.384109 1.730824 2.097870 2.483910 2.887630 3.307764 3.743129 4.192638 4.655319 5.130294 5.616790 6.114110 6.621642 7.138843 7.665226 8.200349 0.000000 0.1961811 0.4140998 0.6523361 0.9100820 1.186657 1.481342 1.793344 2.121791 2.465782 2.824399 3.196748 3.581966 3.979253 4.387864 4.807122 5.236398 5.675137 6.122829 6.579024 7.043298 0.000000 0.1671140 0.3509900 0.5506509 0.7656202 0.9955451 1.240056 1.498731 1.771068 2.056524 2.354508 2.664416 2.985630 3.317558 3.659619 4.011268 4.371979 4.741279 5.118721 5.503901 5.896434 0.000000 0.1383954 0.2891948 0.4517462 0.6257786 0.8111339 1.007656 1.215166 1.433423 1.662155 1.901042 2.149740 2.407871 2.675056 2.950904 3.235029 3.527044 3.826585 4.133299 4.446856 4.766937 0.000000 0.1100249 0.2287182 0.3556608 0.4906982 0.6337658 0.7848156 0.9437942 1.110617 1.285182 1.467361 1.656999 1.853917 2.057926 2.268810 2.486355 2.710322 2.940484 3.176608 3.418470 3.665836 0.000000 8.2001947E-02 0.1695606 0.2624242 0.3604965 0.4637436 0.5721515 0.6857127 0.8044040 0.9282057 1.057082 1.190995 1.329882 1.473684 1.622318 1.775703 1.933733 2.096309 2.263322 2.434657 2.610192 0.000000 5.4324027E-02 0.1117235 0.1720614 0.2352712 0.3013244 0.3702028 0.4419014 0.5164030 0.5937056 0.6737996 0.7566814 0.8423345 0.9307533 1.021918 1.115814 1.212413 1.311694 1.413629 1.518189 1.625332 0.000000 2.6990280E-02 5.5203632E-02 8.4585071E-02 0.1150922 0.1467009 0.1793913 0.2131515 0.2479573 0.2838023 0.3206743 0.3585689 0.3974722 0.4373817 0.4782881 0.5201907 0.5630748 0.6069417 0.6517848 0.6976017 0.7443787 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4305036 0.9363870 1.505972 2.127414 2.790151 3.485580 4.207102 4.949820 5.710126 6.485377 7.273600 8.073296 8.883325 9.702779 10.53094 11.36722 12.21112 13.06225 13.92024 14.78481 0.000000 0.4071472 0.8826928 1.416574 1.998643 2.619721 3.272158 3.949941 4.648511 5.364441 6.095187 6.838823 7.593881 8.359237 9.133988 9.917428 10.70897 11.50812 12.31449 13.12771 13.94750 0.000000 0.3839866 0.8297174 1.328589 1.872004 2.452090 3.062134 3.696732 4.351686 5.023777 5.710570 6.410201 7.121235 7.842561 8.573289 9.312714 10.06025 10.81541 11.57780 12.34706 13.12290 0.000000 0.3610210 0.7774614 1.242026 1.747519 2.287282 2.855514 3.447428 4.059208 4.687865 5.331092 5.987093 6.654470 7.332135 8.019198 8.714967 9.418851 10.13036 10.84911 11.57472 12.30692 0.000000 0.3382507 0.7259267 1.156899 1.625219 2.125346 2.652349 3.202054 3.771053 4.356599 4.956535 5.569147 6.193081 6.827269 7.470838 8.123091 8.783442 9.451405 10.12658 10.80859 11.49716 0.000000 0.3156734 0.6751151 1.073218 1.505140 1.966344 2.452723 2.960703 3.487289 4.030006 4.586861 5.156238 5.736839 6.327625 6.927736 7.536482 8.153280 8.777639 9.409157 10.04746 10.69227 0.000000 0.2932905 0.6250255 0.9909980 1.387321 1.810358 2.256752 2.723515 3.208070 3.708228 4.222182 4.748432 5.285748 5.833131 6.389743 6.954904 7.528036 8.108644 8.696330 9.290718 9.891514 0.000000 0.2711008 0.5756614 0.9102521 1.271809 1.657476 2.064580 2.490684 2.933625 3.391515 3.862749 4.345964 4.840014 5.343956 5.856979 6.378421 6.907713 7.444367 7.987977 8.538176 9.094661 0.000000 0.2491040 0.5270230 0.8309937 1.158648 1.507799 1.876376 2.262448 2.664257 3.080217 3.508946 3.949235 4.400042 4.860489 5.329813 5.807375 6.292623 6.785076 7.284335 7.790033 8.301869 0.000000 0.2273003 0.4791105 0.7532392 1.047889 1.361435 1.692325 2.039083 2.400331 2.774783 3.161290 3.558811 3.966429 4.383349 4.808869 5.242388 5.683376 6.131372 6.585983 7.046850 7.513675 0.000000 0.2056867 0.4319250 0.6769993 0.9395785 1.218495 1.512629 1.820900 2.142276 2.475757 2.820428 3.175428 3.539984 3.913401 4.295051 4.684386 5.080915 5.484201 5.893870 6.309573 6.731018 0.000000 0.1842665 0.3854680 0.6022882 0.8337663 1.079093 1.337503 1.608240 1.890573 2.183769 2.487136 2.800002 3.121739 3.451776 3.789572 4.134649 4.486569 4.844928 5.209384 5.579606 5.955317 0.000000 0.1630360 0.3397377 0.5291154 0.7304949 0.9433442 1.167161 1.401458 1.645749 1.899533 2.162323 2.433626 2.712969 2.999907 3.294005 3.594869 3.902126 4.215425 4.534462 4.858937 5.188596 0.000000 0.1419960 0.2947353 0.4574933 0.6298108 0.8113557 1.001825 1.200925 1.408366 1.623830 1.847009 2.077572 2.315193 2.559553 2.810331 3.067225 3.329941 3.598195 3.871736 4.150305 4.433686 0.000000 0.1211461 0.2504594 0.3874285 0.5317510 0.6832323 0.8417042 1.007010 1.178996 1.357488 1.542312 1.733273 1.930172 2.132807 2.340965 2.554441 2.773029 2.996517 3.224720 3.457435 3.694489 0.000000 0.1004854 0.2069100 0.3189286 0.4363497 0.5590679 0.6869981 0.8200694 0.9582162 1.101355 1.249411 1.402285 1.559875 1.722078 1.888770 2.059838 2.235154 2.414585 2.598016 2.785303 2.976334 0.000000 8.0013253E-02 0.1640859 0.2519996 0.3436361 0.4389456 0.5378878 0.6404350 0.7465712 0.8562648 0.9694932 1.086222 1.206409 1.330017 1.456990 1.587283 1.720832 1.857571 1.997444 2.140370 2.286294 0.000000 5.9729788E-02 0.1219845 0.1866416 0.2536328 0.3229341 0.3945271 0.4684014 0.5445590 0.6229898 0.7036956 0.7866672 0.8718953 0.9593751 1.049088 1.141024 1.235167 1.331490 1.429980 1.530601 1.633341 0.000000 3.9634269E-02 8.0605768E-02 0.1228587 0.1663550 0.2110868 0.2570408 0.3042107 0.3526008 0.4022036 0.4530256 0.5050631 0.5583134 0.6127825 0.6684623 0.7253582 0.7834658 0.8427781 0.9033006 0.9650192 1.027940 0.000000 1.9724885E-02 3.9944153E-02 6.0646165E-02 8.1809625E-02 0.1034368 0.1255160 0.1480411 0.1710144 0.1944281 0.2182852 0.2425793 0.2673073 0.2924745 0.3180708 0.3441015 0.3705640 0.3974527 0.4247745 0.4525179 0.4806922 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.2216921 0.4658858 0.7309934 1.015268 1.316880 1.633999 1.964871 2.307864 2.661510 3.024509 3.395733 3.774208 4.159111 4.549736 4.945494 5.345879 5.750464 6.158889 6.570844 6.986064 0.000000 0.2100767 0.4405090 0.6898988 0.9567382 1.239465 1.536512 1.846369 2.167617 2.498963 2.839247 3.187449 3.542682 3.904181 4.271284 4.643434 5.020149 5.401020 5.785696 6.173875 6.565300 0.000000 0.1985180 0.4153536 0.6492828 0.8990142 1.163222 1.440583 1.729810 2.029685 2.339085 2.656989 2.982489 3.314784 3.653169 3.997039 4.345868 4.699202 5.056649 5.417873 5.782582 6.150527 0.000000 0.1870155 0.3904204 0.6091462 0.8420961 1.088160 1.346227 1.615217 1.894100 2.181914 2.477774 2.780884 3.090527 3.406070 3.726959 4.052708 4.382893 4.717143 5.055139 5.396598 5.741281 0.000000 0.1755688 0.3657079 0.5694890 0.7859898 1.014285 1.253460 1.502620 1.760904 2.027503 2.301664 2.582696 2.869973 3.162935 3.461079 3.763964 4.071198 4.382437 4.697377 5.015752 5.337330 0.000000 0.1641790 0.3412156 0.5303112 0.7306957 0.9416077 1.162302 1.392050 1.630145 1.875918 2.128739 2.388022 2.653229 2.923869 3.199503 3.479730 3.764198 4.052587 4.344617 4.640037 4.938627 0.000000 0.1528449 0.3169436 0.4916141 0.6762178 0.8701372 1.072774 1.283543 1.501877 1.727234 1.959097 2.196980 2.440429 2.689029 2.942394 3.200177 3.462059 3.727756 3.997009 4.269588 4.545285 0.000000 0.1415672 0.2928921 0.4533967 0.6225564 0.7998801 0.9848922 1.177134 1.376159 1.581536 1.792851 2.009713 2.231750 2.458611 2.689975 2.925543 3.165039 3.408209 3.654823 3.904672 4.157567 0.000000 0.1303447 0.2690590 0.4156575 0.5697168 0.7308472 0.8986804 1.072863 1.253050 1.438913 1.630127 1.826384 2.027386 2.232854 2.442520 2.656138 2.873472 3.094306 3.318439 3.545686 3.775878 0.000000 0.1191785 0.2454453 0.3783990 0.5176998 0.6630458 0.8141563 0.9707653 1.132617 1.299462 1.471056 1.647167 1.827564 2.012029 2.200350 2.392328 2.587773 2.786504 2.988351 3.193157 3.400776 0.000000 0.1080682 0.2220505 0.3416187 0.4665069 0.5964827 0.7313384 0.8708797 1.014919 1.163278 1.315779 1.472251 1.632525 1.796437 1.963826 2.134540 2.308428 2.485347 2.665161 2.847739 3.032960 0.000000 9.7013548E-02 0.1988735 0.3053176 0.4161388 0.5311655 0.6502453 0.7732406 0.9000204 1.030460 1.164437 1.301833 1.442527 1.586404 1.733348 1.883247 2.035991 2.191468 2.349580 2.510218 2.673292 0.000000 8.6013667E-02 0.1759134 0.2694942 0.3665988 0.4671009 0.5708930 0.6778831 0.7879802 0.9011049 1.017174 1.136111 1.257836 1.382273 1.509341 1.638966 1.771073 1.905580 2.042418 2.181507 2.322781 0.000000 7.5069159E-02 0.1531710 0.2341481 0.3178854 0.4042927 0.4932969 0.5848370 0.6788555 0.7753016 0.8741263 0.9752811 1.078718 1.184390 1.292248 1.402244 1.514331 1.628456 1.744575 1.862633 1.982586 0.000000 6.4180434E-02 0.1306446 0.1992789 0.2699994 0.3427454 0.4174680 0.4941297 0.5726956 0.6531377 0.7354245 0.8195326 0.9054340 0.9931029 1.082512 1.173636 1.266448 1.360917 1.457016 1.554716 1.653987 0.000000 5.3346120E-02 0.1083348 0.1648849 0.2229408 0.2824612 0.3434175 0.4057864 0.4695480 0.5346875 0.6011885 0.6690406 0.7382293 0.8087437 0.8805696 0.9536967 1.028110 1.103797 1.180745 1.258935 1.338358 0.000000 4.2566914E-02 8.6240061E-02 0.1309648 0.1767077 0.2234432 0.2711529 0.3198252 0.3694490 0.4200181 0.4715239 0.5239627 0.5773287 0.6316181 0.6868256 0.7429475 0.7999788 0.8579148 0.9167500 0.9764787 1.037097 0.000000 3.1843361E-02 6.4359859E-02 9.7518764E-02 0.1312996 0.1656896 0.2006788 0.2362599 0.2724290 0.3091827 0.3465178 0.3844324 0.4229251 0.4619949 0.5016398 0.5418605 0.5826557 0.6240242 0.6659645 0.7084751 0.7515563 0.000000 2.1174211E-02 4.2692803E-02 6.4543270E-02 8.6714134E-02 0.1091997 0.1319957 0.1550999 0.1785084 0.2022221 0.2262366 0.2505533 0.2751718 0.3000912 0.3253108 0.3508308 0.3766522 0.4027741 0.4291972 0.4559189 0.4829422 0.000000 1.0559755E-02 2.1240151E-02 3.2037221E-02 4.2948294E-02 5.3970907E-02 6.5104246E-02 7.6347403E-02 8.7698512E-02 9.9158235E-02 0.1107240 0.1223978 0.1341778 0.1460631 0.1580546 0.1701516 0.1823551 0.1946626 0.2070761 0.2195928 0.2322151 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4154622 -0.9300300 -1.458305 -1.937487 -2.341276 -2.672592 -2.948279 -3.183556 -3.388701 -3.570552 -3.733824 -3.881930 -4.017402 -4.142197 -4.257838 -4.365561 -4.466358 -4.561056 -4.650330 -4.734747 0.000000 -0.3969083 -0.8916984 -1.402301 -1.867873 -2.262486 -2.587765 -2.858535 -3.089248 -3.290016 -3.467634 -3.626800 -3.770917 -3.902508 -4.023522 -4.135474 -4.239596 -4.336874 -4.428130 -4.514035 -4.595152 0.000000 -0.3781472 -0.8527339 -1.345307 -1.797262 -2.182806 -2.502327 -2.768711 -2.995520 -3.192634 -3.366791 -3.522665 -3.663643 -3.792236 -3.910380 -4.019583 -4.121066 -4.215808 -4.304626 -4.388183 -4.467037 0.000000 -0.3591748 -0.8131029 -1.287203 -1.725364 -2.101845 -2.415750 -2.678129 -2.901530 -3.095536 -3.266800 -3.419966 -3.558398 -3.684593 -3.800473 -3.907534 -4.006987 -4.099803 -4.186788 -4.268600 -4.345792 0.000000 -0.3399872 -0.7727702 -1.227869 -1.651893 -2.019197 -2.327513 -2.586135 -2.806504 -2.997818 -3.166621 -3.317511 -3.453830 -3.578056 -3.692096 -3.797433 -3.895268 -3.986562 -4.072113 -4.152570 -4.228479 0.000000 -0.3205810 -0.7316995 -1.167183 -1.576566 -1.934430 -2.237075 -2.492070 -2.709680 -2.898626 -3.065299 -3.214245 -3.348776 -3.471351 -3.583862 -3.687778 -3.784286 -3.874343 -3.958734 -4.038103 -4.112988 0.000000 -0.3009507 -0.6898542 -1.105022 -1.499100 -1.847090 -2.143858 -2.395243 -2.610276 -2.797098 -2.961903 -3.109163 -3.242158 -3.363324 -3.474540 -3.577259 -3.672658 -3.761685 -3.845116 -3.923589 -3.997635 0.000000 -0.2810930 -0.6471970 -1.041259 -1.419207 -1.756690 -2.047227 -2.294902 -2.507445 -2.692322 -2.855460 -3.001239 -3.132896 -3.252845 -3.362946 -3.464642 -3.559097 -3.647252 -3.729872 -3.807590 -3.880934 0.000000 -0.2610030 -0.6036900 -0.9757619 -1.336586 -1.662711 -1.946475 -2.190200 -2.400240 -2.583279 -2.744905 -2.889364 -3.019842 -3.138723 -3.247855 -3.348662 -3.442303 -3.529706 -3.611632 -3.688707 -3.761451 0.000000 -0.2406755 -0.5592930 -0.9083962 -1.250923 -1.564595 -1.840808 -2.080164 -2.287562 -2.468794 -2.629008 -2.772271 -2.901696 -3.019634 -3.127910 -3.227939 -3.320868 -3.407616 -3.488939 -3.565455 -3.637682 0.000000 -0.2201053 -0.5139656 -0.8390174 -1.161890 -1.461740 -1.729329 -1.963656 -2.168104 -2.347449 -2.506292 -2.648445 -2.776914 -2.894006 -3.001521 -3.100859 -3.193160 -3.279331 -3.360125 -3.436151 -3.507926 0.000000 -0.1992881 -0.4676669 -0.7674791 -1.069133 -1.353491 -1.611024 -1.839333 -2.040279 -2.217500 -2.374917 -2.515992 -2.643573 -2.759893 -2.866723 -2.965445 -3.057184 -3.142843 -3.223166 -3.298760 -3.370135 0.000000 -0.1782187 -0.4203542 -0.6936305 -0.9722818 -1.239128 -1.484736 -1.705602 -1.902133 -2.076740 -2.232519 -2.372462 -2.499172 -2.614770 -2.720972 -2.819133 -2.910367 -2.995567 -3.075470 -3.150677 -3.221697 0.000000 -0.1568927 -0.3719843 -0.6173138 -0.8709431 -1.117873 -1.349160 -1.560572 -1.751244 -1.922335 -2.075987 -2.214570 -2.340333 -2.455204 -2.560805 -2.658448 -2.749221 -2.834003 -2.913527 -2.988387 -3.059085 0.000000 -0.1353050 -0.3225140 -0.5383669 -0.7647066 -0.9888805 -1.202822 -1.402006 -1.584601 -1.750607 -1.901133 -2.037787 -2.162308 -2.276321 -2.381282 -2.478409 -2.568740 -2.653137 -2.732311 -2.806856 -2.877264 0.000000 -0.1134503 -0.2718973 -0.4566248 -0.6531476 -0.8512532 -1.044085 -1.227294 -1.398499 -1.556782 -1.702272 -1.835718 -1.958204 -2.070907 -2.174982 -2.271475 -2.361322 -2.445323 -2.524160 -2.598406 -2.668544 0.000000 -9.1323748E-02 -0.2200873 -0.3719165 -0.5358250 -0.7040434 -0.8711686 -1.033456 -1.188461 -1.334750 -1.471699 -1.599258 -1.717784 -1.827863 -1.930204 -2.025539 -2.114590 -2.198022 -2.276430 -2.350337 -2.420193 0.000000 -6.8920575E-02 -0.1670407 -0.2840737 -0.4122941 -0.5462768 -0.6821858 -0.8172017 -0.9492769 -1.076947 -1.199255 -1.315627 -1.425824 -1.529835 -1.627840 -1.720114 -1.807026 -1.888966 -1.966329 -2.039492 -2.108811 0.000000 -4.6235707E-02 -0.1127114 -0.1929211 -0.2821042 -0.3769732 -0.4752126 -0.5750731 -0.6752132 -0.7745678 -0.8723170 -0.9678212 -1.060620 -1.150376 -1.236885 -1.320024 -1.399770 -1.476152 -1.549247 -1.619162 -1.686023 0.000000 -2.3263810E-02 -5.7049960E-02 -9.8284081E-02 -0.1448181 -0.1951771 -0.2483822 -0.3036774 -0.3604899 -0.4183428 -0.4768521 -0.5356843 -0.5945717 -0.6532710 -0.7115913 -0.7693582 -0.8264406 -0.8827178 -0.9380971 -0.9924952 -1.045840 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4154622 -0.9300300 -1.458305 -1.937487 -2.341276 -2.672592 -2.948279 -3.183556 -3.388701 -3.570552 -3.733824 -3.881930 -4.017402 -4.142197 -4.257838 -4.365561 -4.466358 -4.561056 -4.650330 -4.734747 0.000000 -0.3969083 -0.8916984 -1.402301 -1.867873 -2.262486 -2.587765 -2.858535 -3.089248 -3.290016 -3.467634 -3.626800 -3.770917 -3.902508 -4.023522 -4.135475 -4.239596 -4.336874 -4.428130 -4.514035 -4.595152 0.000000 -0.3781472 -0.8527339 -1.345307 -1.797262 -2.182806 -2.502327 -2.768711 -2.995520 -3.192634 -3.366791 -3.522665 -3.663643 -3.792236 -3.910380 -4.019583 -4.121066 -4.215808 -4.304626 -4.388183 -4.467037 0.000000 -0.3591748 -0.8131030 -1.287203 -1.725364 -2.101845 -2.415750 -2.678129 -2.901530 -3.095536 -3.266800 -3.419966 -3.558398 -3.684593 -3.800473 -3.907534 -4.006987 -4.099803 -4.186788 -4.268600 -4.345792 0.000000 -0.3399872 -0.7727702 -1.227869 -1.651893 -2.019197 -2.327513 -2.586135 -2.806504 -2.997818 -3.166621 -3.317511 -3.453830 -3.578056 -3.692096 -3.797433 -3.895268 -3.986562 -4.072113 -4.152570 -4.228479 0.000000 -0.3205810 -0.7316995 -1.167183 -1.576566 -1.934430 -2.237075 -2.492070 -2.709680 -2.898626 -3.065299 -3.214245 -3.348776 -3.471351 -3.583862 -3.687778 -3.784286 -3.874343 -3.958734 -4.038103 -4.112988 0.000000 -0.3009507 -0.6898542 -1.105022 -1.499100 -1.847090 -2.143858 -2.395243 -2.610276 -2.797098 -2.961903 -3.109163 -3.242158 -3.363324 -3.474540 -3.577259 -3.672658 -3.761685 -3.845116 -3.923589 -3.997635 0.000000 -0.2810930 -0.6471970 -1.041259 -1.419207 -1.756690 -2.047227 -2.294902 -2.507445 -2.692322 -2.855461 -3.001239 -3.132896 -3.252845 -3.362946 -3.464642 -3.559097 -3.647252 -3.729872 -3.807590 -3.880934 0.000000 -0.2610030 -0.6036900 -0.9757619 -1.336586 -1.662711 -1.946475 -2.190201 -2.400240 -2.583279 -2.744905 -2.889364 -3.019842 -3.138723 -3.247855 -3.348662 -3.442303 -3.529706 -3.611632 -3.688707 -3.761451 0.000000 -0.2406755 -0.5592930 -0.9083962 -1.250923 -1.564595 -1.840808 -2.080164 -2.287562 -2.468794 -2.629008 -2.772271 -2.901696 -3.019634 -3.127910 -3.227939 -3.320868 -3.407616 -3.488939 -3.565455 -3.637682 0.000000 -0.2201053 -0.5139656 -0.8390174 -1.161890 -1.461740 -1.729329 -1.963656 -2.168104 -2.347449 -2.506292 -2.648445 -2.776914 -2.894006 -3.001521 -3.100859 -3.193160 -3.279331 -3.360125 -3.436151 -3.507926 0.000000 -0.1992881 -0.4676669 -0.7674791 -1.069133 -1.353491 -1.611024 -1.839333 -2.040279 -2.217500 -2.374917 -2.515992 -2.643573 -2.759893 -2.866723 -2.965445 -3.057184 -3.142843 -3.223166 -3.298760 -3.370135 0.000000 -0.1782187 -0.4203542 -0.6936305 -0.9722818 -1.239128 -1.484736 -1.705602 -1.902133 -2.076740 -2.232519 -2.372462 -2.499172 -2.614770 -2.720972 -2.819133 -2.910367 -2.995567 -3.075470 -3.150678 -3.221697 0.000000 -0.1568927 -0.3719843 -0.6173138 -0.8709431 -1.117873 -1.349160 -1.560572 -1.751244 -1.922335 -2.075987 -2.214570 -2.340333 -2.455204 -2.560805 -2.658448 -2.749221 -2.834003 -2.913527 -2.988387 -3.059085 0.000000 -0.1353050 -0.3225140 -0.5383669 -0.7647066 -0.9888805 -1.202822 -1.402006 -1.584601 -1.750607 -1.901133 -2.037787 -2.162308 -2.276322 -2.381282 -2.478409 -2.568740 -2.653137 -2.732311 -2.806856 -2.877264 0.000000 -0.1134503 -0.2718973 -0.4566248 -0.6531476 -0.8512532 -1.044085 -1.227294 -1.398499 -1.556782 -1.702272 -1.835718 -1.958204 -2.070907 -2.174982 -2.271475 -2.361322 -2.445323 -2.524160 -2.598406 -2.668544 0.000000 -9.1323748E-02 -0.2200873 -0.3719165 -0.5358250 -0.7040434 -0.8711686 -1.033456 -1.188461 -1.334750 -1.471699 -1.599258 -1.717784 -1.827863 -1.930204 -2.025539 -2.114590 -2.198022 -2.276430 -2.350337 -2.420193 0.000000 -6.8920575E-02 -0.1670407 -0.2840737 -0.4122941 -0.5462768 -0.6821858 -0.8172018 -0.9492769 -1.076947 -1.199255 -1.315627 -1.425824 -1.529835 -1.627840 -1.720114 -1.807026 -1.888966 -1.966329 -2.039492 -2.108811 0.000000 -4.6235707E-02 -0.1127114 -0.1929211 -0.2821042 -0.3769732 -0.4752126 -0.5750731 -0.6752132 -0.7745678 -0.8723170 -0.9678212 -1.060620 -1.150376 -1.236885 -1.320024 -1.399770 -1.476152 -1.549247 -1.619162 -1.686023 0.000000 -2.3263810E-02 -5.7049960E-02 -9.8284081E-02 -0.1448181 -0.1951771 -0.2483822 -0.3036774 -0.3604899 -0.4183428 -0.4768521 -0.5356843 -0.5945717 -0.6532710 -0.7115913 -0.7693582 -0.8264406 -0.8827178 -0.9380971 -0.9924952 -1.045840 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4154622 -0.9300300 -1.458305 -1.937487 -2.341277 -2.672592 -2.948280 -3.183556 -3.388702 -3.570552 -3.733824 -3.881931 -4.017402 -4.142197 -4.257838 -4.365561 -4.466358 -4.561056 -4.650330 -4.734748 0.000000 -0.3969083 -0.8916985 -1.402301 -1.867874 -2.262486 -2.587765 -2.858535 -3.089248 -3.290016 -3.467634 -3.626801 -3.770918 -3.902508 -4.023522 -4.135475 -4.239596 -4.336874 -4.428130 -4.514035 -4.595152 0.000000 -0.3781473 -0.8527339 -1.345307 -1.797262 -2.182806 -2.502327 -2.768712 -2.995520 -3.192634 -3.366791 -3.522666 -3.663643 -3.792236 -3.910380 -4.019583 -4.121066 -4.215809 -4.304626 -4.388183 -4.467037 0.000000 -0.3591748 -0.8131030 -1.287204 -1.725364 -2.101845 -2.415750 -2.678129 -2.901531 -3.095536 -3.266800 -3.419966 -3.558398 -3.684593 -3.800473 -3.907534 -4.006987 -4.099803 -4.186788 -4.268600 -4.345792 0.000000 -0.3399872 -0.7727703 -1.227869 -1.651893 -2.019197 -2.327514 -2.586135 -2.806504 -2.997818 -3.166621 -3.317512 -3.453830 -3.578056 -3.692096 -3.797433 -3.895269 -3.986562 -4.072113 -4.152570 -4.228479 0.000000 -0.3205810 -0.7316996 -1.167183 -1.576566 -1.934430 -2.237075 -2.492070 -2.709680 -2.898626 -3.065299 -3.214245 -3.348777 -3.471351 -3.583862 -3.687778 -3.784286 -3.874343 -3.958734 -4.038103 -4.112988 0.000000 -0.3009507 -0.6898542 -1.105022 -1.499100 -1.847090 -2.143858 -2.395244 -2.610276 -2.797098 -2.961903 -3.109163 -3.242158 -3.363324 -3.474540 -3.577259 -3.672658 -3.761685 -3.845116 -3.923589 -3.997635 0.000000 -0.2810930 -0.6471970 -1.041259 -1.419207 -1.756690 -2.047227 -2.294902 -2.507445 -2.692322 -2.855461 -3.001239 -3.132896 -3.252845 -3.362946 -3.464642 -3.559097 -3.647252 -3.729872 -3.807591 -3.880934 0.000000 -0.2610030 -0.6036900 -0.9757620 -1.336586 -1.662711 -1.946475 -2.190201 -2.400240 -2.583279 -2.744905 -2.889364 -3.019842 -3.138724 -3.247855 -3.348663 -3.442303 -3.529706 -3.611632 -3.688707 -3.761451 0.000000 -0.2406755 -0.5592930 -0.9083962 -1.250924 -1.564595 -1.840808 -2.080165 -2.287562 -2.468794 -2.629008 -2.772271 -2.901696 -3.019634 -3.127910 -3.227939 -3.320868 -3.407616 -3.488939 -3.565455 -3.637682 0.000000 -0.2201053 -0.5139656 -0.8390174 -1.161890 -1.461740 -1.729329 -1.963656 -2.168104 -2.347449 -2.506292 -2.648445 -2.776914 -2.894006 -3.001521 -3.100859 -3.193160 -3.279331 -3.360125 -3.436151 -3.507926 0.000000 -0.1992881 -0.4676669 -0.7674791 -1.069133 -1.353491 -1.611024 -1.839333 -2.040279 -2.217500 -2.374917 -2.515992 -2.643573 -2.759894 -2.866723 -2.965445 -3.057184 -3.142843 -3.223166 -3.298760 -3.370135 0.000000 -0.1782187 -0.4203542 -0.6936305 -0.9722819 -1.239128 -1.484736 -1.705602 -1.902133 -2.076740 -2.232519 -2.372462 -2.499172 -2.614770 -2.720972 -2.819133 -2.910367 -2.995567 -3.075470 -3.150678 -3.221697 0.000000 -0.1568927 -0.3719843 -0.6173138 -0.8709431 -1.117873 -1.349160 -1.560572 -1.751244 -1.922335 -2.075987 -2.214570 -2.340333 -2.455204 -2.560805 -2.658448 -2.749221 -2.834003 -2.913527 -2.988387 -3.059085 0.000000 -0.1353050 -0.3225140 -0.5383669 -0.7647067 -0.9888805 -1.202822 -1.402006 -1.584601 -1.750607 -1.901133 -2.037787 -2.162308 -2.276322 -2.381282 -2.478409 -2.568740 -2.653137 -2.732311 -2.806856 -2.877264 0.000000 -0.1134503 -0.2718973 -0.4566248 -0.6531476 -0.8512532 -1.044085 -1.227294 -1.398499 -1.556782 -1.702272 -1.835718 -1.958204 -2.070907 -2.174982 -2.271475 -2.361322 -2.445323 -2.524160 -2.598406 -2.668544 0.000000 -9.1323748E-02 -0.2200873 -0.3719165 -0.5358250 -0.7040434 -0.8711686 -1.033456 -1.188461 -1.334750 -1.471699 -1.599258 -1.717784 -1.827863 -1.930204 -2.025539 -2.114590 -2.198022 -2.276430 -2.350337 -2.420193 0.000000 -6.8920575E-02 -0.1670407 -0.2840737 -0.4122941 -0.5462768 -0.6821858 -0.8172018 -0.9492769 -1.076947 -1.199255 -1.315627 -1.425824 -1.529835 -1.627840 -1.720114 -1.807026 -1.888966 -1.966329 -2.039492 -2.108811 0.000000 -4.6235707E-02 -0.1127114 -0.1929211 -0.2821042 -0.3769732 -0.4752126 -0.5750731 -0.6752132 -0.7745678 -0.8723170 -0.9678212 -1.060620 -1.150376 -1.236885 -1.320024 -1.399770 -1.476152 -1.549247 -1.619162 -1.686023 0.000000 -2.3263810E-02 -5.7049960E-02 -9.8284081E-02 -0.1448181 -0.1951771 -0.2483822 -0.3036774 -0.3604899 -0.4183428 -0.4768521 -0.5356843 -0.5945717 -0.6532710 -0.7115913 -0.7693582 -0.8264406 -0.8827178 -0.9380971 -0.9924952 -1.045840 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4154622 -0.9300301 -1.458305 -1.937487 -2.341277 -2.672592 -2.948280 -3.183557 -3.388702 -3.570553 -3.733824 -3.881931 -4.017402 -4.142198 -4.257838 -4.365561 -4.466359 -4.561057 -4.650331 -4.734748 0.000000 -0.3969083 -0.8916986 -1.402301 -1.867874 -2.262486 -2.587766 -2.858535 -3.089249 -3.290016 -3.467634 -3.626801 -3.770918 -3.902509 -4.023522 -4.135475 -4.239597 -4.336875 -4.428131 -4.514035 -4.595153 0.000000 -0.3781473 -0.8527340 -1.345307 -1.797263 -2.182806 -2.502327 -2.768712 -2.995520 -3.192634 -3.366791 -3.522666 -3.663643 -3.792236 -3.910381 -4.019583 -4.121066 -4.215809 -4.304626 -4.388183 -4.467037 0.000000 -0.3591748 -0.8131030 -1.287204 -1.725364 -2.101845 -2.415751 -2.678130 -2.901531 -3.095536 -3.266800 -3.419966 -3.558398 -3.684594 -3.800473 -3.907534 -4.006987 -4.099803 -4.186788 -4.268601 -4.345792 0.000000 -0.3399872 -0.7727704 -1.227869 -1.651893 -2.019197 -2.327514 -2.586135 -2.806504 -2.997818 -3.166621 -3.317512 -3.453831 -3.578056 -3.692096 -3.797434 -3.895269 -3.986563 -4.072113 -4.152570 -4.228479 0.000000 -0.3205810 -0.7316996 -1.167183 -1.576566 -1.934430 -2.237076 -2.492070 -2.709681 -2.898626 -3.065299 -3.214245 -3.348777 -3.471351 -3.583862 -3.687778 -3.784286 -3.874343 -3.958734 -4.038103 -4.112988 0.000000 -0.3009507 -0.6898542 -1.105022 -1.499100 -1.847091 -2.143858 -2.395244 -2.610276 -2.797098 -2.961903 -3.109163 -3.242158 -3.363325 -3.474540 -3.577259 -3.672658 -3.761686 -3.845116 -3.923589 -3.997635 0.000000 -0.2810931 -0.6471970 -1.041259 -1.419208 -1.756691 -2.047227 -2.294903 -2.507445 -2.692322 -2.855461 -3.001239 -3.132896 -3.252845 -3.362946 -3.464642 -3.559097 -3.647252 -3.729872 -3.807591 -3.880934 0.000000 -0.2610030 -0.6036900 -0.9757620 -1.336586 -1.662711 -1.946475 -2.190201 -2.400240 -2.583280 -2.744906 -2.889364 -3.019842 -3.138724 -3.247855 -3.348663 -3.442304 -3.529706 -3.611632 -3.688707 -3.761451 0.000000 -0.2406755 -0.5592930 -0.9083962 -1.250924 -1.564595 -1.840808 -2.080165 -2.287562 -2.468794 -2.629008 -2.772271 -2.901696 -3.019634 -3.127910 -3.227939 -3.320868 -3.407616 -3.488939 -3.565455 -3.637682 0.000000 -0.2201053 -0.5139656 -0.8390175 -1.161890 -1.461740 -1.729329 -1.963656 -2.168104 -2.347449 -2.506292 -2.648445 -2.776914 -2.894006 -3.001521 -3.100859 -3.193160 -3.279332 -3.360125 -3.436152 -3.507926 0.000000 -0.1992881 -0.4676669 -0.7674792 -1.069134 -1.353491 -1.611024 -1.839333 -2.040279 -2.217500 -2.374917 -2.515992 -2.643573 -2.759894 -2.866723 -2.965445 -3.057184 -3.142843 -3.223166 -3.298760 -3.370135 0.000000 -0.1782187 -0.4203542 -0.6936305 -0.9722819 -1.239128 -1.484736 -1.705602 -1.902133 -2.076740 -2.232519 -2.372462 -2.499172 -2.614770 -2.720972 -2.819133 -2.910367 -2.995567 -3.075470 -3.150678 -3.221697 0.000000 -0.1568927 -0.3719843 -0.6173139 -0.8709431 -1.117873 -1.349160 -1.560572 -1.751244 -1.922335 -2.075987 -2.214570 -2.340333 -2.455204 -2.560806 -2.658448 -2.749221 -2.834003 -2.913527 -2.988387 -3.059085 0.000000 -0.1353050 -0.3225140 -0.5383669 -0.7647067 -0.9888806 -1.202822 -1.402006 -1.584601 -1.750607 -1.901134 -2.037787 -2.162308 -2.276322 -2.381282 -2.478409 -2.568740 -2.653137 -2.732311 -2.806856 -2.877264 0.000000 -0.1134503 -0.2718973 -0.4566248 -0.6531476 -0.8512532 -1.044085 -1.227294 -1.398499 -1.556782 -1.702272 -1.835718 -1.958204 -2.070907 -2.174982 -2.271475 -2.361322 -2.445323 -2.524160 -2.598406 -2.668544 0.000000 -9.1323748E-02 -0.2200873 -0.3719165 -0.5358250 -0.7040434 -0.8711686 -1.033456 -1.188461 -1.334750 -1.471699 -1.599258 -1.717784 -1.827863 -1.930204 -2.025539 -2.114590 -2.198022 -2.276430 -2.350337 -2.420193 0.000000 -6.8920575E-02 -0.1670408 -0.2840738 -0.4122941 -0.5462768 -0.6821858 -0.8172018 -0.9492769 -1.076947 -1.199255 -1.315627 -1.425824 -1.529836 -1.627840 -1.720114 -1.807026 -1.888966 -1.966329 -2.039492 -2.108811 0.000000 -4.6235707E-02 -0.1127114 -0.1929211 -0.2821042 -0.3769732 -0.4752126 -0.5750731 -0.6752132 -0.7745678 -0.8723170 -0.9678212 -1.060620 -1.150376 -1.236885 -1.320024 -1.399770 -1.476152 -1.549247 -1.619162 -1.686023 0.000000 -2.3263810E-02 -5.7049960E-02 -9.8284081E-02 -0.1448181 -0.1951771 -0.2483822 -0.3036774 -0.3604899 -0.4183428 -0.4768521 -0.5356843 -0.5945717 -0.6532710 -0.7115913 -0.7693582 -0.8264406 -0.8827178 -0.9380971 -0.9924952 -1.045840 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4154623 -0.9300303 -1.458305 -1.937488 -2.341278 -2.672593 -2.948281 -3.183558 -3.388703 -3.570554 -3.733826 -3.881932 -4.017404 -4.142199 -4.257840 -4.365562 -4.466360 -4.561058 -4.650332 -4.734749 0.000000 -0.3969083 -0.8916988 -1.402302 -1.867875 -2.262487 -2.587767 -2.858536 -3.089250 -3.290017 -3.467635 -3.626802 -3.770919 -3.902510 -4.023524 -4.135476 -4.239598 -4.336876 -4.428132 -4.514036 -4.595154 0.000000 -0.3781473 -0.8527342 -1.345308 -1.797263 -2.182807 -2.502328 -2.768713 -2.995521 -3.192635 -3.366792 -3.522667 -3.663644 -3.792237 -3.910382 -4.019584 -4.121067 -4.215810 -4.304627 -4.388184 -4.467038 0.000000 -0.3591748 -0.8131031 -1.287204 -1.725365 -2.101846 -2.415751 -2.678130 -2.901531 -3.095537 -3.266801 -3.419967 -3.558399 -3.684594 -3.800474 -3.907535 -4.006988 -4.099804 -4.186789 -4.268601 -4.345793 0.000000 -0.3399873 -0.7727705 -1.227869 -1.651893 -2.019197 -2.327514 -2.586136 -2.806505 -2.997819 -3.166622 -3.317513 -3.453831 -3.578057 -3.692097 -3.797434 -3.895269 -3.986563 -4.072114 -4.152571 -4.228480 0.000000 -0.3205810 -0.7316997 -1.167183 -1.576567 -1.934431 -2.237076 -2.492071 -2.709681 -2.898627 -3.065300 -3.214246 -3.348777 -3.471352 -3.583863 -3.687778 -3.784287 -3.874344 -3.958734 -4.038103 -4.112989 0.000000 -0.3009508 -0.6898543 -1.105022 -1.499101 -1.847091 -2.143858 -2.395244 -2.610277 -2.797099 -2.961903 -3.109164 -3.242158 -3.363325 -3.474540 -3.577260 -3.672659 -3.761686 -3.845117 -3.923589 -3.997635 0.000000 -0.2810931 -0.6471971 -1.041259 -1.419208 -1.756691 -2.047228 -2.294903 -2.507446 -2.692322 -2.855461 -3.001240 -3.132897 -3.252846 -3.362947 -3.464642 -3.559098 -3.647252 -3.729872 -3.807591 -3.880935 0.000000 -0.2610030 -0.6036901 -0.9757621 -1.336586 -1.662711 -1.946476 -2.190201 -2.400240 -2.583280 -2.744906 -2.889365 -3.019843 -3.138724 -3.247855 -3.348663 -3.442304 -3.529707 -3.611633 -3.688708 -3.761451 0.000000 -0.2406755 -0.5592931 -0.9083964 -1.250924 -1.564595 -1.840809 -2.080165 -2.287562 -2.468794 -2.629009 -2.772272 -2.901696 -3.019635 -3.127910 -3.227940 -3.320868 -3.407616 -3.488939 -3.565456 -3.637682 0.000000 -0.2201053 -0.5139657 -0.8390176 -1.161890 -1.461741 -1.729330 -1.963657 -2.168104 -2.347450 -2.506293 -2.648445 -2.776914 -2.894006 -3.001521 -3.100859 -3.193160 -3.279332 -3.360125 -3.436152 -3.507926 0.000000 -0.1992881 -0.4676670 -0.7674792 -1.069134 -1.353491 -1.611024 -1.839333 -2.040279 -2.217500 -2.374917 -2.515992 -2.643573 -2.759894 -2.866724 -2.965445 -3.057184 -3.142843 -3.223167 -3.298760 -3.370136 0.000000 -0.1782187 -0.4203542 -0.6936306 -0.9722819 -1.239129 -1.484736 -1.705602 -1.902133 -2.076740 -2.232519 -2.372462 -2.499172 -2.614771 -2.720972 -2.819134 -2.910367 -2.995568 -3.075470 -3.150678 -3.221697 0.000000 -0.1568927 -0.3719843 -0.6173139 -0.8709431 -1.117873 -1.349160 -1.560572 -1.751244 -1.922335 -2.075987 -2.214571 -2.340333 -2.455204 -2.560806 -2.658448 -2.749221 -2.834003 -2.913527 -2.988388 -3.059085 0.000000 -0.1353050 -0.3225140 -0.5383669 -0.7647068 -0.9888806 -1.202822 -1.402006 -1.584601 -1.750607 -1.901134 -2.037787 -2.162308 -2.276322 -2.381282 -2.478409 -2.568741 -2.653137 -2.732311 -2.806856 -2.877264 0.000000 -0.1134503 -0.2718973 -0.4566248 -0.6531476 -0.8512532 -1.044085 -1.227294 -1.398499 -1.556782 -1.702273 -1.835718 -1.958204 -2.070907 -2.174982 -2.271475 -2.361323 -2.445323 -2.524160 -2.598406 -2.668544 0.000000 -9.1323748E-02 -0.2200873 -0.3719165 -0.5358250 -0.7040435 -0.8711686 -1.033456 -1.188461 -1.334751 -1.471700 -1.599258 -1.717784 -1.827863 -1.930204 -2.025539 -2.114590 -2.198022 -2.276430 -2.350337 -2.420193 0.000000 -6.8920575E-02 -0.1670408 -0.2840738 -0.4122941 -0.5462768 -0.6821858 -0.8172018 -0.9492769 -1.076947 -1.199255 -1.315627 -1.425824 -1.529836 -1.627840 -1.720114 -1.807026 -1.888966 -1.966329 -2.039492 -2.108811 0.000000 -4.6235707E-02 -0.1127114 -0.1929211 -0.2821042 -0.3769732 -0.4752126 -0.5750731 -0.6752132 -0.7745679 -0.8723170 -0.9678212 -1.060620 -1.150376 -1.236885 -1.320024 -1.399770 -1.476152 -1.549247 -1.619162 -1.686023 0.000000 -2.3263810E-02 -5.7049960E-02 -9.8284081E-02 -0.1448181 -0.1951771 -0.2483822 -0.3036774 -0.3604900 -0.4183428 -0.4768521 -0.5356843 -0.5945717 -0.6532710 -0.7115913 -0.7693582 -0.8264406 -0.8827178 -0.9380971 -0.9924952 -1.045840 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4154625 -0.9300310 -1.458307 -1.937490 -2.341280 -2.672596 -2.948284 -3.183561 -3.388707 -3.570557 -3.733829 -3.881936 -4.017407 -4.142203 -4.257843 -4.365566 -4.466364 -4.561062 -4.650336 -4.734753 0.000000 -0.3969085 -0.8916994 -1.402303 -1.867876 -2.262490 -2.587769 -2.858539 -3.089253 -3.290020 -3.467638 -3.626805 -3.770922 -3.902513 -4.023527 -4.135479 -4.239601 -4.336879 -4.428134 -4.514040 -4.595157 0.000000 -0.3781475 -0.8527347 -1.345309 -1.797265 -2.182809 -2.502330 -2.768715 -2.995523 -3.192638 -3.366795 -3.522669 -3.663647 -3.792240 -3.910384 -4.019587 -4.121069 -4.215812 -4.304629 -4.388186 -4.467041 0.000000 -0.3591750 -0.8131036 -1.287205 -1.725366 -2.101847 -2.415753 -2.678133 -2.901534 -3.095539 -3.266804 -3.419969 -3.558401 -3.684597 -3.800476 -3.907537 -4.006990 -4.099806 -4.186791 -4.268603 -4.345795 0.000000 -0.3399874 -0.7727709 -1.227870 -1.651894 -2.019199 -2.327516 -2.586138 -2.806507 -2.997821 -3.166624 -3.317514 -3.453833 -3.578058 -3.692098 -3.797436 -3.895271 -3.986565 -4.072115 -4.152572 -4.228482 0.000000 -0.3205811 -0.7317001 -1.167184 -1.576568 -1.934432 -2.237077 -2.492072 -2.709683 -2.898628 -3.065301 -3.214247 -3.348779 -3.471354 -3.583864 -3.687780 -3.784288 -3.874345 -3.958736 -4.038105 -4.112990 0.000000 -0.3009509 -0.6898547 -1.105023 -1.499102 -1.847092 -2.143860 -2.395246 -2.610278 -2.797100 -2.961905 -3.109165 -3.242160 -3.363327 -3.474542 -3.577261 -3.672660 -3.761687 -3.845118 -3.923590 -3.997637 0.000000 -0.2810932 -0.6471974 -1.041260 -1.419209 -1.756692 -2.047229 -2.294904 -2.507447 -2.692324 -2.855463 -3.001241 -3.132898 -3.252847 -3.362948 -3.464643 -3.559099 -3.647253 -3.729873 -3.807592 -3.880936 0.000000 -0.2610030 -0.6036903 -0.9757626 -1.336586 -1.662712 -1.946477 -2.190202 -2.400241 -2.583281 -2.744907 -2.889366 -3.019844 -3.138725 -3.247856 -3.348664 -3.442305 -3.529707 -3.611634 -3.688709 -3.761452 0.000000 -0.2406756 -0.5592933 -0.9083968 -1.250924 -1.564595 -1.840809 -2.080166 -2.287563 -2.468795 -2.629009 -2.772273 -2.901697 -3.019636 -3.127911 -3.227940 -3.320869 -3.407617 -3.488940 -3.565456 -3.637683 0.000000 -0.2201054 -0.5139659 -0.8390178 -1.161891 -1.461741 -1.729330 -1.963657 -2.168105 -2.347450 -2.506293 -2.648446 -2.776915 -2.894007 -3.001522 -3.100860 -3.193161 -3.279332 -3.360126 -3.436152 -3.507927 0.000000 -0.1992881 -0.4676671 -0.7674795 -1.069134 -1.353492 -1.611024 -1.839334 -2.040280 -2.217501 -2.374918 -2.515993 -2.643574 -2.759894 -2.866724 -2.965445 -3.057185 -3.142843 -3.223167 -3.298761 -3.370136 0.000000 -0.1782188 -0.4203542 -0.6936308 -0.9722822 -1.239129 -1.484736 -1.705603 -1.902134 -2.076741 -2.232520 -2.372463 -2.499173 -2.614771 -2.720972 -2.819134 -2.910368 -2.995568 -3.075470 -3.150678 -3.221698 0.000000 -0.1568928 -0.3719844 -0.6173140 -0.8709434 -1.117873 -1.349160 -1.560572 -1.751244 -1.922336 -2.075987 -2.214571 -2.340333 -2.455204 -2.560806 -2.658448 -2.749221 -2.834003 -2.913527 -2.988388 -3.059085 0.000000 -0.1353050 -0.3225141 -0.5383670 -0.7647069 -0.9888808 -1.202822 -1.402006 -1.584601 -1.750607 -1.901134 -2.037787 -2.162308 -2.276322 -2.381282 -2.478409 -2.568741 -2.653137 -2.732312 -2.806856 -2.877264 0.000000 -0.1134503 -0.2718973 -0.4566249 -0.6531477 -0.8512534 -1.044085 -1.227294 -1.398499 -1.556783 -1.702273 -1.835718 -1.958204 -2.070907 -2.174982 -2.271476 -2.361323 -2.445323 -2.524160 -2.598406 -2.668544 0.000000 -9.1323815E-02 -0.2200873 -0.3719166 -0.5358251 -0.7040436 -0.8711687 -1.033456 -1.188461 -1.334751 -1.471700 -1.599258 -1.717784 -1.827863 -1.930204 -2.025539 -2.114590 -2.198022 -2.276430 -2.350337 -2.420194 0.000000 -6.8920575E-02 -0.1670408 -0.2840738 -0.4122941 -0.5462768 -0.6821858 -0.8172019 -0.9492770 -1.076947 -1.199255 -1.315627 -1.425824 -1.529836 -1.627841 -1.720114 -1.807026 -1.888966 -1.966329 -2.039492 -2.108811 0.000000 -4.6235707E-02 -0.1127114 -0.1929212 -0.2821042 -0.3769732 -0.4752126 -0.5750732 -0.6752132 -0.7745679 -0.8723170 -0.9678212 -1.060620 -1.150376 -1.236885 -1.320024 -1.399771 -1.476152 -1.549247 -1.619162 -1.686023 0.000000 -2.3263810E-02 -5.7049960E-02 -9.8284140E-02 -0.1448181 -0.1951771 -0.2483822 -0.3036774 -0.3604900 -0.4183428 -0.4768522 -0.5356843 -0.5945717 -0.6532710 -0.7115914 -0.7693582 -0.8264408 -0.8827178 -0.9380971 -0.9924952 -1.045840 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4154629 -0.9300328 -1.458310 -1.937496 -2.341287 -2.672604 -2.948292 -3.183570 -3.388716 -3.570567 -3.733839 -3.881946 -4.017417 -4.142213 -4.257854 -4.365576 -4.466374 -4.561072 -4.650346 -4.734763 0.000000 -0.3969090 -0.8917010 -1.402306 -1.867881 -2.262496 -2.587776 -2.858546 -3.089260 -3.290028 -3.467646 -3.626813 -3.770930 -3.902521 -4.023535 -4.135487 -4.239609 -4.336887 -4.428143 -4.514047 -4.595164 0.000000 -0.3781479 -0.8527362 -1.345312 -1.797269 -2.182814 -2.502336 -2.768721 -2.995530 -3.192645 -3.366802 -3.522676 -3.663654 -3.792247 -3.910391 -4.019593 -4.121076 -4.215819 -4.304636 -4.388193 -4.467047 0.000000 -0.3591754 -0.8131049 -1.287207 -1.725370 -2.101852 -2.415758 -2.678138 -2.901540 -3.095545 -3.266809 -3.419975 -3.558407 -3.684602 -3.800482 -3.907543 -4.006996 -4.099812 -4.186796 -4.268609 -4.345800 0.000000 -0.3399877 -0.7727721 -1.227872 -1.651898 -2.019203 -2.327521 -2.586143 -2.806512 -2.997826 -3.166629 -3.317519 -3.453838 -3.578063 -3.692103 -3.797441 -3.895276 -3.986570 -4.072119 -4.152577 -4.228486 0.000000 -0.3205814 -0.7317011 -1.167186 -1.576570 -1.934436 -2.237082 -2.492077 -2.709687 -2.898633 -3.065306 -3.214252 -3.348783 -3.471358 -3.583868 -3.687784 -3.784292 -3.874349 -3.958740 -4.038108 -4.112994 0.000000 -0.3009511 -0.6898555 -1.105024 -1.499104 -1.847095 -2.143863 -2.395249 -2.610282 -2.797104 -2.961909 -3.109169 -3.242164 -3.363330 -3.474545 -3.577265 -3.672663 -3.761691 -3.845121 -3.923594 -3.997640 0.000000 -0.2810934 -0.6471980 -1.041261 -1.419211 -1.756694 -2.047232 -2.294907 -2.507450 -2.692327 -2.855466 -3.001244 -3.132901 -3.252850 -3.362951 -3.464646 -3.559102 -3.647256 -3.729876 -3.807595 -3.880938 0.000000 -0.2610033 -0.6036909 -0.9757638 -1.336588 -1.662714 -1.946479 -2.190205 -2.400244 -2.583284 -2.744910 -2.889369 -3.019846 -3.138728 -3.247859 -3.348667 -3.442307 -3.529710 -3.611636 -3.688711 -3.761455 0.000000 -0.2406757 -0.5592938 -0.9083977 -1.250926 -1.564597 -1.840811 -2.080168 -2.287566 -2.468798 -2.629012 -2.772275 -2.901700 -3.019638 -3.127913 -3.227942 -3.320871 -3.407619 -3.488942 -3.565459 -3.637685 0.000000 -0.2201055 -0.5139663 -0.8390186 -1.161892 -1.461743 -1.729332 -1.963659 -2.168107 -2.347452 -2.506295 -2.648448 -2.776917 -2.894009 -3.001524 -3.100862 -3.193162 -3.279334 -3.360127 -3.436154 -3.507929 0.000000 -0.1992882 -0.4676674 -0.7674801 -1.069135 -1.353493 -1.611026 -1.839335 -2.040281 -2.217503 -2.374919 -2.515995 -2.643576 -2.759896 -2.866726 -2.965447 -3.057186 -3.142845 -3.223169 -3.298762 -3.370137 0.000000 -0.1782189 -0.4203545 -0.6936313 -0.9722829 -1.239130 -1.484738 -1.705604 -1.902135 -2.076742 -2.232521 -2.372464 -2.499174 -2.614773 -2.720974 -2.819135 -2.910369 -2.995569 -3.075472 -3.150679 -3.221699 0.000000 -0.1568928 -0.3719846 -0.6173145 -0.8709440 -1.117874 -1.349161 -1.560573 -1.751245 -1.922337 -2.075989 -2.214572 -2.340334 -2.455206 -2.560807 -2.658450 -2.749222 -2.834004 -2.913528 -2.988389 -3.059086 0.000000 -0.1353050 -0.3225142 -0.5383673 -0.7647073 -0.9888813 -1.202823 -1.402007 -1.584602 -1.750608 -1.901135 -2.037788 -2.162309 -2.276323 -2.381283 -2.478410 -2.568742 -2.653138 -2.732313 -2.806857 -2.877265 0.000000 -0.1134503 -0.2718975 -0.4566251 -0.6531481 -0.8512537 -1.044086 -1.227295 -1.398500 -1.556783 -1.702273 -1.835719 -1.958205 -2.070908 -2.174983 -2.271476 -2.361323 -2.445323 -2.524161 -2.598407 -2.668545 0.000000 -9.1323815E-02 -0.2200874 -0.3719167 -0.5358253 -0.7040438 -0.8711690 -1.033456 -1.188462 -1.334751 -1.471700 -1.599259 -1.717785 -1.827863 -1.930205 -2.025539 -2.114590 -2.198023 -2.276431 -2.350337 -2.420194 0.000000 -6.8920575E-02 -0.1670408 -0.2840739 -0.4122943 -0.5462770 -0.6821860 -0.8172021 -0.9492772 -1.076948 -1.199255 -1.315627 -1.425825 -1.529836 -1.627841 -1.720115 -1.807026 -1.888966 -1.966329 -2.039493 -2.108812 0.000000 -4.6235770E-02 -0.1127114 -0.1929212 -0.2821043 -0.3769733 -0.4752127 -0.5750732 -0.6752133 -0.7745680 -0.8723172 -0.9678213 -1.060620 -1.150376 -1.236886 -1.320024 -1.399771 -1.476152 -1.549247 -1.619162 -1.686023 0.000000 -2.3263810E-02 -5.7049960E-02 -9.8284140E-02 -0.1448181 -0.1951771 -0.2483822 -0.3036774 -0.3604900 -0.4183428 -0.4768522 -0.5356843 -0.5945717 -0.6532710 -0.7115914 -0.7693583 -0.8264408 -0.8827178 -0.9380972 -0.9924953 -1.045840 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4154643 -0.9300377 -1.458320 -1.937510 -2.341306 -2.672625 -2.948316 -3.183594 -3.388741 -3.570593 -3.733865 -3.881972 -4.017444 -4.142240 -4.257880 -4.365603 -4.466401 -4.561099 -4.650373 -4.734791 0.000000 -0.3969102 -0.8917054 -1.402315 -1.867894 -2.262512 -2.587795 -2.858566 -3.089281 -3.290050 -3.467668 -3.626835 -3.770952 -3.902543 -4.023557 -4.135509 -4.239631 -4.336909 -4.428164 -4.514069 -4.595186 0.000000 -0.3781489 -0.8527400 -1.345319 -1.797280 -2.182828 -2.502352 -2.768739 -2.995548 -3.192663 -3.366820 -3.522695 -3.663672 -3.792265 -3.910409 -4.019611 -4.121094 -4.215837 -4.304654 -4.388210 -4.467064 0.000000 -0.3591763 -0.8131084 -1.287214 -1.725379 -2.101865 -2.415773 -2.678153 -2.901555 -3.095561 -3.266825 -3.419991 -3.558423 -3.684618 -3.800498 -3.907558 -4.007011 -4.099826 -4.186811 -4.268623 -4.345814 0.000000 -0.3399886 -0.7727751 -1.227878 -1.651906 -2.019214 -2.327533 -2.586156 -2.806526 -2.997840 -3.166643 -3.317533 -3.453852 -3.578077 -3.692117 -3.797454 -3.895289 -3.986582 -4.072132 -4.152589 -4.228498 0.000000 -0.3205822 -0.7317037 -1.167191 -1.576578 -1.934445 -2.237092 -2.492088 -2.709699 -2.898645 -3.065318 -3.214264 -3.348795 -3.471369 -3.583880 -3.687795 -3.784303 -3.874360 -3.958750 -4.038119 -4.113004 0.000000 -0.3009517 -0.6898578 -1.105029 -1.499110 -1.847103 -2.143872 -2.395259 -2.610292 -2.797115 -2.961919 -3.109179 -3.242174 -3.363340 -3.474555 -3.577274 -3.672673 -3.761700 -3.845130 -3.923602 -3.997648 0.000000 -0.2810939 -0.6472000 -1.041265 -1.419216 -1.756701 -2.047240 -2.294916 -2.507459 -2.692336 -2.855475 -3.001253 -3.132910 -3.252859 -3.362959 -3.464655 -3.559110 -3.647264 -3.729883 -3.807602 -3.880946 0.000000 -0.2610037 -0.6036927 -0.9757669 -1.336593 -1.662720 -1.946486 -2.190212 -2.400252 -2.583292 -2.744918 -2.889376 -3.019854 -3.138735 -3.247866 -3.348674 -3.442314 -3.529717 -3.611642 -3.688717 -3.761461 0.000000 -0.2406761 -0.5592952 -0.9084003 -1.250929 -1.564602 -1.840817 -2.080174 -2.287572 -2.468804 -2.629018 -2.772281 -2.901706 -3.019644 -3.127919 -3.227949 -3.320877 -3.407625 -3.488947 -3.565464 -3.637690 0.000000 -0.2201058 -0.5139674 -0.8390208 -1.161895 -1.461747 -1.729337 -1.963664 -2.168113 -2.347458 -2.506301 -2.648453 -2.776923 -2.894014 -3.001529 -3.100867 -3.193167 -3.279339 -3.360132 -3.436159 -3.507933 0.000000 -0.1992885 -0.4676683 -0.7674818 -1.069137 -1.353496 -1.611030 -1.839340 -2.040286 -2.217507 -2.374924 -2.515999 -2.643580 -2.759901 -2.866730 -2.965451 -3.057191 -3.142849 -3.223173 -3.298766 -3.370141 0.000000 -0.1782190 -0.4203553 -0.6936326 -0.9722850 -1.239133 -1.484741 -1.705607 -1.902139 -2.076746 -2.232525 -2.372468 -2.499178 -2.614776 -2.720977 -2.819139 -2.910372 -2.995573 -3.075475 -3.150683 -3.221702 0.000000 -0.1568930 -0.3719851 -0.6173155 -0.8709455 -1.117876 -1.349163 -1.560576 -1.751248 -1.922340 -2.075991 -2.214575 -2.340337 -2.455209 -2.560810 -2.658453 -2.749225 -2.834007 -2.913531 -2.988391 -3.059089 0.000000 -0.1353052 -0.3225146 -0.5383680 -0.7647084 -0.9888828 -1.202825 -1.402009 -1.584604 -1.750611 -1.901137 -2.037791 -2.162311 -2.276325 -2.381285 -2.478412 -2.568744 -2.653140 -2.732315 -2.806859 -2.877267 0.000000 -0.1134504 -0.2718977 -0.4566256 -0.6531487 -0.8512548 -1.044087 -1.227296 -1.398501 -1.556785 -1.702275 -1.835720 -1.958207 -2.070910 -2.174985 -2.271478 -2.361325 -2.445325 -2.524162 -2.598408 -2.668546 0.000000 -9.1323882E-02 -0.2200875 -0.3719170 -0.5358257 -0.7040445 -0.8711697 -1.033457 -1.188463 -1.334752 -1.471701 -1.599260 -1.717786 -1.827865 -1.930206 -2.025541 -2.114592 -2.198024 -2.276432 -2.350338 -2.420195 0.000000 -6.8920575E-02 -0.1670409 -0.2840740 -0.4122945 -0.5462773 -0.6821864 -0.8172025 -0.9492778 -1.076948 -1.199256 -1.315628 -1.425825 -1.529837 -1.627842 -1.720115 -1.807027 -1.888967 -1.966330 -2.039493 -2.108812 0.000000 -4.6235770E-02 -0.1127114 -0.1929213 -0.2821043 -0.3769735 -0.4752129 -0.5750735 -0.6752136 -0.7745683 -0.8723174 -0.9678217 -1.060620 -1.150376 -1.236886 -1.320025 -1.399771 -1.476152 -1.549248 -1.619162 -1.686023 0.000000 -2.3263810E-02 -5.7049960E-02 -9.8284140E-02 -0.1448182 -0.1951772 -0.2483822 -0.3036774 -0.3604901 -0.4183429 -0.4768523 -0.5356845 -0.5945718 -0.6532711 -0.7115915 -0.7693583 -0.8264409 -0.8827179 -0.9380972 -0.9924955 -1.045841 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4154680 -0.9300512 -1.458347 -1.937550 -2.341357 -2.672683 -2.948378 -3.183660 -3.388809 -3.570662 -3.733936 -3.882044 -4.017517 -4.142313 -4.257954 -4.365677 -4.466475 -4.561173 -4.650448 -4.734865 0.000000 -0.3969135 -0.8917174 -1.402338 -1.867929 -2.262556 -2.587845 -2.858621 -3.089338 -3.290108 -3.467728 -3.626895 -3.771013 -3.902603 -4.023617 -4.135569 -4.239690 -4.336968 -4.428223 -4.514127 -4.595243 0.000000 -0.3781519 -0.8527508 -1.345340 -1.797311 -2.182867 -2.502397 -2.768786 -2.995598 -3.192713 -3.366871 -3.522746 -3.663723 -3.792316 -3.910460 -4.019661 -4.121143 -4.215886 -4.304701 -4.388258 -4.467111 0.000000 -0.3591789 -0.8131178 -1.287232 -1.725407 -2.101899 -2.415812 -2.678195 -2.901598 -3.095605 -3.266869 -3.420035 -3.558467 -3.684661 -3.800540 -3.907600 -4.007052 -4.099867 -4.186851 -4.268662 -4.345853 0.000000 -0.3399908 -0.7727833 -1.227894 -1.651930 -2.019243 -2.327567 -2.586192 -2.806563 -2.997878 -3.166681 -3.317571 -3.453889 -3.578114 -3.692153 -3.797490 -3.895324 -3.986616 -4.072165 -4.152622 -4.228530 0.000000 -0.3205841 -0.7317109 -1.167205 -1.576598 -1.934471 -2.237122 -2.492120 -2.709732 -2.898678 -3.065351 -3.214296 -3.348827 -3.471401 -3.583911 -3.687826 -3.784333 -3.874389 -3.958779 -4.038147 -4.113031 0.000000 -0.3009535 -0.6898639 -1.105041 -1.499128 -1.847126 -2.143898 -2.395286 -2.610320 -2.797143 -2.961947 -3.109207 -3.242201 -3.363367 -3.474582 -3.577300 -3.672698 -3.761725 -3.845154 -3.923626 -3.997672 0.000000 -0.2810954 -0.6472054 -1.041275 -1.419231 -1.756720 -2.047261 -2.294939 -2.507483 -2.692361 -2.855499 -3.001277 -3.132934 -3.252882 -3.362982 -3.464677 -3.559132 -3.647285 -3.729904 -3.807623 -3.880965 0.000000 -0.2610050 -0.6036970 -0.9757755 -1.336606 -1.662736 -1.946504 -2.190232 -2.400273 -2.583313 -2.744939 -2.889397 -3.019874 -3.138755 -3.247886 -3.348693 -3.442333 -3.529735 -3.611660 -3.688735 -3.761478 0.000000 -0.2406771 -0.5592988 -0.9084075 -1.250940 -1.564616 -1.840833 -2.080191 -2.287590 -2.468822 -2.629036 -2.772299 -2.901723 -3.019661 -3.127936 -3.227965 -3.320893 -3.407640 -3.488963 -3.565479 -3.637705 0.000000 -0.2201067 -0.5139704 -0.8390266 -1.161904 -1.461758 -1.729350 -1.963678 -2.168127 -2.347473 -2.506316 -2.648468 -2.776937 -2.894029 -3.001543 -3.100881 -3.193181 -3.279352 -3.360145 -3.436171 -3.507945 0.000000 -0.1992892 -0.4676707 -0.7674865 -1.069144 -1.353505 -1.611040 -1.839351 -2.040298 -2.217520 -2.374936 -2.516012 -2.643592 -2.759913 -2.866742 -2.965463 -3.057202 -3.142860 -3.223183 -3.298777 -3.370152 0.000000 -0.1782196 -0.4203572 -0.6936363 -0.9722905 -1.239140 -1.484749 -1.705616 -1.902149 -2.076756 -2.232536 -2.372478 -2.499188 -2.614786 -2.720987 -2.819149 -2.910382 -2.995582 -3.075484 -3.150691 -3.221710 0.000000 -0.1568934 -0.3719865 -0.6173182 -0.8709496 -1.117881 -1.349170 -1.560583 -1.751256 -1.922348 -2.075999 -2.214583 -2.340345 -2.455217 -2.560818 -2.658460 -2.749233 -2.834014 -2.913538 -2.988399 -3.059096 0.000000 -0.1353054 -0.3225157 -0.5383701 -0.7647114 -0.9888867 -1.202829 -1.402014 -1.584610 -1.750617 -1.901144 -2.037797 -2.162318 -2.276332 -2.381292 -2.478418 -2.568750 -2.653146 -2.732321 -2.806865 -2.877273 0.000000 -0.1134506 -0.2718984 -0.4566270 -0.6531508 -0.8512575 -1.044090 -1.227300 -1.398505 -1.556789 -1.702280 -1.835725 -1.958212 -2.070914 -2.174989 -2.271483 -2.361330 -2.445330 -2.524167 -2.598413 -2.668551 0.000000 -9.1324009E-02 -0.2200880 -0.3719179 -0.5358270 -0.7040462 -0.8711719 -1.033460 -1.188466 -1.334755 -1.471704 -1.599263 -1.717789 -1.827868 -1.930210 -2.025544 -2.114595 -2.198027 -2.276435 -2.350342 -2.420198 0.000000 -6.8920642E-02 -0.1670411 -0.2840745 -0.4122953 -0.5462782 -0.6821876 -0.8172039 -0.9492794 -1.076950 -1.199258 -1.315630 -1.425827 -1.529839 -1.627844 -1.720117 -1.807029 -1.888969 -1.966332 -2.039495 -2.108814 0.000000 -4.6235770E-02 -0.1127116 -0.1929215 -0.2821047 -0.3769740 -0.4752134 -0.5750741 -0.6752143 -0.7745690 -0.8723183 -0.9678226 -1.060621 -1.150378 -1.236887 -1.320026 -1.399772 -1.476153 -1.549249 -1.619164 -1.686024 0.000000 -2.3263810E-02 -5.7050023E-02 -9.8284207E-02 -0.1448182 -0.1951773 -0.2483824 -0.3036776 -0.3604903 -0.4183430 -0.4768525 -0.5356846 -0.5945721 -0.6532714 -0.7115918 -0.7693586 -0.8264411 -0.8827182 -0.9380975 -0.9924958 -1.045841 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4154780 -0.9300879 -1.458419 -1.937659 -2.341495 -2.672841 -2.948549 -3.183839 -3.388995 -3.570853 -3.734130 -3.882241 -4.017715 -4.142513 -4.258155 -4.365879 -4.466678 -4.561376 -4.650651 -4.735068 0.000000 -0.3969224 -0.8917502 -1.402403 -1.868025 -2.262677 -2.587983 -2.858769 -3.089493 -3.290267 -3.467889 -3.627058 -3.771177 -3.902767 -4.023781 -4.135733 -4.239853 -4.337130 -4.428383 -4.514287 -4.595402 0.000000 -0.3781599 -0.8527798 -1.345397 -1.797396 -2.182974 -2.502518 -2.768916 -2.995732 -3.192851 -3.367010 -3.522885 -3.663862 -3.792454 -3.910597 -4.019797 -4.121277 -4.216018 -4.304832 -4.388387 -4.467238 0.000000 -0.3591860 -0.8131434 -1.287283 -1.725481 -2.101992 -2.415917 -2.678308 -2.901715 -3.095724 -3.266989 -3.420154 -3.558585 -3.684778 -3.800656 -3.907714 -4.007164 -4.099977 -4.186960 -4.268769 -4.345958 0.000000 -0.3399971 -0.7728058 -1.227938 -1.651995 -2.019325 -2.327659 -2.586290 -2.806665 -2.997981 -3.166784 -3.317674 -3.453991 -3.578214 -3.692252 -3.797587 -3.895419 -3.986710 -4.072257 -4.152711 -4.228618 0.000000 -0.3205896 -0.7317305 -1.167243 -1.576654 -1.934541 -2.237201 -2.492205 -2.709820 -2.898767 -3.065440 -3.214385 -3.348915 -3.471487 -3.583995 -3.687908 -3.784414 -3.874469 -3.958856 -4.038223 -4.113106 0.000000 -0.3009582 -0.6898808 -1.105073 -1.499176 -1.847186 -2.143967 -2.395360 -2.610397 -2.797220 -2.962025 -3.109284 -3.242277 -3.363441 -3.474654 -3.577371 -3.672768 -3.761792 -3.845221 -3.923691 -3.997735 0.000000 -0.2810995 -0.6472197 -1.041303 -1.419272 -1.756772 -2.047321 -2.295003 -2.507549 -2.692427 -2.855566 -3.001343 -3.132999 -3.252946 -3.363045 -3.464738 -3.559191 -3.647343 -3.729961 -3.807678 -3.881019 0.000000 -0.2610085 -0.6037092 -0.9757989 -1.336640 -1.662780 -1.946555 -2.190286 -2.400329 -2.583370 -2.744996 -2.889453 -3.019930 -3.138810 -3.247939 -3.348745 -3.442384 -3.529784 -3.611708 -3.688782 -3.761524 0.000000 -0.2406800 -0.5593089 -0.9084269 -1.250969 -1.564652 -1.840875 -2.080237 -2.287638 -2.468871 -2.629085 -2.772347 -2.901771 -3.019708 -3.127982 -3.228009 -3.320936 -3.407683 -3.489004 -3.565519 -3.637744 0.000000 -0.2201091 -0.5139788 -0.8390425 -1.161927 -1.461788 -1.729385 -1.963717 -2.168168 -2.347514 -2.506357 -2.648509 -2.776978 -2.894068 -3.001582 -3.100919 -3.193218 -3.279388 -3.360180 -3.436205 -3.507978 0.000000 -0.1992911 -0.4676774 -0.7674993 -1.069163 -1.353530 -1.611069 -1.839383 -2.040331 -2.217554 -2.374971 -2.516046 -2.643626 -2.759946 -2.866775 -2.965495 -3.057233 -3.142890 -3.223213 -3.298805 -3.370179 0.000000 -0.1782211 -0.4203623 -0.6936463 -0.9723052 -1.239159 -1.484772 -1.705642 -1.902175 -2.076784 -2.232564 -2.372506 -2.499216 -2.614814 -2.721014 -2.819175 -2.910408 -2.995607 -3.075509 -3.150715 -3.221734 0.000000 -0.1568945 -0.3719905 -0.6173257 -0.8709609 -1.117896 -1.349187 -1.560603 -1.751277 -1.922370 -2.076022 -2.214606 -2.340368 -2.455239 -2.560840 -2.658482 -2.749254 -2.834035 -2.913558 -2.988418 -3.059115 0.000000 -0.1353063 -0.3225186 -0.5383755 -0.7647196 -0.9888974 -1.202842 -1.402029 -1.584626 -1.750634 -1.901161 -2.037815 -2.162335 -2.276349 -2.381309 -2.478436 -2.568767 -2.653162 -2.732337 -2.806880 -2.877288 0.000000 -0.1134512 -0.2719004 -0.4566307 -0.6531565 -0.8512649 -1.044099 -1.227310 -1.398517 -1.556802 -1.702292 -1.835738 -1.958225 -2.070927 -2.175003 -2.271496 -2.361342 -2.445342 -2.524179 -2.598425 -2.668563 0.000000 -9.1324337E-02 -0.2200892 -0.3719202 -0.5358307 -0.7040510 -0.8711777 -1.033466 -1.188473 -1.334763 -1.471713 -1.599272 -1.717798 -1.827877 -1.930219 -2.025553 -2.114604 -2.198036 -2.276444 -2.350350 -2.420207 0.000000 -6.8920895E-02 -0.1670418 -0.2840758 -0.4122972 -0.5462809 -0.6821908 -0.8172078 -0.9492836 -1.076955 -1.199263 -1.315635 -1.425833 -1.529845 -1.627849 -1.720123 -1.807035 -1.888975 -1.966338 -2.039501 -2.108820 0.000000 -4.6235897E-02 -0.1127119 -0.1929221 -0.2821055 -0.3769751 -0.4752148 -0.5750757 -0.6752163 -0.7745712 -0.8723206 -0.9678251 -1.060624 -1.150380 -1.236890 -1.320029 -1.399775 -1.476156 -1.549252 -1.619167 -1.686027 0.000000 -2.3263810E-02 -5.7050087E-02 -9.8284341E-02 -0.1448184 -0.1951775 -0.2483827 -0.3036780 -0.3604907 -0.4183436 -0.4768530 -0.5356854 -0.5945727 -0.6532721 -0.7115926 -0.7693594 -0.8264419 -0.8827190 -0.9380984 -0.9924967 -1.045842 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4155054 -0.9301883 -1.458619 -1.937958 -2.341873 -2.673273 -2.949016 -3.184331 -3.389503 -3.571374 -3.734661 -3.882778 -4.018258 -4.143060 -4.258705 -4.366431 -4.467231 -4.561930 -4.651206 -4.735623 0.000000 -0.3969470 -0.8918397 -1.402580 -1.868289 -2.263010 -2.588361 -2.859176 -3.089918 -3.290703 -3.468332 -3.627505 -3.771626 -3.903217 -4.024230 -4.136180 -4.240298 -4.337572 -4.428823 -4.514722 -4.595834 0.000000 -0.3781818 -0.8528593 -1.345553 -1.797627 -2.183265 -2.502848 -2.769270 -2.996100 -3.193227 -3.367389 -3.523266 -3.664242 -3.792831 -3.910971 -4.020168 -4.121644 -4.216381 -4.305191 -4.388740 -4.467587 0.000000 -0.3592056 -0.8132136 -1.287420 -1.725684 -2.102246 -2.416206 -2.678617 -2.902035 -3.096049 -3.267316 -3.420480 -3.558909 -3.685099 -3.800973 -3.908027 -4.007473 -4.100280 -4.187258 -4.269063 -4.346246 0.000000 -0.3400143 -0.7728673 -1.228057 -1.652171 -2.019547 -2.327911 -2.586560 -2.806943 -2.998263 -3.167066 -3.317955 -3.454269 -3.578488 -3.692522 -3.797852 -3.895680 -3.986966 -4.072508 -4.152957 -4.228859 0.000000 -0.3206047 -0.7317840 -1.167346 -1.576808 -1.934734 -2.237420 -2.492439 -2.710062 -2.899012 -3.065685 -3.214628 -3.349154 -3.471723 -3.584227 -3.688135 -3.784636 -3.874686 -3.959069 -4.038431 -4.113309 0.000000 -0.3009712 -0.6899269 -1.105162 -1.499308 -1.847352 -2.144156 -2.395563 -2.610606 -2.797432 -2.962236 -3.109493 -3.242483 -3.363644 -3.474853 -3.577566 -3.672958 -3.761978 -3.845402 -3.923868 -3.997908 0.000000 -0.2811107 -0.6472592 -1.041379 -1.419385 -1.756914 -2.047483 -2.295177 -2.507730 -2.692610 -2.855748 -3.001523 -3.133177 -3.253120 -3.363215 -3.464905 -3.559354 -3.647502 -3.730116 -3.807829 -3.881167 0.000000 -0.2610179 -0.6037425 -0.9758629 -1.336735 -1.662900 -1.946693 -2.190436 -2.400484 -2.583527 -2.745152 -2.889608 -3.020083 -3.138959 -3.248085 -3.348888 -3.442523 -3.529920 -3.611841 -3.688911 -3.761650 0.000000 -0.2406880 -0.5593367 -0.9084802 -1.251048 -1.564753 -1.840991 -2.080363 -2.287769 -2.469004 -2.629219 -2.772480 -2.901901 -3.019836 -3.128107 -3.228131 -3.321055 -3.407798 -3.489117 -3.565629 -3.637851 0.000000 -0.2201156 -0.5140014 -0.8390861 -1.161992 -1.461871 -1.729481 -1.963822 -2.168278 -2.347626 -2.506470 -2.648621 -2.777088 -2.894177 -3.001688 -3.101022 -3.193318 -3.279486 -3.360276 -3.436298 -3.508069 0.000000 -0.1992964 -0.4676956 -0.7675341 -1.069215 -1.353597 -1.611147 -1.839469 -2.040422 -2.217648 -2.375065 -2.516140 -2.643719 -2.760037 -2.866863 -2.965581 -3.057318 -3.142973 -3.223293 -3.298884 -3.370256 0.000000 -0.1782253 -0.4203767 -0.6936735 -0.9723459 -1.239211 -1.484834 -1.705711 -1.902249 -2.076860 -2.232641 -2.372583 -2.499292 -2.614889 -2.721088 -2.819247 -2.910478 -2.995676 -3.075575 -3.150780 -3.221797 0.000000 -0.1568977 -0.3720013 -0.6173464 -0.8709917 -1.117936 -1.349235 -1.560657 -1.751335 -1.922430 -2.076084 -2.214668 -2.340429 -2.455300 -2.560899 -2.658540 -2.749311 -2.834091 -2.913613 -2.988471 -3.059167 0.000000 -0.1353086 -0.3225265 -0.5383906 -0.7647421 -0.9889269 -1.202878 -1.402069 -1.584670 -1.750679 -1.901208 -2.037863 -2.162383 -2.276397 -2.381356 -2.478482 -2.568812 -2.653207 -2.732380 -2.806923 -2.877330 0.000000 -0.1134528 -0.2719058 -0.4566411 -0.6531720 -0.8512853 -1.044124 -1.227339 -1.398548 -1.556835 -1.702327 -1.835773 -1.958260 -2.070963 -2.175038 -2.271531 -2.361377 -2.445376 -2.524213 -2.598457 -2.668595 0.000000 -9.1325380E-02 -0.2200927 -0.3719268 -0.5358405 -0.7040639 -0.8711935 -1.033485 -1.188493 -1.334785 -1.471736 -1.599296 -1.717823 -1.827902 -1.930244 -2.025578 -2.114629 -2.198061 -2.276468 -2.350374 -2.420230 0.000000 -6.8921469E-02 -0.1670437 -0.2840795 -0.4123026 -0.5462881 -0.6821998 -0.8172181 -0.9492953 -1.076967 -1.199277 -1.315649 -1.425848 -1.529860 -1.627865 -1.720139 -1.807051 -1.888991 -1.966354 -2.039517 -2.108835 0.000000 -4.6236146E-02 -0.1127127 -0.1929237 -0.2821080 -0.3769783 -0.4752187 -0.5750804 -0.6752216 -0.7745770 -0.8723269 -0.9678319 -1.060631 -1.150388 -1.236898 -1.320037 -1.399783 -1.476164 -1.549260 -1.619175 -1.686036 0.000000 -2.3263870E-02 -5.7050277E-02 -9.8284736E-02 -0.1448191 -0.1951783 -0.2483837 -0.3036791 -0.3604921 -0.4183450 -0.4768547 -0.5356871 -0.5945746 -0.6532741 -0.7115946 -0.7693616 -0.8264442 -0.8827214 -0.9381008 -0.9924991 -1.045844 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4155815 -0.9304673 -1.459172 -1.938787 -2.342922 -2.674471 -2.950312 -3.185694 -3.390915 -3.572820 -3.736133 -3.884270 -4.019764 -4.144577 -4.260230 -4.367962 -4.468766 -4.563468 -4.652744 -4.737163 0.000000 -0.3970155 -0.8920887 -1.403070 -1.869020 -2.263931 -2.589409 -2.860303 -3.091095 -3.291912 -3.469561 -3.628745 -3.772870 -3.904463 -4.025474 -4.137419 -4.241531 -4.338798 -4.430040 -4.515930 -4.597032 0.000000 -0.3782429 -0.8530803 -1.345987 -1.798270 -2.184073 -2.503765 -2.770253 -2.997121 -3.194268 -3.368442 -3.524320 -3.665294 -3.793878 -3.912010 -4.021197 -4.122662 -4.217386 -4.306183 -4.389719 -4.468553 0.000000 -0.3592598 -0.8134086 -1.287800 -1.726246 -2.102953 -2.417008 -2.679474 -2.902922 -3.096951 -3.268222 -3.421385 -3.559807 -3.685988 -3.801851 -3.908892 -4.008325 -4.101120 -4.188082 -4.269873 -4.347043 0.000000 -0.3400621 -0.7730382 -1.228390 -1.652662 -2.020163 -2.328610 -2.587306 -2.807715 -2.999045 -3.167850 -3.318733 -3.455040 -3.579248 -3.693270 -3.798587 -3.896401 -3.987673 -4.073202 -4.153638 -4.229526 0.000000 -0.3206465 -0.7319326 -1.167635 -1.577233 -1.935268 -2.238028 -2.493088 -2.710732 -2.899690 -3.066362 -3.215299 -3.349817 -3.472375 -3.584867 -3.688763 -3.785251 -3.875288 -3.959658 -4.039007 -4.113873 0.000000 -0.3010074 -0.6900553 -1.105410 -1.499674 -1.847813 -2.144681 -2.396125 -2.611187 -2.798019 -2.962822 -3.110073 -3.243055 -3.364205 -3.475403 -3.578104 -3.673484 -3.762492 -3.845904 -3.924358 -3.998387 0.000000 -0.2811418 -0.6473687 -1.041590 -1.419696 -1.757308 -2.047933 -2.295661 -2.508230 -2.693116 -2.856253 -3.002023 -3.133668 -3.253602 -3.363687 -3.465366 -3.559804 -3.647942 -3.730545 -3.808248 -3.881575 0.000000 -0.2610443 -0.6038349 -0.9760408 -1.336998 -1.663234 -1.947076 -2.190849 -2.400913 -2.583961 -2.745586 -2.890038 -3.020505 -3.139373 -3.248490 -3.349283 -3.442909 -3.530296 -3.612207 -3.689268 -3.761998 0.000000 -0.2407100 -0.5594136 -0.9086279 -1.251267 -1.565032 -1.841313 -2.080713 -2.288133 -2.469374 -2.629589 -2.772846 -2.902262 -3.020189 -3.128452 -3.228468 -3.321384 -3.408119 -3.489429 -3.565933 -3.638147 0.000000 -0.2201337 -0.5140645 -0.8392069 -1.162171 -1.462100 -1.729748 -1.964114 -2.168583 -2.347938 -2.506783 -2.648931 -2.777393 -2.894476 -3.001981 -3.101308 -3.193597 -3.279758 -3.360540 -3.436556 -3.508320 0.000000 -0.1993110 -0.4677463 -0.7676309 -1.069359 -1.353782 -1.611364 -1.839708 -2.040674 -2.217906 -2.375325 -2.516399 -2.643975 -2.760288 -2.867109 -2.965822 -3.057552 -3.143201 -3.223516 -3.299100 -3.370467 0.000000 -0.1782367 -0.4204162 -0.6937492 -0.9724588 -1.239357 -1.485007 -1.705903 -1.902453 -2.077070 -2.232854 -2.372796 -2.499503 -2.615096 -2.721291 -2.819446 -2.910672 -2.995865 -3.075760 -3.150960 -3.221973 0.000000 -0.1569065 -0.3720314 -0.6174037 -0.8710774 -1.118048 -1.349368 -1.560806 -1.751495 -1.922597 -2.076254 -2.214839 -2.340600 -2.455468 -2.561065 -2.658702 -2.749470 -2.834246 -2.913764 -2.988619 -3.059310 0.000000 -0.1353151 -0.3225483 -0.5384322 -0.7648045 -0.9890086 -1.202976 -1.402180 -1.584790 -1.750807 -1.901339 -2.037996 -2.162516 -2.276529 -2.381487 -2.478610 -2.568938 -2.653330 -2.732501 -2.807040 -2.877444 0.000000 -0.1134572 -0.2719209 -0.4566697 -0.6532148 -0.8513418 -1.044193 -1.227417 -1.398634 -1.556927 -1.702423 -1.835871 -1.958359 -2.071062 -2.175137 -2.271628 -2.361473 -2.445471 -2.524305 -2.598548 -2.668683 0.000000 -9.1328189E-02 -0.2201023 -0.3719449 -0.5358677 -0.7040998 -0.8712374 -1.033535 -1.188550 -1.334846 -1.471801 -1.599363 -1.717891 -1.827971 -1.930313 -2.025647 -2.114697 -2.198129 -2.276535 -2.350440 -2.420295 0.000000 -6.8923004E-02 -0.1670491 -0.2840895 -0.4123178 -0.5463082 -0.6822244 -0.8172469 -0.9493278 -1.077003 -1.199315 -1.315690 -1.425889 -1.529903 -1.627908 -1.720183 -1.807095 -1.889035 -1.966398 -2.039560 -2.108878 0.000000 -4.6236832E-02 -0.1127151 -0.1929281 -0.2821146 -0.3769871 -0.4752297 -0.5750932 -0.6752360 -0.7745931 -0.8723445 -0.9678505 -1.060651 -1.150408 -1.236919 -1.320058 -1.399806 -1.476187 -1.549283 -1.619198 -1.686059 0.000000 -2.3264054E-02 -5.7050843E-02 -9.8285854E-02 -0.1448206 -0.1951805 -0.2483864 -0.3036824 -0.3604957 -0.4183491 -0.4768591 -0.5356919 -0.5945798 -0.6532795 -0.7116003 -0.7693676 -0.8264504 -0.8827278 -0.9381074 -0.9925058 -1.045851 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4158022 -0.9312744 -1.460772 -1.941182 -2.345950 -2.677926 -2.954047 -3.189620 -3.394978 -3.576983 -3.740369 -3.888561 -4.024097 -4.148940 -4.264616 -4.372364 -4.473179 -4.567887 -4.657167 -4.741586 0.000000 -0.3972135 -0.8928086 -1.404488 -1.871129 -2.266588 -2.592430 -2.863550 -3.094483 -3.295389 -3.473092 -3.632308 -3.776448 -3.908042 -4.029046 -4.140978 -4.245071 -4.342316 -4.433533 -4.519396 -4.600469 0.000000 -0.3784198 -0.8537191 -1.347238 -1.800124 -2.186402 -2.506407 -2.773081 -3.000057 -3.197264 -3.371464 -3.527350 -3.668317 -3.796883 -3.914990 -4.024148 -4.125580 -4.220268 -4.309028 -4.392527 -4.471321 0.000000 -0.3594167 -0.8139721 -1.288899 -1.727870 -2.104989 -2.419315 -2.681939 -2.905473 -3.099541 -3.270824 -3.423980 -3.562384 -3.688538 -3.804368 -3.911374 -4.010767 -4.103522 -4.190445 -4.272195 -4.349324 0.000000 -0.3402004 -0.7735321 -1.229349 -1.654077 -2.021936 -2.330620 -2.589453 -2.809931 -3.001290 -3.170097 -3.320967 -3.457249 -3.581427 -3.695414 -3.800693 -3.898468 -3.989701 -4.075189 -4.155585 -4.231434 0.000000 -0.3207674 -0.7323623 -1.168466 -1.578458 -1.936805 -2.239773 -2.494954 -2.712656 -2.901635 -3.068305 -3.217226 -3.351718 -3.474245 -3.586702 -3.690562 -3.787012 -3.877011 -3.961343 -4.040655 -4.115485 0.000000 -0.3011123 -0.6904258 -1.106125 -1.500727 -1.849137 -2.146189 -2.397740 -2.612853 -2.799703 -2.964501 -3.111736 -3.244692 -3.365813 -3.476977 -3.579644 -3.674989 -3.763963 -3.847340 -3.925761 -3.999756 0.000000 -0.2812318 -0.6476850 -1.042199 -1.420594 -1.758440 -2.049227 -2.297051 -2.509667 -2.694568 -2.857702 -3.003456 -3.135077 -3.254984 -3.365039 -3.466687 -3.561094 -3.649199 -3.731772 -3.809444 -3.882742 0.000000 -0.2611206 -0.6041018 -0.9765536 -1.337755 -1.664192 -1.948176 -2.192035 -2.402143 -2.585207 -2.746829 -2.891267 -3.021714 -3.140558 -3.249648 -3.350414 -3.444011 -3.531371 -3.613255 -3.690289 -3.762993 0.000000 -0.2407738 -0.5596359 -0.9090539 -1.251897 -1.565833 -1.842238 -2.081716 -2.289178 -2.470435 -2.630648 -2.773895 -2.903294 -3.021200 -3.129440 -3.229433 -3.322324 -3.409035 -3.490321 -3.566802 -3.638994 0.000000 -0.2201862 -0.5142464 -0.8395549 -1.162687 -1.462760 -1.730515 -1.964950 -2.169459 -2.348831 -2.507678 -2.649819 -2.778267 -2.895333 -3.002818 -3.102125 -3.194394 -3.280535 -3.361296 -3.437293 -3.509038 0.000000 -0.1993533 -0.4678922 -0.7679098 -1.069773 -1.354314 -1.611988 -1.840394 -2.041398 -2.218647 -2.376071 -2.517140 -2.644706 -2.761007 -2.867812 -2.966508 -3.058222 -3.143854 -3.224152 -3.299720 -3.371070 0.000000 -0.1782700 -0.4205306 -0.6939672 -0.9727832 -1.239777 -1.485502 -1.706452 -1.903037 -2.077674 -2.233464 -2.373406 -2.500107 -2.615690 -2.721874 -2.820015 -2.911228 -2.996407 -3.076288 -3.151475 -3.222474 0.000000 -0.1569318 -0.3721181 -0.6175689 -0.8713236 -1.118368 -1.349750 -1.561233 -1.751954 -1.923075 -2.076741 -2.215328 -2.341086 -2.455949 -2.561538 -2.659166 -2.749922 -2.834688 -2.914196 -2.989039 -3.059721 0.000000 -0.1353336 -0.3226115 -0.5385523 -0.7649838 -0.9892431 -1.203258 -1.402499 -1.585137 -1.751171 -1.901714 -2.038375 -2.162897 -2.276906 -2.381860 -2.478977 -2.569297 -2.653682 -2.732844 -2.807376 -2.877772 0.000000 -0.1134700 -0.2719644 -0.4567521 -0.6533382 -0.8515038 -1.044389 -1.227642 -1.398881 -1.557190 -1.702697 -1.836152 -1.958643 -2.071346 -2.175418 -2.271907 -2.361748 -2.445740 -2.524569 -2.598807 -2.668936 0.000000 -9.1336355E-02 -0.2201298 -0.3719971 -0.5359457 -0.7042030 -0.8713633 -1.033681 -1.188712 -1.335021 -1.471985 -1.599555 -1.718087 -1.828169 -1.930512 -2.025846 -2.114894 -2.198323 -2.276726 -2.350628 -2.420480 0.000000 -6.8927601E-02 -0.1670644 -0.2841185 -0.4123612 -0.5463657 -0.6822950 -0.8173294 -0.9494206 -1.077105 -1.199423 -1.315804 -1.426008 -1.530025 -1.628033 -1.720308 -1.807220 -1.889160 -1.966522 -2.039684 -2.109000 0.000000 -4.6238828E-02 -0.1127219 -0.1929409 -0.2821337 -0.3770123 -0.4752608 -0.5751299 -0.6752778 -0.7746392 -0.8723945 -0.9679041 -1.060707 -1.150467 -1.236980 -1.320121 -1.399869 -1.476252 -1.549348 -1.619263 -1.686124 0.000000 -2.3264602E-02 -5.7052549E-02 -9.8288946E-02 -0.1448254 -0.1951867 -0.2483941 -0.3036914 -0.3605061 -0.4183607 -0.4768718 -0.5357056 -0.5945944 -0.6532950 -0.7116166 -0.7693846 -0.8264681 -0.8827461 -0.9381261 -0.9925250 -1.045871 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4161993 -0.9327227 -1.463635 -1.945463 -2.351356 -2.684084 -2.960698 -3.196606 -3.402200 -3.584378 -3.747891 -3.896178 -4.031784 -4.156678 -4.272391 -4.380166 -4.480998 -4.575717 -4.665002 -4.749421 0.000000 -0.3975700 -0.8940997 -1.407025 -1.874897 -2.271326 -2.597807 -2.869322 -3.100500 -3.301559 -3.479354 -3.638620 -3.782781 -3.914376 -4.035365 -4.147270 -4.251328 -4.348530 -4.439700 -4.525513 -4.606533 0.000000 -0.3787379 -0.8548641 -1.349476 -1.803431 -2.190549 -2.511104 -2.778103 -3.005265 -3.202570 -3.376815 -3.532709 -3.673658 -3.802190 -3.920251 -4.029353 -4.130724 -4.225348 -4.314040 -4.397470 -4.476194 0.000000 -0.3596989 -0.8149818 -1.290863 -1.730763 -2.108611 -2.423413 -2.686312 -2.909991 -3.104125 -3.275424 -3.428564 -3.566931 -3.693035 -3.808805 -3.915744 -4.015068 -4.107751 -4.194601 -4.276278 -4.353333 0.000000 -0.3404492 -0.7744167 -1.231062 -1.656596 -2.025088 -2.334189 -2.593258 -2.813854 -3.005258 -3.174065 -3.324908 -3.461144 -3.585265 -3.699188 -3.804399 -3.902103 -3.993263 -4.078680 -4.159005 -4.234784 0.000000 -0.3209849 -0.7331313 -1.169950 -1.580639 -1.939537 -2.242869 -2.498257 -2.716059 -2.905071 -3.071734 -3.220623 -3.355067 -3.477536 -3.589930 -3.693722 -3.790106 -3.880036 -3.964301 -4.043547 -4.118312 0.000000 -0.3013008 -0.6910887 -1.107401 -1.502602 -1.851489 -2.148861 -2.400596 -2.615797 -2.802674 -2.967463 -3.114664 -3.247574 -3.368640 -3.479745 -3.582350 -3.677633 -3.766544 -3.849859 -3.928220 -4.002157 0.000000 -0.2813934 -0.6482509 -1.043285 -1.422191 -1.760449 -2.051518 -2.299507 -2.512203 -2.697129 -2.860253 -3.005977 -3.137556 -3.257412 -3.367413 -3.469005 -3.563355 -3.651405 -3.733922 -3.811541 -3.884787 0.000000 -0.2612576 -0.6045792 -0.9774672 -1.339100 -1.665891 -1.950123 -2.194132 -2.404314 -2.587402 -2.749018 -2.893430 -3.023839 -3.142639 -3.251681 -3.352397 -3.445945 -3.533256 -3.615091 -3.692077 -3.764735 0.000000 -0.2408884 -0.5600330 -0.9098125 -1.253015 -1.567253 -1.843875 -2.083487 -2.291019 -2.472302 -2.632513 -2.775739 -2.905107 -3.022975 -3.131175 -3.231124 -3.323972 -3.410640 -3.491884 -3.568324 -3.640476 0.000000 -0.2202804 -0.5145715 -0.8401746 -1.163603 -1.463928 -1.731870 -1.966427 -2.171004 -2.350404 -2.509252 -2.651378 -2.779802 -2.896837 -3.004288 -3.103559 -3.195791 -3.281895 -3.362621 -3.438582 -3.510293 0.000000 -0.1994292 -0.4681530 -0.7684061 -1.070508 -1.355257 -1.613090 -1.841604 -2.042672 -2.219952 -2.377383 -2.518444 -2.645991 -2.762267 -2.869045 -2.967712 -3.059395 -3.144997 -3.225264 -3.300803 -3.372125 0.000000 -0.1783297 -0.4207347 -0.6943550 -0.9733586 -1.240520 -1.486377 -1.707422 -1.904067 -2.078735 -2.234538 -2.374477 -2.501166 -2.616732 -2.722894 -2.821012 -2.912201 -2.997356 -3.077213 -3.152375 -3.223351 0.000000 -0.1569773 -0.3722730 -0.6178625 -0.8717602 -1.118935 -1.350423 -1.561987 -1.752762 -1.923916 -2.077597 -2.216188 -2.341940 -2.456791 -2.562366 -2.659977 -2.750715 -2.835462 -2.914950 -2.989775 -3.060438 0.000000 -0.1353669 -0.3227242 -0.5387655 -0.7653015 -0.9896578 -1.203755 -1.403062 -1.585747 -1.751812 -1.902373 -2.039042 -2.163564 -2.277569 -2.382513 -2.479619 -2.569927 -2.654298 -2.733446 -2.807964 -2.878345 0.000000 -0.1134930 -0.2720420 -0.4568986 -0.6535567 -0.8517905 -1.044735 -1.228038 -1.399316 -1.557652 -1.703178 -1.836644 -1.959140 -2.071843 -2.175912 -2.272394 -2.362227 -2.446211 -2.525031 -2.599259 -2.669379 0.000000 -9.1350980E-02 -0.2201790 -0.3720897 -0.5360841 -0.7043852 -0.8715853 -1.033938 -1.188997 -1.335328 -1.472309 -1.599890 -1.718430 -1.828516 -1.930860 -2.026192 -2.115237 -2.198662 -2.277061 -2.350957 -2.420803 0.000000 -6.8935774E-02 -0.1670918 -0.2841701 -0.4124381 -0.5464673 -0.6824196 -0.8174747 -0.9495838 -1.077283 -1.199614 -1.316005 -1.426216 -1.530238 -1.628250 -1.720527 -1.807440 -1.889379 -1.966740 -2.039900 -2.109214 0.000000 -4.6242449E-02 -0.1127339 -0.1929634 -0.2821674 -0.3770570 -0.4753158 -0.5751945 -0.6753510 -0.7747203 -0.8724824 -0.9679979 -1.060806 -1.150570 -1.237086 -1.320230 -1.399981 -1.476365 -1.549462 -1.619378 -1.686239 0.000000 -2.3265457E-02 -5.7055514E-02 -9.8294534E-02 -0.1448337 -0.1951978 -0.2484077 -0.3037074 -0.3605244 -0.4183811 -0.4768941 -0.5357298 -0.5946202 -0.6533223 -0.7116452 -0.7694144 -0.8264990 -0.8827780 -0.9381590 -0.9925587 -1.045905 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4166729 -0.9344426 -1.467026 -1.950519 -2.357728 -2.691331 -2.968511 -3.204803 -3.410667 -3.593038 -3.756694 -3.905086 -4.040769 -4.165720 -4.281472 -4.389274 -4.490124 -4.584852 -4.674140 -4.758557 0.000000 -0.3979948 -0.8956317 -1.410024 -1.879340 -2.276902 -2.604122 -2.876089 -3.107544 -3.308771 -3.486666 -3.645983 -3.790163 -3.921753 -4.042718 -4.154588 -4.258600 -4.355750 -4.446862 -4.532612 -4.613567 0.000000 -0.3791172 -0.8562220 -1.352119 -1.807328 -2.195422 -2.516610 -2.783980 -3.011348 -3.208760 -3.383049 -3.538945 -3.679868 -3.808355 -3.926356 -4.035390 -4.136687 -4.231232 -4.319842 -4.403188 -4.481830 0.000000 -0.3600352 -0.8161784 -1.293180 -1.734168 -2.112861 -2.428212 -2.691422 -2.915260 -3.109462 -3.280773 -3.433889 -3.572208 -3.698247 -3.813943 -3.920803 -4.020042 -4.112638 -4.199400 -4.280990 -4.357959 0.000000 -0.3407454 -0.7754642 -1.233082 -1.659558 -2.028784 -2.338362 -2.597698 -2.818423 -3.009872 -3.178674 -3.329478 -3.465657 -3.589708 -3.703552 -3.808680 -3.906300 -3.997375 -4.082706 -4.162947 -4.238643 0.000000 -0.3212438 -0.7340416 -1.171699 -1.583201 -1.942735 -2.246485 -2.502107 -2.720018 -2.909062 -3.075711 -3.224556 -3.358941 -3.481339 -3.593657 -3.697370 -3.793673 -3.883523 -3.967708 -4.046875 -4.121563 0.000000 -0.3015251 -0.6918730 -1.108902 -1.504801 -1.854240 -2.151979 -2.403922 -2.619219 -2.806121 -2.970893 -3.118052 -3.250905 -3.371904 -3.482938 -3.585469 -3.680677 -3.769514 -3.852758 -3.931047 -4.004915 0.000000 -0.2815857 -0.6489196 -1.044562 -1.424063 -1.762797 -2.054189 -2.302364 -2.515148 -2.700098 -2.863206 -3.008891 -3.140418 -3.260214 -3.370150 -3.471675 -3.565958 -3.653942 -3.736394 -3.813950 -3.887135 0.000000 -0.2614207 -0.6051432 -0.9785414 -1.340676 -1.667876 -1.952392 -2.196568 -2.406832 -2.589945 -2.751549 -2.895928 -3.026291 -3.145038 -3.254023 -3.354680 -3.448169 -3.535421 -3.617199 -3.694131 -3.766735 0.000000 -0.2410246 -0.5605021 -0.9107038 -1.254325 -1.568910 -1.845780 -2.085544 -2.293155 -2.474464 -2.634669 -2.777869 -2.907197 -3.025021 -3.133171 -3.233069 -3.325866 -3.412484 -3.493679 -3.570070 -3.642176 0.000000 -0.2203925 -0.5149552 -0.8409023 -1.164674 -1.465291 -1.733447 -1.968141 -2.172793 -2.352222 -2.511070 -2.653178 -2.781571 -2.898568 -3.005978 -3.105206 -3.197395 -3.283456 -3.364140 -3.440060 -3.511731 0.000000 -0.1995195 -0.4684607 -0.7689887 -1.071368 -1.356356 -1.614371 -1.843008 -2.044147 -2.221460 -2.378897 -2.519946 -2.647471 -2.763718 -2.870463 -2.969095 -3.060742 -3.146308 -3.226541 -3.302045 -3.373333 0.000000 -0.1784007 -0.4209754 -0.6948099 -0.9740310 -1.241384 -1.487394 -1.708546 -1.905258 -2.079962 -2.235776 -2.375711 -2.502385 -2.617930 -2.724067 -2.822158 -2.913318 -2.998444 -3.078272 -3.153407 -3.224355 0.000000 -0.1570314 -0.3724555 -0.6182067 -0.8722700 -1.119594 -1.351205 -1.562860 -1.753697 -1.924886 -2.078585 -2.217178 -2.342923 -2.457761 -2.563317 -2.660908 -2.751625 -2.836349 -2.915815 -2.990618 -3.061259 0.000000 -0.1354063 -0.3228570 -0.5390155 -0.7656724 -0.9901402 -1.204332 -1.403713 -1.586451 -1.752552 -1.903133 -2.039810 -2.164331 -2.278329 -2.383263 -2.480355 -2.570648 -2.655003 -2.734135 -2.808636 -2.879001 0.000000 -0.1135203 -0.2721333 -0.4570702 -0.6538115 -0.8521237 -1.045137 -1.228496 -1.399818 -1.558186 -1.703733 -1.837211 -1.959711 -2.072413 -2.176478 -2.272954 -2.362778 -2.446751 -2.525560 -2.599777 -2.669885 0.000000 -9.1368414E-02 -0.2202369 -0.3721982 -0.5362455 -0.7045970 -0.8718427 -1.034234 -1.189326 -1.335683 -1.472683 -1.600277 -1.718825 -1.828915 -1.931259 -2.026589 -2.115631 -2.199051 -2.277444 -2.351333 -2.421172 0.000000 -6.8945549E-02 -0.1671241 -0.2842303 -0.4125278 -0.5465854 -0.6825641 -0.8176426 -0.9497722 -1.077489 -1.199834 -1.316236 -1.426456 -1.530483 -1.628499 -1.720778 -1.807692 -1.889630 -1.966990 -2.040147 -2.109458 0.000000 -4.6246756E-02 -0.1127481 -0.1929899 -0.2822067 -0.3771089 -0.4753796 -0.5752691 -0.6754355 -0.7748137 -0.8725836 -0.9681058 -1.060920 -1.150689 -1.237209 -1.320356 -1.400108 -1.476494 -1.549592 -1.619509 -1.686370 0.000000 -2.3266554E-02 -5.7059046E-02 -9.8301046E-02 -0.1448434 -0.1952105 -0.2484234 -0.3037260 -0.3605454 -0.4184045 -0.4769198 -0.5357574 -0.5946496 -0.6533536 -0.7116780 -0.7694486 -0.8265345 -0.8828146 -0.9381966 -0.9925972 -1.045944 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4172534 -0.9365391 -1.471144 -1.956644 -2.365428 -2.700070 -2.977916 -3.214655 -3.420830 -3.603425 -3.767243 -3.915752 -4.051520 -4.176532 -4.292328 -4.400157 -4.501024 -4.595759 -4.685048 -4.769459 0.000000 -0.3985155 -0.8974977 -1.413663 -1.884714 -2.283626 -2.611720 -2.884212 -3.115985 -3.317402 -3.495404 -3.654773 -3.798966 -3.930541 -4.051472 -4.163292 -4.267244 -4.364326 -4.455363 -4.541036 -4.621909 0.000000 -0.3795814 -0.8578744 -1.355321 -1.812032 -2.201289 -2.523222 -2.791020 -3.018621 -3.216148 -3.390478 -3.546367 -3.687251 -3.815675 -3.933600 -4.042547 -4.143749 -4.238195 -4.326705 -4.409948 -4.488486 0.000000 -0.3604469 -0.8176333 -1.295985 -1.738273 -2.117970 -2.433963 -2.697531 -2.921547 -3.115820 -3.287135 -3.440213 -3.578466 -3.704423 -3.820025 -3.926783 -4.025918 -4.118407 -4.205062 -4.286545 -4.363409 0.000000 -0.3411077 -0.7767370 -1.235525 -1.663125 -2.033219 -2.343355 -2.602998 -2.823865 -3.015358 -3.184144 -3.334896 -3.471000 -3.594961 -3.708707 -3.813733 -3.911248 -4.002218 -4.087445 -4.167583 -4.243179 0.000000 -0.3215604 -0.7351468 -1.173811 -1.586282 -1.946568 -2.250807 -2.506696 -2.724726 -2.913800 -3.080424 -3.229213 -3.363520 -3.485831 -3.598053 -3.701669 -3.797872 -3.887624 -3.971712 -4.050785 -4.125381 0.000000 -0.3017992 -0.6928243 -1.110715 -1.507444 -1.857534 -2.155701 -2.407882 -2.623284 -2.810209 -2.974954 -3.122058 -3.254837 -3.375753 -3.486699 -3.589140 -3.684258 -3.773005 -3.856161 -3.934365 -4.008150 0.000000 -0.2818207 -0.6497307 -1.046102 -1.426309 -1.765606 -2.057374 -2.305763 -2.518643 -2.703614 -2.866698 -3.012332 -3.143793 -3.263514 -3.373370 -3.474814 -3.569016 -3.656920 -3.739294 -3.816774 -3.889885 0.000000 -0.2616197 -0.6058264 -0.9798354 -1.342566 -1.670248 -1.955094 -2.199464 -2.409819 -2.592955 -2.754540 -2.898875 -3.029181 -3.147861 -3.256777 -3.357362 -3.450779 -3.537961 -3.619671 -3.696535 -3.769076 0.000000 -0.2411910 -0.5610699 -0.9117768 -1.255894 -1.570888 -1.848047 -2.087986 -2.295684 -2.477021 -2.637214 -2.780379 -2.909659 -3.027426 -3.135516 -3.235353 -3.328088 -3.414645 -3.495780 -3.572114 -3.644165 0.000000 -0.2205291 -0.5154195 -0.8417777 -1.165956 -1.466916 -1.735322 -1.970175 -2.174910 -2.354371 -2.513216 -2.655298 -2.783652 -2.900603 -3.007963 -3.107139 -3.199276 -3.285285 -3.365918 -3.441789 -3.513413 0.000000 -0.1996296 -0.4688329 -0.7696888 -1.072396 -1.357666 -1.615894 -1.844673 -2.045893 -2.223241 -2.380682 -2.521715 -2.649212 -2.765422 -2.872127 -2.970716 -3.062320 -3.147844 -3.228034 -3.303497 -3.374746 0.000000 -0.1784872 -0.4212665 -0.6953563 -0.9748348 -1.242414 -1.488601 -1.709878 -1.906667 -2.081409 -2.237235 -2.377163 -2.503818 -2.619337 -2.725443 -2.823500 -2.914626 -2.999717 -3.079511 -3.154613 -3.225528 0.000000 -0.1570972 -0.3726760 -0.6186200 -0.8728791 -1.120379 -1.352133 -1.563894 -1.754801 -1.926031 -2.079748 -2.218342 -2.344078 -2.458898 -2.564433 -2.661999 -2.752689 -2.837387 -2.916826 -2.991603 -3.062218 0.000000 -0.1354545 -0.3230174 -0.5393155 -0.7661152 -0.9907141 -1.205016 -1.404483 -1.587283 -1.753424 -1.904028 -2.040713 -2.165232 -2.279222 -2.384142 -2.481218 -2.571492 -2.655828 -2.734940 -2.809422 -2.879767 0.000000 -0.1135536 -0.2722435 -0.4572759 -0.6541158 -0.8525199 -1.045614 -1.229039 -1.400411 -1.558815 -1.704385 -1.837876 -1.960382 -2.073083 -2.177142 -2.273608 -2.363421 -2.447383 -2.526178 -2.600381 -2.670475 0.000000 -9.1389574E-02 -0.2203067 -0.3723283 -0.5364379 -0.7048487 -0.8721477 -1.034585 -1.189714 -1.336100 -1.473122 -1.600730 -1.719287 -1.829382 -1.931726 -2.027055 -2.116092 -2.199505 -2.277891 -2.351773 -2.421603 0.000000 -6.8957359E-02 -0.1671630 -0.2843026 -0.4126346 -0.5467256 -0.6827350 -0.8178411 -0.9499945 -1.077731 -1.200093 -1.316507 -1.426737 -1.530771 -1.628791 -1.721072 -1.807986 -1.889924 -1.967281 -2.040435 -2.109743 0.000000 -4.6252001E-02 -0.1127652 -0.1930216 -0.2822536 -0.3771705 -0.4754550 -0.5753573 -0.6755351 -0.7749236 -0.8727025 -0.9682325 -1.061053 -1.150827 -1.237352 -1.320502 -1.400258 -1.476645 -1.549745 -1.619662 -1.686523 0.000000 -2.3267835E-02 -5.7063274E-02 -9.8308869E-02 -0.1448549 -0.1952257 -0.2484420 -0.3037478 -0.3605703 -0.4184321 -0.4769499 -0.5357900 -0.5946843 -0.6533901 -0.7117164 -0.7694886 -0.8265759 -0.8828573 -0.9382404 -0.9926420 -1.045990 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4179914 -0.9391875 -1.476322 -1.964322 -2.375054 -2.710963 -2.989616 -3.226888 -3.433432 -3.616288 -3.780293 -3.928936 -4.064800 -4.189879 -4.305719 -4.413576 -4.514457 -4.609196 -4.698480 -4.782880 0.000000 -0.3991770 -0.8998521 -1.418232 -1.891435 -2.292009 -2.621163 -2.894284 -3.126427 -3.328059 -3.506176 -3.665595 -3.809791 -3.941336 -4.062213 -4.173963 -4.277833 -4.374822 -4.465761 -4.551331 -4.632098 0.000000 -0.3801711 -0.8599572 -1.359336 -1.817904 -2.208587 -2.531420 -2.799724 -3.027591 -3.225242 -3.399607 -3.555472 -3.696294 -3.824632 -3.942452 -4.051282 -4.152361 -4.246679 -4.335058 -4.418170 -4.496577 0.000000 -0.3609692 -0.8194652 -1.299496 -1.743389 -2.124313 -2.441079 -2.705066 -2.929283 -3.123625 -3.294930 -3.447948 -3.586111 -3.711956 -3.827435 -3.934062 -4.033062 -4.125415 -4.211933 -4.293281 -4.370012 0.000000 -0.3415674 -0.7783380 -1.238578 -1.667562 -2.038716 -2.349522 -2.609523 -2.830548 -3.022079 -3.190832 -3.341509 -3.477510 -3.601354 -3.714973 -3.819868 -3.917249 -4.008087 -4.093183 -4.173193 -4.248663 0.000000 -0.3219618 -0.7365356 -1.176449 -1.590109 -1.951311 -2.256135 -2.512336 -2.730498 -2.919595 -3.086177 -3.234886 -3.369091 -3.491286 -3.603387 -3.706878 -3.802956 -3.892584 -3.976552 -4.055506 -4.129988 0.000000 -0.3021466 -0.6940189 -1.112975 -1.510722 -1.861603 -2.160284 -2.412741 -2.628259 -2.815201 -2.979904 -3.126930 -3.259613 -3.380422 -3.491256 -3.593582 -3.688586 -3.777221 -3.860267 -3.938365 -4.012048 0.000000 -0.2821184 -0.6507481 -1.048020 -1.429093 -1.769072 -2.061290 -2.309928 -2.522915 -2.707902 -2.870948 -3.016514 -3.147887 -3.267511 -3.377266 -3.478608 -3.572708 -3.660512 -3.742789 -3.820175 -3.893195 0.000000 -0.2618718 -0.6066831 -0.9814461 -1.344905 -1.673171 -1.958412 -2.203008 -2.413465 -2.596620 -2.758176 -2.902452 -3.032681 -3.151278 -3.260104 -3.360600 -3.453928 -3.541022 -3.622647 -3.699429 -3.771890 0.000000 -0.2414014 -0.5617813 -0.9131110 -1.257835 -1.573324 -1.850828 -2.090973 -2.298769 -2.480131 -2.640305 -2.783422 -2.912639 -3.030334 -3.138348 -3.238108 -3.330766 -3.417247 -3.498309 -3.574572 -3.646554 0.000000 -0.2207020 -0.5160007 -0.8428653 -1.167541 -1.468915 -1.737620 -1.972659 -2.177491 -2.356984 -2.515819 -2.657866 -2.786169 -2.903062 -3.010358 -3.109469 -3.201541 -3.287486 -3.368057 -3.443867 -3.515433 0.000000 -0.1997688 -0.4692985 -0.7705581 -1.073664 -1.359275 -1.617758 -1.846704 -2.048018 -2.225405 -2.382847 -2.523857 -2.651315 -2.767480 -2.874133 -2.972669 -3.064220 -3.149690 -3.229828 -3.305241 -3.376441 0.000000 -0.1785965 -0.4216303 -0.6960341 -0.9758262 -1.243679 -1.490078 -1.711502 -1.908380 -2.083166 -2.239003 -2.378920 -2.505549 -2.621034 -2.727100 -2.825117 -2.916199 -3.001248 -3.081000 -3.156060 -3.226935 0.000000 -0.1571804 -0.3729515 -0.6191323 -0.8736298 -1.121342 -1.353268 -1.565154 -1.756143 -1.927420 -2.081156 -2.219750 -2.345472 -2.460269 -2.565776 -2.663311 -2.753969 -2.838634 -2.918040 -2.992784 -3.063367 0.000000 -0.1355152 -0.3232176 -0.5396870 -0.7666606 -0.9914177 -1.205852 -1.405422 -1.588294 -1.754482 -1.905110 -2.041804 -2.166319 -2.280297 -2.385200 -2.482255 -2.572507 -2.656819 -2.735906 -2.810363 -2.880685 0.000000 -0.1135955 -0.2723810 -0.4575305 -0.6544901 -0.8530052 -1.046195 -1.229698 -1.401130 -1.559577 -1.705174 -1.838680 -1.961190 -2.073889 -2.177940 -2.274395 -2.364195 -2.448140 -2.526920 -2.601105 -2.671183 0.000000 -9.1416225E-02 -0.2203938 -0.3724891 -0.5366744 -0.7051568 -0.8725197 -1.035011 -1.190185 -1.336606 -1.473652 -1.601278 -1.719845 -1.829944 -1.932289 -2.027613 -2.116645 -2.200051 -2.278427 -2.352299 -2.422119 0.000000 -6.8972304E-02 -0.1672115 -0.2843918 -0.4127660 -0.5468972 -0.6829435 -0.8180823 -0.9502639 -1.078024 -1.200405 -1.316834 -1.427075 -1.531117 -1.629141 -1.721425 -1.808339 -1.890275 -1.967630 -2.040781 -2.110084 0.000000 -4.6258617E-02 -0.1127866 -0.1930607 -0.2823111 -0.3772458 -0.4755468 -0.5754644 -0.6756559 -0.7750565 -0.8728460 -0.9683851 -1.061213 -1.150994 -1.237524 -1.320678 -1.400437 -1.476826 -1.549927 -1.619845 -1.686706 0.000000 -2.3269484E-02 -5.7068575E-02 -9.8318540E-02 -0.1448691 -0.1952442 -0.2484647 -0.3037743 -0.3606004 -0.4184655 -0.4769863 -0.5358291 -0.5947260 -0.6534341 -0.7117625 -0.7695366 -0.8266256 -0.8829084 -0.9382930 -0.9926957 -1.046045 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4189807 -0.9427076 -1.483167 -1.974428 -2.387677 -2.725203 -3.004866 -3.242799 -3.449793 -3.632962 -3.797189 -3.945988 -4.081960 -4.207111 -4.322997 -4.430878 -4.531767 -4.626503 -4.715772 -4.800150 0.000000 -0.4000629 -0.9029768 -1.424256 -1.900256 -2.302966 -2.633459 -2.907356 -3.139943 -3.341821 -3.520060 -3.679517 -3.823695 -3.955182 -4.075974 -4.187618 -4.291367 -4.388226 -4.479028 -4.564455 -4.645077 0.000000 -0.3809602 -0.8627173 -1.364619 -1.825592 -2.218097 -2.542060 -2.810980 -3.039157 -3.236937 -3.411319 -3.567131 -3.707854 -3.836062 -3.953732 -4.062400 -4.163309 -4.257452 -4.345654 -4.428588 -4.506819 0.000000 -0.3616679 -0.8218899 -1.304109 -1.750070 -2.132556 -2.450289 -2.714783 -2.939225 -3.133628 -3.304896 -3.457818 -3.595845 -3.721534 -3.836840 -3.943288 -4.042106 -4.134275 -4.220612 -4.301781 -4.378336 0.000000 -0.3421817 -0.7804542 -1.242582 -1.673346 -2.045843 -2.357484 -2.617915 -2.839114 -3.030670 -3.199360 -3.349922 -3.485778 -3.609458 -3.722904 -3.827621 -3.924825 -4.015486 -4.100409 -4.180250 -4.255556 0.000000 -0.3224977 -0.7383693 -1.179902 -1.595089 -1.957450 -2.262999 -2.519575 -2.737881 -2.926984 -3.093495 -3.242087 -3.376148 -3.498186 -3.610122 -3.713446 -3.809359 -3.898824 -3.982632 -4.061433 -4.135766 0.000000 -0.3026102 -0.6955943 -1.115930 -1.514980 -1.866861 -2.166176 -2.418966 -2.634610 -2.821554 -2.986187 -3.133103 -3.265652 -3.386316 -3.496998 -3.599172 -3.694026 -3.782514 -3.865417 -3.943377 -4.016927 0.000000 -0.2825153 -0.6520885 -1.050525 -1.432704 -1.773541 -2.066317 -2.315255 -2.528359 -2.713351 -2.876336 -3.021802 -3.153055 -3.272549 -3.382170 -3.483376 -3.577343 -3.665016 -3.747166 -3.824430 -3.897334 0.000000 -0.2622077 -0.6078103 -0.9835464 -1.347935 -1.676934 -1.962665 -2.207534 -2.418104 -2.601272 -2.762778 -2.906970 -3.037095 -3.155578 -3.264287 -3.364664 -3.457875 -3.544855 -3.626369 -3.703046 -3.775405 0.000000 -0.2416818 -0.5627165 -0.9148487 -1.260345 -1.576456 -1.854387 -2.094781 -2.302690 -2.484074 -2.644212 -2.787261 -2.916391 -3.033990 -3.141903 -3.241561 -3.334119 -3.420501 -3.501469 -3.577640 -3.649535 0.000000 -0.2209321 -0.5167641 -0.8442802 -1.169588 -1.471482 -1.740557 -1.975823 -2.180766 -2.360291 -2.519106 -2.661101 -2.789336 -2.906149 -3.013361 -3.112387 -3.204374 -3.290236 -3.370726 -3.446460 -3.517951 0.000000 -0.1999539 -0.4699093 -0.7716876 -1.075301 -1.361340 -1.620139 -1.849288 -2.050712 -2.228140 -2.385577 -2.526553 -2.653959 -2.770061 -2.876647 -2.975113 -3.066594 -3.151995 -3.232067 -3.307415 -3.378552 0.000000 -0.1787418 -0.4221071 -0.6969141 -0.9771038 -1.245300 -1.491962 -1.713566 -1.910550 -2.085385 -2.241231 -2.381129 -2.507723 -2.623161 -2.729176 -2.827137 -2.918165 -3.003158 -3.082855 -3.157862 -3.228687 0.000000 -0.1572910 -0.3733124 -0.6197967 -0.8745962 -1.122575 -1.354714 -1.566754 -1.757842 -1.929173 -2.082929 -2.221519 -2.347220 -2.461987 -2.567457 -2.664951 -2.755568 -2.840189 -2.919553 -2.994255 -3.064798 0.000000 -0.1355959 -0.3234796 -0.5401684 -0.7673620 -0.9923176 -1.206916 -1.406612 -1.589573 -1.755815 -1.906472 -2.043174 -2.167683 -2.281644 -2.386523 -2.483551 -2.573773 -2.658054 -2.737110 -2.811535 -2.881826 0.000000 -0.1136512 -0.2725609 -0.4578602 -0.6549711 -0.8536254 -1.046935 -1.230535 -1.402040 -1.560537 -1.706167 -1.839689 -1.962204 -2.074898 -2.178938 -2.275378 -2.365159 -2.449085 -2.527843 -2.602007 -2.672062 0.000000 -9.1451623E-02 -0.2205077 -0.3726971 -0.5369782 -0.7055502 -0.8729925 -1.035552 -1.190779 -1.337242 -1.474319 -1.601965 -1.720544 -1.830647 -1.932991 -2.028311 -2.117334 -2.200730 -2.279094 -2.352954 -2.422760 0.000000 -6.8992101E-02 -0.1672747 -0.2845072 -0.4129344 -0.5471161 -0.6832083 -0.8183875 -0.9506039 -1.078393 -1.200797 -1.317244 -1.427498 -1.531549 -1.629579 -1.721865 -1.808779 -1.890713 -1.968064 -2.041210 -2.110508 0.000000 -4.6267357E-02 -0.1128143 -0.1931113 -0.2823848 -0.3773417 -0.4756635 -0.5755998 -0.6758083 -0.7752237 -0.8730262 -0.9685765 -1.061414 -1.151203 -1.237738 -1.320898 -1.400660 -1.477052 -1.550154 -1.620072 -1.686933 0.000000 -2.3271680E-02 -5.7075456E-02 -9.8330967E-02 -0.1448872 -0.1952678 -0.2484934 -0.3038078 -0.3606383 -0.4185074 -0.4770321 -0.5358782 -0.5947782 -0.6534891 -0.7118200 -0.7695963 -0.8266873 -0.8829721 -0.9383582 -0.9927624 -1.046113 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4204202 -0.9477708 -1.492936 -1.988774 -2.405510 -2.745231 -3.026236 -3.265030 -3.472599 -3.656161 -3.820656 -3.969639 -4.105732 -4.230959 -4.346885 -4.454782 -4.555665 -4.650380 -4.739615 -4.823951 0.000000 -0.4013506 -0.9074619 -1.432829 -1.912727 -2.318370 -2.650659 -2.925560 -3.158697 -3.360858 -3.539214 -3.698681 -3.842795 -3.974168 -4.094811 -4.206281 -4.309840 -4.406497 -4.497089 -4.582302 -4.662707 0.000000 -0.3821059 -0.8666713 -1.372116 -1.836421 -2.231411 -2.556874 -2.826578 -3.055119 -3.253020 -3.427378 -3.583075 -3.723626 -3.851624 -3.969061 -4.077481 -4.178134 -4.272018 -4.359961 -4.442638 -4.520615 0.000000 -0.3626812 -0.8253567 -1.310636 -1.759452 -2.144056 -2.463062 -2.728192 -2.952887 -3.147324 -3.318498 -3.471249 -3.609060 -3.734505 -3.849554 -3.955737 -4.054287 -4.146192 -4.232267 -4.313179 -4.389485 0.000000 -0.3430718 -0.7834747 -1.248236 -1.681444 -2.055754 -2.368490 -2.629456 -2.850842 -3.042387 -3.210954 -3.361327 -3.496957 -3.620391 -3.733581 -3.838041 -3.934988 -4.025397 -4.110074 -4.189677 -4.264752 0.000000 -0.3232737 -0.7409820 -1.184767 -1.602044 -1.965961 -2.272460 -2.529500 -2.747958 -2.937033 -3.103413 -3.251817 -3.385661 -3.507465 -3.619161 -3.722245 -3.817922 -3.907156 -3.990741 -4.069325 -4.143451 0.000000 -0.3032807 -0.6978354 -1.120084 -1.520914 -1.874132 -2.174277 -2.427479 -2.643258 -2.830171 -2.994682 -3.141423 -3.273772 -3.394221 -3.504686 -3.606643 -3.701284 -3.789566 -3.872269 -3.950037 -4.023403 0.000000 -0.2830888 -0.6539922 -1.054041 -1.437724 -1.779709 -2.073213 -2.322523 -2.535754 -2.720725 -2.883603 -3.028915 -3.159989 -3.279293 -3.388720 -3.489734 -3.583513 -3.671004 -3.752978 -3.830074 -3.902816 0.000000 -0.2626925 -0.6094091 -0.9864885 -1.352139 -1.682119 -1.968487 -2.213696 -2.424394 -2.607554 -2.768974 -2.913034 -3.043006 -3.161324 -3.269864 -3.370074 -3.463121 -3.549943 -3.631304 -3.707834 -3.780053 0.000000 -0.2420860 -0.5640411 -0.9172788 -1.263821 -1.580761 -1.859251 -2.099958 -2.307996 -2.489389 -2.649463 -2.792406 -2.921408 -3.038867 -3.146637 -3.246152 -3.338569 -3.424816 -3.505652 -3.581698 -3.653472 0.000000 -0.2212637 -0.5178438 -0.8462557 -1.172418 -1.475005 -1.744564 -1.980116 -2.185192 -2.364744 -2.523518 -2.665433 -2.793564 -2.910263 -3.017356 -3.116262 -3.208131 -3.293878 -3.374257 -3.449884 -3.521273 0.000000 -0.2002205 -0.4707722 -0.7732624 -1.077561 -1.364169 -1.623380 -1.852790 -2.054347 -2.231818 -2.389237 -2.530157 -2.657485 -2.773497 -2.879987 -2.978355 -3.069739 -3.155045 -3.235024 -3.310284 -3.381336 0.000000 -0.1789508 -0.4227801 -0.6981392 -0.9788653 -1.247517 -1.494524 -1.716359 -1.913475 -2.088366 -2.244214 -2.384080 -2.510619 -2.625990 -2.731931 -2.829816 -2.920765 -3.005682 -3.085305 -3.160240 -3.230995 0.000000 -0.1574498 -0.3738210 -0.6207204 -0.8759268 -1.124260 -1.356677 -1.568915 -1.760129 -1.931525 -2.085301 -2.223879 -2.349548 -2.464270 -2.569686 -2.667123 -2.757680 -2.842243 -2.921548 -2.996193 -3.066681 0.000000 -0.1357118 -0.3238485 -0.5408369 -0.7683265 -0.9935454 -1.208360 -1.408219 -1.591292 -1.757602 -1.908291 -2.044999 -2.169496 -2.283431 -2.388277 -2.485266 -2.575446 -2.659683 -2.738696 -2.813079 -2.883328 0.000000 -0.1137311 -0.2728139 -0.4583176 -0.6556316 -0.8544707 -1.047937 -1.231663 -1.403261 -1.561823 -1.707491 -1.841032 -1.963550 -2.076236 -2.180260 -2.276677 -2.366432 -2.450330 -2.529058 -2.603193 -2.673219 0.000000 -9.1502436E-02 -0.2206675 -0.3729855 -0.5373949 -0.7060858 -0.8736326 -1.036279 -1.191577 -1.338094 -1.475209 -1.602879 -1.721471 -1.831579 -1.933920 -2.029232 -2.118243 -2.201625 -2.279973 -2.353815 -2.423603 0.000000 -6.9020458E-02 -0.1673636 -0.2846669 -0.4131653 -0.5474138 -0.6835663 -0.8187984 -0.9510597 -1.078886 -1.201320 -1.317790 -1.428060 -1.532122 -1.630158 -1.722447 -1.809360 -1.891290 -1.968636 -2.041775 -2.111064 0.000000 -4.6279844E-02 -0.1128534 -0.1931811 -0.2824858 -0.3774723 -0.4758210 -0.5757819 -0.6760122 -0.7754470 -0.8732662 -0.9688307 -1.061680 -1.151479 -1.238022 -1.321188 -1.400954 -1.477349 -1.550452 -1.620371 -1.687232 0.000000 -2.3274790E-02 -5.7085048E-02 -9.8348193E-02 -0.1449120 -0.1952998 -0.2485322 -0.3038528 -0.3606890 -0.4185635 -0.4770927 -0.5359433 -0.5948473 -0.6535617 -0.7118959 -0.7696752 -0.8267688 -0.8830559 -0.9384441 -0.9928501 -1.046202 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4228446 -0.9561466 -1.508909 -2.012043 -2.434230 -2.777273 -3.060245 -3.300260 -3.508617 -3.692697 -3.857532 -4.006730 -4.142951 -4.268240 -4.384182 -4.492060 -4.592896 -4.687544 -4.776699 -4.860940 0.000000 -0.4035153 -0.9148559 -1.446776 -1.932820 -2.342986 -2.677935 -2.954244 -3.188090 -3.390560 -3.568983 -3.728363 -3.872289 -4.003407 -4.123749 -4.234888 -4.338096 -4.434391 -4.524613 -4.609454 -4.689487 0.000000 -0.3840286 -0.8731689 -1.384259 -1.853770 -2.252547 -2.580198 -2.850963 -3.079923 -3.277886 -3.452097 -3.607522 -3.747724 -3.875327 -3.992343 -4.100328 -4.200541 -4.293986 -4.381494 -4.463744 -4.541302 0.000000 -0.3643787 -0.8310363 -1.321166 -1.774407 -2.162208 -2.483051 -2.749021 -2.973974 -3.168349 -3.339280 -3.491687 -3.629096 -3.754108 -3.868710 -3.974443 -4.072547 -4.164014 -4.249663 -4.330161 -4.406065 0.000000 -0.3445604 -0.7884094 -1.257322 -1.694295 -2.071322 -2.385624 -2.647286 -2.868846 -3.060275 -3.228568 -3.378581 -3.513806 -3.636815 -3.749574 -3.853605 -3.950132 -4.040133 -4.124416 -4.203638 -4.278347 0.000000 -0.3245692 -0.7452390 -1.192559 -1.613037 -1.979273 -2.287124 -2.544765 -2.763355 -2.952301 -3.118411 -3.266470 -3.399933 -3.521340 -3.632638 -3.735330 -3.830624 -3.919490 -4.002719 -4.080964 -4.154764 0.000000 -0.3043983 -0.7014778 -1.126717 -1.530259 -1.885461 -2.186784 -2.440521 -2.656419 -2.843214 -3.007477 -3.153905 -3.285907 -3.405999 -3.516106 -3.617712 -3.712013 -3.799967 -3.882357 -3.959825 -4.032905 0.000000 -0.2840434 -0.6570788 -1.059636 -1.445605 -1.789286 -2.083822 -2.333620 -2.546974 -2.731850 -2.894514 -3.039551 -3.170321 -3.289310 -3.398422 -3.499127 -3.592607 -3.679811 -3.761512 -3.838345 -3.910839 0.000000 -0.2634984 -0.6119954 -0.9911588 -1.358719 -1.690143 -1.977418 -2.223078 -2.433908 -2.617005 -2.778251 -2.922079 -3.051790 -3.169836 -3.278105 -3.378047 -3.470836 -3.557410 -3.638534 -3.714838 -3.786842 0.000000 -0.2427570 -0.5661793 -0.9211267 -1.269247 -1.587408 -1.866691 -2.107817 -2.316002 -2.497366 -2.657308 -2.800062 -2.928847 -3.046077 -3.153616 -3.252904 -3.345101 -3.431136 -3.511769 -3.587622 -3.659212 0.000000 -0.2218132 -0.5195833 -0.8493763 -1.176824 -1.480429 -1.750678 -1.986619 -2.191855 -2.371411 -2.530095 -2.671864 -2.799821 -2.916332 -3.023234 -3.121951 -3.213634 -3.299203 -3.379411 -3.454875 -3.526109 0.000000 -0.2006617 -0.4721596 -0.7757446 -1.081072 -1.368514 -1.628316 -1.858082 -2.059809 -2.237315 -2.394683 -2.535499 -2.662694 -2.778558 -2.884894 -2.983108 -3.074340 -3.159498 -3.239336 -3.314460 -3.385383 0.000000 -0.1792964 -0.4238599 -0.7000661 -0.9815953 -1.250916 -1.498417 -1.720571 -1.917860 -2.092813 -2.248645 -2.388446 -2.514891 -2.630152 -2.735974 -2.833736 -2.924565 -3.009363 -3.088871 -3.163696 -3.234345 0.000000 -0.1577122 -0.3746356 -0.6221705 -0.8779849 -1.126837 -1.359654 -1.572170 -1.763552 -1.935028 -2.088819 -2.227367 -2.352978 -2.467623 -2.572953 -2.670299 -2.760764 -2.845235 -2.924450 -2.999009 -3.069412 0.000000 -0.1359029 -0.3244385 -0.5418844 -0.7698154 -0.9954202 -1.210546 -1.410634 -1.593861 -1.760260 -1.910987 -2.047694 -2.172163 -2.286054 -2.390844 -2.487770 -2.577884 -2.662055 -2.741001 -2.815319 -2.885504 0.000000 -0.1138626 -0.2732179 -0.4590330 -0.6566496 -0.8557592 -1.049452 -1.233355 -1.405083 -1.563732 -1.709451 -1.843013 -1.965529 -2.078197 -2.182192 -2.278573 -2.368287 -2.452140 -2.530824 -2.604913 -2.674894 0.000000 -9.1585912E-02 -0.2209225 -0.3734356 -0.5380362 -0.7069009 -0.8745981 -1.037370 -1.192766 -1.339356 -1.476523 -1.604225 -1.722833 -1.832944 -1.935278 -2.030575 -2.119567 -2.202925 -2.281248 -2.355062 -2.424823 0.000000 -6.9067016E-02 -0.1675050 -0.2849160 -0.4135201 -0.5478662 -0.6841058 -0.8194132 -0.9517381 -1.079616 -1.202091 -1.318592 -1.428884 -1.532960 -1.631003 -1.723294 -1.810204 -1.892128 -1.969464 -2.042592 -2.111869 0.000000 -4.6300381E-02 -0.1129154 -0.1932900 -0.2826406 -0.3776701 -0.4760582 -0.5760541 -0.6763155 -0.7757774 -0.8736200 -0.9692042 -1.062070 -1.151882 -1.238436 -1.321609 -1.401381 -1.477779 -1.550885 -1.620804 -1.687663 0.000000 -2.3279855E-02 -5.7100318E-02 -9.8374896E-02 -0.1449500 -0.1953484 -0.2485905 -0.3039200 -0.3607644 -0.4186462 -0.4771823 -0.5360389 -0.5949484 -0.6536679 -0.7120066 -0.7697898 -0.8268871 -0.8831774 -0.9385683 -0.9929767 -1.046331 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.4285855 -0.9752882 -1.544620 -2.063308 -2.496673 -2.846104 -3.132601 -3.374655 -3.584227 -3.769027 -3.934264 -4.083653 -4.219917 -4.345147 -4.460957 -4.568648 -4.669261 -4.763659 -4.852542 -4.936500 0.000000 -0.4086212 -0.9316282 -1.477619 -1.976454 -2.395610 -2.735423 -3.013981 -3.248700 -3.451303 -3.629433 -3.788263 -3.931484 -4.061800 -4.181282 -4.291530 -4.393832 -4.489218 -4.578537 -4.662485 -4.741641 0.000000 -0.3885462 -0.8878064 -1.410854 -1.890986 -2.297110 -2.628622 -2.900924 -3.130185 -3.327802 -3.501318 -3.655857 -3.795070 -3.921636 -4.037597 -4.144531 -4.243707 -4.336139 -4.422662 -4.503958 -4.580595 0.000000 -0.3683526 -0.8437499 -1.344032 -1.806154 -2.200036 -2.524043 -2.791150 -3.016132 -3.209969 -3.380074 -3.531507 -3.667878 -3.791831 -3.905381 -4.010084 -4.107187 -4.197689 -4.282411 -4.362020 -4.437075 0.000000 -0.3480330 -0.7993895 -1.276900 -1.721331 -2.103446 -2.420405 -2.682976 -2.904457 -3.095303 -3.262763 -3.411828 -3.546061 -3.668073 -3.779853 -3.882935 -3.978549 -4.067677 -4.151126 -4.229555 -4.303510 0.000000 -0.3275811 -0.7546589 -1.209232 -1.635979 -2.006508 -2.316633 -2.575055 -2.793548 -2.981941 -3.147276 -3.294463 -3.427020 -3.547524 -3.657942 -3.759785 -3.854267 -3.942359 -4.024855 -4.102403 -4.175544 0.000000 -0.3069883 -0.7094958 -1.140819 -1.549624 -1.908468 -2.211764 -2.466210 -2.682041 -2.868353 -3.031931 -3.177584 -3.308784 -3.428078 -3.537408 -3.638268 -3.731856 -3.819135 -3.900885 -3.977748 -4.050256 0.000000 -0.2862484 -0.6638404 -1.071464 -1.461833 -1.808609 -2.104875 -2.355340 -2.568680 -2.753163 -2.915245 -3.059614 -3.189689 -3.307985 -3.416422 -3.516480 -3.609344 -3.695963 -3.777111 -3.853422 -3.925423 0.000000 -0.2653540 -0.6176351 -1.000978 -1.372190 -1.706239 -1.995039 -2.241339 -2.452218 -2.635020 -2.795790 -2.939059 -3.068181 -3.185636 -3.293327 -3.392715 -3.484976 -3.571048 -3.651698 -3.727555 -3.799137 0.000000 -0.2442975 -0.5708216 -0.9291764 -1.280298 -1.600670 -1.881296 -2.123041 -2.331338 -2.512503 -2.672076 -2.814377 -2.942673 -3.059409 -3.166463 -3.265282 -3.357031 -3.442641 -3.522871 -3.598344 -3.669576 0.000000 -0.2230713 -0.5233444 -0.8558745 -1.185756 -1.491202 -1.762626 -1.999161 -2.204565 -2.384014 -2.542430 -2.683846 -2.811412 -2.927519 -3.034020 -3.132348 -3.223658 -3.308871 -3.388741 -3.463886 -3.534818 0.000000 -0.2016689 -0.4751481 -0.7808911 -1.088157 -1.377107 -1.637921 -1.868249 -2.070189 -2.247670 -2.404864 -2.545421 -2.672315 -2.787859 -2.893873 -2.991771 -3.082697 -3.167563 -3.247123 -3.321982 -3.392656 0.000000 -0.1800832 -0.4261775 -0.7040454 -0.9870826 -1.257610 -1.505964 -1.728636 -1.926167 -2.101163 -2.256905 -2.396534 -2.522761 -2.637780 -2.743353 -2.840867 -2.931453 -3.016016 -3.095299 -3.169910 -3.240356 0.000000 -0.1583078 -0.3763780 -0.6251541 -0.8821060 -1.131894 -1.365407 -1.578382 -1.770017 -1.941587 -2.095359 -2.233812 -2.359280 -2.473756 -2.578904 -2.676064 -2.766342 -2.850632 -2.929672 -3.004062 -3.074304 0.000000 -0.1363357 -0.3256961 -0.5440320 -0.7727867 -0.9990872 -1.214754 -1.415228 -1.598699 -1.765224 -1.915985 -2.052662 -2.177056 -2.290842 -2.395511 -2.492307 -2.582289 -2.666326 -2.745142 -2.819333 -2.889396 0.000000 -0.1141600 -0.2740762 -0.4604947 -0.6586746 -0.8582714 -1.052361 -1.236566 -1.408507 -1.567290 -1.713077 -1.846656 -1.969152 -2.081772 -2.185700 -2.282002 -2.371631 -2.455396 -2.533991 -2.607991 -2.677886 0.000000 -9.1774188E-02 -0.2214625 -0.3743529 -0.5393077 -0.7084855 -0.8764474 -1.039433 -1.194995 -1.341704 -1.478949 -1.606696 -1.725321 -1.835426 -1.937739 -2.033002 -2.121951 -2.205261 -2.283532 -2.357292 -2.426998 0.000000 -6.9171824E-02 -0.1678037 -0.2854218 -0.4142215 -0.5487434 -0.6851361 -0.8205739 -0.9530066 -1.080971 -1.203513 -1.320062 -1.430387 -1.534482 -1.632533 -1.724821 -1.811722 -1.893631 -1.970947 -2.044052 -2.113303 0.000000 -4.6346519E-02 -0.1130460 -0.1935104 -0.2829461 -0.3780529 -0.4765100 -0.5765668 -0.6768814 -0.7763892 -0.8742708 -0.9698877 -1.062780 -1.152614 -1.239184 -1.322369 -1.402148 -1.478551 -1.551658 -1.621575 -1.688431 0.000000 -2.3291264E-02 -5.7132442E-02 -9.8428890E-02 -0.1450247 -0.1954421 -0.2487014 -0.3040465 -0.3609048 -0.4187992 -0.4773467 -0.5362136 -0.5951323 -0.6538602 -0.7122062 -0.7699962 -0.8270994 -0.8833947 -0.9387903 -0.9932026 -1.046560 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.5922861 -1.178493 -1.705710 -2.152275 -2.521024 -2.826152 -3.083139 -3.304305 -3.498244 -3.670870 -3.826348 -3.967743 -4.097348 -4.216949 -4.327945 -4.431481 -4.528477 -4.619687 -4.705744 -4.787194 0.000000 -0.5635248 -1.123253 -1.629128 -2.059827 -2.416720 -2.712389 -2.961117 -3.174626 -3.361308 -3.526999 -3.675826 -3.810824 -3.934264 -4.047914 -4.153156 -4.251123 -4.342719 -4.428689 -4.509656 -4.586157 0.000000 -0.5347484 -1.068156 -1.553185 -1.968950 -2.315334 -2.603184 -2.845534 -3.053437 -3.235019 -3.396006 -3.540471 -3.671407 -3.791052 -3.901145 -4.003047 -4.097868 -4.186498 -4.269664 -4.347976 -4.421958 0.000000 -0.5059419 -1.013082 -1.477514 -1.878867 -2.215572 -2.496647 -2.733805 -2.937361 -3.115119 -3.272674 -3.414025 -3.542118 -3.659158 -3.766852 -3.866538 -3.959305 -4.046025 -4.127411 -4.204061 -4.276485 0.000000 -0.4770917 -0.9579253 -1.401794 -1.788936 -2.116405 -2.391344 -2.624071 -2.824100 -2.998854 -3.153769 -3.292767 -3.418741 -3.533864 -3.639814 -3.737908 -3.829212 -3.914585 -3.994727 -4.070223 -4.141575 0.000000 -0.4481840 -0.9025875 -1.325745 -1.698601 -2.016962 -2.286104 -2.514876 -2.711915 -2.884216 -3.037020 -3.174163 -3.298490 -3.412134 -3.516749 -3.613632 -3.703834 -3.788198 -3.867413 -3.942054 -4.012616 0.000000 -0.4192060 -0.8469795 -1.249107 -1.607366 -1.916476 -2.179904 -2.404973 -2.599368 -2.769588 -2.920650 -3.056283 -3.179281 -3.291743 -3.395299 -3.491226 -3.580562 -3.664137 -3.742630 -3.816610 -3.886561 0.000000 -0.3901453 -0.7910171 -1.171648 -1.514775 -1.814236 -2.071795 -2.293217 -2.485154 -2.653540 -2.803116 -2.937488 -3.059385 -3.170876 -3.273567 -3.368718 -3.457352 -3.540290 -3.618203 -3.691652 -3.761115 0.000000 -0.3609903 -0.7346212 -1.093143 -1.420393 -1.709556 -1.960851 -2.178487 -2.368007 -2.534694 -2.682955 -2.816241 -2.937206 -3.047881 -3.149848 -3.244352 -3.332405 -3.414817 -3.492251 -3.565263 -3.634326 0.000000 -0.3317290 -0.6777180 -1.013386 -1.323803 -1.601761 -1.846133 -2.059625 -2.246606 -2.411617 -2.558657 -2.690975 -2.811131 -2.921105 -3.022456 -3.116410 -3.203972 -3.285939 -3.362972 -3.435616 -3.504342 0.000000 -0.3023508 -0.6202367 -0.9321746 -1.224594 -1.490165 -1.726660 -1.935388 -2.119508 -2.282726 -2.428550 -2.559961 -2.679387 -2.788745 -2.889560 -2.983042 -3.070179 -3.151766 -3.228452 -3.300784 -3.369224 0.000000 -0.2728452 -0.5621099 -0.8493150 -1.122360 -1.374063 -1.601387 -1.804401 -1.985070 -2.146190 -2.290676 -2.421162 -2.539891 -2.648685 -2.749022 -2.842086 -2.928855 -3.010110 -3.086498 -3.158558 -3.226750 0.000000 -0.2432019 -0.5032734 -0.7646202 -1.016695 -1.252728 -1.469183 -1.665118 -1.841380 -1.999814 -2.142642 -2.272059 -2.390046 -2.498283 -2.598171 -2.690856 -2.777295 -2.858257 -2.934381 -3.006202 -3.074177 0.000000 -0.2134115 -0.4436650 -0.6779064 -0.9071949 -1.125403 -1.328823 -1.515785 -1.686174 -1.840899 -1.981425 -2.109404 -2.226458 -2.334056 -2.433473 -2.525785 -2.611914 -2.692608 -2.768495 -2.840103 -2.907885 0.000000 -0.1834649 -0.3832247 -0.5889958 -0.7934532 -0.9913059 -1.178985 -1.354417 -1.516764 -1.666105 -1.803137 -1.928886 -2.044523 -2.151201 -2.249997 -2.341868 -2.427661 -2.508086 -2.583747 -2.655158 -2.722764 0.000000 -0.1533526 -0.3218939 -0.4977139 -0.6750672 -0.8496350 -1.018258 -1.178797 -1.329992 -1.471300 -1.602739 -1.724700 -1.837822 -1.942848 -2.040558 -2.131705 -2.217000 -2.297067 -2.372458 -2.443655 -2.511083 0.000000 -0.1230655 -0.2596172 -0.4038915 -0.5516400 -0.6995789 -0.8451664 -0.9864969 -1.122220 -1.251467 -1.373783 -1.489028 -1.597324 -1.698950 -1.794302 -1.883830 -1.968020 -2.047329 -2.122193 -2.193016 -2.260170 0.000000 -9.2595182E-02 -0.1963418 -0.3073637 -0.4227824 -0.5403357 -0.6582088 -0.7749514 -0.8894207 -1.000744 -1.108291 -1.211634 -1.310528 -1.404866 -1.494666 -1.580026 -1.661127 -1.738173 -1.811394 -1.881028 -1.947327 0.000000 -6.1932858E-02 -0.1320141 -0.2079736 -0.2881216 -0.3711292 -0.4559128 -0.5415779 -0.6273803 -0.7126958 -0.7970188 -0.8799263 -0.9610929 -1.040256 -1.117225 -1.191867 -1.264108 -1.333906 -1.401252 -1.466169 -1.528706 0.000000 -3.1070219E-02 -6.6583894E-02 -0.1055678 -0.1473033 -0.1912332 -0.2369066 -0.2839495 -0.3320478 -0.3809277 -0.4303600 -0.4801363 -0.5300866 -0.5800498 -0.6298924 -0.6794921 -0.7287549 -0.7775860 -0.8259032 -0.8736352 -0.9207280 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.5944546 -1.142173 -1.618235 -2.018566 -2.351921 -2.631588 -2.870010 -3.076952 -3.259531 -3.422827 -3.570507 -3.705286 -3.829226 -3.943927 -4.050665 -4.150461 -4.244150 -4.332426 -4.415875 -4.494985 0.000000 -0.5657648 -1.089370 -1.546957 -1.933731 -2.256869 -2.528238 -2.759395 -2.959645 -3.135896 -3.293135 -3.434991 -3.564152 -3.682662 -3.792106 -3.893745 -3.988591 -4.077471 -4.161067 -4.239958 -4.314627 0.000000 -0.5370163 -1.036472 -1.475729 -1.849402 -2.163133 -2.427314 -2.652534 -2.847572 -3.019078 -3.171925 -3.309680 -3.434995 -3.549884 -3.655915 -3.754328 -3.846117 -3.932097 -4.012937 -4.089205 -4.161372 0.000000 -0.5081998 -0.9834002 -1.404318 -1.765090 -2.069887 -2.327599 -2.547759 -2.738555 -2.906332 -3.055816 -3.190501 -3.312990 -3.425270 -3.528879 -3.625039 -3.714728 -3.798741 -3.877737 -3.952272 -4.022809 0.000000 -0.4793056 -0.9300872 -1.332510 -1.680364 -1.976434 -2.228096 -2.443769 -2.630972 -2.795702 -2.942505 -3.074785 -3.195097 -3.305390 -3.407179 -3.501663 -3.589802 -3.672382 -3.750045 -3.823339 -3.892715 0.000000 -0.4503245 -0.8764665 -1.260114 -1.594837 -1.882150 -2.127942 -2.339466 -2.523507 -2.685652 -2.830245 -2.960577 -3.079148 -3.187868 -3.288229 -3.381409 -3.468355 -3.549833 -3.626482 -3.698835 -3.767337 0.000000 -0.4212484 -0.8224766 -1.186950 -1.508151 -1.786464 -2.026351 -2.233869 -2.415000 -2.574874 -2.717580 -2.846286 -2.963423 -3.070863 -3.170068 -3.262200 -3.348190 -3.428793 -3.504639 -3.576249 -3.644066 0.000000 -0.3920684 -0.7680602 -1.112847 -1.419968 -1.688833 -1.922572 -2.126039 -2.304363 -2.462147 -2.603188 -2.730496 -2.846420 -2.952787 -3.051034 -3.142301 -3.227506 -3.307395 -3.382586 -3.453594 -3.520855 0.000000 -0.3627771 -0.7131620 -1.037649 -1.329963 -1.588729 -1.815862 -2.015043 -2.190506 -2.346262 -2.485762 -2.611826 -2.726696 -2.832147 -2.929579 -3.020118 -3.104664 -3.183956 -3.258599 -3.329108 -3.395909 0.000000 -0.3333662 -0.6577301 -0.9612024 -1.237823 -1.485625 -1.705467 -1.899916 -2.072285 -2.225943 -2.363930 -2.488830 -2.602751 -2.707393 -2.804121 -2.894033 -2.978017 -3.056798 -3.130979 -3.201064 -3.267475 0.000000 -0.3038288 -0.6017148 -0.8833619 -1.143242 -1.378994 -1.590603 -1.779623 -1.948457 -2.099779 -2.236163 -2.359893 -2.472909 -2.576811 -2.672909 -2.762269 -2.845763 -2.924104 -2.997884 -3.067605 -3.133682 0.000000 -0.2741571 -0.5450692 -0.8039874 -1.045916 -1.268300 -1.470452 -1.653049 -1.817633 -1.966162 -2.100680 -2.223120 -2.335194 -2.438368 -2.533873 -2.622732 -2.705787 -2.783738 -2.857167 -2.926570 -2.992356 0.000000 -0.2443445 -0.4877475 -0.7229446 -0.9455505 -1.153000 -1.344151 -1.518973 -1.678240 -1.823207 -1.955355 -2.076198 -2.187164 -2.289536 -2.384427 -2.472794 -2.555437 -2.633031 -2.706145 -2.775263 -2.840792 0.000000 -0.2143847 -0.4297069 -0.6401030 -0.8418540 -1.032545 -1.210792 -1.376060 -1.528491 -1.668699 -1.797596 -1.916236 -2.025702 -2.127034 -2.221181 -2.308991 -2.391199 -2.468439 -2.541251 -2.610105 -2.675399 0.000000 -0.1842700 -0.3709049 -0.5553371 -0.7345393 -0.9063794 -1.069430 -1.222861 -1.366361 -1.500021 -1.624228 -1.739570 -1.846745 -1.946488 -2.039528 -2.126554 -2.208190 -2.284997 -2.357470 -2.426049 -2.491109 0.000000 -0.1539949 -0.3113023 -0.4685274 -0.6233293 -0.7739525 -0.9190922 -1.057829 -1.189595 -1.314123 -1.431387 -1.541559 -1.644949 -1.741961 -1.833049 -1.918683 -1.999326 -2.075417 -2.147366 -2.215551 -2.280308 0.000000 -0.1235531 -0.2508611 -0.3795587 -0.5079564 -0.6347252 -0.7588016 -0.8793503 -0.9957459 -1.107548 -1.214483 -1.316426 -1.413372 -1.505415 -1.592722 -1.675514 -1.754040 -1.828564 -1.899358 -1.966691 -2.030817 0.000000 -9.2938259E-02 -0.1895441 -0.2883216 -0.3881658 -0.4881769 -0.5876011 -0.6858011 -0.7822533 -0.8765270 -0.9682834 -1.057266 -1.143297 -1.226265 -1.306117 -1.382855 -1.456516 -1.527168 -1.594906 -1.659846 -1.722109 0.000000 -6.2145185E-02 -0.1273168 -0.1947127 -0.2637186 -0.3338231 -0.4045867 -0.4756216 -0.5465955 -0.6172110 -0.6872120 -0.7563767 -0.8245153 -0.8914706 -0.9571156 -1.021345 -1.084080 -1.145259 -1.204839 -1.262802 -1.319135 0.000000 -3.1167248E-02 -6.4146131E-02 -9.8635368E-02 -0.1343962 -0.1712250 -0.2089469 -0.2474054 -0.2864668 -0.3260053 -0.3659075 -0.4060751 -0.4464153 -0.4868455 -0.5272911 -0.5676851 -0.6079650 -0.6480753 -0.6879604 -0.7275810 -0.7668883 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.5130268 -0.9831784 -1.398112 -1.755928 -2.061558 -2.323080 -2.548928 -2.746415 -2.921361 -3.078201 -3.220286 -3.350138 -3.469706 -3.580499 -3.683724 -3.780342 -3.871150 -3.956807 -4.037864 -4.114783 0.000000 -0.4882647 -0.9376233 -1.336170 -1.681528 -1.977647 -2.231587 -2.451010 -2.642748 -2.812354 -2.964126 -3.101342 -3.226492 -3.341501 -3.447866 -3.546784 -3.639207 -3.725926 -3.807592 -3.884753 -3.957863 0.000000 -0.4634341 -0.8918743 -1.273963 -1.606955 -1.893879 -2.140788 -2.354538 -2.541429 -2.706709 -2.854506 -2.988009 -3.109659 -3.221353 -3.324569 -3.420488 -3.510049 -3.594034 -3.673084 -3.747739 -3.818446 0.000000 -0.4385309 -0.8458929 -1.211373 -1.531949 -1.809804 -2.050002 -2.258565 -2.441221 -2.602862 -2.747417 -2.877967 -2.996890 -3.106045 -3.206887 -3.300578 -3.388044 -3.470053 -3.547236 -3.620125 -3.689157 0.000000 -0.4135487 -0.7996450 -1.148285 -1.456271 -1.725016 -1.958629 -2.162286 -2.341099 -2.499568 -2.641387 -2.769505 -2.886224 -2.993360 -3.092335 -3.184295 -3.270149 -3.350652 -3.426426 -3.497992 -3.565780 0.000000 -0.3884849 -0.7530950 -1.084598 -1.379699 -1.639137 -1.866117 -2.064970 -2.240164 -2.395761 -2.535191 -2.661240 -2.776122 -2.881598 -2.979061 -3.069628 -3.154196 -3.233508 -3.308174 -3.378705 -3.445527 0.000000 -0.3633339 -0.7062119 -1.020211 -1.302025 -1.551815 -1.771951 -1.965940 -2.137582 -2.290470 -2.427727 -2.551956 -2.665262 -2.769335 -2.865535 -2.954952 -3.038466 -3.116807 -3.190574 -3.260271 -3.326317 0.000000 -0.3380929 -0.6589664 -0.9550312 -1.223051 -1.462711 -1.675631 -1.864532 -2.032541 -2.182750 -2.317942 -2.440505 -2.552405 -2.655263 -2.750382 -2.838827 -2.921454 -2.998984 -3.072004 -3.141012 -3.206418 0.000000 -0.3127565 -0.6113275 -0.8889694 -1.142586 -1.371495 -1.576662 -1.760082 -1.924218 -2.071644 -2.204766 -2.325722 -2.436320 -2.538081 -2.632245 -2.719846 -2.801713 -2.878552 -2.950940 -3.019365 -3.084233 0.000000 -0.2873212 -0.5632682 -0.8219418 -1.060447 -1.277842 -1.474551 -1.651912 -1.811762 -1.956143 -2.087061 -2.206369 -2.315686 -2.416405 -2.509696 -2.596539 -2.677737 -2.753973 -2.825813 -2.893739 -2.958145 0.000000 -0.2617846 -0.5147622 -0.7538652 -0.9764569 -1.181435 -1.368798 -1.539322 -1.694266 -1.835155 -1.963576 -2.081067 -2.189020 -2.288683 -2.381121 -2.467250 -2.547834 -2.623529 -2.694885 -2.762371 -2.826375 0.000000 -0.2361403 -0.4657832 -0.6846645 -0.8904428 -1.081957 -1.258895 -1.421579 -1.570760 -1.707478 -1.832904 -1.948232 -2.054608 -2.153088 -2.244614 -2.330015 -2.409998 -2.485180 -2.556090 -2.623177 -2.686822 0.000000 -0.2103863 -0.4163066 -0.6142632 -0.8022389 -0.9790987 -1.144331 -1.297919 -1.440198 -1.571782 -1.693438 -1.806020 -1.910395 -2.007407 -2.097837 -2.182400 -2.261724 -2.336372 -2.406835 -2.473539 -2.536848 0.000000 -0.1845197 -0.3663105 -0.5425916 -0.7116858 -0.8725512 -1.024586 -1.167548 -1.301461 -1.426588 -1.543344 -1.652258 -1.753909 -1.848907 -1.937843 -2.021292 -2.099771 -2.173766 -2.243711 -2.309995 -2.372951 0.000000 -0.1585352 -0.3157716 -0.4695798 -0.6186277 -0.7620163 -0.8991433 -1.029649 -1.153359 -1.270277 -1.380541 -1.484395 -1.582152 -1.674182 -1.760873 -1.842628 -1.919828 -1.992854 -2.062057 -2.127765 -2.190267 0.000000 -0.1324312 -0.2646677 -0.3951640 -0.5229158 -0.6472040 -0.7674933 -0.8833984 -0.9946513 -1.101104 -1.202704 -1.299483 -1.391536 -1.479020 -1.562124 -1.641072 -1.716092 -1.787430 -1.855331 -1.920033 -1.981756 0.000000 -0.1062040 -0.2129796 -0.3192835 -0.4244128 -0.5278387 -0.6291397 -0.7279786 -0.8240782 -0.9172396 -1.007312 -1.094210 -1.177882 -1.258329 -1.335583 -1.409710 -1.480790 -1.548932 -1.614258 -1.676895 -1.736972 0.000000 -7.9849780E-02 -0.1606862 -0.2418790 -0.3229856 -0.4036610 -0.4836156 -0.5626054 -0.6404061 -0.7168399 -0.7917512 -0.8650153 -0.9365279 -1.006214 -1.074013 -1.139897 -1.203839 -1.265843 -1.325920 -1.384098 -1.440408 0.000000 -5.3366121E-02 -0.1077706 -0.1628974 -0.2185128 -0.2744330 -0.3304931 -0.3865551 -0.4424781 -0.4981481 -0.5534588 -0.6083148 -0.6626272 -0.7163223 -0.7693291 -0.8215915 -0.8730510 -0.9236667 -0.9734023 -1.022230 -1.070117 0.000000 -2.6750972E-02 -5.4213047E-02 -8.2286887E-02 -0.1108847 -0.1399399 -0.1693927 -0.1991924 -0.2292784 -0.2596098 -0.2901406 -0.3208342 -0.3516468 -0.3825478 -0.4135011 -0.4444800 -0.4754476 -0.5063811 -0.5372556 -0.5680469 -0.5987273 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.3798582 -0.7354524 -1.061528 -1.356025 -1.619391 -1.853787 -2.062336 -2.248488 -2.415552 -2.566498 -2.703840 -2.829665 -2.945681 -3.053267 -3.153560 -3.247481 -3.335786 -3.419122 -3.498007 -3.572906 0.000000 -0.3613946 -0.7008054 -1.013192 -1.296426 -1.550663 -1.777650 -1.980081 -2.161027 -2.323508 -2.470286 -2.603744 -2.725880 -2.838354 -2.942509 -3.039465 -3.130131 -3.215252 -3.295472 -3.371304 -3.443210 0.000000 -0.3428831 -0.6660000 -0.9645656 -1.236434 -1.481512 -1.701169 -1.897680 -2.073737 -2.232055 -2.375176 -2.505329 -2.624410 -2.734018 -2.835456 -2.929816 -3.017993 -3.100722 -3.178634 -3.252239 -3.321993 0.000000 -0.3243231 -0.6310217 -0.9156058 -1.175952 -1.411762 -1.624061 -1.814725 -1.986066 -2.140488 -2.280292 -2.407536 -2.524002 -2.631212 -2.730421 -2.822689 -2.908885 -2.989735 -3.065858 -3.137754 -3.205874 0.000000 -0.3057132 -0.5958606 -0.8662743 -1.114890 -1.341250 -1.546065 -1.730838 -1.897516 -2.048177 -2.184869 -2.309465 -2.423617 -2.528755 -2.626076 -2.716600 -2.801171 -2.880496 -2.955180 -3.025717 -3.092546 0.000000 -0.2870511 -0.5605029 -0.8165321 -1.053163 -1.269817 -1.466935 -1.645672 -1.807618 -1.954535 -2.088207 -2.210305 -2.322332 -2.425618 -2.521288 -2.610317 -2.693513 -2.771564 -2.845059 -2.914480 -2.980259 0.000000 -0.2683360 -0.5249395 -0.7663444 -0.9906910 -1.197317 -1.386434 -1.558886 -1.715927 -1.859005 -1.989639 -2.109283 -2.219282 -2.320847 -2.415023 -2.502724 -2.584725 -2.661681 -2.734166 -2.802649 -2.867550 0.000000 -0.2495662 -0.4891588 -0.7156751 -0.9273949 -1.123608 -1.304337 -1.470154 -1.622005 -1.761039 -1.888506 -2.005640 -2.113614 -2.213507 -2.306269 -2.392748 -2.473670 -2.549657 -2.621260 -2.688932 -2.753084 0.000000 -0.2307403 -0.4531506 -0.6644924 -0.8632018 -1.048553 -1.220424 -1.379154 -1.525417 -1.660082 -1.784137 -1.898598 -2.004450 -2.102633 -2.193988 -2.279284 -2.359187 -2.434282 -2.505090 -2.572042 -2.635534 0.000000 -0.2118568 -0.4169040 -0.6127641 -0.7980409 -0.9720224 -1.134482 -1.285571 -1.425729 -1.555569 -1.675843 -1.787341 -1.890865 -1.987201 -2.077069 -2.161144 -2.240032 -2.314259 -2.384310 -2.450595 -2.513487 0.000000 -0.1929152 -0.3804105 -0.5604610 -0.7318435 -0.8938877 -1.046300 -1.189089 -1.322498 -1.446926 -1.562900 -1.671005 -1.771857 -1.866085 -1.954278 -2.037009 -2.114799 -2.188117 -2.257402 -2.323027 -2.385341 0.000000 -0.1739133 -0.3436606 -0.5075524 -0.6645455 -0.8140277 -0.9556758 -1.089396 -1.215283 -1.333555 -1.444550 -1.548664 -1.646336 -1.738038 -1.824225 -1.905358 -1.981865 -2.054143 -2.122575 -2.187487 -2.249197 0.000000 -0.1548501 -0.3066451 -0.4540116 -0.5960839 -0.7323254 -0.8624108 -0.9861846 -1.103635 -1.214845 -1.319995 -1.419319 -1.513100 -1.601661 -1.685326 -1.764435 -1.839319 -1.910290 -1.977665 -2.041712 -2.102711 0.000000 -0.1357251 -0.2693562 -0.3998128 -0.5263996 -0.6486670 -0.7663113 -0.8791518 -0.9871088 -1.090170 -1.188401 -1.281908 -1.370842 -1.455395 -1.535767 -1.612188 -1.684883 -1.754076 -1.820007 -1.882882 -1.942922 0.000000 -0.1165355 -0.2317838 -0.3449301 -0.4554366 -0.5629441 -0.6671926 -0.7680019 -0.8652605 -0.9589012 -1.048911 -1.135310 -1.218147 -1.297512 -1.373499 -1.446237 -1.515857 -1.582496 -1.646310 -1.707441 -1.766042 0.000000 -9.7282059E-02 -0.1939225 -0.2893386 -0.3831398 -0.4750561 -0.5648794 -0.6524501 -0.7376586 -0.8204114 -0.9006589 -0.9783670 -1.053520 -1.126138 -1.196239 -1.263872 -1.329091 -1.391955 -1.452548 -1.510938 -1.567222 0.000000 -7.7962622E-02 -0.1557621 -0.2330171 -0.3094592 -0.3849058 -0.4592028 -0.5322281 -0.6038878 -0.6740940 -0.7427877 -0.8099121 -0.8754259 -0.9393067 -1.001531 -1.062099 -1.121010 -1.178269 -1.233904 -1.287926 -1.340381 0.000000 -5.8575336E-02 -0.1172971 -0.1759419 -0.2343477 -0.2924031 -0.3500106 -0.4070851 -0.4635631 -0.5193768 -0.5744777 -0.6288152 -0.6823420 -0.7350307 -0.7868410 -0.8377532 -0.8877447 -0.9367916 -0.9848912 -1.032024 -1.078196 0.000000 -3.9120138E-02 -7.8518420E-02 -0.1180933 -0.1577605 -0.1974671 -0.2371609 -0.2767937 -0.3163349 -0.3557401 -0.3949840 -0.4340319 -0.4728512 -0.5114232 -0.5497154 -0.5877116 -0.6253873 -0.6627192 -0.6996980 -0.7362956 -0.7725093 0.000000 -1.9595634E-02 -3.9422411E-02 -5.9452876E-02 -7.9656318E-02 -0.1000213 -0.1205265 -0.1411541 -0.1618972 -0.1827339 -0.2036608 -0.2246609 -0.2457200 -0.2668356 -0.2879879 -0.3091758 -0.3303863 -0.3516054 -0.3728336 -0.3940516 -0.4152630 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.2069731 -0.4071109 -0.5993757 -0.7830326 -0.9576146 -1.122895 -1.278855 -1.425652 -1.563587 -1.693069 -1.814581 -1.928648 -2.035817 -2.136629 -2.231610 -2.321259 -2.406039 -2.486375 -2.562657 -2.635238 0.000000 -0.1967886 -0.3874127 -0.5708867 -0.7465028 -0.9137977 -1.072525 -1.222628 -1.364209 -1.497509 -1.622861 -1.740682 -1.851428 -1.955585 -2.053637 -2.146065 -2.233327 -2.315852 -2.394044 -2.468267 -2.538859 0.000000 -0.1865878 -0.3676554 -0.5422719 -0.7097676 -0.8696886 -1.021778 -1.165947 -1.302255 -1.430880 -1.552097 -1.666250 -1.773734 -1.874971 -1.970388 -2.060417 -2.145476 -2.225959 -2.302239 -2.374659 -2.443537 0.000000 -0.1763708 -0.3478349 -0.5135266 -0.6728135 -0.8252600 -0.9706059 -1.108741 -1.239681 -1.363559 -1.480585 -1.591043 -1.695264 -1.793608 -1.886449 -1.974168 -2.057137 -2.135713 -2.210238 -2.281029 -2.348381 0.000000 -0.1661366 -0.3279522 -0.4846452 -0.6356272 -0.7804879 -0.9189686 -1.050941 -1.176393 -1.295407 -1.408145 -1.514832 -1.615736 -1.711161 -1.801424 -1.886857 -1.967785 -2.044526 -2.117388 -2.186659 -2.252611 0.000000 -0.1558866 -0.3080036 -0.4556201 -0.5981960 -0.7353466 -0.8668214 -0.9924826 -1.112291 -1.226295 -1.334606 -1.437397 -1.534881 -1.627306 -1.714936 -1.798049 -1.876927 -1.951847 -2.023080 -2.090882 -2.155502 0.000000 -0.1456189 -0.2879891 -0.4264480 -0.5605078 -0.6898132 -0.8141247 -0.9333035 -1.047289 -1.156099 -1.259803 -1.358530 -1.452441 -1.541732 -1.626614 -1.707320 -1.784082 -1.857138 -1.926720 -1.993053 -2.056358 0.000000 -0.1353351 -0.2679056 -0.3971240 -0.5225505 -0.6438642 -0.7608421 -0.8733444 -0.9812986 -1.084698 -1.183578 -1.278028 -1.368163 -1.454132 -1.536101 -1.614251 -1.688774 -1.759865 -1.827719 -1.892527 -1.954480 0.000000 -0.1250332 -0.2477536 -0.3676425 -0.4843129 -0.5974784 -0.7069350 -0.8125473 -0.9142372 -1.011976 -1.105777 -1.195693 -1.281801 -1.364208 -1.443035 -1.518425 -1.590525 -1.659488 -1.725475 -1.788643 -1.849150 0.000000 -0.1147147 -0.2275298 -0.3379977 -0.4457839 -0.5506346 -0.6523690 -0.7508591 -0.8460239 -0.9378236 -1.026252 -1.111332 -1.193110 -1.271658 -1.347061 -1.419421 -1.488845 -1.555453 -1.619367 -1.680713 -1.739618 0.000000 -0.1043773 -0.2072343 -0.3081879 -0.4069530 -0.5033141 -0.5971101 -0.6882259 -0.7765823 -0.8621328 -0.9448544 -1.024754 -1.101851 -1.176187 -1.247817 -1.316809 -1.383238 -1.447188 -1.508749 -1.568015 -1.625084 0.000000 -9.4022498E-02 -0.1868642 -0.2782062 -0.3678108 -0.4554960 -0.5411258 -0.6245983 -0.7058384 -0.7847983 -0.8614482 -0.9357764 -1.007789 -1.077502 -1.144946 -1.210161 -1.273195 -1.334103 -1.392945 -1.449786 -1.504698 0.000000 -8.3649911E-02 -0.1664194 -0.2480494 -0.3283465 -0.4071628 -0.4843859 -0.5599273 -0.6337215 -0.7057225 -0.7758947 -0.8442208 -0.9106923 -0.9753106 -1.038087 -1.099040 -1.158197 -1.215589 -1.271251 -1.325223 -1.377553 0.000000 -7.3259391E-02 -0.1458974 -0.2177125 -0.2885510 -0.3582968 -0.4268593 -0.4941672 -0.5601646 -0.6248081 -0.6880652 -0.7499132 -0.8103364 -0.8693287 -0.9268861 -0.9830153 -1.037724 -1.091026 -1.142941 -1.193487 -1.242691 0.000000 -6.2850036E-02 -0.1252982 -0.1871917 -0.2484155 -0.3088813 -0.3685203 -0.4272751 -0.4851024 -0.5419652 -0.5978343 -0.6526870 -0.7065066 -0.7592794 -0.8109959 -0.8616543 -0.9112518 -0.9597903 -1.007275 -1.053713 -1.099114 0.000000 -5.2422293E-02 -0.1046197 -0.1564831 -0.2079314 -0.2588998 -0.3093397 -0.3592087 -0.4084742 -0.4571075 -0.5050843 -0.5523852 -0.5989939 -0.6448967 -0.6900821 -0.7345422 -0.7782705 -0.8212618 -0.8635145 -0.9050257 -0.9457972 0.000000 -4.1975908E-02 -8.3860748E-02 -0.1255835 -0.1670894 -0.2083378 -0.2492942 -0.2899307 -0.3302244 -0.3701552 -0.4097052 -0.4488601 -0.4876065 -0.5259318 -0.5638266 -0.6012819 -0.6382895 -0.6748431 -0.7109371 -0.7465658 -0.7817261 0.000000 -3.1510431E-02 -6.3020721E-02 -9.4488434E-02 -0.1258833 -0.1571801 -0.1883586 -0.2194033 -0.2502984 -0.2810327 -0.3115951 -0.3419738 -0.3721640 -0.4021534 -0.4319354 -0.4615031 -0.4908522 -0.5199732 -0.5488642 -0.5775163 -0.6059286 0.000000 -2.1026241E-02 -4.2097811E-02 -6.3195124E-02 -8.4304400E-02 -0.1054123 -0.1265112 -0.1475923 -0.1686473 -0.1896731 -0.2106606 -0.2316068 -0.2525059 -0.2733534 -0.2941449 -0.3148773 -0.3355467 -0.3561484 -0.3766798 -0.3971362 -0.4175158 0.000000 -1.0522217E-02 -2.1091191E-02 -3.1700216E-02 -4.2345703E-02 -5.3022958E-02 -6.3731208E-02 -7.4467398E-02 -8.5227996E-02 -9.6013650E-02 -0.1068190 -0.1176464 -0.1284904 -0.1393520 -0.1502282 -0.1611192 -0.1720226 -0.1829366 -0.1938615 -0.2047930 -0.2157331 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 1.541072 2.407329 2.989820 3.414844 3.738269 3.988093 4.180425 4.325439 4.429355 4.547315 4.608249 4.682954 4.748678 4.755261 4.777794 4.795011 4.803470 4.802835 4.780824 4.697332 0.000000 1.484232 2.319297 2.878100 3.246206 3.539160 3.765400 3.937550 4.107977 4.218285 4.290570 4.378431 4.410089 4.459142 4.500289 4.532004 4.553328 4.564288 4.566023 4.546681 4.467375 0.000000 1.420283 2.218845 2.721143 3.097881 3.380074 3.592715 3.753831 3.873200 3.997890 4.069609 4.107177 4.160254 4.167130 4.190965 4.211554 4.223039 4.223103 4.217004 4.193570 4.113676 0.000000 1.351761 2.091967 2.591264 2.947116 3.203046 3.399239 3.548464 3.658920 3.737514 3.787886 3.811092 3.853329 3.852656 3.869431 3.880693 3.844127 3.828902 3.815996 3.789513 3.707955 0.000000 1.280310 1.986456 2.456891 2.759033 2.996853 3.176069 3.308067 3.403576 3.469629 3.503341 3.514162 3.546339 3.538816 3.544546 3.511287 3.501277 3.489813 3.471838 3.441800 3.362017 0.000000 1.197075 1.876741 2.316056 2.600299 2.820773 2.978061 3.094027 3.176421 3.198694 3.215968 3.217168 3.235842 3.221036 3.189281 3.179812 3.168653 3.116480 3.080205 3.036366 2.946826 0.000000 1.125132 1.762689 2.153787 2.435329 2.608757 2.749830 2.845904 2.911847 2.920992 2.928210 2.921821 2.902246 2.901095 2.869003 2.851381 2.800594 2.732291 2.686265 2.610100 2.534198 0.000000 1.051152 1.628797 2.009973 2.244038 2.422043 2.517717 2.600583 2.646514 2.644156 2.641179 2.627275 2.602538 2.564327 2.540385 2.488598 2.424259 2.350445 2.298708 2.222208 2.125127 0.000000 0.9752597 1.513004 1.841738 2.074207 2.206951 2.310305 2.349566 2.380528 2.366472 2.353061 2.331040 2.293172 2.243215 2.187581 2.124174 2.054352 1.978599 1.918370 1.842287 1.752052 0.000000 0.8978293 1.392925 1.692870 1.878773 2.010584 2.072632 2.096493 2.112420 2.085472 2.062674 2.026381 1.960080 1.903710 1.839313 1.769159 1.695860 1.618788 1.539971 1.474473 1.389433 0.000000 0.8191284 1.268737 1.537124 1.699116 1.790854 1.833312 1.843213 1.837160 1.801503 1.766812 1.705172 1.647330 1.583508 1.500547 1.426240 1.349351 1.272106 1.195053 1.118028 1.034310 0.000000 0.7322325 1.130963 1.364801 1.498867 1.568092 1.608294 1.585562 1.549598 1.518614 1.459328 1.400674 1.324381 1.254106 1.180209 1.093966 1.016094 0.9403206 0.8650527 0.7903913 0.7113289 0.000000 0.6538008 1.004613 1.204066 1.310380 1.357157 1.363019 1.325821 1.279529 1.233113 1.164855 1.089747 1.018826 0.9347960 0.8587789 0.7746251 0.6984459 0.6243683 0.5498887 0.4762116 0.4004453 0.000000 0.5737855 0.8746486 1.027979 1.106310 1.129604 1.115852 1.065834 1.009411 0.9424395 0.8672202 0.7951948 0.7124755 0.6295589 0.5528533 0.4717453 0.3976565 0.3241084 0.2498379 0.1769909 0.1049370 0.000000 0.4924043 0.7355163 0.8629799 0.9100677 0.9015099 0.8695320 0.8077338 0.7415171 0.6672857 0.5870908 0.5042473 0.4212884 0.3433931 0.2630267 0.1874085 0.1136443 4.0387098E-02 -3.2840442E-02 -0.1031497 -0.1687476 0.000000 0.4097476 0.6064280 0.6878643 0.7076492 0.6770132 0.6279885 0.5558001 0.4806250 0.4000477 0.3159567 0.2322195 0.1496868 7.0333734E-02 -6.6907015E-03 -8.1938326E-02 -0.1544014 -0.2263039 -0.2944847 -0.3542235 -0.4083710 0.000000 0.3241390 0.4761577 0.5247389 0.5117472 0.4625481 0.3984470 0.3179757 0.2356127 0.1501556 6.4256378E-02 -1.9415649E-02 -0.1016657 -0.1796823 -0.2543217 -0.3248290 -0.3929742 -0.4579438 -0.5139912 -0.5592889 -0.6066359 0.000000 0.2429842 0.3447296 0.3631974 0.3305931 0.2686211 0.1938251 0.1097047 2.2594007E-02 -6.5713525E-02 -0.1509085 -0.2348826 -0.3132914 -0.3866202 -0.4550759 -0.5196270 -0.5795013 -0.6323841 -0.6725183 -0.7117555 -0.7460734 0.000000 0.1611223 0.2192326 0.2164145 0.1748170 0.1107066 3.5191026E-02 -4.6615828E-02 -0.1302757 -0.2136310 -0.2930054 -0.3703933 -0.4414580 -0.5062652 -0.5652934 -0.6221032 -0.6694005 -0.7083413 -0.7416020 -0.7681468 -0.7891864 0.000000 7.9189867E-02 0.1041164 9.3273908E-02 5.9352212E-02 1.1658604E-02 -4.3479249E-02 -0.1026028 -0.1643599 -0.2243355 -0.2846135 -0.3415003 -0.3966671 -0.4413955 -0.4844798 -0.5258420 -0.5593628 -0.5838819 -0.5983802 -0.6125420 -0.6270785 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 1.445551 2.259518 2.806915 3.206181 3.509697 3.743514 3.922815 4.056998 4.194274 4.278654 4.369074 4.407315 4.457502 4.500939 4.534184 4.556383 4.567382 4.568500 4.548026 4.468586 0.000000 1.391774 2.176412 2.701591 3.048079 3.323055 3.534770 3.695024 3.855114 3.956590 4.062849 4.117133 4.178967 4.192112 4.221997 4.246076 4.260639 4.265715 4.262593 4.239267 4.157241 0.000000 1.331135 2.081495 2.554794 2.908864 3.173189 3.371883 3.521890 3.632261 3.748330 3.813287 3.845063 3.897411 3.941632 3.937288 3.945980 3.951288 3.950265 3.943222 3.918767 3.838090 0.000000 1.266325 1.962561 2.432230 2.765601 3.005019 3.188863 3.327943 3.430027 3.501621 3.546402 3.603602 3.619773 3.644881 3.628510 3.630750 3.629628 3.620051 3.607887 3.581694 3.503420 0.000000 1.186964 1.863212 2.304910 2.585570 2.810435 2.977902 3.100195 3.187778 3.247097 3.276041 3.320251 3.325969 3.307214 3.309972 3.309756 3.270633 3.249766 3.228668 3.193605 3.109833 0.000000 1.121090 1.759418 2.150419 2.437411 2.644137 2.790248 2.897136 2.971830 2.988847 3.002153 3.030405 3.025541 3.003960 2.998223 2.961404 2.940769 2.913695 2.856290 2.808148 2.719366 0.000000 1.052911 1.651429 2.019003 2.282139 2.443367 2.573495 2.660943 2.719271 2.724185 2.727762 2.717536 2.722095 2.698648 2.661748 2.637798 2.581191 2.539423 2.475207 2.421751 2.333128 0.000000 0.9829280 1.525769 1.882783 2.101223 2.265930 2.352772 2.426082 2.466965 2.461080 2.453777 2.435598 2.406310 2.390480 2.344832 2.285607 2.219244 2.171865 2.101552 2.042330 1.953686 0.000000 0.9112643 1.416233 1.723979 1.939859 2.061631 2.155101 2.186614 2.217029 2.196809 2.178609 2.151733 2.113275 2.061519 1.999504 1.932556 1.881443 1.812999 1.735829 1.668018 1.576782 0.000000 0.8382660 1.302726 1.582746 1.754546 1.874581 1.928626 1.965251 1.962256 1.929552 1.900683 1.859050 1.807704 1.731776 1.664475 1.593565 1.534402 1.459054 1.378385 1.294840 1.202671 0.000000 0.7641749 1.185317 1.434950 1.583599 1.665469 1.700332 1.722502 1.702667 1.659352 1.615988 1.549827 1.488120 1.420138 1.348379 1.273403 1.195716 1.113978 1.031168 0.9512014 0.8662292 0.000000 0.6828615 1.055536 1.271831 1.393393 1.453264 1.485325 1.474510 1.439981 1.386102 1.319882 1.257239 1.176507 1.102108 1.025248 0.9469560 0.8675675 0.7791497 0.6978183 0.6257677 0.5459824 0.000000 0.6090887 0.9359831 1.119247 1.213974 1.251960 1.251106 1.223512 1.173047 1.110908 1.039033 0.9579707 0.8819140 0.7957597 0.7159664 0.6353882 0.5558533 0.4721579 0.3928084 0.3187058 0.2405012 0.000000 0.5339636 0.8132106 0.9525416 1.020050 1.035067 1.015047 0.9717454 0.9007867 0.8364139 0.7574616 0.6741449 0.5880558 0.5066060 0.4210796 0.3405430 0.2614289 0.1827575 0.1042699 2.8369872E-02 -4.7737736E-02 0.000000 0.4576745 0.6822578 0.7962280 0.8335273 0.8178619 0.7799551 0.7216875 0.6431917 0.5636663 0.4796407 0.3974518 0.3112713 0.2259027 0.1441594 6.3608557E-02 -1.5029693E-02 -9.2725664E-02 -0.1685433 -0.2435036 -0.3129986 0.000000 0.3802895 0.5608209 0.6309433 0.6417296 0.6044609 0.5499139 0.4782172 0.3932272 0.3083101 0.2204663 0.1343539 4.9007937E-02 -3.4148823E-02 -0.1162065 -0.1954120 -0.2724735 -0.3423496 -0.4117621 -0.4788127 -0.5356129 0.000000 0.3003904 0.4387358 0.4776008 0.4570194 0.4060009 0.3323629 0.2501402 0.1604373 7.2680607E-02 -1.7954143E-02 -0.1056252 -0.1900068 -0.2697372 -0.3478751 -0.4219483 -0.4923393 -0.5539970 -0.6134645 -0.6684058 -0.7103822 0.000000 0.2247772 0.3160997 0.3268391 0.2879164 0.2232674 0.1412184 5.2798267E-02 -3.8318686E-02 -0.1283931 -0.2198099 -0.3032229 -0.3837570 -0.4573497 -0.5310296 -0.5962170 -0.6566059 -0.7111277 -0.7569356 -0.7987710 -0.8278122 0.000000 0.1487496 0.1997676 0.1914471 0.1452706 7.8041323E-02 -1.5787897E-03 -8.7241493E-02 -0.1741266 -0.2577730 -0.3431906 -0.4192581 -0.4922109 -0.5572900 -0.6243765 -0.6771867 -0.7256652 -0.7659307 -0.7979141 -0.8276945 -0.8500555 0.000000 7.2990119E-02 9.4086617E-02 8.0472209E-02 4.4244833E-02 -5.5347751E-03 -6.2374730E-02 -0.1231606 -0.1861674 -0.2485020 -0.3094223 -0.3676027 -0.4199972 -0.4708391 -0.5139778 -0.5513005 -0.5851871 -0.6104219 -0.6351007 -0.6525986 -0.6625779 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 1.347371 2.107239 2.618099 2.990613 3.273443 3.490649 3.656358 3.779234 3.905734 3.981487 4.063669 4.095256 4.139563 4.177798 4.205794 4.222962 4.229277 4.225957 4.201458 4.119226 0.000000 1.296564 2.029162 2.519423 2.843370 3.099660 3.296253 3.479554 3.605013 3.690970 3.785777 3.831558 3.888813 3.937398 3.976192 3.965248 3.966021 3.962409 3.952986 3.925052 3.839875 0.000000 1.239604 1.940281 2.383313 2.713626 2.959641 3.144039 3.282504 3.383456 3.490527 3.547443 3.615458 3.637654 3.669359 3.694595 3.674053 3.668861 3.661463 3.650595 3.623365 3.540618 0.000000 1.178591 1.830239 2.268410 2.578968 2.801695 2.972185 3.100436 3.193645 3.257171 3.333121 3.365879 3.370255 3.389347 3.370313 3.367503 3.364026 3.355333 3.340628 3.309703 3.227871 0.000000 1.105505 1.736879 2.148452 2.410050 2.618736 2.773444 2.885467 2.964843 3.046917 3.086326 3.100818 3.093571 3.102517 3.077693 3.068827 3.057151 3.038316 2.987082 2.944661 2.884023 0.000000 1.043519 1.639151 2.003799 2.270488 2.461854 2.596241 2.693746 2.760842 2.803196 2.825579 2.826987 2.809318 2.806110 2.776079 2.759975 2.712724 2.680133 2.646888 2.578097 2.505249 0.000000 0.9794147 1.537448 1.880076 2.124009 2.272460 2.391260 2.470214 2.521021 2.550421 2.555210 2.539877 2.517057 2.486120 2.466835 2.418489 2.382725 2.323602 2.277347 2.202272 2.123504 0.000000 0.9136390 1.420083 1.751616 1.953603 2.104506 2.182107 2.246886 2.280853 2.293007 2.261268 2.236051 2.225037 2.187714 2.136820 2.078000 2.034226 1.965184 1.905273 1.826007 1.729515 0.000000 0.8463130 1.316910 1.602386 1.800887 1.911137 1.994387 2.019061 2.042628 2.017741 1.994802 1.963611 1.923327 1.871728 1.810465 1.759895 1.689677 1.610944 1.527828 1.458731 1.368167 0.000000 0.7778007 1.210102 1.468951 1.625829 1.733578 1.779263 1.808238 1.799443 1.762263 1.728922 1.687792 1.633464 1.569573 1.499865 1.425271 1.346870 1.264672 1.180602 1.106524 1.016559 0.000000 0.7083750 1.099650 1.329307 1.463784 1.535249 1.562118 1.576795 1.551271 1.504017 1.459714 1.403790 1.326933 1.253678 1.176391 1.096906 1.015127 0.9316353 0.8477755 0.7640286 0.6813619 0.000000 0.6326813 0.9780376 1.175591 1.283800 1.333770 1.357240 1.340148 1.300341 1.243376 1.185059 1.109219 1.034814 0.9468417 0.8649622 0.7815523 0.6980278 0.6145267 0.5311892 0.4486897 0.3665141 0.000000 0.5636865 0.8655397 1.031433 1.113720 1.142327 1.134169 1.100444 1.047638 0.9809836 0.9037341 0.8274995 0.7399271 0.6566776 0.5664382 0.4816384 0.3978643 0.3148558 0.2313846 0.1503551 6.7832686E-02 0.000000 0.4935742 0.7502471 0.8744124 0.9302617 0.9363636 0.9093147 0.8600056 0.7948439 0.7188269 0.6350264 0.5462677 0.4610054 0.3713502 0.2850166 0.1994073 0.1155170 3.3652846E-02 -5.1497079E-02 -0.1331144 -0.2136200 0.000000 0.4225089 0.6277534 0.7271919 0.7539079 0.7303585 0.6856358 0.6215535 0.5451759 0.4610247 0.3719553 0.2808101 0.1924010 0.1032634 1.6999600E-02 -6.8244517E-02 -0.1512070 -0.2323138 -0.3147677 -0.3875412 -0.4580291 0.000000 0.3505446 0.5143011 0.5722052 0.5732545 0.5286301 0.4675538 0.3903719 0.3045279 0.2144723 0.1219047 3.0566305E-02 -5.9373692E-02 -0.1467892 -0.2322655 -0.3123977 -0.3912642 -0.4652553 -0.5403755 -0.6009504 -0.6646804 0.000000 0.2764852 0.4007348 0.4291966 0.4003733 0.3423913 0.2630510 0.1758291 8.3328649E-02 -1.0071256E-02 -0.1043077 -0.1954782 -0.2830122 -0.3660153 -0.4468107 -0.5185956 -0.5906273 -0.6593151 -0.7221720 -0.7710683 -0.8235878 0.000000 0.2065216 0.2871810 0.2897492 0.2440533 0.1735496 8.6638495E-02 -5.7051722E-03 -0.1012873 -0.1955368 -0.2880613 -0.3739043 -0.4566165 -0.5321367 -0.6069902 -0.6745982 -0.7364439 -0.7919600 -0.8397068 -0.8828098 -0.9214709 0.000000 0.1363948 0.1821244 0.1662311 0.1152379 4.3809775E-02 -3.9386880E-02 -0.1281658 -0.2179670 -0.3040274 -0.3915856 -0.4696683 -0.5444492 -0.6110749 -0.6791326 -0.7347523 -0.7839606 -0.8253953 -0.8586093 -0.8892312 -0.9126283 0.000000 6.6751830E-02 8.4137790E-02 6.7704283E-02 2.9111819E-02 -2.2628907E-02 -8.1480391E-02 -0.1438914 -0.2086124 -0.2703888 -0.3346703 -0.3945127 -0.4479681 -0.5011196 -0.5440147 -0.5811126 -0.6173813 -0.6439003 -0.6631125 -0.6811221 -0.6912301 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 1.248077 1.950934 2.422923 2.767349 3.028573 3.228459 3.379966 3.491072 3.607126 3.673964 3.748211 3.812544 3.865510 3.868273 3.881428 3.888764 3.887658 3.878223 3.848727 3.800875 0.000000 1.200312 1.878371 2.331277 2.631070 2.868083 3.049076 3.218055 3.332345 3.411270 3.497845 3.536218 3.586905 3.629289 3.662038 3.685104 3.698457 3.702178 3.697667 3.673603 3.594319 0.000000 1.146649 1.795816 2.206594 2.512066 2.738964 2.908398 3.034816 3.157966 3.233491 3.277357 3.336787 3.352418 3.378812 3.400191 3.415121 3.420880 3.415929 3.405174 3.378055 3.298981 0.000000 1.089662 1.695182 2.100202 2.386729 2.591981 2.748480 2.865304 2.949168 3.005280 3.073737 3.100442 3.099770 3.114707 3.127914 3.133646 3.098416 3.078382 3.059120 3.027440 2.975455 0.000000 1.023025 1.608455 1.988232 2.229614 2.421417 2.562738 2.663680 2.734880 2.808955 2.841500 2.850139 2.839021 2.845339 2.847223 2.814529 2.796552 2.775260 2.750243 2.715380 2.635764 0.000000 0.9652155 1.517295 1.853987 2.099369 2.274739 2.396022 2.485042 2.544866 2.579476 2.594982 2.593131 2.574311 2.568302 2.534045 2.513155 2.489130 2.437828 2.400327 2.354997 2.269798 0.000000 0.9055193 1.422299 1.738530 1.962528 2.097662 2.204681 2.278716 2.318837 2.340412 2.345320 2.331898 2.303851 2.264655 2.238991 2.190139 2.154355 2.112691 2.048306 1.990770 1.901366 0.000000 0.8441750 1.313542 1.618531 1.803539 1.940176 2.028537 2.065705 2.091313 2.101174 2.087983 2.059077 2.022772 1.977624 1.924856 1.884320 1.820069 1.763379 1.690345 1.625509 1.534442 0.000000 0.7813432 1.217040 1.479690 1.660420 1.758828 1.831516 1.849163 1.865750 1.855326 1.811075 1.773758 1.729136 1.673756 1.626284 1.558730 1.483012 1.416883 1.338328 1.265318 1.172032 0.000000 0.7174067 1.117274 1.354875 1.496590 1.591833 1.628964 1.650130 1.635560 1.593919 1.556090 1.510464 1.452301 1.384755 1.312177 1.234809 1.153473 1.080306 0.9974065 0.9105555 0.8232126 0.000000 0.6526976 1.014223 1.224160 1.344386 1.405415 1.424206 1.431328 1.400411 1.348647 1.299679 1.239417 1.159179 1.084004 1.004719 0.9222386 0.8368195 0.7570074 0.6701792 0.5829055 0.4953861 0.000000 0.5826217 0.9012946 1.080528 1.175521 1.215724 1.230636 1.207344 1.162244 1.100716 1.037842 0.9579337 0.8799447 0.7968300 0.7118549 0.6247704 0.5360495 0.4474037 0.3586457 0.2735471 0.1840249 0.000000 0.5184529 0.7963795 0.9453194 1.015549 1.035061 1.019905 0.9800985 0.9220349 0.8507394 0.7692930 0.6896976 0.5980861 0.5105669 0.4221020 0.3320798 0.2423975 0.1538219 6.4864822E-02 -2.1491908E-02 -0.1111670 0.000000 0.4534004 0.6888632 0.7983674 0.8431917 0.8408496 0.8072612 0.7518527 0.6814921 0.6008224 0.5127028 0.4245719 0.3307173 0.2398371 0.1482804 5.7033751E-02 -3.2586560E-02 -0.1214284 -0.2114949 -0.2951173 -0.3815144 0.000000 0.3876130 0.5748503 0.6604763 0.6774013 0.6464983 0.5955552 0.5254808 0.4440214 0.3553236 0.2618358 0.1681353 7.4557245E-02 -1.7824639E-02 -0.1108495 -0.2019352 -0.2890126 -0.3732246 -0.4563530 -0.5327691 -0.6086352 0.000000 0.3210990 0.4692770 0.5157988 0.5080147 0.4613874 0.3892184 0.3066059 0.2158062 0.1214410 2.4718435E-02 -7.1663335E-02 -0.1649609 -0.2562319 -0.3457008 -0.4321169 -0.5117458 -0.5905572 -0.6599542 -0.7305921 -0.7978736 0.000000 0.2528578 0.3640404 0.3829100 0.3466181 0.2822485 0.1972658 0.1051592 8.2948739E-03 -8.9790672E-02 -0.1891467 -0.2831688 -0.3730473 -0.4603888 -0.5440814 -0.6227907 -0.6985034 -0.7637187 -0.8238376 -0.8805849 -0.9264988 0.000000 0.1885054 0.2592339 0.2543775 0.2045317 0.1265098 3.5305627E-02 -6.2072530E-02 -0.1621234 -0.2584708 -0.3575123 -0.4464371 -0.5308823 -0.6134197 -0.6885770 -0.7575536 -0.8217517 -0.8797986 -0.9206573 -0.9643653 -1.003872 0.000000 0.1242122 0.1630535 0.1421122 8.7593541E-02 1.1373457E-02 -7.6202467E-02 -0.1670241 -0.2599932 -0.3486086 -0.4385376 -0.5184932 -0.5940051 -0.6692417 -0.7330206 -0.7899552 -0.8406205 -0.8834306 -0.9180381 -0.9494819 -0.9737477 0.000000 6.1094653E-02 7.4457228E-02 5.5397887E-02 1.4320178E-02 -3.8938053E-02 -9.9057049E-02 -0.1642046 -0.2281930 -0.2934311 -0.3584793 -0.4203744 -0.4759356 -0.5240594 -0.5736830 -0.6116050 -0.6491265 -0.6767197 -0.6969262 -0.7155097 -0.7263435 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 1.134561 1.786177 2.218517 2.534417 2.773444 2.955360 3.092170 3.223333 3.309011 3.395137 3.437699 3.486722 3.528304 3.560358 3.582267 3.593772 3.594994 3.587310 3.559896 3.478611 0.000000 1.101656 1.721085 2.112525 2.406039 2.625947 2.791581 2.946676 3.049326 3.150645 3.207675 3.269654 3.288849 3.319357 3.343375 3.359416 3.366566 3.364863 3.355795 3.328006 3.279656 0.000000 1.051796 1.629358 2.021147 2.301938 2.509278 2.663295 2.777243 2.888727 2.955279 3.022446 3.054776 3.092146 3.091957 3.102387 3.109417 3.110323 3.104534 3.093314 3.065403 3.015895 0.000000 0.9902996 1.554218 1.924662 2.186519 2.373813 2.515852 2.620935 2.695274 2.743707 2.804724 2.825233 2.851092 2.843011 2.846049 2.847007 2.842304 2.829563 2.810426 2.779103 2.700865 0.000000 0.9388921 1.474583 1.821127 2.041728 2.216170 2.343663 2.433687 2.495696 2.561352 2.587424 2.590527 2.604443 2.588516 2.583431 2.574267 2.558610 2.512786 2.481353 2.442533 2.382620 0.000000 0.8854572 1.390576 1.697759 1.921367 2.080230 2.188896 2.267331 2.318384 2.346660 2.356059 2.348753 2.349959 2.325498 2.310209 2.269461 2.239599 2.205256 2.169685 2.103392 2.029195 0.000000 0.8305711 1.302894 1.591250 1.794640 1.915864 2.010671 2.073938 2.107751 2.123126 2.121192 2.104728 2.074475 2.054399 2.011608 1.978616 1.921237 1.873686 1.824318 1.750381 1.669859 0.000000 0.7739031 1.203215 1.480243 1.647466 1.769260 1.846244 1.875392 1.897534 1.897655 1.883987 1.855800 1.815792 1.766728 1.726699 1.664937 1.611072 1.540533 1.476911 1.396194 1.310531 0.000000 0.7158837 1.113811 1.352196 1.514340 1.600373 1.662132 1.689648 1.683248 1.669119 1.639610 1.596521 1.546838 1.489240 1.422913 1.350545 1.286929 1.206520 1.131999 1.046829 0.9576769 0.000000 0.6567110 1.021528 1.236403 1.362160 1.444430 1.472669 1.485700 1.465067 1.436998 1.380370 1.326768 1.267302 1.198362 1.122018 1.051147 0.9679196 0.8789583 0.7966895 0.7087194 0.6175975 0.000000 0.5968419 0.9263462 1.115026 1.220327 1.270471 1.280852 1.280017 1.243444 1.198911 1.134036 1.071417 0.9983535 0.9176429 0.8334023 0.7459999 0.6554473 0.5633430 0.4764152 0.3856506 0.2922459 0.000000 0.5324003 0.8225902 0.9819328 1.063160 1.093235 1.099122 1.069251 1.018602 0.9522443 0.8864699 0.8109372 0.7206727 0.6332227 0.5434138 0.4508213 0.3565743 0.2661325 0.1726592 7.9474039E-02 -1.5137673E-02 0.000000 0.4731050 0.7256162 0.8562362 0.9140056 0.9241042 0.9012796 0.8551476 0.7915588 0.7153832 0.6375904 0.5463452 0.4552854 0.3622130 0.2670510 0.1702915 7.5214341E-02 -1.7136622E-02 -0.1148572 -0.2109290 -0.3062353 0.000000 0.4131543 0.6261989 0.7200389 0.7535636 0.7423539 0.7014424 0.6399847 0.5640613 0.4784653 0.3898322 0.2927330 0.1965649 9.9295966E-02 1.2305937E-03 -9.6598007E-02 -0.1913807 -0.2831006 -0.3798607 -0.4688786 -0.5565821 0.000000 0.3526986 0.5210364 0.5922816 0.5991545 0.5605639 0.5025607 0.4266753 0.3397319 0.2458819 0.1489022 4.9144331E-02 -4.9678553E-02 -0.1491718 -0.2482558 -0.3388499 -0.4293359 -0.5182057 -0.6066722 -0.6870657 -0.7636504 0.000000 0.2917041 0.4237066 0.4585975 0.4418538 0.3876776 0.3092971 0.2209420 0.1249775 2.5348542E-02 -7.7538975E-02 -0.1779658 -0.2757186 -0.3717054 -0.4663860 -0.5485608 -0.6328815 -0.7190362 -0.7902439 -0.8640550 -0.9272264 0.000000 0.2293278 0.3271475 0.3364808 0.2927194 0.2215838 0.1325262 3.3602498E-02 -6.8613157E-02 -0.1738140 -0.2762480 -0.3734499 -0.4671891 -0.5582364 -0.6454868 -0.7197539 -0.7968895 -0.8709182 -0.9313617 -0.9877065 -1.042139 0.000000 0.1706077 0.2314901 0.2192979 0.1631643 7.9661779E-02 -1.6479705E-02 -0.1200337 -0.2223790 -0.3269155 -0.4247099 -0.5161049 -0.6029943 -0.6875566 -0.7646144 -0.8352326 -0.9011385 -0.9603744 -1.013725 -1.049865 -1.088503 0.000000 0.1121212 0.1443727 0.1197003 5.9491850E-02 -2.0752110E-02 -0.1117869 -0.2080435 -0.3020525 -0.3968728 -0.4855270 -0.5676768 -0.6455749 -0.7223284 -0.7878621 -0.8461857 -0.8984118 -0.9421061 -0.9801313 -1.011594 -1.035310 0.000000 5.4973394E-02 6.5001525E-02 4.3421842E-02 9.5249037E-05 -5.5220079E-02 -0.1168573 -0.1822966 -0.2511607 -0.3163529 -0.3827496 -0.4418364 -0.5026568 -0.5524093 -0.6034997 -0.6423236 -0.6811401 -0.7094626 -0.7292633 -0.7502877 -0.7627082 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 1.027934 1.612298 2.004753 2.291376 2.507316 2.670513 2.791958 2.908680 2.982795 3.057996 3.091745 3.132772 3.167183 3.192708 3.208676 3.214701 3.210895 3.230931 3.216625 3.147568 0.000000 0.9879478 1.554935 1.910889 2.177078 2.375515 2.550210 2.672295 2.757901 2.845595 2.892434 2.946277 2.990988 3.026333 3.052166 3.069089 3.076809 3.075405 3.066747 3.040011 2.992563 0.000000 0.9453275 1.474970 1.829363 2.083116 2.269922 2.407877 2.508782 2.608127 2.665209 2.727980 2.752869 2.783227 2.807515 2.825119 2.834109 2.833059 2.824636 2.811539 2.783421 2.708010 0.000000 0.8993871 1.406883 1.741427 1.977750 2.146425 2.273468 2.366308 2.430884 2.501087 2.534173 2.542356 2.560369 2.575209 2.582718 2.555913 2.540699 2.523542 2.503701 2.471450 2.417679 0.000000 0.8520466 1.334428 1.646444 1.845754 2.002293 2.115448 2.194064 2.270699 2.308962 2.324314 2.320840 2.328769 2.332642 2.306698 2.292403 2.274549 2.249478 2.221896 2.184874 2.107004 0.000000 0.8030380 1.257911 1.534169 1.736014 1.877771 1.973305 2.040792 2.083024 2.104091 2.107439 2.094806 2.093235 2.066286 2.048572 2.027229 1.978509 1.938030 1.896964 1.849772 1.784086 0.000000 0.7531894 1.166657 1.437830 1.620113 1.726798 1.808811 1.861702 1.887614 1.896101 1.888093 1.866302 1.851238 1.815147 1.785814 1.733016 1.687501 1.623387 1.569004 1.509262 1.433536 0.000000 0.7014278 1.088278 1.336716 1.485425 1.591703 1.656759 1.677548 1.691947 1.685765 1.665999 1.634245 1.591467 1.555271 1.498803 1.433136 1.376280 1.314353 1.237197 1.164494 1.080186 0.000000 0.6487632 1.006623 1.220066 1.362913 1.435906 1.486297 1.505252 1.492170 1.471922 1.440134 1.396345 1.342900 1.280961 1.210836 1.145811 1.065820 0.9902588 0.9038822 0.8226036 0.7330030 0.000000 0.5947818 0.9223862 1.113945 1.222992 1.291723 1.310821 1.315562 1.288527 1.254561 1.207701 1.149921 1.084908 1.011933 0.9319578 0.8466730 0.7579521 0.6729597 0.5800228 0.4924112 0.3978407 0.000000 0.5350716 0.8356773 1.002534 1.092188 1.130977 1.132848 1.123817 1.081426 1.033694 0.9649255 0.8958101 0.8192518 0.7354729 0.6464762 0.5540333 0.4631592 0.3664794 0.2723197 0.1776734 7.8192472E-02 0.000000 0.4815985 0.7416213 0.8805388 0.9473813 0.9670343 0.9638363 0.9272265 0.8709767 0.8098232 0.7313740 0.6500900 0.5619050 0.4687599 0.3725037 0.2736217 0.1732926 7.5791821E-02 -2.2507180E-02 -0.1252258 -0.2301655 0.000000 0.4273317 0.6531233 0.7649313 0.8097550 0.8103287 0.7797722 0.7272456 0.6581538 0.5837188 0.4952196 0.4028946 0.3056857 0.2060344 0.1041597 1.7018587E-03 -0.1000879 -0.1997316 -0.3003131 -0.4029970 -0.5050970 0.000000 0.3725994 0.5622103 0.6400331 0.6619388 0.6418560 0.5936002 0.5260940 0.4446286 0.3577103 0.2602708 0.1596955 5.7029717E-02 -4.6445765E-02 -0.1518658 -0.2547639 -0.3509683 -0.4467996 -0.5462701 -0.6418125 -0.7355008 0.000000 0.3175722 0.4662748 0.5229408 0.5196332 0.4733721 0.4082832 0.3266444 0.2340472 0.1364612 3.3157036E-02 -7.2773762E-02 -0.1774631 -0.2821267 -0.3834090 -0.4799389 -0.5693014 -0.6626183 -0.7530584 -0.8426668 -0.9233370 0.000000 0.2621903 0.3775942 0.4007865 0.3750486 0.3133581 0.2310673 0.1361644 3.3399872E-02 -7.2355814E-02 -0.1795668 -0.2845696 -0.3869414 -0.4875535 -0.5800298 -0.6743269 -0.7540394 -0.8395611 -0.9268275 -0.9937066 -1.067156 0.000000 0.2057537 0.2901016 0.2898788 0.2387006 0.1607802 6.5558411E-02 -3.8363151E-02 -0.1476601 -0.2551588 -0.3611150 -0.4616771 -0.5585905 -0.6522117 -0.7418116 -0.8262379 -0.8972450 -0.9746088 -1.046530 -1.099591 -1.157038 0.000000 0.1527383 0.2039010 0.1844872 0.1220601 3.3476871E-02 -6.8863511E-02 -0.1761154 -0.2855021 -0.3908970 -0.4920806 -0.5864162 -0.6759915 -0.7626271 -0.8419645 -0.9141750 -0.9812756 -1.048060 -1.100489 -1.145461 -1.186663 0.000000 0.1000998 0.1259960 9.6421890E-02 3.1851869E-02 -5.2467924E-02 -0.1472341 -0.2462877 -0.3439565 -0.4415652 -0.5327281 -0.6173318 -0.6972309 -0.7757350 -0.8433772 -0.9026785 -0.9568613 -1.012006 -1.041907 -1.072296 -1.096871 0.000000 4.8913252E-02 5.5794083E-02 3.1799294E-02 -1.3605576E-02 -7.0787162E-02 -0.1345983 -0.2024949 -0.2696318 -0.3391156 -0.4068836 -0.4675602 -0.5295669 -0.5808070 -0.6338749 -0.6727740 -0.7132497 -0.7428788 -0.7631440 -0.7871447 -0.8001623 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.9054621 1.429119 1.781606 2.037894 2.229578 2.373087 2.478237 2.580304 2.642186 2.706240 2.760703 2.804821 2.838734 2.862602 2.876716 2.881056 2.875895 2.863112 2.861510 2.801378 0.000000 0.8773273 1.379166 1.699592 1.937849 2.114082 2.269492 2.375977 2.450444 2.526466 2.589915 2.617810 2.651294 2.677611 2.695878 2.705992 2.707614 2.701025 2.687857 2.686210 2.626906 0.000000 0.8441842 1.312208 1.629412 1.855378 2.020705 2.141707 2.251899 2.322171 2.365955 2.418361 2.460479 2.469083 2.483107 2.492759 2.496355 2.493118 2.482797 2.467642 2.462981 2.403489 0.000000 0.8039271 1.254135 1.551494 1.761169 1.910094 2.021224 2.101142 2.158555 2.217569 2.241539 2.268359 2.266193 2.271065 2.273080 2.269428 2.259405 2.243249 2.223646 2.192556 2.140090 0.000000 0.7610465 1.189392 1.466470 1.642829 1.780226 1.878254 1.964613 2.014044 2.040915 2.048801 2.063944 2.052394 2.048026 2.039274 2.023536 2.003912 1.979034 1.951330 1.914852 1.840826 0.000000 0.7167737 1.121206 1.366323 1.544228 1.667924 1.749653 1.804989 1.838634 1.852598 1.849592 1.851054 1.829087 1.814728 1.777954 1.749855 1.717854 1.679632 1.639102 1.591377 1.510287 0.000000 0.6723206 1.040317 1.279902 1.439901 1.531317 1.599849 1.641703 1.661960 1.661860 1.647961 1.620345 1.601894 1.562943 1.527594 1.487555 1.429855 1.376398 1.319976 1.258680 1.181808 0.000000 0.6257587 0.9704120 1.189185 1.318630 1.408652 1.460994 1.488023 1.480616 1.470020 1.442712 1.404572 1.371626 1.319963 1.258944 1.203605 1.143501 1.067676 0.9955316 0.9214889 0.8352577 0.000000 0.5783897 0.8974206 1.084671 1.207641 1.266836 1.304998 1.316290 1.308599 1.272968 1.232621 1.183731 1.126600 1.060039 0.9961539 0.9184690 0.8439189 0.7571317 0.6734160 0.5884786 0.4938498 0.000000 0.5307753 0.8219243 0.9890482 1.080865 1.135223 1.145483 1.143009 1.118621 1.070671 1.018079 0.9574399 0.8863071 0.8064121 0.7216891 0.6394288 0.5479386 0.4562140 0.3614541 0.2657180 0.1627248 0.000000 0.4775801 0.7368574 0.8886119 0.9619714 0.9887990 0.9932019 0.9648733 0.9250403 0.8647336 0.7994350 0.7246821 0.6345251 0.5442810 0.4550888 0.3586096 0.2603298 0.1584292 5.5224150E-02 -4.9718924E-02 -0.1612829 0.000000 0.4296519 0.6602330 0.7784458 0.8303927 0.8476802 0.8270139 0.7829863 0.7281214 0.6556388 0.5773699 0.4852684 0.3903573 0.2911012 0.1914164 8.7609947E-02 -2.0123718E-02 -0.1279660 -0.2357266 -0.3464990 -0.4586999 0.000000 0.3809473 0.5807914 0.6736443 0.7051493 0.6959466 0.6577216 0.5981585 0.5287490 0.4440447 0.3530783 0.2516579 0.1477527 4.1913956E-02 -6.4883418E-02 -0.1755754 -0.2847204 -0.3896547 -0.4985916 -0.6028637 -0.7077963 0.000000 0.3317354 0.4987786 0.5605496 0.5707703 0.5417642 0.4863070 0.4120208 0.3283783 0.2321600 0.1302372 2.2369867E-02 -8.7763496E-02 -0.1981099 -0.3051931 -0.4150328 -0.5157610 -0.6193908 -0.7258687 -0.8202744 -0.9179208 0.000000 0.2822976 0.4122979 0.4545712 0.4413917 0.3914537 0.3151655 0.2296139 0.1303807 2.5147781E-02 -8.5289694E-02 -0.1981922 -0.3063539 -0.4148440 -0.5190410 -0.6218880 -0.7171026 -0.8209854 -0.9091284 -0.9957791 -1.089048 0.000000 0.2326358 0.3324310 0.3479254 0.3099632 0.2410274 0.1520271 5.0697256E-02 -5.8334582E-02 -0.1706434 -0.2840250 -0.3953130 -0.4962514 -0.5998270 -0.7013838 -0.7914101 -0.8858600 -0.9762378 -1.052516 -1.135656 -1.205956 0.000000 0.1822580 0.2540990 0.2448296 0.1886898 0.1021986 1.4428953E-03 -0.1098856 -0.2250269 -0.3376328 -0.4488808 -0.5537922 -0.6503367 -0.7471113 -0.8387359 -0.9245792 -1.009827 -1.079945 -1.150775 -1.216861 -1.279960 0.000000 0.1349688 0.1772834 0.1512405 8.2979016E-02 -1.1187702E-02 -0.1184212 -0.2325329 -0.3439999 -0.4532930 -0.5581376 -0.6541554 -0.7511014 -0.8378242 -0.9193622 -0.9926021 -1.067933 -1.129110 -1.182759 -1.231184 -1.274500 0.000000 8.8182725E-02 0.1084364 7.4412242E-02 5.9465603E-03 -8.2957178E-02 -0.1809574 -0.2834980 -0.3843567 -0.4848632 -0.5786337 -0.6639653 -0.7545725 -0.8277147 -0.8991616 -0.9591291 -1.023836 -1.063659 -1.101988 -1.134154 -1.160066 0.000000 4.2929251E-02 4.7656037E-02 2.0861244E-02 -2.6387025E-02 -8.5745357E-02 -0.1514992 -0.2211475 -0.2898424 -0.3610508 -0.4305500 -0.4932600 -0.5557667 -0.6082727 -0.6622296 -0.7027820 -0.7372561 -0.7741357 -0.7957633 -0.8134454 -0.8260194 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.7715623 1.237779 1.548459 1.772659 1.938609 2.061161 2.170763 2.243980 2.313260 2.348947 2.387434 2.419014 2.442338 2.456954 2.462904 2.459884 2.473867 2.469899 2.469918 2.414788 0.000000 0.7493159 1.181834 1.475895 1.686183 1.858260 1.980175 2.067030 2.149371 2.197642 2.247785 2.288666 2.321126 2.345186 2.361293 2.369608 2.369669 2.361817 2.348196 2.343499 2.285870 0.000000 0.7249666 1.137558 1.417689 1.615817 1.759038 1.862279 1.956817 2.014627 2.073058 2.099745 2.130871 2.153916 2.170059 2.178419 2.178085 2.171103 2.157805 2.141635 2.134895 2.078215 0.000000 0.6999922 1.090294 1.351801 1.533908 1.662132 1.756565 1.823225 1.889003 1.922827 1.954760 1.962139 1.972139 1.976855 1.954643 1.940315 1.923636 1.902448 1.898121 1.872987 1.824442 0.000000 0.6667870 1.038202 1.277903 1.429979 1.547301 1.629528 1.702121 1.740546 1.758329 1.779067 1.775943 1.775497 1.752433 1.735966 1.716996 1.693615 1.665265 1.634534 1.595397 1.536294 0.000000 0.6279666 0.9784838 1.190466 1.343160 1.447892 1.515313 1.558480 1.581711 1.588177 1.595339 1.579764 1.567955 1.536483 1.509617 1.477961 1.443372 1.403568 1.360582 1.311125 1.231490 0.000000 0.5877483 0.9082770 1.114712 1.251032 1.326252 1.380681 1.410910 1.421795 1.417078 1.394988 1.379092 1.343712 1.311025 1.260824 1.216690 1.167849 1.112235 1.053110 0.9887803 0.9090269 0.000000 0.5478947 0.8472713 1.035086 1.143900 1.216741 1.255730 1.271982 1.270276 1.240293 1.205791 1.174801 1.127890 1.072037 1.018930 0.9599765 0.8873399 0.8150680 0.7388327 0.6592180 0.5676398 0.000000 0.5058290 0.7836564 0.9436579 1.045271 1.089557 1.114987 1.116258 1.100157 1.058403 1.012426 0.9581984 0.9056043 0.8387138 0.7631817 0.6873869 0.6064324 0.5155097 0.4239925 0.3308195 0.2312917 0.000000 0.4633433 0.7178562 0.8593466 0.9323372 0.9714462 0.9710296 0.9590074 0.9269774 0.8731807 0.8148516 0.7486786 0.6743433 0.5978775 0.5096871 0.4153453 0.3203135 0.2200980 0.1158452 1.1338754E-02 -0.1016265 0.000000 0.4180353 0.6437245 0.7704775 0.8261499 0.8399428 0.8336076 0.7973006 0.7504716 0.6842523 0.6130977 0.5338910 0.4460303 0.3509554 0.2529309 0.1484977 4.0801030E-02 -7.1364075E-02 -0.1837439 -0.2986465 -0.4194684 0.000000 0.3755793 0.5765094 0.6728819 0.7086562 0.7131762 0.6835182 0.6320838 0.5707049 0.4919346 0.4080034 0.3151167 0.2145298 0.1081695 -1.4733894E-04 -0.1151550 -0.2319298 -0.3457769 -0.4587717 -0.5722916 -0.6911473 0.000000 0.3332458 0.5067479 0.5797450 0.5966698 0.5770108 0.5304710 0.4641268 0.3881020 0.2971452 0.2006149 9.5395789E-02 -1.4394758E-02 -0.1310441 -0.2463065 -0.3653119 -0.4788764 -0.5883455 -0.7009656 -0.8127312 -0.9254256 0.000000 0.2903017 0.4344071 0.4793519 0.4766887 0.4385247 0.3752182 0.2975144 0.2037239 0.1030899 -5.2947383E-03 -0.1202075 -0.2368596 -0.3568197 -0.4709989 -0.5850783 -0.6929260 -0.7953932 -0.9107423 -1.014836 -1.115438 0.000000 0.2468143 0.3579580 0.3852141 0.3613016 0.3033185 0.2226757 0.1272574 2.2311887E-02 -8.9109115E-02 -0.2052003 -0.3232024 -0.4406772 -0.5601317 -0.6676805 -0.7712989 -0.8740654 -0.9695863 -1.078383 -1.168364 -1.254640 0.000000 0.2030005 0.2873529 0.2908537 0.2443898 0.1681908 7.2197132E-02 -3.6119293E-02 -0.1508812 -0.2675501 -0.3858453 -0.5011404 -0.6151976 -0.7284371 -0.8294944 -0.9272547 -1.014076 -1.109377 -1.206737 -1.278500 -1.357172 0.000000 0.1587555 0.2185131 0.2002142 0.1370260 4.4784643E-02 -6.3361660E-02 -0.1813589 -0.3002462 -0.4177501 -0.5334929 -0.6422610 -0.7522803 -0.8558622 -0.9528525 -1.033805 -1.118530 -1.202835 -1.284607 -1.337347 -1.396700 0.000000 0.1172653 0.1512905 0.1189119 4.5069516E-02 -5.4818947E-02 -0.1670745 -0.2860375 -0.4022394 -0.5156763 -0.6242635 -0.7238820 -0.8310701 -0.9213265 -1.006116 -1.083517 -1.154332 -1.227492 -1.290657 -1.328695 -1.371690 0.000000 7.6356202E-02 9.1511518E-02 5.3487141E-02 -1.8907364E-02 -0.1115705 -0.2135927 -0.3197419 -0.4239776 -0.5275623 -0.6238699 -0.7122140 -0.8047653 -0.8802456 -0.9534887 -1.015394 -1.070323 -1.133535 -1.175231 -1.208855 -1.235964 0.000000 3.7010990E-02 3.9435767E-02 1.0569082E-02 -3.8579028E-02 -9.9070624E-02 -0.1675386 -0.2389952 -0.3094029 -0.3826990 -0.4532738 -0.5175803 -0.5813925 -0.6354692 -0.6905252 -0.7325431 -0.7700064 -0.7981214 -0.8208035 -0.8470360 -0.8613971 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.6325300 1.029187 1.305869 1.495559 1.633790 1.733559 1.822230 1.878525 1.932408 1.976895 2.012217 2.038759 2.056890 2.066751 2.068727 2.062667 2.070228 2.062971 2.058352 2.023459 0.000000 0.6154287 0.9924343 1.245679 1.424318 1.569068 1.669663 1.740510 1.806987 1.860855 1.887088 1.915222 1.936653 1.951180 1.958714 1.959397 1.952911 1.960218 1.954083 1.951077 1.918074 0.000000 0.5950300 0.9534171 1.195440 1.364634 1.484916 1.585604 1.651531 1.693851 1.738781 1.773355 1.782875 1.794685 1.801940 1.803751 1.799993 1.790231 1.792339 1.782650 1.776673 1.724542 0.000000 0.5727608 0.9133930 1.140339 1.296083 1.403322 1.480170 1.535357 1.586476 1.608214 1.633043 1.632450 1.635043 1.633983 1.628636 1.618004 1.601487 1.579284 1.570259 1.543523 1.493955 0.000000 0.5511137 0.8720126 1.080610 1.208207 1.304706 1.385451 1.431256 1.455850 1.479519 1.483424 1.470332 1.462149 1.451432 1.434921 1.411754 1.384635 1.352839 1.319000 1.278705 1.220190 0.000000 0.5299229 0.8284067 1.007930 1.134482 1.219274 1.274082 1.302963 1.317786 1.331484 1.321630 1.297602 1.278544 1.255427 1.213712 1.177575 1.138610 1.094321 1.047156 1.004178 0.9388249 0.000000 0.5027469 0.7721762 0.9440684 1.055482 1.125433 1.154514 1.183702 1.187264 1.175850 1.152251 1.117746 1.086858 1.040270 0.9964372 0.9478869 0.8931792 0.8330724 0.7691813 0.7006311 0.6172675 0.000000 0.4675652 0.7209796 0.8763375 0.9634526 1.018765 1.043764 1.048632 1.037610 1.013368 0.9778561 0.9321843 0.8865473 0.8280686 0.7691905 0.6973413 0.6258548 0.5490664 0.4670510 0.3807977 0.2860189 0.000000 0.4313121 0.6670732 0.7985706 0.8786626 0.9073763 0.9193154 0.9101726 0.8854388 0.8478628 0.7993057 0.7411888 0.6748923 0.6069000 0.5270185 0.4448439 0.3569797 0.2624863 0.1614271 5.8389429E-02 -5.3152461E-02 0.000000 0.3906275 0.6116319 0.7268293 0.7807785 0.8038311 0.7919988 0.7701751 0.7305499 0.6789948 0.6164593 0.5449961 0.4651209 0.3767251 0.2847146 0.1865914 8.1457503E-02 -2.8988350E-02 -0.1462871 -0.2642980 -0.3919276 0.000000 0.3562312 0.5488713 0.6507216 0.6884567 0.6883228 0.6706840 0.6263158 0.5727944 0.5064315 0.4297307 0.3441121 0.2492355 0.1467008 4.0503420E-02 -7.3013902E-02 -0.1926956 -0.3135064 -0.4358514 -0.5586581 -0.6887643 0.000000 0.3197793 0.4916327 0.5668961 0.5860678 0.5770320 0.5381497 0.4795869 0.4117375 0.3304781 0.2399918 0.1394005 3.0519348E-02 -8.3805010E-02 -0.2018185 -0.3254721 -0.4483452 -0.5695596 -0.6908398 -0.8099161 -0.9347328 0.000000 0.2830938 0.4322602 0.4865085 0.4883938 0.4576007 0.4029913 0.3336146 0.2467577 0.1521613 4.7796559E-02 -6.6847645E-02 -0.1861639 -0.3060372 -0.4305704 -0.5550030 -0.6742720 -0.7906052 -0.9052239 -1.016658 -1.136845 0.000000 0.2474177 0.3706040 0.3996368 0.3836631 0.3363206 0.2681610 0.1802798 8.1024081E-02 -2.6892269E-02 -0.1441291 -0.2680938 -0.3881602 -0.5116097 -0.6339434 -0.7572292 -0.8674840 -0.9783962 -1.084005 -1.192828 -1.314586 0.000000 0.2109025 0.3048816 0.3180067 0.2831488 0.2176206 0.1295633 2.7744401E-02 -8.4388956E-02 -0.2030271 -0.3269963 -0.4535797 -0.5704161 -0.6913756 -0.8139556 -0.9207088 -1.023458 -1.130063 -1.227106 -1.339250 -1.433748 0.000000 0.1733877 0.2439127 0.2363836 0.1815976 9.8999582E-02 -4.1039516E-03 -0.1195055 -0.2406292 -0.3650762 -0.4908425 -0.6135487 -0.7255624 -0.8409420 -0.9532297 -1.051606 -1.148946 -1.236790 -1.333734 -1.429524 -1.502875 0.000000 0.1353936 0.1846177 0.1583468 8.8868223E-02 -8.9365151E-03 -0.1250817 -0.2471861 -0.3720207 -0.4973101 -0.6184776 -0.7324409 -0.8433842 -0.9489233 -1.048977 -1.142811 -1.222105 -1.309325 -1.390692 -1.465614 -1.520668 0.000000 9.9771410E-02 0.1268955 9.0281352E-02 1.0991947E-02 -9.4048396E-02 -0.2138355 -0.3354870 -0.4584810 -0.5806615 -0.6934425 -0.7976122 -0.9010494 -0.9938840 -1.081456 -1.160235 -1.239718 -1.311752 -1.374252 -1.427730 -1.475416 0.000000 6.4694017E-02 7.5897843E-02 3.4845494E-02 -4.0775925E-02 -0.1370471 -0.2451074 -0.3527704 -0.4650188 -0.5673984 -0.6667179 -0.7579097 -0.8525544 -0.9304762 -1.005088 -1.069643 -1.137632 -1.191005 -1.234275 -1.269449 -1.297979 0.000000 3.1184027E-02 3.1979628E-02 1.7609181E-03 -4.8780181E-02 -0.1116327 -0.1820013 -0.2528976 -0.3273655 -0.4022576 -0.4697380 -0.5402791 -0.5993754 -0.6616318 -0.7102304 -0.7608761 -0.7997352 -0.8286505 -0.8525348 -0.8800164 -0.8953815 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.5007095 0.8312794 1.053841 1.206121 1.313471 1.387762 1.453562 1.506631 1.534174 1.560610 1.580718 1.593962 1.600306 1.599629 1.609797 1.605800 1.609720 1.600895 1.592939 1.555840 0.000000 0.4804680 0.8008761 1.009129 1.152471 1.266929 1.343526 1.409379 1.448452 1.485598 1.514183 1.535701 1.550518 1.559063 1.561665 1.558417 1.548941 1.550385 1.541190 1.534259 1.498915 0.000000 0.4611343 0.7666901 0.9665926 1.103243 1.197714 1.276678 1.325298 1.369702 1.389677 1.410815 1.425556 1.434402 1.437693 1.435728 1.428517 1.415774 1.412029 1.399105 1.388964 1.351235 0.000000 0.4395989 0.7310852 0.9197532 1.046774 1.133875 1.192933 1.243674 1.269007 1.290988 1.295271 1.299680 1.299528 1.294876 1.285077 1.269938 1.249809 1.224630 1.210150 1.181994 1.133432 0.000000 0.4190094 0.6955096 0.8713490 0.9862430 1.063423 1.113985 1.144163 1.157358 1.172446 1.165645 1.159068 1.148742 1.132479 1.109806 1.083276 1.052974 1.017986 0.9810659 0.9483345 0.8941684 0.000000 0.4039217 0.6607329 0.8158297 0.9175528 0.9818056 1.020148 1.038704 1.052679 1.045484 1.025351 1.007219 0.9843232 0.9458151 0.9103132 0.8716846 0.8287221 0.7803341 0.7288299 0.6797584 0.6107050 0.000000 0.3861755 0.6220506 0.7672276 0.8536489 0.9043318 0.9307714 0.9373900 0.9289724 0.9084491 0.8775608 0.8476887 0.8037285 0.7604995 0.7125831 0.6586756 0.5997612 0.5345821 0.4650408 0.3910995 0.3065928 0.000000 0.3701893 0.5901965 0.7133201 0.7783709 0.8161487 0.8281415 0.8207255 0.7997747 0.7675462 0.7253391 0.6810541 0.6248405 0.5675013 0.4989446 0.4280878 0.3511094 0.2671841 0.1788575 8.4980972E-02 -1.8396374E-02 0.000000 0.3553996 0.5486284 0.6506181 0.7092119 0.7305484 0.7214153 0.7022347 0.6683964 0.6236612 0.5688498 0.5054077 0.4399962 0.3634883 0.2821410 0.1928942 9.6236847E-02 -6.4288224E-03 -0.1191790 -0.2331232 -0.3590389 0.000000 0.3227908 0.5037094 0.5926775 0.6287778 0.6358473 0.6191109 0.5809218 0.5349550 0.4763165 0.4080831 0.3314949 0.2495573 0.1568088 5.7129234E-02 -5.0358754E-02 -0.1654960 -0.2864151 -0.4125010 -0.5339470 -0.6695746 0.000000 0.2938314 0.4529509 0.5310554 0.5523129 0.5380242 0.5087391 0.4617121 0.3979289 0.3253430 0.2432932 0.1521050 5.2761760E-02 -5.6337144E-02 -0.1726331 -0.2928442 -0.4181291 -0.5461677 -0.6769486 -0.8023017 -0.9410464 0.000000 0.2629681 0.4060374 0.4625336 0.4665938 0.4435790 0.3958508 0.3346474 0.2573120 0.1708093 7.5168930E-02 -3.2481436E-02 -0.1477811 -0.2692215 -0.3918756 -0.5198623 -0.6481081 -0.7760992 -0.9060064 -1.035503 -1.169384 0.000000 0.2318763 0.3575985 0.3965474 0.3845979 0.3421087 0.2804937 0.2046409 0.1143029 1.3363465E-02 -9.8673806E-02 -0.2204420 -0.3439043 -0.4680033 -0.5947673 -0.7267796 -0.8503151 -0.9771140 -1.102625 -1.222746 -1.343332 0.000000 0.2011428 0.3073310 0.3277769 0.2959629 0.2418801 0.1646487 7.1454540E-02 -3.3197921E-02 -0.1482212 -0.2716536 -0.3998940 -0.5269407 -0.6507258 -0.7808782 -0.9011542 -1.020266 -1.146122 -1.262631 -1.370442 -1.477061 0.000000 0.1705460 0.2534846 0.2560648 0.2108517 0.1386739 4.4870339E-02 -6.2066235E-02 -0.1804003 -0.3059453 -0.4362468 -0.5624614 -0.6926142 -0.8111395 -0.9344878 -1.049430 -1.165521 -1.271491 -1.381391 -1.477430 -1.575647 0.000000 0.1409848 0.2029329 0.1872851 0.1249621 3.8288232E-02 -7.1381673E-02 -0.1907577 -0.3196803 -0.4500442 -0.5806236 -0.7055339 -0.8296534 -0.9411161 -1.055940 -1.167904 -1.265100 -1.365575 -1.450382 -1.545708 -1.641586 0.000000 0.1099572 0.1532673 0.1217673 4.7163904E-02 -5.5073421E-02 -0.1756350 -0.3025058 -0.4389037 -0.5685897 -0.6946765 -0.8082812 -0.9231657 -1.031069 -1.133911 -1.230657 -1.325547 -1.403470 -1.485700 -1.562754 -1.635251 0.000000 8.1531592E-02 0.1047920 6.5090463E-02 -1.7036520E-02 -0.1258862 -0.2499436 -0.3762666 -0.5088052 -0.6303070 -0.7468255 -0.8590081 -0.9629418 -1.057604 -1.147760 -1.229135 -1.310892 -1.384695 -1.448731 -1.504766 -1.554072 0.000000 5.3028550E-02 6.2146731E-02 1.9908732E-02 -5.7591982E-02 -0.1569280 -0.2684290 -0.3797364 -0.4953438 -0.6010338 -0.7033932 -0.8046732 -0.8941060 -0.9744830 -1.051088 -1.117620 -1.187346 -1.242114 -1.286910 -1.323588 -1.353642 0.000000 2.5436297E-02 2.5608014E-02 -4.8206197E-03 -5.6749944E-02 -0.1213824 -0.1936906 -0.2662334 -0.3423881 -0.4147823 -0.4877890 -0.5542583 -0.6202205 -0.6839811 -0.7337667 -0.7862795 -0.8254746 -0.8556418 -0.8806990 -0.9003504 -0.9237713 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.3766986 0.6262623 0.7879610 0.9029135 0.9744228 1.030981 1.064389 1.092914 1.114123 1.128618 1.137057 1.139729 1.136832 1.140398 1.134172 1.132786 1.120737 1.116443 1.107238 1.071580 0.000000 0.3603001 0.6054145 0.7670534 0.8779982 0.9510042 0.9995893 1.040640 1.071281 1.083540 1.095406 1.102890 1.105576 1.114681 1.114308 1.107703 1.107190 1.096787 1.094391 1.088107 1.055678 0.000000 0.3447301 0.5782759 0.7346038 0.8321939 0.9050846 0.9506364 0.9783928 1.003199 1.019930 1.031037 1.036888 1.037889 1.034387 1.026520 1.014272 1.007758 0.9921350 0.9838369 0.9632956 0.9218799 0.000000 0.3245183 0.5484786 0.6955584 0.7864154 0.8457739 0.8916983 0.9158216 0.9246152 0.9349982 0.9384183 0.9366240 0.9299008 0.9184810 0.9023240 0.8818195 0.8572768 0.8370786 0.8115851 0.7884493 0.7434995 0.000000 0.3075556 0.5159525 0.6544719 0.7384846 0.7918020 0.8227199 0.8365088 0.8482696 0.8416150 0.8346290 0.8215412 0.8030515 0.7788137 0.7504738 0.7185744 0.6833003 0.6439494 0.6094165 0.5677155 0.5140015 0.000000 0.2873771 0.4853895 0.6100357 0.6869107 0.7298744 0.7501953 0.7622219 0.7552359 0.7429043 0.7187614 0.6930582 0.6552709 0.6173083 0.5761702 0.5312977 0.4822995 0.4323138 0.3757628 0.3178015 0.2463867 0.000000 0.2724290 0.4568894 0.5752860 0.6409932 0.6717656 0.6810805 0.6740636 0.6532958 0.6290748 0.5940381 0.5548341 0.5050768 0.4544924 0.3993737 0.3387246 0.2715437 0.1991237 0.1195128 3.6086105E-02 -5.8703899E-02 0.000000 0.2555738 0.4314407 0.5402374 0.5853143 0.6043322 0.6007705 0.5810094 0.5477741 0.5128402 0.4646134 0.4075224 0.3481280 0.2827805 0.2105946 0.1299273 4.1160651E-02 -5.4029658E-02 -0.1581393 -0.2656077 -0.3898044 0.000000 0.2405573 0.4084876 0.4974219 0.5343333 0.5389792 0.5221297 0.4848486 0.4455961 0.3928572 0.3308128 0.2607807 0.1858429 0.1026463 1.0774002E-02 -9.1944076E-02 -0.2003445 -0.3133591 -0.4379138 -0.5611520 -0.7026429 0.000000 0.2275521 0.3874672 0.4563197 0.4739200 0.4659940 0.4360288 0.3911334 0.3354450 0.2691332 0.1934986 0.1093153 1.7130775E-02 -8.5233688E-02 -0.1967265 -0.3143525 -0.4331273 -0.5627519 -0.6993553 -0.8323193 -0.9832935 0.000000 0.2153948 0.3577254 0.4115162 0.4168600 0.3935170 0.3474888 0.2912488 0.2225487 0.1425740 5.2553389E-02 -4.7430288E-02 -0.1574922 -0.2747508 -0.3991789 -0.5224428 -0.6540988 -0.7915434 -0.9310972 -1.073156 -1.224308 0.000000 0.2078064 0.3226409 0.3607555 0.3548866 0.3152005 0.2575225 0.1891453 0.1066360 1.2245956E-02 -9.2882991E-02 -0.2086962 -0.3305271 -0.4576429 -0.5880912 -0.7199255 -0.8585464 -0.9958811 -1.131801 -1.267674 -1.408155 0.000000 0.1852155 0.2854384 0.3111573 0.2874977 0.2344399 0.1678357 8.3567895E-02 -1.3515010E-02 -0.1233190 -0.2410224 -0.3676332 -0.4987972 -0.6311917 -0.7630095 -0.8971193 -1.037524 -1.166926 -1.295984 -1.420899 -1.550048 0.000000 0.1602062 0.2471291 0.2586934 0.2200190 0.1541482 7.2775736E-02 -2.5343331E-02 -0.1384960 -0.2600392 -0.3880628 -0.5192389 -0.6570045 -0.7909880 -0.9194188 -1.055112 -1.177459 -1.301471 -1.421108 -1.530695 -1.656954 0.000000 0.1354118 0.2051489 0.2027039 0.1497502 7.1583733E-02 -2.4862058E-02 -0.1378017 -0.2626819 -0.3960131 -0.5256059 -0.6635548 -0.7952565 -0.9318225 -1.049682 -1.175206 -1.291551 -1.413369 -1.520289 -1.614564 -1.723456 0.000000 0.1104110 0.1658099 0.1477656 8.0984578E-02 -9.3136728E-03 -0.1219768 -0.2466556 -0.3811837 -0.5183786 -0.6497720 -0.7841928 -0.9163155 -1.039719 -1.147663 -1.262760 -1.377451 -1.476253 -1.574988 -1.654128 -1.747306 0.000000 8.5403532E-02 0.1262054 9.4644934E-02 1.6862322E-02 -8.5579447E-02 -0.2084159 -0.3396137 -0.4808756 -0.6159691 -0.7477702 -0.8750346 -0.9965659 -1.099950 -1.205731 -1.307643 -1.406854 -1.500693 -1.570404 -1.646678 -1.719521 0.000000 6.2656835E-02 8.6176857E-02 4.8503693E-02 -3.4732770E-02 -0.1448872 -0.2698867 -0.4007097 -0.5380639 -0.6645448 -0.7861332 -0.9026363 -1.010290 -1.108976 -1.201146 -1.291202 -1.374275 -1.447471 -1.511265 -1.567213 -1.618363 0.000000 4.0432882E-02 5.1137052E-02 1.1455267E-02 -6.5340325E-02 -0.1662047 -0.2793479 -0.3947996 -0.5142461 -0.6234675 -0.7293163 -0.8333076 -0.9254298 -1.008202 -1.086759 -1.165638 -1.230807 -1.284408 -1.328782 -1.365772 -1.400256 0.000000 1.9338246E-02 2.0835700E-02 -7.5706001E-03 -5.9770413E-02 -0.1256663 -0.1974225 -0.2738168 -0.3518297 -0.4257037 -0.5003054 -0.5682171 -0.6355007 -0.6935124 -0.7512842 -0.7967684 -0.8444416 -0.8761450 -0.9021875 -0.9227753 -0.9464428 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.2473918 0.4049664 0.5015152 0.5651491 0.6125284 0.6366259 0.6510514 0.6579837 0.6590245 0.6555197 0.6480640 0.6368841 0.6288798 0.6152700 0.6043805 0.5934571 0.5761588 0.5640203 0.5486462 0.5175166 0.000000 0.2412277 0.3959053 0.4950290 0.5589122 0.6076820 0.6362457 0.6483009 0.6568914 0.6604633 0.6598312 0.6555251 0.6477321 0.6440282 0.6343015 0.6274928 0.6146985 0.6045592 0.5976471 0.5882040 0.5630190 0.000000 0.2359689 0.3802407 0.4752720 0.5357840 0.5793114 0.5979907 0.6121855 0.6192163 0.6212912 0.6192312 0.6137573 0.6050964 0.5933895 0.5786999 0.5674125 0.5508083 0.5360919 0.5237674 0.5097455 0.4761747 0.000000 0.2269578 0.3638771 0.4471862 0.5055854 0.5330216 0.5524873 0.5571537 0.5596265 0.5559607 0.5481607 0.5362141 0.5204912 0.5012952 0.4787232 0.4579405 0.4320118 0.4061335 0.3772649 0.3490882 0.3070767 0.000000 0.2125432 0.3397447 0.4172370 0.4661487 0.4895114 0.4985832 0.5016382 0.4911418 0.4790118 0.4608602 0.4382289 0.4111741 0.3800302 0.3449671 0.3094473 0.2689295 0.2257541 0.1782013 0.1296360 7.0334353E-02 0.000000 0.1952842 0.3151872 0.3848975 0.4237794 0.4448853 0.4458338 0.4340624 0.4178112 0.3896310 0.3589722 0.3228250 0.2816783 0.2357329 0.1848143 0.1304499 7.0593864E-02 2.4156743E-03 -6.9049515E-02 -0.1450414 -0.2378113 0.000000 0.1793020 0.2894312 0.3545997 0.3882017 0.3958152 0.3844223 0.3641727 0.3313708 0.2929173 0.2466415 0.1954893 0.1385432 7.5226776E-02 4.1481284E-03 -6.9554090E-02 -0.1545934 -0.2478460 -0.3464320 -0.4520678 -0.5751588 0.000000 0.1630349 0.2646078 0.3263055 0.3521599 0.3473894 0.3227439 0.2861384 0.2398878 0.1883777 0.1283275 6.1355736E-02 -1.3467779E-02 -9.4900928E-02 -0.1841968 -0.2810019 -0.3910761 -0.5046742 -0.6262373 -0.7538898 -0.8944215 0.000000 0.1486010 0.2416561 0.3002820 0.3135120 0.2944461 0.2561454 0.2065052 0.1481061 8.2958214E-02 7.0265406E-03 -7.5212754E-02 -0.1673257 -0.2657159 -0.3746269 -0.4908727 -0.6175047 -0.7458732 -0.8909102 -1.029611 -1.180198 0.000000 0.1334597 0.2214610 0.2749886 0.2763977 0.2404537 0.1897828 0.1279452 5.8168024E-02 -2.2859728E-02 -0.1124757 -0.2108892 -0.3192627 -0.4315524 -0.5553769 -0.6891575 -0.8213350 -0.9677183 -1.118208 -1.260729 -1.426264 0.000000 0.1191944 0.2044030 0.2538586 0.2351173 0.1896787 0.1253240 5.1736917E-02 -3.1940561E-02 -0.1266253 -0.2296681 -0.3422756 -0.4645675 -0.5890329 -0.7244784 -0.8639074 -1.009497 -1.162884 -1.305574 -1.458313 -1.621008 0.000000 0.1071026 0.1895856 0.2279921 0.1961382 0.1367391 6.1129715E-02 -2.3434345E-02 -0.1204335 -0.2265109 -0.3413261 -0.4671747 -0.5992037 -0.7367050 -0.8775692 -1.019590 -1.171838 -1.323596 -1.470931 -1.617154 -1.768792 0.000000 9.7238660E-02 0.1810354 0.1980856 0.1553601 8.5086539E-02 -1.5610233E-03 -9.7695038E-02 -0.2070847 -0.3237131 -0.4509595 -0.5887875 -0.7275620 -0.8708171 -1.012333 -1.159629 -1.317851 -1.458043 -1.595522 -1.730692 -1.872403 0.000000 8.9391991E-02 0.1762405 0.1669678 0.1150795 3.2499079E-02 -6.3599497E-02 -0.1712810 -0.2919092 -0.4190422 -0.5588830 -0.6978956 -0.8409488 -0.9879712 -1.128014 -1.284217 -1.419988 -1.546175 -1.676089 -1.798408 -1.939860 0.000000 8.4079422E-02 0.1495004 0.1344606 7.3040083E-02 -1.9269265E-02 -0.1250342 -0.2446434 -0.3727323 -0.5115904 -0.6561102 -0.7992361 -0.9443848 -1.079697 -1.223202 -1.369907 -1.489716 -1.607044 -1.733195 -1.840687 -1.958046 0.000000 8.1478015E-02 0.1215277 0.1023827 3.1640779E-02 -6.9775201E-02 -0.1846786 -0.3142460 -0.4530879 -0.5962361 -0.7416742 -0.8880067 -1.020055 -1.155221 -1.288964 -1.421686 -1.524568 -1.640580 -1.737174 -1.833088 -1.911478 0.000000 6.2394708E-02 9.4216071E-02 6.9852263E-02 -8.9695267E-03 -0.1160257 -0.2399594 -0.3767458 -0.5206926 -0.6627882 -0.8039570 -0.9403176 -1.068747 -1.190215 -1.313761 -1.428426 -1.518858 -1.617997 -1.701659 -1.764622 -1.838813 0.000000 4.5256495E-02 6.7303225E-02 3.9225001E-02 -4.1709624E-02 -0.1500578 -0.2765024 -0.4117616 -0.5548488 -0.6882802 -0.8210670 -0.9428347 -1.055997 -1.160121 -1.277260 -1.369690 -1.456008 -1.534606 -1.587555 -1.646468 -1.701031 0.000000 2.8732084E-02 4.2061884E-02 1.2772845E-02 -6.0211074E-02 -0.1587402 -0.2739665 -0.3934994 -0.5180719 -0.6323634 -0.7511331 -0.8520216 -0.9487475 -1.035463 -1.128607 -1.199710 -1.268150 -1.324709 -1.372092 -1.412062 -1.448956 0.000000 1.3610444E-02 1.7832438E-02 -3.3601013E-03 -5.1769190E-02 -0.1171804 -0.1916692 -0.2706676 -0.3516174 -0.4271645 -0.5042552 -0.5736982 -0.6430545 -0.7026963 -0.7622283 -0.8093807 -0.8586039 -0.8919266 -0.9195696 -0.9417517 -0.9664061 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 8.0646276E-02 0.1580680 0.2054581 0.2260409 0.2279576 0.2176886 0.1984150 0.1761331 0.1497484 0.1218728 9.2808083E-02 6.3211434E-02 3.2784406E-02 3.0062716E-03 -2.8478859E-02 -5.8747008E-02 -8.8850997E-02 -0.1195711 -0.1454857 -0.1705325 0.000000 7.0692256E-02 0.1449303 0.1972990 0.2287616 0.2419204 0.2434462 0.2368080 0.2243947 0.2101165 0.1926003 0.1749564 0.1555353 0.1360738 0.1166356 9.6454762E-02 7.5905629E-02 5.5103775E-02 3.2307640E-02 1.1982879E-02 -8.6743413E-03 0.000000 5.8851548E-02 0.1235059 0.1755392 0.2048074 0.2188700 0.2225559 0.2188558 0.2111734 0.2002900 0.1854751 0.1695883 0.1521190 0.1339492 0.1153833 9.5936209E-02 7.5827368E-02 5.3386275E-02 2.8842861E-02 6.6113439E-03 -1.6832780E-02 0.000000 4.6314232E-02 9.8062120E-02 0.1398062 0.1644390 0.1789113 0.1822315 0.1773427 0.1676734 0.1544998 0.1372334 0.1181880 9.6238539E-02 7.2302110E-02 4.6337817E-02 1.7854296E-02 -1.3019819E-02 -4.6486981E-02 -8.2700528E-02 -0.1152970 -0.1623076 0.000000 3.3955004E-02 6.8781279E-02 9.6578650E-02 0.1172933 0.1265427 0.1251280 0.1150032 9.9552251E-02 7.9379261E-02 5.4656334E-02 2.5575189E-02 -7.7572768E-03 -4.5849606E-02 -8.6703353E-02 -0.1316155 -0.1836943 -0.2406870 -0.3032769 -0.3678018 -0.4490978 0.000000 2.1781536E-02 3.5339542E-02 5.0418910E-02 6.3180625E-02 6.4523153E-02 5.4447323E-02 3.5315491E-02 8.8657551E-03 -2.3760540E-02 -6.2275335E-02 -0.1064255 -0.1595716 -0.2210348 -0.2862321 -0.3598453 -0.4345128 -0.5186237 -0.6094683 -0.7025560 -0.8202324 0.000000 9.8393010E-03 9.7844459E-04 3.2077457E-03 3.4861993E-03 -7.4692811E-03 -3.0502299E-02 -6.3640907E-02 -0.1063838 -0.1558387 -0.2145468 -0.2838182 -0.3614592 -0.4445848 -0.5358024 -0.6340110 -0.7311152 -0.8413013 -0.9579892 -1.085459 -1.233461 0.000000 -1.7603586E-03 -3.2592360E-02 -4.5835044E-02 -6.2356960E-02 -9.0252325E-02 -0.1315038 -0.1838170 -0.2469442 -0.3174000 -0.3978877 -0.4928972 -0.5903405 -0.6965445 -0.8103779 -0.9280650 -1.055785 -1.189546 -1.332221 -1.480948 -1.657572 0.000000 -1.2964135E-02 -6.4068973E-02 -9.6575677E-02 -0.1352582 -0.1853173 -0.2478410 -0.3217689 -0.4058654 -0.4963882 -0.6041694 -0.7144014 -0.8315446 -0.9665256 -1.096622 -1.233335 -1.386490 -1.536273 -1.707805 -1.863234 -2.045663 0.000000 -2.3719614E-02 -9.3036927E-02 -0.1496690 -0.2141648 -0.2899933 -0.3749915 -0.4709306 -0.5721474 -0.6880258 -0.8158432 -0.9439223 -1.086128 -1.234487 -1.375849 -1.536214 -1.688054 -1.857530 -2.025040 -2.175743 -2.355603 0.000000 -3.3220623E-02 -0.1190605 -0.2026692 -0.2971703 -0.3977188 -0.5085597 -0.6215621 -0.7476546 -0.8827555 -1.025165 -1.172953 -1.328663 -1.475945 -1.635002 -1.796147 -1.959935 -2.125095 -2.268049 -2.430449 -2.603006 0.000000 -4.0705230E-02 -0.1436694 -0.2558075 -0.3746442 -0.5037777 -0.6355121 -0.7737249 -0.9174886 -1.068227 -1.219425 -1.374355 -1.539253 -1.699885 -1.855894 -2.010247 -2.163631 -2.315353 -2.467499 -2.617754 -2.774555 0.000000 -4.6423860E-02 -0.1613658 -0.2995197 -0.4473742 -0.6014747 -0.7532875 -0.9101016 -1.065993 -1.231019 -1.386691 -1.550294 -1.722951 -1.872999 -2.025114 -2.171019 -2.311113 -2.455537 -2.594616 -2.729095 -2.867590 0.000000 -4.9288113E-02 -0.1743638 -0.3369046 -0.5071212 -0.6828301 -0.8539368 -1.029372 -1.193937 -1.350223 -1.517957 -1.691524 -1.838043 -1.982534 -2.136296 -2.273848 -2.399523 -2.549272 -2.673230 -2.802662 -2.926480 0.000000 -4.9901206E-02 -0.1833855 -0.3561822 -0.5465928 -0.7383447 -0.9295187 -1.104339 -1.279497 -1.436257 -1.600475 -1.762384 -1.903972 -2.049121 -2.174453 -2.318681 -2.424265 -2.556691 -2.675349 -2.806298 -2.911657 0.000000 -4.8484564E-02 -0.1812591 -0.3605659 -0.5582719 -0.7574161 -0.9517071 -1.138682 -1.303198 -1.467480 -1.623038 -1.772701 -1.918668 -2.038743 -2.170986 -2.290730 -2.384558 -2.505865 -2.629401 -2.718855 -2.828419 0.000000 -4.4368260E-02 -0.1705542 -0.3428105 -0.5351146 -0.7300667 -0.9195663 -1.101502 -1.271272 -1.428528 -1.573997 -1.713489 -1.846302 -1.969876 -2.086666 -2.175406 -2.280753 -2.386695 -2.483646 -2.573027 -2.659390 0.000000 -3.7689835E-02 -0.1466146 -0.2963257 -0.4701393 -0.6462772 -0.8207081 -0.9947704 -1.154157 -1.299871 -1.434963 -1.567135 -1.687266 -1.795633 -1.897473 -1.989859 -2.087516 -2.173894 -2.245149 -2.311481 -2.373059 0.000000 -2.8321460E-02 -0.1109131 -0.2258379 -0.3609222 -0.5005781 -0.6456156 -0.7829864 -0.9259968 -1.049924 -1.170220 -1.292400 -1.396538 -1.489922 -1.579528 -1.656750 -1.747999 -1.810164 -1.861139 -1.912656 -1.953514 0.000000 -1.5879015E-02 -6.1879102E-02 -0.1267841 -0.2030957 -0.2867190 -0.3696054 -0.4577703 -0.5477288 -0.6291829 -0.7150984 -0.7909637 -0.8691778 -0.9353566 -1.003360 -1.056753 -1.113544 -1.152443 -1.185511 -1.222935 -1.241846 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 7.2501801E-02 8.3982125E-02 6.6413082E-02 3.0364890E-02 -1.6352598E-02 -6.9146529E-02 -0.1229070 -0.1753445 -0.2279484 -0.2777176 -0.3230264 -0.3724429 -0.4268716 -0.4827809 -0.5346217 -0.5901305 -0.6483060 -0.6982437 -0.7502645 -0.8248186 0.000000 7.0866153E-02 9.1406353E-02 8.8636674E-02 6.8487071E-02 3.8405981E-02 3.4710362E-03 -3.5724543E-02 -7.5928621E-02 -0.1145933 -0.1536236 -0.1907336 -0.2267994 -0.2588105 -0.2891061 -0.3250261 -0.3636584 -0.4002195 -0.4361672 -0.4708762 -0.5258713 0.000000 6.6384286E-02 8.8960595E-02 9.3365029E-02 8.3174542E-02 6.1835054E-02 3.3500820E-02 1.4868204E-03 -3.3949424E-02 -6.7720018E-02 -0.1005372 -0.1316124 -0.1599261 -0.1872519 -0.2120965 -0.2452203 -0.2771457 -0.3124388 -0.3466214 -0.3790467 -0.4303384 0.000000 6.0582213E-02 8.1124239E-02 8.6834662E-02 7.8597307E-02 5.8998521E-02 3.3532616E-02 4.4043036E-03 -2.5832467E-02 -5.5197783E-02 -8.3666280E-02 -0.1124309 -0.1414027 -0.1724414 -0.2071623 -0.2462064 -0.2874429 -0.3316922 -0.3759001 -0.4227773 -0.4870565 0.000000 5.2822199E-02 6.7550570E-02 6.9504090E-02 5.9270043E-02 4.0050652E-02 1.5317624E-02 -1.1074809E-02 -3.8655885E-02 -6.8645328E-02 -0.1009226 -0.1362244 -0.1786898 -0.2248402 -0.2732282 -0.3275743 -0.3827164 -0.4425145 -0.5089827 -0.5766400 -0.6621865 0.000000 4.4266984E-02 5.0460663E-02 4.4559874E-02 3.0341251E-02 9.6152201E-03 -1.4418289E-02 -4.2602930E-02 -7.5776659E-02 -0.1150253 -0.1604347 -0.2129038 -0.2706621 -0.3333067 -0.3973625 -0.4697394 -0.5437948 -0.6294233 -0.7213665 -0.8131892 -0.9326007 0.000000 3.5252791E-02 3.0286478E-02 1.4086165E-02 -5.7150433E-03 -2.9213700E-02 -5.8135435E-02 -9.5707990E-02 -0.1418310 -0.1975264 -0.2603343 -0.3307811 -0.4024443 -0.4818160 -0.5685393 -0.6614025 -0.7631131 -0.8738478 -0.9938346 -1.113718 -1.269071 0.000000 2.6392587E-02 7.1117920E-03 -2.0376077E-02 -4.7476970E-02 -7.8266457E-02 -0.1200399 -0.1736184 -0.2368339 -0.3070523 -0.3887765 -0.4762473 -0.5687791 -0.6701590 -0.7773617 -0.8944435 -1.020467 -1.151794 -1.304737 -1.453471 -1.617762 0.000000 1.7142480E-02 -1.6966160E-02 -5.7269976E-02 -9.5448412E-02 -0.1404447 -0.2007301 -0.2734525 -0.3530169 -0.4398445 -0.5408126 -0.6459552 -0.7585550 -0.8839474 -1.011027 -1.161013 -1.305478 -1.455064 -1.618767 -1.774975 -1.964134 0.000000 8.1306845E-03 -4.1141346E-02 -9.6510038E-02 -0.1500054 -0.2161915 -0.2979866 -0.3848980 -0.4850536 -0.5900496 -0.7106853 -0.8353897 -0.9708537 -1.105405 -1.259697 -1.424382 -1.579508 -1.744874 -1.896856 -2.070110 -2.259944 0.000000 -2.5752650E-04 -6.5213472E-02 -0.1375419 -0.2126198 -0.3004946 -0.4022014 -0.5074366 -0.6244537 -0.7530364 -0.8905075 -1.038628 -1.181195 -1.339357 -1.505426 -1.671294 -1.839224 -1.989589 -2.152666 -2.321947 -2.501141 0.000000 -7.8882352E-03 -8.7435149E-02 -0.1799955 -0.2760001 -0.3899304 -0.5111468 -0.6384662 -0.7736335 -0.9183195 -1.070492 -1.229295 -1.390379 -1.559799 -1.724714 -1.883375 -2.043492 -2.198893 -2.353230 -2.512273 -2.674749 0.000000 -1.4505423E-02 -0.1074654 -0.2174624 -0.3404583 -0.4792836 -0.6191668 -0.7633021 -0.9156376 -1.070603 -1.240667 -1.403868 -1.569755 -1.745412 -1.896803 -2.051233 -2.199705 -2.338220 -2.487410 -2.631063 -2.770832 0.000000 -1.9940058E-02 -0.1224072 -0.2531079 -0.3998850 -0.5610739 -0.7188618 -0.8797978 -1.051387 -1.211553 -1.385281 -1.551024 -1.720163 -1.870939 -2.010641 -2.171370 -2.299781 -2.432412 -2.584965 -2.705154 -2.831802 0.000000 -2.3582835E-02 -0.1339358 -0.2772787 -0.4469137 -0.6260707 -0.8004164 -0.9770845 -1.155540 -1.317548 -1.488865 -1.659532 -1.806343 -1.956809 -2.088144 -2.228036 -2.340503 -2.483955 -2.594795 -2.705441 -2.842263 0.000000 -2.5755601E-02 -0.1364558 -0.2915275 -0.4730175 -0.6626825 -0.8526833 -1.027932 -1.204442 -1.373552 -1.536504 -1.692694 -1.842023 -1.966242 -2.103654 -2.205828 -2.323964 -2.450141 -2.550705 -2.667418 -2.775037 0.000000 -2.5870409E-02 -0.1307639 -0.2844237 -0.4689941 -0.6581383 -0.8459962 -1.026477 -1.199307 -1.360385 -1.512706 -1.653892 -1.788720 -1.917945 -2.038999 -2.130325 -2.238450 -2.346597 -2.445739 -2.537359 -2.599787 0.000000 -2.3496773E-02 -0.1172190 -0.2561979 -0.4246593 -0.5981636 -0.7726911 -0.9398293 -1.106063 -1.255881 -1.395902 -1.523089 -1.649082 -1.762284 -1.866457 -1.960768 -2.060225 -2.148021 -2.220963 -2.288673 -2.351628 0.000000 -1.8549418E-02 -9.1830857E-02 -0.2013076 -0.3345543 -0.4729834 -0.6197794 -0.7581937 -0.8908636 -1.026652 -1.148703 -1.259243 -1.377533 -1.471876 -1.562612 -1.640866 -1.733377 -1.796591 -1.848647 -1.900896 -1.942744 0.000000 -1.0909310E-02 -5.2711416E-02 -0.1159060 -0.1920198 -0.2729843 -0.3592274 -0.4480208 -0.5332308 -0.6203646 -0.7068970 -0.7830645 -0.8618689 -0.9283663 -0.9969630 -1.050692 -1.108093 -1.147349 -1.180821 -1.218817 -1.238166 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 8.4171809E-02 5.7770193E-02 -1.3698847E-03 -7.5642966E-02 -0.1546755 -0.2346726 -0.3118053 -0.3848084 -0.4607618 -0.5453064 -0.6265994 -0.7067206 -0.7866185 -0.8669211 -0.9480742 -1.030547 -1.104016 -1.180660 -1.255969 -1.369934 0.000000 8.6831830E-02 8.0893233E-02 4.0512688E-02 -1.3674625E-02 -7.5627342E-02 -0.1382899 -0.1988142 -0.2563313 -0.3098767 -0.3641109 -0.4225769 -0.4803172 -0.5374264 -0.5943304 -0.6510088 -0.7084366 -0.7669858 -0.8151248 -0.8716817 -0.9502627 0.000000 8.8196568E-02 9.3351446E-02 6.4348377E-02 2.3396626E-02 -2.6907366E-02 -8.0162682E-02 -0.1333165 -0.1837922 -0.2292365 -0.2740265 -0.3203358 -0.3686282 -0.4167297 -0.4648888 -0.5135474 -0.5573128 -0.6053272 -0.6521352 -0.7025042 -0.7727969 0.000000 8.6819336E-02 9.6675880E-02 7.4238680E-02 3.9806288E-02 -3.2691897E-03 -5.1051151E-02 -9.8298624E-02 -0.1434045 -0.1838040 -0.2243967 -0.2660011 -0.3111113 -0.3606129 -0.4094348 -0.4595357 -0.5105628 -0.5646386 -0.6179681 -0.6732993 -0.7481248 0.000000 8.1189275E-02 9.2449993E-02 7.2702996E-02 4.2158246E-02 1.1990159E-03 -4.3464713E-02 -8.6836159E-02 -0.1274643 -0.1683445 -0.2123207 -0.2603326 -0.3134697 -0.3669905 -0.4268742 -0.4862321 -0.5471838 -0.6174622 -0.6843870 -0.7549080 -0.8542629 0.000000 7.4729733E-02 8.3959237E-02 6.3570172E-02 3.1869970E-02 -9.3106143E-03 -5.1435087E-02 -9.3896799E-02 -0.1372399 -0.1867674 -0.2406044 -0.2999149 -0.3641194 -0.4287129 -0.5008342 -0.5783249 -0.6541501 -0.7417551 -0.8281639 -0.9282793 -1.053063 0.000000 6.7454644E-02 7.0574135E-02 4.6536703E-02 1.0516912E-02 -3.0708296E-02 -7.3604219E-02 -0.1224173 -0.1765543 -0.2378971 -0.3044805 -0.3765228 -0.4533723 -0.5355952 -0.6239339 -0.7202003 -0.8171329 -0.9265969 -1.042596 -1.167928 -1.313243 0.000000 5.8855709E-02 5.4508388E-02 2.2885965E-02 -1.8283699E-02 -6.2846951E-02 -0.1130847 -0.1744372 -0.2429068 -0.3167534 -0.3971981 -0.4837349 -0.5769082 -0.6759778 -0.7809391 -0.9045678 -1.029899 -1.160496 -1.299056 -1.442868 -1.605685 0.000000 5.0263695E-02 3.5799421E-02 -6.3518267E-03 -5.3233847E-02 -0.1068427 -0.1700940 -0.2461839 -0.3279472 -0.4157794 -0.5151833 -0.6172757 -0.7332503 -0.8521993 -0.9764008 -1.120345 -1.261354 -1.407708 -1.568608 -1.725028 -1.915207 0.000000 4.0544756E-02 1.5659925E-02 -3.8850375E-02 -9.5807984E-02 -0.1633609 -0.2437601 -0.3339705 -0.4334733 -0.5372273 -0.6539803 -0.7738473 -0.9048433 -1.048011 -1.189883 -1.349107 -1.501546 -1.664638 -1.818698 -1.994113 -2.183856 0.000000 3.1500794E-02 -5.8261715E-03 -7.4161157E-02 -0.1453495 -0.2313424 -0.3314407 -0.4351479 -0.5497274 -0.6744053 -0.8069329 -0.9497662 -1.090292 -1.246147 -1.406471 -1.569675 -1.736180 -1.889713 -2.059134 -2.222529 -2.394540 0.000000 2.2304127E-02 -2.8257625E-02 -0.1097874 -0.1991159 -0.3070611 -0.4245040 -0.5478066 -0.6792831 -0.8189206 -0.9671142 -1.122842 -1.283387 -1.445565 -1.603586 -1.761962 -1.926853 -2.091784 -2.250170 -2.384417 -2.542665 0.000000 1.3548709E-02 -4.9898889E-02 -0.1459476 -0.2564315 -0.3867416 -0.5212614 -0.6600766 -0.8078907 -0.9586663 -1.127092 -1.289911 -1.457012 -1.613225 -1.763440 -1.912431 -2.083336 -2.230938 -2.372617 -2.523180 -2.674639 0.000000 5.8789374E-03 -6.8109706E-02 -0.1791056 -0.3129856 -0.4644015 -0.6153191 -0.7708588 -0.9361394 -1.096282 -1.271608 -1.439238 -1.608713 -1.752422 -1.900906 -2.038840 -2.192313 -2.323266 -2.458507 -2.610606 -2.743705 0.000000 -4.4603442E-04 -8.2529612E-02 -0.2087926 -0.3624771 -0.5320293 -0.6974113 -0.8712640 -1.037853 -1.210200 -1.384131 -1.557839 -1.698914 -1.838230 -1.991872 -2.110747 -2.247767 -2.371942 -2.508305 -2.620445 -2.748999 0.000000 -5.5913166E-03 -9.1824748E-02 -0.2298896 -0.3926844 -0.5782356 -0.7548885 -0.9348087 -1.110533 -1.280754 -1.447416 -1.606339 -1.739859 -1.884913 -2.015803 -2.121989 -2.246186 -2.374343 -2.477589 -2.583820 -2.664536 0.000000 -9.1914712E-03 -9.3196094E-02 -0.2328456 -0.4015175 -0.5892068 -0.7727057 -0.9521815 -1.122468 -1.287445 -1.442876 -1.585597 -1.722317 -1.853178 -1.955438 -2.066040 -2.175655 -2.284924 -2.385574 -2.453408 -2.536757 0.000000 -1.0528260E-02 -8.8248678E-02 -0.2171027 -0.3743702 -0.5485952 -0.7194147 -0.8876701 -1.044258 -1.205621 -1.346229 -1.473806 -1.600966 -1.714544 -1.819062 -1.913793 -2.013453 -2.102308 -2.175934 -2.244214 -2.307807 0.000000 -9.7656669E-03 -7.1659960E-02 -0.1761784 -0.3031453 -0.4431289 -0.5835110 -0.7278950 -0.8603069 -0.9964601 -1.118469 -1.228753 -1.347505 -1.441673 -1.532517 -1.610645 -1.703914 -1.767060 -1.818898 -1.871433 -1.913543 0.000000 -6.3706120E-03 -4.3171223E-02 -0.1041611 -0.1794436 -0.2600380 -0.3463295 -0.4352383 -0.5202245 -0.6073634 -0.6939449 -0.7697357 -0.8485647 -0.9146855 -0.9833400 -1.036704 -1.094225 -1.133167 -1.166395 -1.204616 -1.223879 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 1.8512949E-02 -1.6442545E-02 -8.9972861E-02 -0.1895612 -0.2946441 -0.3968287 -0.5049357 -0.6145434 -0.7283568 -0.8363968 -0.9421808 -1.045979 -1.159915 -1.267666 -1.373930 -1.480300 -1.587748 -1.694246 -1.794736 -1.941464 0.000000 3.6709201E-02 2.3068706E-02 -3.2725815E-02 -0.1121965 -0.1965817 -0.2774462 -0.3565007 -0.4363486 -0.5183213 -0.6044176 -0.6857972 -0.7647902 -0.8420088 -0.9179293 -0.9929132 -1.067995 -1.143927 -1.217265 -1.284655 -1.392730 0.000000 5.5560194E-02 5.3886093E-02 1.0710756E-02 -5.2289918E-02 -0.1226312 -0.1932351 -0.2613342 -0.3249672 -0.3893081 -0.4597280 -0.5258987 -0.5897134 -0.6528233 -0.7149324 -0.7763224 -0.8377221 -0.9004090 -0.9603890 -1.024577 -1.109662 0.000000 7.3986232E-02 7.3646493E-02 4.0449791E-02 -1.2522014E-02 -7.4280597E-02 -0.1368061 -0.1966103 -0.2523994 -0.3098238 -0.3682202 -0.4264777 -0.4889626 -0.5484006 -0.6070553 -0.6668513 -0.7272261 -0.7900615 -0.8519000 -0.9156356 -1.008555 0.000000 8.0398068E-02 8.5796945E-02 5.7535514E-02 1.0588471E-02 -4.5370374E-02 -0.1027416 -0.1567436 -0.2087600 -0.2631467 -0.3227145 -0.3822541 -0.4461268 -0.5078355 -0.5770136 -0.6438047 -0.7119313 -0.7913494 -0.8655354 -0.9429360 -1.050138 0.000000 7.8225747E-02 8.8881388E-02 6.3565992E-02 1.9942908E-02 -3.2741759E-02 -8.6703464E-02 -0.1394706 -0.1931751 -0.2530744 -0.3173600 -0.3856888 -0.4531647 -0.5271336 -0.6074862 -0.6857793 -0.7729229 -0.8685420 -0.9599146 -1.064012 -1.193537 0.000000 7.4959010E-02 8.6717896E-02 6.1517853E-02 1.6906003E-02 -3.4432784E-02 -8.7611251E-02 -0.1439300 -0.2071479 -0.2767201 -0.3473618 -0.4247130 -0.5067293 -0.5951650 -0.6889704 -0.7872849 -0.8921358 -1.005748 -1.126348 -1.242856 -1.401268 0.000000 7.2431587E-02 7.8693338E-02 5.0790083E-02 4.0354445E-03 -4.9136657E-02 -0.1065769 -0.1720716 -0.2458382 -0.3258995 -0.4111865 -0.5015423 -0.5990480 -0.7073277 -0.8157236 -0.9326438 -1.057298 -1.193410 -1.332847 -1.475573 -1.652454 0.000000 6.4904332E-02 6.7673810E-02 3.3630610E-02 -1.7512564E-02 -7.7071466E-02 -0.1433968 -0.2216723 -0.3070025 -0.4029877 -0.5017670 -0.6089040 -0.7262374 -0.8446078 -0.9688864 -1.112398 -1.258223 -1.418898 -1.571457 -1.725388 -1.910874 0.000000 5.6759991E-02 5.3516299E-02 1.0416840E-02 -4.7945973E-02 -0.1178853 -0.1977745 -0.2891773 -0.3910320 -0.4976234 -0.6157957 -0.7443444 -0.8696784 -1.011493 -1.153076 -1.312230 -1.480204 -1.632161 -1.802983 -1.964040 -2.151687 0.000000 4.9772263E-02 3.7217706E-02 -1.7254995E-02 -8.7245680E-02 -0.1702405 -0.2672740 -0.3732905 -0.4889349 -0.6144209 -0.7472315 -0.8903611 -1.030847 -1.185780 -1.346509 -1.511346 -1.679067 -1.834087 -2.004874 -2.171569 -2.346359 0.000000 4.1096739E-02 1.8950591E-02 -4.8186488E-02 -0.1332777 -0.2334667 -0.3498180 -0.4715209 -0.6028537 -0.7421238 -0.8899015 -1.045783 -1.204870 -1.367615 -1.528577 -1.689628 -1.855735 -2.022461 -2.183807 -2.320623 -2.477978 0.000000 3.3354826E-02 -5.3070806E-04 -8.1303291E-02 -0.1847326 -0.3038131 -0.4371785 -0.5734633 -0.7200724 -0.8701304 -1.038065 -1.199824 -1.366280 -1.526783 -1.681369 -1.832627 -2.004906 -2.155695 -2.300688 -2.443499 -2.594001 0.000000 2.5265196E-02 -1.9393150E-02 -0.1147156 -0.2385831 -0.3765718 -0.5265999 -0.6785720 -0.8418701 -1.002135 -1.177648 -1.339914 -1.514956 -1.665096 -1.816651 -1.956653 -2.112938 -2.247036 -2.383901 -2.512189 -2.666155 0.000000 1.7562803E-02 -3.6627885E-02 -0.1465334 -0.2864733 -0.4448824 -0.6095889 -0.7790403 -0.9447967 -1.117498 -1.292992 -1.453728 -1.612414 -1.755203 -1.910486 -2.031858 -2.172152 -2.297734 -2.434030 -2.547683 -2.676116 0.000000 1.0547983E-02 -5.0418049E-02 -0.1724949 -0.3256086 -0.4986788 -0.6741176 -0.8501698 -1.025822 -1.197055 -1.365958 -1.527488 -1.663083 -1.809843 -1.942699 -2.051024 -2.176805 -2.303634 -2.406875 -2.515212 -2.598002 0.000000 4.5002075E-03 -5.7801064E-02 -0.1835597 -0.3446318 -0.5261564 -0.7051684 -0.8819997 -1.052593 -1.218845 -1.375849 -1.520160 -1.658186 -1.790295 -1.893265 -2.005845 -2.112939 -2.220393 -2.323868 -2.393572 -2.477788 0.000000 1.8859524E-04 -5.9973277E-02 -0.1785648 -0.3309324 -0.5012335 -0.6693163 -0.8361489 -0.9927463 -1.155197 -1.296258 -1.424257 -1.551931 -1.665918 -1.770756 -1.866756 -1.956392 -2.049804 -2.127610 -2.196607 -2.260213 0.000000 -2.2711887E-03 -5.2233879E-02 -0.1506180 -0.2748798 -0.4131272 -0.5522994 -0.6963331 -0.8283976 -0.9647844 -1.086641 -1.196579 -1.315568 -1.409377 -1.500080 -1.577911 -1.654086 -1.734244 -1.785779 -1.838189 -1.879981 0.000000 -2.5208024E-03 -3.3292234E-02 -9.1804154E-02 -0.1663295 -0.2463986 -0.3325643 -0.4214478 -0.5061327 -0.5931858 -0.6797081 -0.7549956 -0.8337035 -0.8992817 -0.9678172 -1.020632 -1.078089 -1.116517 -1.149284 -1.187574 -1.206319 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -3.3062179E-02 -0.1026539 -0.2140351 -0.3474605 -0.4810318 -0.6260845 -0.7744899 -0.9168866 -1.064242 -1.203086 -1.348930 -1.484850 -1.632669 -1.769451 -1.902390 -2.035019 -2.167908 -2.299077 -2.443789 -2.634703 0.000000 -2.0988278E-02 -6.8456270E-02 -0.1545405 -0.2598361 -0.3662105 -0.4718003 -0.5876532 -0.6977440 -0.8118079 -0.9183616 -1.020793 -1.130744 -1.231801 -1.329513 -1.424948 -1.520032 -1.615443 -1.707143 -1.807478 -1.950847 0.000000 -1.1490250E-02 -3.8629435E-02 -9.9630438E-02 -0.1842277 -0.2731771 -0.3589308 -0.4501137 -0.5407175 -0.6340022 -0.7201316 -0.8021507 -0.8815566 -0.9677829 -1.047008 -1.123644 -1.199998 -1.276883 -1.350407 -1.428443 -1.529121 0.000000 -1.5507053E-03 -6.6062086E-03 -5.2030571E-02 -0.1234628 -0.1999449 -0.2741026 -0.3486966 -0.4255912 -0.5043068 -0.5768759 -0.6539736 -0.7245591 -0.7940305 -0.8624963 -0.9405601 -1.014079 -1.088770 -1.160336 -1.234675 -1.343453 0.000000 9.7833490E-03 2.5399376E-02 -1.5971409E-02 -7.7725463E-02 -0.1450876 -0.2112733 -0.2784948 -0.3472072 -0.4149849 -0.4866366 -0.5560722 -0.6296111 -0.6996696 -0.7775682 -0.8519271 -0.9361318 -1.016152 -1.094276 -1.188296 -1.311534 0.000000 2.2840865E-02 5.0917398E-02 1.0004601E-02 -4.5403618E-02 -0.1063993 -0.1679720 -0.2302313 -0.2963471 -0.3670643 -0.4407335 -0.5173996 -0.5908874 -0.6723323 -0.7591632 -0.8426507 -0.9346169 -1.023790 -1.125461 -1.238615 -1.377489 0.000000 3.8002945E-02 6.2816046E-02 2.6133729E-02 -2.6325127E-02 -8.4229805E-02 -0.1441919 -0.2068547 -0.2787185 -0.3541043 -0.4327373 -0.5161126 -0.6043965 -0.6965330 -0.7931612 -0.8963810 -0.9959096 -1.113030 -1.238261 -1.370803 -1.523988 0.000000 5.4402124E-02 6.8175025E-02 3.3327427E-02 -1.9801714E-02 -7.7418923E-02 -0.1400109 -0.2100640 -0.2885169 -0.3718857 -0.4598251 -0.5588421 -0.6589255 -0.7624418 -0.8743919 -0.9934143 -1.121971 -1.270773 -1.413883 -1.561447 -1.727388 0.000000 6.3765153E-02 6.8520352E-02 3.1816617E-02 -2.4388086E-02 -8.5372046E-02 -0.1546575 -0.2348613 -0.3226450 -0.4198224 -0.5202898 -0.6341486 -0.7469273 -0.8668775 -1.001835 -1.137789 -1.296474 -1.448180 -1.603757 -1.758955 -1.944483 0.000000 5.8238152E-02 6.3423976E-02 2.2077441E-02 -3.9237287E-02 -0.1073889 -0.1884290 -0.2793830 -0.3818215 -0.4895924 -0.6082026 -0.7363693 -0.8651308 -1.006575 -1.147044 -1.307129 -1.476941 -1.637684 -1.809450 -1.968903 -2.158401 0.000000 5.2689899E-02 5.5350527E-02 5.4103979E-03 -6.3595243E-02 -0.1424191 -0.2383810 -0.3429221 -0.4591456 -0.5848797 -0.7173631 -0.8595849 -1.009598 -1.154911 -1.315820 -1.483986 -1.654448 -1.829166 -1.986116 -2.159573 -2.345584 0.000000 4.5544788E-02 4.3714788E-02 -1.6256182E-02 -9.6285596E-02 -0.1896612 -0.3020377 -0.4245117 -0.5560794 -0.6949503 -0.8417410 -0.9965764 -1.153535 -1.315554 -1.481214 -1.646369 -1.813818 -1.982147 -2.147044 -2.312005 -2.484644 0.000000 3.9397828E-02 2.9799959E-02 -4.1720919E-02 -0.1362651 -0.2470328 -0.3770256 -0.5142772 -0.6606396 -0.8101259 -0.9760444 -1.136634 -1.296418 -1.461949 -1.623894 -1.776786 -1.950080 -2.105547 -2.255562 -2.411719 -2.568227 0.000000 3.1602707E-02 1.4407675E-02 -6.9991030E-02 -0.1811397 -0.3110326 -0.4584042 -0.6112863 -0.7741229 -0.9335943 -1.106622 -1.267141 -1.428408 -1.597822 -1.750991 -1.890854 -2.052301 -2.193313 -2.334388 -2.488954 -2.624838 0.000000 2.4495287E-02 -2.1975001E-03 -9.8499142E-02 -0.2247103 -0.3750967 -0.5381426 -0.7088345 -0.8744143 -1.045114 -1.218394 -1.374807 -1.540370 -1.687594 -1.835069 -1.963762 -2.112612 -2.243583 -2.380777 -2.494863 -2.624251 0.000000 1.9069429E-02 -1.7182309E-02 -0.1229406 -0.2642102 -0.4300735 -0.6043532 -0.7830312 -0.9583883 -1.124249 -1.294559 -1.445910 -1.598628 -1.739299 -1.859217 -1.991105 -2.121261 -2.250237 -2.352250 -2.460875 -2.545463 0.000000 1.3044225E-02 -2.7985090E-02 -0.1393512 -0.2894712 -0.4623034 -0.6399447 -0.8238771 -0.9939157 -1.143674 -1.315234 -1.463080 -1.602155 -1.717883 -1.839045 -1.953701 -2.063433 -2.168561 -2.270673 -2.342774 -2.427752 0.000000 7.6031270E-03 -3.4422401E-02 -0.1414745 -0.2869517 -0.4553071 -0.6238379 -0.7909764 -0.9471292 -1.095772 -1.250350 -1.379546 -1.507345 -1.622157 -1.727721 -1.824227 -1.915308 -1.998868 -2.082080 -2.152580 -2.214271 0.000000 3.2813188E-03 -3.4098964E-02 -0.1246888 -0.2452524 -0.3831936 -0.5226830 -0.6669370 -0.7985850 -0.9257620 -1.056736 -1.166459 -1.285713 -1.379355 -1.470039 -1.547752 -1.623641 -1.686853 -1.756404 -1.801188 -1.843295 0.000000 3.9971338E-04 -2.3661666E-02 -7.8910001E-02 -0.1508989 -0.2325342 -0.3189616 -0.4079805 -0.4924036 -0.5793808 -0.6658598 -0.7407247 -0.8193473 -0.8844598 -0.9528928 -1.005229 -1.062618 -1.100593 -1.132968 -1.159357 -1.189711 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -6.9806814E-02 -0.2028803 -0.3764479 -0.5627893 -0.7614392 -0.9602516 -1.157847 -1.354627 -1.549914 -1.726612 -1.912459 -2.083918 -2.269002 -2.438806 -2.603183 -2.792220 -2.966071 -3.134136 -3.317157 -3.550787 0.000000 -5.5291470E-02 -0.1602074 -0.3020518 -0.4564157 -0.6083715 -0.7669705 -0.9236038 -1.068530 -1.215370 -1.364379 -1.497941 -1.641378 -1.769789 -1.893234 -2.012926 -2.152221 -2.278680 -2.397888 -2.526207 -2.702976 0.000000 -4.5795821E-02 -0.1274838 -0.2404989 -0.3655109 -0.4896332 -0.6197712 -0.7482350 -0.8666515 -0.9871415 -1.095737 -1.208395 -1.309367 -1.419395 -1.518029 -1.612963 -1.707115 -1.800689 -1.889705 -1.983667 -2.119144 0.000000 -3.8291316E-02 -9.8957591E-02 -0.1850068 -0.2881633 -0.3956220 -0.4996660 -0.6066611 -0.7127135 -0.8071120 -0.9031946 -0.9894316 -1.073023 -1.164400 -1.248431 -1.343931 -1.430847 -1.517554 -1.601835 -1.688054 -1.811261 0.000000 -3.1755190E-02 -7.2039343E-02 -0.1353823 -0.2216933 -0.3120488 -0.4019851 -0.4944179 -0.5846034 -0.6663992 -0.7512364 -0.8380066 -0.9176944 -1.004978 -1.086200 -1.178482 -1.263548 -1.362932 -1.451818 -1.541855 -1.668107 0.000000 -2.5417471E-02 -4.4755574E-02 -9.0339445E-02 -0.1661722 -0.2473806 -0.3289489 -0.4093802 -0.4911840 -0.5736026 -0.6569719 -0.7424253 -0.8229434 -0.9109399 -1.004374 -1.103517 -1.195707 -1.301244 -1.398258 -1.512689 -1.655403 0.000000 -1.8530015E-02 -1.5744751E-02 -5.4227762E-02 -0.1233679 -0.1970250 -0.2734633 -0.3529012 -0.4353980 -0.5191863 -0.6036795 -0.6918298 -0.7834628 -0.8798475 -0.9826928 -1.090764 -1.205889 -1.315170 -1.438467 -1.573463 -1.733653 0.000000 -1.0481759E-02 1.4594098E-02 -2.7349303E-02 -9.2122436E-02 -0.1645238 -0.2403565 -0.3231564 -0.4091690 -0.4961703 -0.5873623 -0.6833781 -0.7824825 -0.8975415 -1.012855 -1.137133 -1.267475 -1.403638 -1.550454 -1.703243 -1.891335 0.000000 -1.4222604E-03 3.6311720E-02 -1.0249715E-02 -7.5176656E-02 -0.1487463 -0.2281015 -0.3166799 -0.4077234 -0.5029104 -0.6090055 -0.7161421 -0.8312193 -0.9602067 -1.091666 -1.240219 -1.385926 -1.541581 -1.713568 -1.877725 -2.075860 0.000000 9.2189992E-03 4.3672059E-02 -1.8376267E-03 -7.0200838E-02 -0.1478687 -0.2342702 -0.3308515 -0.4300475 -0.5416357 -0.6554045 -0.7823220 -0.9205105 -1.059325 -1.212351 -1.361824 -1.530852 -1.709311 -1.873764 -2.051772 -2.247521 0.000000 2.2332795E-02 4.6387237E-02 -2.7121117E-03 -7.6765388E-02 -0.1622023 -0.2578211 -0.3646824 -0.4766099 -0.6018723 -0.7340258 -0.8764095 -1.027531 -1.188412 -1.342047 -1.511728 -1.684411 -1.858169 -2.035321 -2.192730 -2.376719 0.000000 3.8744133E-02 4.3793701E-02 -1.0747741E-02 -9.2976898E-02 -0.1895453 -0.2968598 -0.4167681 -0.5475204 -0.6864820 -0.8334531 -0.9902372 -1.151080 -1.317729 -1.489640 -1.660169 -1.824736 -1.989752 -2.155773 -2.323018 -2.498175 0.000000 3.8977645E-02 3.7100110E-02 -2.4780016E-02 -0.1184234 -0.2253177 -0.3502931 -0.4853505 -0.6312751 -0.7816339 -0.9484051 -1.113144 -1.282560 -1.449106 -1.625816 -1.783611 -1.940570 -2.096949 -2.250342 -2.408545 -2.566688 0.000000 3.2660328E-02 2.8392816E-02 -4.3862488E-02 -0.1506142 -0.2729263 -0.4149039 -0.5658879 -0.7288162 -0.8897383 -1.065696 -1.232259 -1.411559 -1.570421 -1.725019 -1.867218 -2.029993 -2.174134 -2.317743 -2.473204 -2.610950 0.000000 2.6318638E-02 1.7245324E-02 -6.6429488E-02 -0.1847108 -0.3253437 -0.4837303 -0.6526174 -0.8193190 -0.9905498 -1.171025 -1.333920 -1.503175 -1.652511 -1.801713 -1.932715 -2.083315 -2.216771 -2.355410 -2.470959 -2.601211 0.000000 2.0000106E-02 4.6143527E-03 -8.7577373E-02 -0.2184462 -0.3751632 -0.5459766 -0.7225654 -0.8996575 -1.061251 -1.247945 -1.403545 -1.559147 -1.700367 -1.822451 -1.956488 -2.088722 -2.218974 -2.322209 -2.430270 -2.514948 0.000000 1.3821498E-02 -6.4939857E-03 -0.1042581 -0.2436735 -0.4097938 -0.5854689 -0.7631228 -0.9349549 -1.097021 -1.272348 -1.423560 -1.562649 -1.678781 -1.802913 -1.919726 -2.030690 -2.136103 -2.237035 -2.307106 -2.391231 0.000000 8.5152341E-03 -1.5028019E-02 -0.1100447 -0.2475271 -0.4122342 -0.5801874 -0.7491825 -0.9083467 -1.057800 -1.215142 -1.346617 -1.468773 -1.587959 -1.696475 -1.794669 -1.884126 -1.967813 -2.044664 -2.112246 -2.173932 0.000000 4.4510369E-03 -1.9243879E-02 -0.1010284 -0.2174547 -0.3542491 -0.4941221 -0.6398349 -0.7727356 -0.9009891 -1.032537 -1.142624 -1.249440 -1.356034 -1.446889 -1.525673 -1.595015 -1.661466 -1.716319 -1.761134 -1.803516 0.000000 1.3947014E-03 -1.5318838E-02 -6.6431977E-02 -0.1373112 -0.2190789 -0.3060874 -0.3957472 -0.4804230 -0.5676309 -0.6542141 -0.7288716 -0.8074820 -0.8724080 -0.9408170 -0.9929774 -1.039891 -1.088143 -1.120344 -1.146622 -1.176991 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.1664830 -0.3872147 -0.6484053 -0.9259636 -1.198368 -1.476116 -1.739284 -1.995283 -2.224548 -2.460486 -2.699725 -2.943464 -3.159864 -3.397602 -3.613056 -3.855523 -4.074342 -4.284216 -4.553449 -4.858499 0.000000 -0.1365859 -0.3216015 -0.5461999 -0.7688308 -0.9932659 -1.209166 -1.417059 -1.619182 -1.818020 -2.015808 -2.190183 -2.374174 -2.536962 -2.717614 -2.876596 -3.059778 -3.220180 -3.371732 -3.532967 -3.746602 0.000000 -0.1117790 -0.2750641 -0.4560622 -0.6435435 -0.8327007 -1.012974 -1.186504 -1.354943 -1.519004 -1.663417 -1.810602 -1.940778 -2.081806 -2.205673 -2.346575 -2.470726 -2.590532 -2.704764 -2.823323 -2.988121 0.000000 -9.6107557E-02 -0.2305708 -0.3836811 -0.5438989 -0.7029166 -0.8533192 -0.9979694 -1.136660 -1.270613 -1.385650 -1.505869 -1.611013 -1.726533 -1.831255 -1.950090 -2.054731 -2.178146 -2.282684 -2.386935 -2.535426 0.000000 -8.3275102E-02 -0.1942512 -0.3232403 -0.4554014 -0.5873083 -0.7146660 -0.8370392 -0.9535199 -1.064618 -1.173946 -1.269298 -1.374188 -1.484443 -1.581496 -1.689154 -1.785478 -1.899552 -1.998963 -2.118970 -2.271511 0.000000 -7.3786855E-02 -0.1627782 -0.2675358 -0.3732856 -0.4857998 -0.6014584 -0.7090586 -0.8056492 -0.9050256 -1.004920 -1.105753 -1.208483 -1.313140 -1.406624 -1.511659 -1.623027 -1.743295 -1.850054 -1.977955 -2.135988 0.000000 -6.5195426E-02 -0.1367152 -0.2106411 -0.3046611 -0.4033653 -0.5026402 -0.6018264 -0.6988993 -0.7971063 -0.8953567 -0.9953224 -1.096706 -1.200340 -1.309348 -1.422607 -1.541061 -1.669755 -1.807705 -1.956989 -2.127859 0.000000 -5.7509053E-02 -0.1093452 -0.1579159 -0.2432574 -0.3340421 -0.4293006 -0.5249638 -0.6256500 -0.7250811 -0.8259318 -0.9301253 -1.033901 -1.153892 -1.272745 -1.396768 -1.531703 -1.676068 -1.845531 -2.007260 -2.186472 0.000000 -4.9689189E-02 -7.9681754E-02 -0.1174279 -0.1954048 -0.2850760 -0.3821044 -0.4769106 -0.5815725 -0.6837304 -0.7979623 -0.9082419 -1.021634 -1.156199 -1.288730 -1.430332 -1.596584 -1.752637 -1.930642 -2.095843 -2.297176 0.000000 -4.3500736E-02 -4.8060577E-02 -8.4536687E-02 -0.1634784 -0.2555982 -0.3508416 -0.4530861 -0.5627810 -0.6734877 -0.7950250 -0.9153055 -1.050926 -1.200627 -1.350174 -1.518267 -1.691393 -1.851663 -2.034033 -2.204560 -2.406479 0.000000 -3.7164714E-02 -1.4289848E-02 -6.3047655E-02 -0.1446499 -0.2395895 -0.3413503 -0.4508211 -0.5683609 -0.6962563 -0.8243161 -0.9648232 -1.115366 -1.277662 -1.448959 -1.624095 -1.784666 -1.960528 -2.140125 -2.325682 -2.523038 0.000000 -2.9592467E-02 6.9930358E-03 -5.0287042E-02 -0.1373840 -0.2399081 -0.3492297 -0.4689912 -0.5986223 -0.7396686 -0.8857991 -1.041657 -1.204162 -1.378454 -1.551730 -1.724061 -1.896244 -2.064339 -2.236030 -2.409461 -2.592170 0.000000 -1.9861603E-02 1.1877364E-02 -4.5546897E-02 -0.1414866 -0.2539197 -0.3733532 -0.5067826 -0.6515586 -0.8095344 -0.9689081 -1.135856 -1.308175 -1.492858 -1.660687 -1.831919 -1.992924 -2.150139 -2.317921 -2.475519 -2.653373 0.000000 -7.9540862E-03 1.3991389E-02 -4.8959959E-02 -0.1553863 -0.2756236 -0.4126615 -0.5615007 -0.7235172 -0.8859353 -1.063924 -1.233997 -1.416858 -1.581621 -1.744335 -1.913664 -2.060919 -2.215223 -2.380683 -2.513119 -2.648894 0.000000 7.3090089E-03 1.1933002E-02 -5.9142455E-02 -0.1764749 -0.3081731 -0.4616462 -0.6284745 -0.7962271 -0.9729152 -1.154652 -1.321696 -1.496319 -1.651986 -1.815042 -1.948700 -2.097589 -2.254415 -2.375589 -2.491676 -2.631058 0.000000 1.2677972E-02 6.8492396E-03 -7.1623638E-02 -0.1972111 -0.3435822 -0.5111503 -0.6876092 -0.8667505 -1.042923 -1.223022 -1.384337 -1.545807 -1.693347 -1.838173 -1.958208 -2.091185 -2.223623 -2.329378 -2.440919 -2.554128 0.000000 9.1206245E-03 6.6671835E-04 -8.3212622E-02 -0.2150685 -0.3719147 -0.5465136 -0.7256359 -0.9007766 -1.067122 -1.246965 -1.403067 -1.547079 -1.667769 -1.794813 -1.913121 -2.026175 -2.134218 -2.238002 -2.312800 -2.399576 0.000000 5.2322089E-03 -6.0463808E-03 -8.8108219E-02 -0.2177850 -0.3742726 -0.5457976 -0.7170078 -0.8796554 -1.032774 -1.193719 -1.328591 -1.453869 -1.575336 -1.685405 -1.784111 -1.877555 -1.962875 -2.046810 -2.118514 -2.181534 0.000000 2.3971335E-03 -1.0964722E-02 -8.2488149E-02 -0.1937679 -0.3294437 -0.4704483 -0.6182856 -0.7535017 -0.8839772 -1.017381 -1.129235 -1.237283 -1.344895 -1.436429 -1.515226 -1.592048 -1.655689 -1.725272 -1.771141 -1.813875 0.000000 4.0014350E-04 -9.9293385E-03 -5.5466708E-02 -0.1250457 -0.2071716 -0.2952902 -0.3861090 -0.4716411 -0.5596372 -0.6468555 -0.7219486 -0.8008645 -0.8660371 -0.9345609 -0.9869108 -1.044209 -1.082174 -1.114471 -1.141058 -1.171407 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.3824281 -0.7632635 -1.161944 -1.545087 -1.923499 -2.275614 -2.613452 -2.939589 -3.257145 -3.568477 -3.876403 -4.183354 -4.492610 -4.807203 -5.130309 -5.408757 -5.725727 -6.005528 -6.352570 -6.729783 0.000000 -0.3375071 -0.6698532 -1.007624 -1.329428 -1.649916 -1.943646 -2.224470 -2.494509 -2.756268 -3.012675 -3.266487 -3.482910 -3.716102 -3.958583 -4.165951 -4.401821 -4.606946 -4.844620 -5.065382 -5.341204 0.000000 -0.3019882 -0.5924823 -0.8695662 -1.145431 -1.407158 -1.652353 -1.903788 -2.135553 -2.355897 -2.568501 -2.745490 -2.933675 -3.127721 -3.290192 -3.475551 -3.635176 -3.822231 -3.978260 -4.134970 -4.344837 0.000000 -0.2726092 -0.5134849 -0.7535543 -0.9947754 -1.221172 -1.429799 -1.644118 -1.834599 -2.013766 -2.163948 -2.318215 -2.474331 -2.607323 -2.757057 -2.916759 -3.048633 -3.205273 -3.331917 -3.459893 -3.636610 0.000000 -0.2422697 -0.4430990 -0.6573611 -0.8656853 -1.057104 -1.246584 -1.413092 -1.568061 -1.715764 -1.840034 -1.971069 -2.104678 -2.241735 -2.381853 -2.497968 -2.630125 -2.745584 -2.883206 -3.005191 -3.200052 0.000000 -0.2159788 -0.3829191 -0.5735760 -0.7479295 -0.9171308 -1.066825 -1.206417 -1.339464 -1.467500 -1.590863 -1.715705 -1.840321 -1.965887 -2.092916 -2.198585 -2.322053 -2.457450 -2.599977 -2.724435 -2.916232 0.000000 -0.1889872 -0.3340939 -0.4964152 -0.6383482 -0.7811745 -0.9086038 -1.033044 -1.154972 -1.271357 -1.398979 -1.518809 -1.636149 -1.752247 -1.870574 -1.995355 -2.129198 -2.270627 -2.415411 -2.569652 -2.749835 0.000000 -0.1638228 -0.2946075 -0.4223223 -0.5429674 -0.6610433 -0.7776297 -0.9024515 -1.015173 -1.128543 -1.252753 -1.368702 -1.481544 -1.597549 -1.720485 -1.872488 -2.017841 -2.166714 -2.322514 -2.486487 -2.694434 0.000000 -0.1385949 -0.2572334 -0.3509091 -0.4528373 -0.5610262 -0.6780520 -0.7889363 -0.9080787 -1.021662 -1.145451 -1.261361 -1.378328 -1.518207 -1.655142 -1.818676 -1.976156 -2.134920 -2.320004 -2.491938 -2.702676 0.000000 -0.1128755 -0.2211179 -0.2823496 -0.3768071 -0.4856211 -0.5948091 -0.7109253 -0.8320162 -0.9491531 -1.075943 -1.198045 -1.336600 -1.491873 -1.645492 -1.814284 -1.994553 -2.162541 -2.355121 -2.535337 -2.749887 0.000000 -0.1022629 -0.1851321 -0.2213289 -0.3160791 -0.4238211 -0.5388855 -0.6576026 -0.7823283 -0.9134225 -1.042197 -1.183867 -1.338136 -1.505992 -1.681004 -1.843469 -2.025859 -2.212590 -2.406306 -2.605508 -2.814769 0.000000 -9.2718638E-02 -0.1502536 -0.1799406 -0.2718137 -0.3840660 -0.5022641 -0.6276021 -0.7586368 -0.8987970 -1.046102 -1.203569 -1.373040 -1.546504 -1.722598 -1.902951 -2.083398 -2.267217 -2.455617 -2.638644 -2.825463 0.000000 -8.2274638E-02 -0.1112487 -0.1434885 -0.2387801 -0.3564493 -0.4848638 -0.6189885 -0.7610493 -0.9141592 -1.070785 -1.252384 -1.428405 -1.601257 -1.781184 -1.957859 -2.123172 -2.315335 -2.487800 -2.650776 -2.821902 0.000000 -7.1380056E-02 -6.9292322E-02 -0.1172238 -0.2194361 -0.3466491 -0.4849839 -0.6304747 -0.7871324 -0.9573715 -1.124790 -1.315830 -1.489188 -1.662243 -1.847694 -2.012525 -2.163630 -2.340259 -2.492974 -2.644031 -2.814196 0.000000 -5.9623189E-02 -3.5710335E-02 -0.1009915 -0.2115007 -0.3478242 -0.5001821 -0.6577327 -0.8327681 -1.003278 -1.187016 -1.376752 -1.541413 -1.720288 -1.877959 -2.036140 -2.172244 -2.331656 -2.470627 -2.615749 -2.738116 0.000000 -4.6672393E-02 -2.9334301E-02 -9.2023119E-02 -0.2121121 -0.3560494 -0.5220968 -0.6924840 -0.8737267 -1.054756 -1.236739 -1.416318 -1.571489 -1.735353 -1.884086 -2.007057 -2.144128 -2.281479 -2.417079 -2.520227 -2.641544 0.000000 -3.1366736E-02 -2.3248106E-02 -8.6290687E-02 -0.2112349 -0.3643206 -0.5380057 -0.7195551 -0.9003139 -1.075050 -1.249226 -1.411451 -1.563815 -1.708781 -1.824200 -1.945333 -2.062078 -2.177044 -2.285373 -2.384759 -2.479197 0.000000 -1.3610628E-02 -1.8368287E-02 -8.1142299E-02 -0.2036986 -0.3578514 -0.5256730 -0.6998600 -0.8674147 -1.026329 -1.192269 -1.331975 -1.468164 -1.590582 -1.701974 -1.803787 -1.899771 -1.996930 -2.078021 -2.150245 -2.216956 0.000000 -8.8854199E-03 -1.5232391E-02 -7.1199052E-02 -0.1763948 -0.3108562 -0.4537714 -0.6048888 -0.7441361 -0.8784868 -1.015110 -1.130192 -1.253153 -1.350853 -1.444380 -1.525547 -1.603990 -1.685669 -1.739592 -1.793999 -1.837526 0.000000 -4.8839631E-03 -1.0172606E-02 -4.7105685E-02 -0.1144383 -0.1973169 -0.2873290 -0.3801714 -0.4674855 -0.5570027 -0.6454625 -0.7218058 -0.8016432 -0.8679544 -0.9371848 -0.9906437 -1.048431 -1.087445 -1.120695 -1.159216 -1.178557 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.8850555 -1.461936 -2.025761 -2.575544 -3.081537 -3.585232 -4.043140 -4.514589 -4.948410 -5.366081 -5.773373 -6.173989 -6.570929 -6.967784 -7.367652 -7.775410 -8.194271 -8.629072 -9.096292 -9.658563 0.000000 -0.8116733 -1.315345 -1.809147 -2.292405 -2.728306 -3.161887 -3.549748 -3.912109 -4.258382 -4.593195 -4.919654 -5.240461 -5.559121 -5.878154 -6.199861 -6.527532 -6.861671 -7.133285 -7.467354 -7.909555 0.000000 -0.7401912 -1.182949 -1.616390 -2.016274 -2.408120 -2.758193 -3.108272 -3.418123 -3.711818 -3.992367 -4.262721 -4.527510 -4.789430 -5.051945 -5.314813 -5.524600 -5.770363 -5.968420 -6.221122 -6.511210 0.000000 -0.6735420 -1.057864 -1.440443 -1.789738 -2.130138 -2.432789 -2.707342 -2.985828 -3.232656 -3.462467 -3.682545 -3.897175 -4.110062 -4.280372 -4.472697 -4.677279 -4.842573 -5.039126 -5.259557 -5.504187 0.000000 -0.6101635 -0.9501817 -1.282261 -1.585013 -1.882375 -2.143653 -2.374764 -2.609346 -2.809950 -2.997991 -3.178861 -3.355115 -3.530973 -3.671227 -3.835224 -4.008464 -4.186265 -4.368623 -4.512755 -4.746531 0.000000 -0.5485922 -0.8470789 -1.136646 -1.401717 -1.659815 -1.881063 -2.091829 -2.270617 -2.437499 -2.596668 -2.748620 -2.902219 -3.055299 -3.207618 -3.358618 -3.509055 -3.666497 -3.829096 -3.958374 -4.173722 0.000000 -0.4969693 -0.7492115 -1.003026 -1.237315 -1.458217 -1.639723 -1.819019 -1.972297 -2.122335 -2.261133 -2.418926 -2.562003 -2.700802 -2.835129 -2.971166 -3.116787 -3.269215 -3.423904 -3.593425 -3.821497 0.000000 -0.4457452 -0.6659638 -0.8814072 -1.096031 -1.269088 -1.436528 -1.581039 -1.737883 -1.869165 -1.999477 -2.147820 -2.280796 -2.407694 -2.535925 -2.704099 -2.859874 -3.015974 -3.181852 -3.385432 -3.585290 0.000000 -0.3940560 -0.5892729 -0.7753783 -0.9504906 -1.096949 -1.245006 -1.390483 -1.516872 -1.657154 -1.783928 -1.926792 -2.053097 -2.180278 -2.339814 -2.520848 -2.682313 -2.849222 -3.043289 -3.218756 -3.443145 0.000000 -0.3492337 -0.5148010 -0.6762820 -0.8138719 -0.9518602 -1.079952 -1.214186 -1.346679 -1.485938 -1.613960 -1.753617 -1.881998 -2.037419 -2.211035 -2.397781 -2.569098 -2.760306 -2.930893 -3.136131 -3.367460 0.000000 -0.3090503 -0.4430961 -0.5819611 -0.6885557 -0.8166029 -0.9478079 -1.077786 -1.210230 -1.349237 -1.492121 -1.625667 -1.778782 -1.949290 -2.130693 -2.318918 -2.514434 -2.684740 -2.883094 -3.092185 -3.313923 0.000000 -0.2678641 -0.3735667 -0.4912539 -0.5857629 -0.7081212 -0.8383780 -0.9668353 -1.103897 -1.244259 -1.392462 -1.550004 -1.719139 -1.901700 -2.086196 -2.274932 -2.462812 -2.655518 -2.858516 -3.056663 -3.257471 0.000000 -0.2257372 -0.3257762 -0.4056959 -0.4904600 -0.6111922 -0.7414500 -0.8826393 -1.025308 -1.173717 -1.333376 -1.500261 -1.695998 -1.880903 -2.070973 -2.257076 -2.431130 -2.640548 -2.832719 -3.009321 -3.192297 0.000000 -0.1924564 -0.2820271 -0.3170833 -0.4107178 -0.5401369 -0.6733558 -0.8219787 -0.9745501 -1.136020 -1.314579 -1.492183 -1.693709 -1.874930 -2.077194 -2.247866 -2.415749 -2.616957 -2.785346 -2.945268 -3.128254 0.000000 -0.1617226 -0.2338615 -0.2399807 -0.3494815 -0.4792076 -0.6238528 -0.7839122 -0.9473752 -1.128784 -1.305664 -1.499336 -1.695028 -1.872744 -2.053344 -2.210371 -2.384837 -2.565763 -2.704921 -2.862266 -2.996502 0.000000 -0.1298683 -0.1851102 -0.1956939 -0.2971273 -0.4371061 -0.5899345 -0.7624268 -0.9374378 -1.123308 -1.313412 -1.500255 -1.681165 -1.858575 -2.007611 -2.163371 -2.317241 -2.473601 -2.584202 -2.711436 -2.842478 0.000000 -9.6796654E-02 -0.1333319 -0.1543724 -0.2567363 -0.4020080 -0.5626373 -0.7433459 -0.9289666 -1.116001 -1.298092 -1.468891 -1.631027 -1.785761 -1.928475 -2.059470 -2.196884 -2.325933 -2.415879 -2.518010 -2.616584 0.000000 -7.1597420E-02 -7.5972416E-02 -0.1156524 -0.2174956 -0.3624937 -0.5251914 -0.7027336 -0.8779279 -1.059536 -1.222186 -1.370960 -1.514676 -1.644769 -1.762960 -1.869599 -1.999812 -2.096685 -2.180018 -2.257013 -2.328301 0.000000 -4.7451064E-02 -4.8069444E-02 -8.2791306E-02 -0.1722517 -0.3000470 -0.4444517 -0.6008304 -0.7477854 -0.8980911 -1.032612 -1.153950 -1.281211 -1.384096 -1.481485 -1.567136 -1.663890 -1.732223 -1.790074 -1.846642 -1.892753 0.000000 -2.1969324E-02 -2.5625223E-02 -4.7395244E-02 -0.1062436 -0.1888968 -0.2817012 -0.3784830 -0.4697172 -0.5624660 -0.6535127 -0.7326639 -0.8143507 -0.8832347 -0.9538328 -1.009780 -1.068495 -1.109845 -1.145197 -1.184290 -1.205689 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -2.106509 -3.805920 -5.282413 -6.644459 -7.838819 -9.021436 -10.06637 -11.04706 -12.09458 -13.02591 -13.91892 -14.78415 -15.63077 -16.46583 -17.29552 -18.12098 -18.94634 -19.77307 -20.60814 -21.63572 0.000000 -2.000512 -3.560899 -4.903702 -6.145611 -7.222425 -8.205552 -9.195427 -10.06618 -10.88709 -11.67072 -12.42167 -13.14980 -13.86077 -14.56131 -15.25780 -15.95121 -16.64579 -17.34419 -18.04983 -18.93926 0.000000 -1.893669 -3.313038 -4.533725 -5.597487 -6.604899 -7.480887 -8.280913 -9.103674 -9.816726 -10.48658 -11.12686 -11.74532 -12.34990 -12.94497 -13.53700 -14.12744 -14.72038 -15.31930 -15.92570 -16.53605 0.000000 -1.785919 -3.067523 -4.173167 -5.124082 -6.022377 -6.793666 -7.485389 -8.117981 -8.707762 -9.263512 -9.792845 -10.30482 -10.80394 -11.29591 -11.78384 -12.27228 -12.76486 -13.25789 -13.75617 -14.26053 0.000000 -1.677199 -2.826192 -3.823247 -4.669119 -5.464976 -6.128472 -6.730211 -7.276427 -7.779302 -8.251589 -8.702526 -9.135614 -9.557058 -9.970984 -10.38284 -10.79705 -11.09165 -11.45622 -11.85150 -12.25545 0.000000 -1.567437 -2.591914 -3.485485 -4.228195 -4.879341 -5.504815 -6.021778 -6.487371 -6.920361 -7.326515 -7.707298 -8.070555 -8.423012 -8.770811 -9.118206 -9.354511 -9.655667 -9.982898 -10.21024 -10.51099 0.000000 -1.456524 -2.365131 -3.130952 -3.812132 -4.380167 -4.877975 -5.317294 -5.762345 -6.138881 -6.480022 -6.796733 -7.100831 -7.397298 -7.689898 -7.884406 -8.139306 -8.414915 -8.613843 -8.878206 -9.169350 0.000000 -1.344321 -2.142664 -2.820409 -3.419095 -3.915319 -4.346301 -4.717943 -5.106833 -5.419586 -5.702066 -5.969834 -6.229143 -6.479617 -6.657176 -6.884541 -7.125732 -7.370891 -7.618112 -7.872900 -8.141463 0.000000 -1.230656 -1.935290 -2.519919 -3.047211 -3.481515 -3.848218 -4.205548 -4.498132 -4.756190 -4.999904 -5.234358 -5.455048 -5.667281 -5.892371 -6.115857 -6.337285 -6.555905 -6.781490 -7.017943 -7.272143 0.000000 -1.115831 -1.730575 -2.245768 -2.699674 -3.074062 -3.379300 -3.688979 -3.933870 -4.159421 -4.384727 -4.586753 -4.780835 -5.027446 -5.240351 -5.445343 -5.645176 -5.860206 -6.084411 -6.312756 -6.618363 0.000000 -1.000620 -1.535733 -1.980891 -2.376264 -2.685891 -2.973390 -3.210155 -3.424427 -3.670004 -3.863701 -4.044740 -4.235685 -4.469634 -4.667638 -4.857263 -5.058806 -5.317984 -5.536252 -5.767825 -6.061357 0.000000 -0.8860148 -1.351340 -1.725054 -2.068928 -2.317320 -2.565949 -2.771360 -2.999910 -3.187288 -3.360624 -3.573999 -3.759867 -3.979999 -4.167889 -4.362324 -4.598739 -4.799585 -5.066059 -5.288148 -5.554444 0.000000 -0.7732522 -1.167705 -1.479572 -1.773491 -1.973395 -2.193448 -2.404314 -2.585270 -2.762814 -2.956108 -3.165561 -3.344567 -3.556913 -3.749049 -3.970660 -4.158856 -4.396425 -4.649876 -4.847271 -5.081914 0.000000 -0.6635973 -0.9946995 -1.268367 -1.488294 -1.677954 -1.854574 -2.049021 -2.244204 -2.409418 -2.604647 -2.809238 -2.990670 -3.201741 -3.414476 -3.594529 -3.810150 -4.032511 -4.258813 -4.437981 -4.650005 0.000000 -0.5574419 -0.8345628 -1.064331 -1.212368 -1.387126 -1.566407 -1.737830 -1.917286 -2.103905 -2.298032 -2.498288 -2.701613 -2.910194 -3.086663 -3.286875 -3.485056 -3.682746 -3.876130 -4.064132 -4.252555 0.000000 -0.4559901 -0.6754302 -0.8637432 -0.9601420 -1.123833 -1.292605 -1.471118 -1.648140 -1.835895 -2.028502 -2.222782 -2.421079 -2.615958 -2.805042 -2.984774 -3.159194 -3.329335 -3.487014 -3.651139 -3.808951 0.000000 -0.3586179 -0.5163710 -0.6699529 -0.7571962 -0.8946103 -1.058381 -1.225727 -1.404732 -1.589283 -1.780058 -1.962941 -2.162516 -2.339295 -2.505671 -2.658495 -2.814213 -2.955807 -3.082594 -3.236916 -3.352812 0.000000 -0.2637091 -0.3822382 -0.4652529 -0.5565437 -0.6745334 -0.8270721 -0.9918548 -1.162683 -1.339023 -1.522692 -1.687755 -1.844829 -2.013272 -2.147742 -2.280707 -2.423923 -2.530224 -2.635845 -2.733028 -2.818765 0.000000 -0.1723025 -0.2504891 -0.2930323 -0.3679941 -0.4691994 -0.5954179 -0.7388505 -0.8838512 -1.038251 -1.176006 -1.319537 -1.445201 -1.573498 -1.679076 -1.798859 -1.887910 -1.973575 -2.066417 -2.138226 -2.200953 0.000000 -8.4744878E-02 -0.1178097 -0.1478678 -0.1867995 -0.2523046 -0.3322391 -0.4215561 -0.5141112 -0.6071649 -0.6905404 -0.7765560 -0.8604965 -0.9326747 -1.007309 -1.080174 -1.137251 -1.200085 -1.247405 -1.300840 -1.337483 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -2.206266 -4.153139 -5.834904 -7.385701 -8.831644 -10.19659 -11.49930 -12.75251 -13.96917 -15.15950 -16.16963 -17.25520 -18.35182 -19.45784 -20.57151 -21.47538 -22.51826 -23.59754 -24.70262 -25.80720 0.000000 -2.097214 -3.913799 -5.455929 -6.878088 -8.202325 -9.447863 -10.63309 -11.77026 -12.87200 -13.79609 -14.78385 -15.77210 -16.59677 -17.51719 -18.46205 -19.22852 -20.12320 -21.05564 -21.79315 -22.66260 0.000000 -1.987909 -3.671849 -5.080264 -6.381667 -7.587931 -8.717834 -9.789745 -10.70309 -11.63423 -12.54911 -13.45107 -14.18998 -15.01112 -15.69085 -16.47003 -17.11116 -17.86826 -18.66812 -19.28441 -20.03021 0.000000 -1.878344 -3.427521 -4.713152 -5.897504 -6.991600 -8.012532 -8.876389 -9.742941 -10.58341 -11.40444 -12.07039 -12.80521 -13.40578 -14.09450 -14.65126 -15.31521 -15.84310 -16.49598 -17.00717 -17.63640 0.000000 -1.768510 -3.183639 -4.352969 -5.428501 -6.416019 -7.248047 -8.067414 -8.848997 -9.600979 -10.21050 -10.87390 -11.41105 -12.02097 -12.50820 -13.08827 -13.54267 -14.10755 -14.54126 -15.10291 -15.53582 0.000000 -1.658398 -2.942314 -4.002468 -4.971546 -5.794359 -6.582914 -7.317324 -8.012577 -8.592793 -9.190028 -9.684152 -10.22130 -10.66018 -11.16058 -11.56115 -12.04154 -12.41883 -12.89334 -13.26121 -13.71958 0.000000 -1.547993 -2.705440 -3.664337 -4.487669 -5.256071 -5.958172 -6.611083 -7.230976 -7.720359 -8.243875 -8.669129 -9.135536 -9.508711 -9.939755 -10.27868 -10.69485 -11.01598 -11.42904 -11.72714 -12.12380 0.000000 -1.437275 -2.446263 -3.298529 -4.058074 -4.745469 -5.367612 -5.948833 -6.425927 -6.901887 -7.360458 -7.725720 -8.127389 -8.444645 -8.815068 -9.110448 -9.469192 -9.747478 -9.997510 -10.34082 -10.71846 0.000000 -1.326217 -2.217366 -2.978053 -3.653985 -4.257667 -4.811504 -5.322410 -5.729575 -6.138204 -6.537569 -6.849533 -7.193730 -7.471197 -7.803349 -8.055096 -8.373296 -8.603938 -8.913529 -9.253408 -9.609128 0.000000 -1.214785 -1.998153 -2.672292 -3.267784 -3.796479 -4.286403 -4.721951 -5.069523 -5.431889 -5.769393 -6.041706 -6.347992 -6.650337 -6.883421 -7.171532 -7.380747 -7.660748 -7.963434 -8.278259 -8.601356 0.000000 -1.102931 -1.783784 -2.372059 -2.894202 -3.363400 -3.782051 -4.148053 -4.494283 -4.768080 -5.065641 -5.348905 -5.576087 -5.839653 -6.098505 -6.297706 -6.556094 -6.826679 -7.103933 -7.387814 -7.677262 0.000000 -0.9905822 -1.579665 -2.087687 -2.533958 -2.950101 -3.294918 -3.609458 -3.909859 -4.191986 -4.415502 -4.670208 -4.912319 -5.102608 -5.337556 -5.579530 -5.823473 -6.070371 -6.320877 -6.576704 -6.834837 0.000000 -0.8776311 -1.374907 -1.819744 -2.205063 -2.550513 -2.828209 -3.108795 -3.368667 -3.616925 -3.858594 -4.050586 -4.265350 -4.487285 -4.711209 -4.933897 -5.158962 -5.385830 -5.616941 -5.848351 -6.075672 0.000000 -0.7639191 -1.185851 -1.556700 -1.892823 -2.161168 -2.397820 -2.643112 -2.872489 -3.096700 -3.312573 -3.515494 -3.723269 -3.934682 -4.142133 -4.349328 -4.561907 -4.779220 -4.996430 -5.200776 -5.403990 0.000000 -0.6495779 -0.9976589 -1.296981 -1.587961 -1.781923 -2.018777 -2.229720 -2.439993 -2.646640 -2.839763 -3.031005 -3.233742 -3.429950 -3.626066 -3.828649 -4.026866 -4.255228 -4.444462 -4.634876 -4.828269 0.000000 -0.5353967 -0.8134087 -1.058527 -1.288413 -1.439913 -1.637421 -1.824384 -2.016915 -2.204731 -2.383097 -2.593315 -2.782030 -2.967097 -3.155446 -3.366306 -3.539677 -3.715010 -3.885986 -4.093111 -4.256776 0.000000 -0.4222932 -0.6418384 -0.8375766 -0.9991755 -1.126701 -1.286334 -1.454182 -1.645575 -1.809302 -1.984085 -2.179757 -2.353487 -2.529818 -2.716971 -2.878471 -3.036488 -3.215718 -3.357718 -3.529627 -3.658561 0.000000 -0.3122480 -0.4706140 -0.6255121 -0.7013712 -0.8297487 -0.9687647 -1.114059 -1.269878 -1.431395 -1.592626 -1.764521 -1.921292 -2.087698 -2.229439 -2.390853 -2.519407 -2.667477 -2.778975 -2.914217 -3.015275 0.000000 -0.2054469 -0.3073611 -0.4025889 -0.4623812 -0.5528240 -0.6520666 -0.7775051 -0.8988805 -1.034276 -1.175193 -1.301193 -1.438555 -1.553893 -1.678462 -1.801946 -1.901512 -2.011382 -2.096177 -2.198876 -2.274611 0.000000 -0.1013731 -0.1519044 -0.1914127 -0.2324035 -0.2772639 -0.3394730 -0.4143415 -0.4896408 -0.5704931 -0.6520958 -0.7335339 -0.8139147 -0.8824964 -0.9561858 -1.028198 -1.098872 -1.154969 -1.217882 -1.279545 -1.325756 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -1.914798 -3.736990 -5.368609 -6.826546 -8.212628 -9.613811 -10.85135 -12.05162 -13.20020 -14.30372 -15.36766 -16.39690 -17.56742 -18.54817 -19.52715 -20.48345 -21.42126 -22.34271 -23.25165 -24.13876 0.000000 -1.819873 -3.538853 -5.054869 -6.394115 -7.669159 -8.872954 -10.09846 -11.18680 -12.23623 -13.24010 -14.20429 -15.13396 -16.03356 -16.91022 -17.76396 -18.59797 -19.41415 -20.21592 -21.00583 -21.77766 0.000000 -1.724856 -3.339563 -4.738436 -5.965549 -7.137062 -8.238124 -9.364236 -10.34954 -11.29505 -12.20129 -13.06890 -13.90153 -14.70484 -15.48466 -16.24293 -16.98334 -17.70725 -18.41854 -19.11862 -19.80012 0.000000 -1.629758 -3.138991 -4.377003 -5.545907 -6.614036 -7.617126 -8.559296 -9.538341 -10.38408 -11.19310 -11.96474 -12.71245 -13.43110 -14.12563 -14.79873 -15.45545 -16.09691 -16.72615 -17.34593 -17.94674 0.000000 -1.534569 -2.936976 -4.062521 -5.133800 -6.104386 -7.012210 -7.864446 -8.664879 -9.420325 -10.23502 -10.92130 -11.58160 -12.21511 -12.82805 -13.42286 -14.00145 -14.56677 -15.11957 -15.66185 -16.18630 0.000000 -1.439294 -2.733320 -3.752288 -4.731840 -5.609306 -6.431817 -7.194150 -7.911332 -8.585925 -9.221369 -9.825415 -10.40190 -10.95434 -11.48498 -11.99783 -12.49297 -12.97357 -13.44450 -13.90749 -14.35683 0.000000 -1.343938 -2.528272 -3.449532 -4.342473 -5.132938 -5.866099 -6.553127 -7.192932 -7.791638 -8.356853 -8.894279 -9.403565 -9.889598 -10.35271 -10.79621 -11.22695 -11.64965 -12.06457 -12.47181 -12.86479 0.000000 -1.248491 -2.323231 -3.153347 -3.961973 -4.670571 -5.327275 -5.938787 -6.505028 -7.038970 -7.541692 -8.014403 -8.457669 -8.878231 -9.277079 -9.671662 -10.05856 -10.43288 -10.79442 -11.14797 -11.49014 0.000000 -1.152965 -2.119336 -2.862823 -3.555619 -4.219385 -4.809335 -5.346158 -5.852664 -6.326405 -6.765358 -7.172451 -7.555823 -7.921351 -8.300468 -8.656454 -8.992807 -9.316622 -9.630860 -9.941180 -10.24637 0.000000 -1.057347 -1.917781 -2.583806 -3.199859 -3.796069 -4.306922 -4.785836 -5.234235 -5.643969 -6.018283 -6.370243 -6.709266 -7.122980 -7.443364 -7.746939 -8.041389 -8.328808 -8.611212 -8.888626 -9.153699 0.000000 -0.9616504 -1.718949 -2.310544 -2.849684 -3.382093 -3.823579 -4.252896 -4.639330 -4.982585 -5.306556 -5.621999 -5.988357 -6.276565 -6.552418 -6.818421 -7.077708 -7.336612 -7.584352 -7.823505 -8.054261 0.000000 -0.8658628 -1.525248 -2.043032 -2.515877 -2.976705 -3.371888 -3.740810 -4.058806 -4.351035 -4.645111 -4.970773 -5.233515 -5.485262 -5.729140 -5.969923 -6.212797 -6.436876 -6.651703 -6.869388 -7.081243 0.000000 -0.7699906 -1.338249 -1.789382 -2.199324 -2.581481 -2.938511 -3.239279 -3.497407 -3.767347 -4.059095 -4.299912 -4.532368 -4.757707 -4.984009 -5.248855 -5.451312 -5.648320 -5.855303 -6.056281 -6.246786 0.000000 -0.6740392 -1.153739 -1.537266 -1.887119 -2.222942 -2.517148 -2.746592 -2.978068 -3.243652 -3.463401 -3.677746 -3.889437 -4.130725 -4.326374 -4.517933 -4.702780 -4.933765 -5.122562 -5.304070 -5.486866 0.000000 -0.5779979 -0.9777253 -1.293743 -1.578573 -1.875399 -2.100676 -2.270174 -2.516635 -2.714795 -2.911289 -3.132450 -3.318669 -3.505681 -3.712301 -3.880625 -4.058627 -4.269998 -4.442900 -4.616847 -4.836637 0.000000 -0.4818775 -0.8019933 -1.063628 -1.291635 -1.534508 -1.688425 -1.869692 -2.051530 -2.223133 -2.419360 -2.588447 -2.790127 -2.943747 -3.105649 -3.297200 -3.456599 -3.650570 -3.806232 -4.003118 -4.150559 0.000000 -0.3856672 -0.6348194 -0.8352409 -1.022782 -1.196850 -1.292466 -1.467532 -1.612502 -1.778651 -1.930484 -2.106589 -2.251659 -2.417057 -2.568072 -2.739395 -2.887764 -3.055199 -3.198321 -3.358914 -3.482833 0.000000 -0.2893787 -0.4677925 -0.6114221 -0.7635056 -0.8579515 -0.9644146 -1.084515 -1.210628 -1.338914 -1.483109 -1.617548 -1.754211 -1.905460 -2.036776 -2.182337 -2.329507 -2.452809 -2.591919 -2.698813 -2.829909 0.000000 -0.1930008 -0.3087683 -0.4043722 -0.4940948 -0.5525240 -0.6358132 -0.7233880 -0.8119660 -0.9179929 -1.032182 -1.132264 -1.246502 -1.362748 -1.479798 -1.578227 -1.690928 -1.802602 -1.888501 -1.987487 -2.087501 0.000000 -9.6539356E-02 -0.1517334 -0.1985612 -0.2368959 -0.2764165 -0.3196148 -0.3627791 -0.4183905 -0.4810391 -0.5466096 -0.6085066 -0.6750185 -0.7412944 -0.8074369 -0.8730150 -0.9377915 -1.001737 -1.052119 -1.111046 -1.168842 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -1.407664 -2.821134 -4.132501 -5.350864 -6.478338 -7.593261 -8.709349 -9.679212 -10.73745 -11.65057 -12.66262 -13.51835 -14.49852 -15.30543 -16.26375 -17.02611 -17.96904 -18.69518 -19.62960 -20.32254 0.000000 -1.337568 -2.680522 -3.913926 -5.048494 -6.089229 -7.120069 -8.074077 -9.046139 -10.02824 -10.86084 -11.80010 -12.57954 -13.48698 -14.21704 -15.10323 -15.78866 -16.48902 -17.30946 -17.95455 -18.77862 0.000000 -1.267442 -2.539746 -3.694272 -4.743863 -5.698627 -6.651065 -7.528405 -8.425961 -9.239239 -10.09126 -10.84314 -11.65963 -12.35615 -13.14944 -13.79799 -14.57577 -15.18276 -15.95326 -16.52532 -17.09989 0.000000 -1.197285 -2.398799 -3.473400 -4.437205 -5.311831 -6.191308 -6.993961 -7.820159 -8.559546 -9.343338 -10.02131 -10.77295 -11.39705 -12.12699 -12.70505 -13.42174 -13.96132 -14.50232 -15.16737 -15.66194 0.000000 -1.127098 -2.257665 -3.251164 -4.131343 -4.930478 -5.739390 -6.469582 -7.230976 -7.898170 -8.618915 -9.227877 -9.916960 -10.47619 -11.14610 -11.65916 -12.16734 -12.78282 -13.24844 -13.71028 -14.29537 0.000000 -1.056881 -2.116346 -3.027358 -3.828375 -4.556898 -5.298102 -5.962783 -6.656083 -7.259665 -7.917161 -8.463340 -9.094041 -9.588724 -10.07605 -10.64870 -11.09280 -11.53090 -12.06781 -12.46913 -12.86330 0.000000 -0.9866331 -1.974820 -2.802237 -3.530200 -4.191162 -4.869792 -5.463806 -6.102726 -6.639384 -7.240867 -7.725623 -8.201309 -8.736247 -9.165792 -9.593376 -10.08313 -10.46806 -10.85123 -11.31117 -11.65193 0.000000 -0.9163492 -1.833069 -2.577180 -3.238386 -3.830628 -4.450603 -4.987789 -5.562299 -6.043309 -6.514282 -7.017623 -7.436759 -7.922348 -8.303787 -8.684924 -9.127023 -9.462441 -9.794301 -10.19884 -10.49258 0.000000 -0.8460412 -1.691064 -2.353347 -2.950970 -3.485844 -4.044379 -4.521354 -4.987764 -5.470433 -5.884111 -6.334176 -6.709383 -7.147634 -7.484785 -7.818701 -8.203424 -8.489901 -8.776698 -9.135438 -9.394694 0.000000 -0.7757031 -1.548772 -2.131922 -2.646061 -3.145219 -3.612283 -4.067490 -4.487559 -4.913281 -5.276220 -5.684769 -6.017309 -6.404440 -6.693536 -6.976007 -7.308965 -7.562716 -7.820587 -8.134809 -8.368222 0.000000 -0.7053350 -1.406135 -1.913290 -2.370932 -2.815566 -3.224205 -3.637669 -4.000689 -4.371410 -4.702579 -5.063553 -5.350782 -5.678401 -5.920064 -6.167917 -6.463562 -6.696057 -6.985314 -7.190492 -7.397037 0.000000 -0.6349368 -1.263094 -1.699849 -2.105874 -2.497845 -2.851974 -3.217017 -3.522962 -3.863837 -4.152301 -4.460690 -4.697165 -4.967622 -5.186229 -5.465173 -5.671592 -5.874036 -6.121668 -6.310091 -6.486809 0.000000 -0.5645087 -1.119535 -1.493186 -1.840708 -2.182548 -2.497297 -2.802544 -3.077750 -3.374915 -3.618657 -3.865039 -4.058040 -4.299941 -4.502778 -4.738847 -4.922330 -5.149126 -5.317545 -5.482984 -5.694592 0.000000 -0.4940505 -0.9752978 -1.289079 -1.591765 -1.879138 -2.147406 -2.400507 -2.652533 -2.899265 -3.090223 -3.278932 -3.461479 -3.678994 -3.893057 -4.055046 -4.219971 -4.415948 -4.566089 -4.758038 -4.958418 0.000000 -0.4235623 -0.8305146 -1.093540 -1.344250 -1.589932 -1.801020 -2.030737 -2.239146 -2.428741 -2.588929 -2.733910 -2.932951 -3.089041 -3.266492 -3.416110 -3.592374 -3.730994 -3.901315 -4.079953 -4.196145 0.000000 -0.3530443 -0.6859762 -0.8983377 -1.101343 -1.302548 -1.475660 -1.670212 -1.846446 -1.958428 -2.085246 -2.238117 -2.397104 -2.554000 -2.683391 -2.840368 -2.965932 -3.118532 -3.275191 -3.384559 -3.523825 0.000000 -0.2824964 -0.5425888 -0.7117668 -0.8716327 -1.016098 -1.180638 -1.315260 -1.430882 -1.504006 -1.640148 -1.778103 -1.888824 -2.017717 -2.153669 -2.264616 -2.396590 -2.535241 -2.636545 -2.757713 -2.875449 0.000000 -0.2119185 -0.4023475 -0.5254077 -0.6425318 -0.7554653 -0.8731874 -0.9606003 -1.020858 -1.120787 -1.215730 -1.314591 -1.417072 -1.527484 -1.619598 -1.729699 -1.844494 -1.938228 -2.039951 -2.141429 -2.242089 0.000000 -0.1413108 -0.2654315 -0.3471161 -0.4216518 -0.4982795 -0.5669577 -0.6160294 -0.6727228 -0.7386537 -0.8092358 -0.8796580 -0.9478049 -1.025526 -1.108194 -1.194712 -1.280254 -1.348974 -1.429882 -1.510378 -1.588093 0.000000 -7.0673436E-02 -0.1313250 -0.1708721 -0.2105910 -0.2412474 -0.2729895 -0.3045909 -0.3367819 -0.3709588 -0.4032432 -0.4417702 -0.4841643 -0.5297725 -0.5773873 -0.6258847 -0.6746643 -0.7168411 -0.7644290 -0.8104054 -0.8565643 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.7572105 -1.516911 -2.279081 -3.037611 -3.763685 -4.454251 -5.121064 -5.776021 -6.428245 -7.001418 -7.605675 -8.205420 -8.805511 -9.408879 -9.884127 -10.44526 -11.00872 -11.57715 -12.00243 -12.53281 0.000000 -0.7194067 -1.441304 -2.165658 -2.885975 -3.571546 -4.219152 -4.841565 -5.451631 -6.059105 -6.584657 -7.143515 -7.698807 -8.255543 -8.728782 -9.247570 -9.767111 -10.28949 -10.81717 -11.19820 -11.68842 0.000000 -0.6816034 -1.365665 -2.052178 -2.734204 -3.378926 -3.983027 -4.560423 -5.125070 -5.687552 -6.166504 -6.682727 -7.196285 -7.713055 -8.143390 -8.622008 -9.101026 -9.584347 -9.962127 -10.40980 -10.86095 0.000000 -0.6437871 -1.290008 -1.938642 -2.582282 -3.185771 -3.745732 -4.277448 -4.796559 -5.316809 -5.752087 -6.228302 -6.702681 -7.180069 -7.568573 -8.008267 -8.448574 -8.894032 -9.229486 -9.639257 -10.05282 0.000000 -0.6059647 -1.214326 -1.825056 -2.430193 -2.992013 -3.507112 -3.992642 -4.468933 -4.950346 -5.342957 -5.781104 -6.216786 -6.658528 -7.003201 -7.406388 -7.811417 -8.220305 -8.511473 -8.886241 -9.265578 0.000000 -0.5681426 -1.138618 -1.711407 -2.277941 -2.797565 -3.266974 -3.707966 -4.144283 -4.536985 -4.941398 -5.341923 -5.741465 -6.085440 -6.454076 -6.819376 -7.189254 -7.479700 -7.817589 -8.157707 -8.503063 0.000000 -0.5303074 -1.062886 -1.597703 -2.125496 -2.602318 -3.025562 -3.425081 -3.824499 -4.179436 -4.547538 -4.909967 -5.278936 -5.583982 -5.914657 -6.250731 -6.588962 -6.840171 -7.143661 -7.451892 -7.681414 0.000000 -0.4924727 -0.9871222 -1.483942 -1.972852 -2.406129 -2.784272 -3.145364 -3.511158 -3.828588 -4.159000 -4.493605 -4.826382 -5.094458 -5.397620 -5.699625 -6.003932 -6.219388 -6.494598 -6.774012 -6.966781 0.000000 -0.4546253 -0.9113398 -1.370125 -1.819976 -2.208825 -2.544239 -2.869141 -3.202302 -3.483583 -3.786043 -4.083629 -4.387393 -4.623236 -4.892892 -5.160758 -5.379239 -5.625909 -5.872018 -6.120535 -6.281191 0.000000 -0.4167714 -0.8355328 -1.256259 -1.666826 -2.010695 -2.306659 -2.598316 -2.903269 -3.150073 -3.417648 -3.687216 -3.921267 -4.161998 -4.401825 -4.648784 -4.836640 -5.054085 -5.268949 -5.484598 -5.619693 0.000000 -0.3789180 -0.7597005 -1.142330 -1.513364 -1.812515 -2.071924 -2.335670 -2.579091 -2.822809 -3.060945 -3.303576 -3.501544 -3.716372 -3.935086 -4.151786 -4.310705 -4.496722 -4.683160 -4.826353 -4.991214 0.000000 -0.3410515 -0.6838434 -1.028346 -1.359505 -1.615269 -1.842425 -2.076686 -2.292165 -2.501905 -2.716624 -2.924112 -3.097775 -3.292079 -3.480836 -3.665750 -3.796086 -3.962933 -4.130076 -4.252955 -4.391190 0.000000 -0.3031857 -0.6079549 -0.9143055 -1.205155 -1.420188 -1.619742 -1.826813 -2.005017 -2.195676 -2.375674 -2.559660 -2.713160 -2.877370 -3.034864 -3.188219 -3.314324 -3.459441 -3.600237 -3.738536 -3.814029 0.000000 -0.2653067 -0.5320483 -0.8002096 -1.050147 -1.228534 -1.399665 -1.579676 -1.734514 -1.891349 -2.046943 -2.209775 -2.335772 -2.468424 -2.602248 -2.747904 -2.854366 -2.974295 -3.088271 -3.197942 -3.287374 0.000000 -0.2274216 -0.4561166 -0.6860650 -0.8946065 -1.040703 -1.188194 -1.338352 -1.465833 -1.596228 -1.732911 -1.864450 -1.961783 -2.077851 -2.202924 -2.319806 -2.409317 -2.502747 -2.590589 -2.666039 -2.724769 0.000000 -0.1895369 -0.3801602 -0.5718581 -0.7393374 -0.8579378 -0.9771153 -1.103137 -1.202130 -1.315020 -1.422140 -1.519459 -1.609472 -1.714049 -1.811980 -1.903352 -1.988150 -2.040740 -2.096100 -2.136759 -2.176465 0.000000 -0.1516393 -0.3041790 -0.4575958 -0.5852391 -0.6795323 -0.7746992 -0.8688530 -0.9519529 -1.036263 -1.112040 -1.199850 -1.290081 -1.356978 -1.429360 -1.492295 -1.548160 -1.577779 -1.617353 -1.675753 -1.710458 0.000000 -0.1137422 -0.2281663 -0.3432778 -0.4343077 -0.5039183 -0.5725445 -0.6453752 -0.7029115 -0.7622437 -0.8274871 -0.8919569 -0.9559753 -1.003297 -1.047423 -1.081966 -1.112269 -1.164630 -1.204374 -1.235234 -1.253210 0.000000 -7.5832210E-02 -0.1521356 -0.2289049 -0.2867210 -0.3321410 -0.3784938 -0.4221073 -0.4620674 -0.5049556 -0.5468562 -0.5869212 -0.6229127 -0.6490309 -0.6773247 -0.7038372 -0.7378659 -0.7730443 -0.7934562 -0.8153493 -0.8411006 0.000000 -3.7915926E-02 -7.6080158E-02 -0.1144834 -0.1419566 -0.1645070 -0.1865390 -0.2089601 -0.2311276 -0.2490140 -0.2659339 -0.2835411 -0.3015437 -0.3190003 -0.3366002 -0.3542988 -0.3722672 -0.3910163 -0.3994595 -0.4137990 -0.4297720 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 1.164589 2.041359 2.675874 3.149821 3.513366 3.797371 4.020349 4.193126 4.325025 4.419540 4.527045 4.582489 4.651005 4.666624 4.700148 4.729431 4.751040 4.764639 4.760589 4.701695 0.000000 1.095904 1.919870 2.516189 2.929201 3.259796 3.518085 3.718551 3.872271 3.986373 4.109963 4.180351 4.261868 4.293683 4.338189 4.334237 4.349061 4.360903 4.368069 4.360726 4.302416 0.000000 1.025164 1.795313 2.327791 2.736571 3.047779 3.282899 3.466466 3.608042 3.713798 3.788190 3.877840 3.920973 3.933405 3.964360 3.952726 3.960405 3.967066 3.968782 3.955343 3.895267 0.000000 0.9545237 1.654547 2.168669 2.547171 2.800963 3.014654 3.179785 3.304336 3.395351 3.493275 3.544726 3.567873 3.568291 3.589955 3.573785 3.575689 3.575558 3.534989 3.508772 3.442139 0.000000 0.8768793 1.535390 2.008824 2.331160 2.589889 2.784518 2.928802 3.037992 3.116340 3.169503 3.200628 3.212506 3.207012 3.219215 3.198819 3.195013 3.157856 3.140079 3.115500 3.053161 0.000000 0.8113902 1.415492 1.828945 2.143579 2.375325 2.522236 2.648260 2.735297 2.798466 2.838619 2.860537 2.866443 2.856839 2.833367 2.829249 2.796381 2.781228 2.736179 2.705981 2.640616 0.000000 0.7464277 1.295495 1.672629 1.953337 2.139111 2.288722 2.368622 2.443480 2.489770 2.518113 2.532175 2.530244 2.515378 2.490415 2.456265 2.440482 2.398094 2.373760 2.325413 2.257375 0.000000 0.6823634 1.166477 1.515750 1.747816 1.925841 2.031813 2.117537 2.157827 2.189090 2.208075 2.208927 2.196483 2.178102 2.152338 2.119504 2.080269 2.037269 2.014121 1.966429 1.901927 0.000000 0.6193907 1.052930 1.346362 1.561962 1.697222 1.781341 1.854360 1.877934 1.898498 1.904716 1.879980 1.864922 1.843508 1.815433 1.781820 1.743331 1.718745 1.676859 1.627037 1.566254 0.000000 0.5530661 0.9403070 1.195607 1.365766 1.474596 1.558394 1.596593 1.607685 1.618667 1.600280 1.588027 1.567815 1.541056 1.510478 1.476002 1.438041 1.394395 1.347569 1.299381 1.243224 0.000000 0.4948142 0.8215660 1.046641 1.187043 1.273927 1.324395 1.347420 1.348554 1.346912 1.325229 1.307142 1.270494 1.239605 1.205358 1.168810 1.129760 1.075637 1.028736 0.9819216 0.9288313 0.000000 0.4373082 0.7174456 0.8948781 1.004730 1.067777 1.100133 1.109818 1.101047 1.079690 1.063608 1.029785 0.9994170 0.9561250 0.9185284 0.8788064 0.8376859 0.7856013 0.7384868 0.6912904 0.6394846 0.000000 0.3783372 0.6157734 0.7570972 0.8302484 0.8721622 0.8878593 0.8845346 0.8657737 0.8384812 0.8126273 0.7757450 0.7332616 0.6945110 0.6470662 0.6040344 0.5591936 0.5075972 0.4583762 0.4089223 0.3563842 0.000000 0.3237030 0.5134196 0.6207681 0.6755799 0.6963760 0.6952515 0.6722175 0.6442989 0.6101347 0.5706699 0.5327493 0.4873597 0.4394624 0.3934557 0.3429123 0.2937374 0.2424293 0.1894053 0.1364075 8.1012271E-02 0.000000 0.2745768 0.4221311 0.4983009 0.5246051 0.5266949 0.5098307 0.4762977 0.4391987 0.3972406 0.3514397 0.3027386 0.2549927 0.2036627 0.1506941 9.8011024E-02 4.4104505E-02 -1.2537705E-02 -6.8408668E-02 -0.1248524 -0.1833756 0.000000 0.2235644 0.3331677 0.3819947 0.3879752 0.3741423 0.3437504 0.3008689 0.2548136 0.2048485 0.1522658 9.7601198E-02 4.3305717E-02 -1.2154702E-02 -6.9864862E-02 -0.1276025 -0.1860505 -0.2460072 -0.2997371 -0.3574226 -0.4133725 0.000000 0.1742117 0.2530595 0.2777740 0.2713023 0.2418689 0.2015211 0.1516571 9.8210402E-02 4.2003017E-02 -1.6670274E-02 -7.6846600E-02 -0.1360582 -0.1962920 -0.2563157 -0.3151066 -0.3744970 -0.4332822 -0.4860574 -0.5420275 -0.5975829 0.000000 0.1270163 0.1788879 0.1873390 0.1698383 0.1343070 8.9181609E-02 3.7100658E-02 -1.9973129E-02 -7.9550326E-02 -0.1409706 -0.2019698 -0.2622624 -0.3238619 -0.3835537 -0.4404864 -0.4992386 -0.5543749 -0.6081497 -0.6592923 -0.7082110 0.000000 8.1875041E-02 0.1114322 0.1102650 8.9500137E-02 5.4936308E-02 1.3220360E-02 -3.4238320E-02 -8.5982360E-02 -0.1392030 -0.1959905 -0.2510006 -0.3062519 -0.3639868 -0.4180027 -0.4692751 -0.5247558 -0.5733289 -0.6214323 -0.6649198 -0.7065808 0.000000 3.9482590E-02 5.1003557E-02 4.6439622E-02 3.1137442E-02 8.7453956E-03 -1.8440107E-02 -4.9120516E-02 -8.2989849E-02 -0.1176021 -0.1552891 -0.1931118 -0.2294784 -0.2682461 -0.3066960 -0.3435962 -0.3803080 -0.4164951 -0.4516267 -0.4833626 -0.5144070 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 1.126184 1.953799 2.548708 2.991794 3.331004 3.594287 3.800391 3.959466 4.081126 4.167544 4.266439 4.315676 4.377559 4.388662 4.417849 4.442787 4.460396 4.470302 4.463329 4.403586 0.000000 1.060546 1.838785 2.397517 2.784765 3.093845 3.334509 3.520790 3.662846 3.767485 3.881438 3.944814 4.019192 4.045931 4.085178 4.119787 4.106184 4.107807 4.108138 4.096254 4.036424 0.000000 0.9930351 1.720873 2.221571 2.603720 2.893705 3.112880 3.283210 3.413863 3.510741 3.578141 3.660204 3.697924 3.706377 3.732813 3.756090 3.735817 3.732665 3.730070 3.715724 3.654872 0.000000 0.9256523 1.588917 2.070867 2.424267 2.661591 2.859901 3.011460 3.126280 3.209484 3.299086 3.344589 3.363267 3.360320 3.377263 3.358725 3.357898 3.357122 3.351927 3.300342 3.225222 0.000000 0.8522014 1.475530 1.919112 2.220956 2.460901 2.636185 2.772441 2.873481 2.944489 2.991372 3.017385 3.025062 3.016131 3.026582 3.005257 2.999495 2.992119 2.950313 2.919505 2.852393 0.000000 0.7893740 1.361467 1.749735 2.042829 2.231853 2.390271 2.507576 2.586346 2.642185 2.676164 2.692898 2.694329 2.681037 2.681858 2.656262 2.644581 2.603176 2.577428 2.524295 2.450770 0.000000 0.7270290 1.247267 1.601184 1.843636 2.032884 2.170275 2.242242 2.308431 2.347662 2.369921 2.378594 2.372082 2.353342 2.324924 2.311256 2.273494 2.227418 2.201786 2.148747 2.077638 0.000000 0.6655055 1.125140 1.451946 1.667547 1.830815 1.926586 2.002491 2.035679 2.060230 2.072994 2.068668 2.051740 2.029090 1.999320 1.963026 1.922887 1.898422 1.854534 1.799630 1.731770 0.000000 0.6049566 1.016773 1.291527 1.490564 1.613747 1.688194 1.751291 1.768156 1.782051 1.782262 1.753335 1.733379 1.707187 1.675022 1.638009 1.612707 1.570882 1.523618 1.471314 1.408982 0.000000 0.5406885 0.9092245 1.147848 1.304354 1.402030 1.475008 1.505166 1.509773 1.514111 1.490775 1.473113 1.447911 1.416456 1.382567 1.344436 1.302664 1.257843 1.210995 1.161578 1.103988 0.000000 0.4844674 0.7959089 1.005894 1.134046 1.210490 1.251882 1.267322 1.262088 1.254199 1.227385 1.203890 1.163083 1.129757 1.091857 1.050441 1.007171 0.9618667 0.9149494 0.8661194 0.8108541 0.000000 0.4288720 0.6961092 0.8614326 0.9605559 1.014153 1.038162 1.040688 1.025804 0.9990494 0.9773068 0.9389580 0.9041489 0.8662571 0.8180346 0.7738076 0.7281003 0.6810272 0.6320528 0.5816446 0.5270143 0.000000 0.3744109 0.5985439 0.7298214 0.7943164 0.8278550 0.8360386 0.8261464 0.8017010 0.7693086 0.7383525 0.6972249 0.6512773 0.6084407 0.5633389 0.5121716 0.4632219 0.4128752 0.3606325 0.3079170 0.2526948 0.000000 0.3198833 0.4999690 0.5995196 0.6467108 0.6604089 0.6527996 0.6244535 0.5914010 0.5526591 0.5091323 0.4677200 0.4186123 0.3668748 0.3176353 0.2664268 0.2113049 0.1575055 0.1016799 4.6678420E-02 -1.0673765E-02 0.000000 0.2702590 0.4120313 0.4822073 0.5028082 0.4991077 0.4769591 0.4388922 0.3974447 0.3515994 0.3023397 0.2529110 0.1992457 0.1445267 8.9354508E-02 3.2481410E-02 -2.4174618E-02 -8.1958264E-02 -0.1415385 -0.2003684 -0.2625771 0.000000 0.2201792 0.3255979 0.3705307 0.3722776 0.3542131 0.3198110 0.2733507 0.2238717 0.1708647 0.1156000 5.8560725E-02 1.0628417E-03 -5.8542430E-02 -0.1198213 -0.1812071 -0.2382437 -0.2981823 -0.3591429 -0.4174103 -0.4776747 0.000000 0.1720240 0.2491897 0.2701007 0.2606050 0.2286342 0.1855849 0.1331620 7.7329203E-02 1.8960198E-02 -4.1805189E-02 -0.1047961 -0.1661615 -0.2300134 -0.2929753 -0.3543792 -0.4117131 -0.4717795 -0.5311647 -0.5902308 -0.6422334 0.000000 0.1257740 0.1774613 0.1824878 0.1634645 0.1265538 7.9925582E-02 2.6276631E-02 -3.2165844E-02 -9.2971846E-02 -0.1553875 -0.2178964 -0.2791403 -0.3448839 -0.4059430 -0.4643003 -0.5242529 -0.5810053 -0.6366912 -0.6895983 -0.7402082 0.000000 8.1302419E-02 0.1101306 0.1080343 8.6078942E-02 5.1217169E-02 8.9652054E-03 -3.9120987E-02 -9.1512434E-02 -0.1453427 -0.2022236 -0.2581990 -0.3138975 -0.3721689 -0.4265563 -0.4781837 -0.5342155 -0.5833216 -0.6317301 -0.6757249 -0.7179525 0.000000 3.9329819E-02 5.1124737E-02 4.5895390E-02 3.0433176E-02 7.8907115E-03 -1.9452007E-02 -5.0264187E-02 -8.3486333E-02 -0.1191045 -0.1563192 -0.1928942 -0.2313650 -0.2702667 -0.3089334 -0.3456967 -0.3826816 -0.4190038 -0.4497851 -0.4809613 -0.5120314 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 1.083756 1.858431 2.411548 2.822547 3.105104 3.336521 3.517291 3.691746 3.813141 3.896085 3.988540 4.032766 4.088794 4.138410 4.137680 4.151931 4.162857 4.167783 4.157348 4.096371 0.000000 1.022245 1.751223 2.247448 2.626540 2.915855 3.138798 3.310394 3.440554 3.535509 3.640303 3.696419 3.763350 3.784840 3.818754 3.848230 3.831639 3.830800 3.828999 3.815347 3.755459 0.000000 0.9582806 1.624915 2.106892 2.461786 2.729282 2.931629 3.088552 3.208267 3.296102 3.356151 3.430316 3.462371 3.466746 3.489086 3.509608 3.488595 3.482811 3.477332 3.461347 3.402560 0.000000 0.8944371 1.518796 1.966794 2.293395 2.513355 2.696163 2.835059 2.939193 3.013646 3.094291 3.133484 3.147403 3.140922 3.153993 3.164983 3.139046 3.129786 3.119106 3.096833 3.036499 0.000000 0.8255743 1.411992 1.823930 2.104448 2.325714 2.486577 2.610081 2.700815 2.763710 2.803960 2.824531 2.827727 2.815204 2.821474 2.797221 2.788163 2.776796 2.733516 2.702314 2.638392 0.000000 0.7656437 1.304485 1.665848 1.937252 2.111312 2.254848 2.359895 2.430079 2.478415 2.506005 2.517223 2.513965 2.496867 2.493228 2.464517 2.449050 2.407233 2.380919 2.349892 2.289152 0.000000 0.7060984 1.184802 1.526646 1.750617 1.923317 2.044031 2.110010 2.167694 2.199754 2.215609 2.218581 2.207389 2.184649 2.152685 2.134663 2.093874 2.066207 2.021546 1.985225 1.923809 0.000000 0.6472579 1.082068 1.385941 1.584236 1.715178 1.816639 1.883496 1.909518 1.927061 1.933241 1.923614 1.902158 1.875018 1.841113 1.801095 1.757503 1.728776 1.681486 1.640483 1.577401 0.000000 0.5892372 0.9792110 1.235038 1.416491 1.527703 1.592669 1.645738 1.655754 1.662423 1.656572 1.623547 1.598301 1.567106 1.530416 1.489299 1.459282 1.413612 1.362864 1.307562 1.243052 0.000000 0.5273086 0.8769431 1.098808 1.240814 1.327898 1.390277 1.412308 1.410225 1.407439 1.379879 1.356255 1.325129 1.288749 1.250247 1.207843 1.161969 1.113195 1.062788 1.010276 0.9501022 0.000000 0.4731328 0.7692678 0.9550064 1.079898 1.146265 1.178801 1.186471 1.174595 1.162502 1.129850 1.098931 1.053067 1.015253 0.9728382 0.9270810 0.8794910 0.8303489 0.7800807 0.7280042 0.6696666 0.000000 0.4194584 0.6738995 0.8272035 0.9157847 0.9602359 0.9760136 0.9711081 0.9498242 0.9266841 0.8902091 0.8462633 0.8076478 0.7650338 0.7123165 0.6637362 0.6139833 0.5637218 0.5113082 0.4573322 0.3997238 0.000000 0.3668002 0.5805616 0.7018805 0.7580381 0.7834289 0.7841153 0.7673588 0.7369583 0.6991267 0.6624832 0.6165832 0.5722477 0.5205393 0.4709745 0.4157398 0.3640168 0.3107212 0.2542848 0.1983180 0.1416802 0.000000 0.3129097 0.4859644 0.5777185 0.6175332 0.6242743 0.6101032 0.5762012 0.5377492 0.4940569 0.4457316 0.3996187 0.3466547 0.2948385 0.2386544 0.1844635 0.1288531 7.0304029E-02 1.1126994E-02 -4.6939019E-02 -0.1084424 0.000000 0.2644594 0.4014801 0.4655728 0.4805625 0.4711849 0.4436172 0.4008109 0.3547719 0.3046191 0.2511283 0.1978941 0.1408418 8.3333708E-02 2.4714358E-02 -3.3287231E-02 -9.4057545E-02 -0.1566536 -0.2170545 -0.2763101 -0.3419562 0.000000 0.2180948 0.3175873 0.3585410 0.3561071 0.3337379 0.2951890 0.2449924 0.1919468 0.1353399 7.7375785E-02 1.6938085E-02 -4.4575747E-02 -0.1075291 -0.1698832 -0.2301037 -0.2929958 -0.3546688 -0.4125786 -0.4750203 -0.5397331 0.000000 0.1694774 0.2434950 0.2619565 0.2496043 0.2147449 0.1688405 0.1137423 5.6093886E-02 -5.7678623E-03 -6.9349200E-02 -0.1341759 -0.1988250 -0.2630403 -0.3261570 -0.3882318 -0.4508193 -0.5082389 -0.5682305 -0.6274004 -0.6866468 0.000000 0.1242598 0.1731833 0.1772285 0.1567936 0.1181931 6.9924928E-02 1.4583398E-02 -4.5226950E-02 -0.1084041 -0.1715153 -0.2369765 -0.3017111 -0.3645751 -0.4260553 -0.4849933 -0.5456374 -0.6036438 -0.6595727 -0.7125329 -0.7662457 0.000000 8.0549464E-02 0.1096119 0.1054876 8.2481265E-02 4.7031909E-02 4.2093247E-03 -4.4658124E-02 -9.7749643E-02 -0.1537738 -0.2097145 -0.2662992 -0.3256580 -0.3812740 -0.4359128 -0.4882938 -0.5446742 -0.5942978 -0.6430757 -0.6878689 -0.7370325 0.000000 3.9086189E-02 5.0567128E-02 4.5166530E-02 2.9502900E-02 6.7777205E-03 -2.0774964E-02 -5.1764902E-02 -8.5220516E-02 -0.1209725 -0.1583531 -0.1951698 -0.2337405 -0.2729430 -0.3084539 -0.3485261 -0.3855816 -0.4180208 -0.4531116 -0.4849124 -0.5148193 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 1.031311 1.750106 2.260612 2.613349 2.891891 3.107852 3.274412 3.434343 3.544404 3.618160 3.701301 3.738575 3.788068 3.831428 3.866162 3.891526 3.907721 3.915621 3.907396 3.851646 0.000000 0.9735252 1.649855 2.109273 2.458452 2.724306 2.927796 3.084146 3.202158 3.320685 3.394375 3.436860 3.493905 3.508740 3.538524 3.563151 3.580762 3.591172 3.594633 3.583080 3.527968 0.000000 0.9136234 1.533535 1.978693 2.304817 2.546218 2.733209 2.877250 2.986059 3.064847 3.117469 3.183666 3.210054 3.244419 3.242281 3.252507 3.260620 3.262932 3.226110 3.198907 3.134823 0.000000 0.8465811 1.435143 1.848509 2.125262 2.347442 2.516599 2.642799 2.736154 2.801709 2.873244 2.905862 2.914749 2.936394 2.926423 2.928874 2.928367 2.893987 2.875196 2.850854 2.790881 0.000000 0.7903476 1.336014 1.699549 1.974091 2.176939 2.322827 2.433470 2.513587 2.567773 2.600850 2.615457 2.613813 2.623766 2.606822 2.601326 2.568347 2.548362 2.527447 2.500352 2.441094 0.000000 0.7340712 1.236406 1.571907 1.820253 1.979151 2.107671 2.200264 2.260493 2.300338 2.320924 2.326246 2.318079 2.296970 2.288834 2.256684 2.236754 2.193223 2.164780 2.130771 2.067715 0.000000 0.6781642 1.126635 1.443686 1.647934 1.803863 1.910740 1.966987 2.014820 2.038955 2.048111 2.045191 2.029033 2.001904 1.966172 1.943424 1.901987 1.873005 1.823303 1.781509 1.716528 0.000000 0.6229070 1.031578 1.300705 1.494649 1.609811 1.699031 1.754975 1.773152 1.783382 1.782952 1.767624 1.740892 1.709020 1.671209 1.629092 1.599330 1.551628 1.496611 1.452170 1.388984 0.000000 0.5683574 0.9362679 1.174490 1.326170 1.435355 1.490417 1.532904 1.535775 1.535409 1.522969 1.484772 1.453607 1.418479 1.377036 1.344633 1.297972 1.245465 1.190070 1.144805 1.084581 0.000000 0.5099309 0.8411070 1.047308 1.175421 1.249390 1.301160 1.314855 1.305918 1.296014 1.262531 1.232264 1.198265 1.157129 1.110979 1.063044 1.012149 0.9587059 0.9041270 0.8577141 0.7992900 0.000000 0.4586363 0.7404514 0.9130484 1.014892 1.080074 1.103735 1.103573 1.084901 1.065630 1.026734 0.9913633 0.9505132 0.8967929 0.8485275 0.7976003 0.7447539 0.6911604 0.6367089 0.5871031 0.5280041 0.000000 0.4075847 0.6502173 0.7927034 0.8710339 0.9062412 0.9140472 0.9013951 0.8737005 0.8436785 0.8009273 0.7596420 0.7079845 0.6586339 0.6071272 0.5493753 0.4957066 0.4409669 0.3843071 0.3292705 0.2682722 0.000000 0.3571681 0.5615306 0.6743137 0.7227226 0.7402549 0.7338764 0.7097084 0.6735016 0.6295606 0.5877693 0.5363984 0.4853779 0.4285559 0.3745945 0.3199483 0.2634730 0.2053311 0.1441494 8.3285965E-02 2.1852605E-02 0.000000 0.3076175 0.4711725 0.5567062 0.5898390 0.5902107 0.5644076 0.5302849 0.4860917 0.4367267 0.3878711 0.3323564 0.2737136 0.2174358 0.1598079 0.1015432 4.0302947E-02 -2.1106916E-02 -8.6737439E-02 -0.1493260 -0.2129830 0.000000 0.2579088 0.3902316 0.4498118 0.4599931 0.4456330 0.4129954 0.3652579 0.3142028 0.2591354 0.2034555 0.1431161 8.2314968E-02 2.1559460E-02 -3.9775919E-02 -0.1025524 -0.1680458 -0.2316819 -0.2969276 -0.3565231 -0.4227553 0.000000 0.2099866 0.3124227 0.3472733 0.3414475 0.3153755 0.2728648 0.2186770 0.1616833 0.1021790 3.9264042E-02 -2.5482038E-02 -9.0417102E-02 -0.1539672 -0.2172895 -0.2819317 -0.3484161 -0.4115132 -0.4733531 -0.5314340 -0.5958095 0.000000 0.1660646 0.2377577 0.2542466 0.2396414 0.2023192 0.1536053 9.6578389E-02 3.4932081E-02 -2.9613424E-02 -9.6349865E-02 -0.1641047 -0.2308910 -0.2945546 -0.3583624 -0.4234530 -0.4881696 -0.5508957 -0.6065751 -0.6659690 -0.7257567 0.000000 0.1220815 0.1689602 0.1720615 0.1505745 0.1105643 6.0555905E-02 3.2982803E-03 -5.8495611E-02 -0.1228276 -0.1890402 -0.2538603 -0.3197541 -0.3836918 -0.4456458 -0.5093033 -0.5694317 -0.6266844 -0.6830123 -0.7366045 -0.7908791 0.000000 7.9347968E-02 0.1072635 0.1031278 7.8814395E-02 4.3360472E-02 -6.4471475E-04 -5.0848622E-02 -0.1042355 -0.1609560 -0.2175633 -0.2747281 -0.3346716 -0.3908997 -0.4460291 -0.5039820 -0.5557257 -0.6059545 -0.6551338 -0.7004975 -0.7499965 0.000000 3.8613167E-02 4.9724825E-02 4.4158623E-02 2.8276948E-02 5.3112549E-03 -2.2458555E-02 -5.3673517E-02 -8.7399580E-02 -0.1233250 -0.1610252 -0.1979798 -0.2366741 -0.2760762 -0.3118000 -0.3486254 -0.3853689 -0.4220183 -0.4572175 -0.4893281 -0.5194837 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.9677047 1.626439 2.092828 2.414941 2.668941 2.865298 3.015919 3.160591 3.258882 3.323202 3.397478 3.463237 3.484858 3.516399 3.542443 3.560859 3.571258 3.574167 3.562053 3.504858 0.000000 0.9134863 1.532561 1.953066 2.271720 2.513720 2.698459 2.839838 2.945696 3.052416 3.117248 3.153023 3.203497 3.247337 3.250780 3.265290 3.276041 3.280946 3.280538 3.267624 3.213318 0.000000 0.8578038 1.426176 1.831635 2.127961 2.347192 2.516499 2.646408 2.743855 2.813467 2.858835 2.917695 2.938504 2.967139 2.960976 2.967374 2.971393 2.971282 2.965735 2.947243 2.891288 0.000000 0.7966875 1.334513 1.709802 1.961181 2.162023 2.314237 2.427074 2.509630 2.566407 2.629404 2.655507 2.659357 2.675147 2.661632 2.660344 2.657845 2.650054 2.609910 2.578995 2.516376 0.000000 0.7443052 1.242234 1.572180 1.820002 2.002176 2.132328 2.230027 2.299575 2.345057 2.370924 2.379542 2.372889 2.379429 2.360139 2.351570 2.340077 2.301274 2.275740 2.244761 2.181461 0.000000 0.6919678 1.149840 1.453618 1.676543 1.817798 1.930565 2.010334 2.060354 2.091364 2.104692 2.103719 2.090135 2.086009 2.060021 2.042914 2.004346 1.976163 1.945946 1.891337 1.818351 0.000000 0.6400158 1.049228 1.334777 1.516842 1.653423 1.744997 1.790135 1.827439 1.842854 1.845016 1.835565 1.815105 1.784472 1.763607 1.724511 1.694758 1.645072 1.605599 1.548520 1.475772 0.000000 0.5886915 0.9614295 1.203258 1.373922 1.472157 1.546031 1.589566 1.598034 1.600927 1.593624 1.575352 1.546592 1.509981 1.467143 1.433577 1.384960 1.330245 1.287601 1.229540 1.170366 0.000000 0.5380298 0.8736069 1.086404 1.217674 1.308752 1.350336 1.380430 1.374008 1.368922 1.350298 1.320050 1.282366 1.240964 1.195127 1.145348 1.091864 1.046567 0.9926554 0.9333116 0.8743483 0.000000 0.4838122 0.7859898 0.9687078 1.077438 1.135547 1.172882 1.175988 1.170182 1.143880 1.113255 1.065836 1.024132 0.9783669 0.9290630 0.8768442 0.8218756 0.7728602 0.7163698 0.6579831 0.5992635 0.000000 0.4359749 0.6934112 0.8449458 0.9289454 0.9779811 0.9890989 0.9789327 0.9618865 0.9273022 0.8806184 0.8379536 0.7903622 0.7395011 0.6870174 0.6322303 0.5756344 0.5176557 0.4590620 0.4031994 0.3392531 0.000000 0.3882612 0.6097825 0.7336851 0.7958358 0.8173011 0.8134702 0.7915368 0.7640439 0.7215449 0.6707116 0.6213989 0.5638302 0.5102751 0.4546365 0.3971494 0.3384803 0.2786953 0.2190972 0.1556258 9.0390034E-02 0.000000 0.3409567 0.5275002 0.6243861 0.6593150 0.6645813 0.6477426 0.6150960 0.5776875 0.5278595 0.4730265 0.4145209 0.3585641 0.3008986 0.2411285 0.1805485 0.1185910 5.5897865E-02 -1.0627310E-02 -7.8013837E-02 -0.1453001 0.000000 0.2942795 0.4435922 0.5160083 0.5372178 0.5270783 0.4976158 0.4549564 0.4038438 0.3481945 0.2890171 0.2275539 0.1668479 0.1048596 4.1021004E-02 -2.2266936E-02 -8.8661849E-02 -0.1557010 -0.2257622 -0.2906880 -0.3591872 0.000000 0.2468415 0.3682024 0.4174278 0.4182804 0.3952755 0.3548837 0.3035927 0.2459441 0.1849214 0.1212707 5.7132371E-02 -7.9092886E-03 -7.4494757E-02 -0.1418657 -0.2085796 -0.2758735 -0.3426614 -0.4098478 -0.4742924 -0.5467024 0.000000 0.2028909 0.2955801 0.3227977 0.3098815 0.2770682 0.2284130 0.1705775 0.1079233 4.1901417E-02 -2.5473576E-02 -9.3669459E-02 -0.1615732 -0.2297472 -0.2980232 -0.3675734 -0.4311755 -0.4989318 -0.5608460 -0.6280738 -0.6947539 0.000000 0.1602354 0.2255265 0.2366508 0.2170364 0.1750261 0.1218436 6.0577687E-02 -4.5285434E-03 -7.4232168E-02 -0.1436374 -0.2130311 -0.2814245 -0.3502684 -0.4177319 -0.4861603 -0.5480562 -0.6120788 -0.6748479 -0.7370970 -0.7915426 0.000000 0.1178084 0.1602716 0.1620167 0.1358430 9.2900701E-02 4.0039014E-02 -1.9986467E-02 -8.3943158E-02 -0.1518205 -0.2188921 -0.2856946 -0.3512481 -0.4180876 -0.4819136 -0.5472165 -0.6086349 -0.6670523 -0.7244326 -0.7789587 -0.8342185 0.000000 7.6818101E-02 0.1023105 9.5871873E-02 7.0340790E-02 3.3613615E-02 -1.1910222E-02 -6.3382283E-02 -0.1178062 -0.1758555 -0.2336524 -0.2917681 -0.3491111 -0.4095860 -0.4657605 -0.5245600 -0.5771500 -0.6281438 -0.6780100 -0.7237731 -0.7743722 0.000000 3.7517253E-02 4.7728635E-02 4.1537952E-02 2.5080066E-02 1.5916921E-03 -2.6610492E-02 -5.8286034E-02 -9.2121139E-02 -0.1287174 -0.1652952 -0.2041021 -0.2434723 -0.2801343 -0.3189517 -0.3561257 -0.3932180 -0.4301377 -0.4658366 -0.4977281 -0.5286437 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.8930637 1.488674 1.891727 2.196470 2.428253 2.605755 2.740678 2.870088 2.956522 3.042594 3.089122 3.141012 3.185826 3.190236 3.204632 3.215021 3.219265 3.217176 3.201396 3.143104 0.000000 0.8430579 1.389259 1.780718 2.069616 2.287921 2.453967 2.580313 2.673960 2.768573 2.824379 2.885295 2.909969 2.941942 2.968927 2.959244 2.960369 2.959057 2.953786 2.937399 2.882257 0.000000 0.7846887 1.305123 1.669820 1.936020 2.133008 2.284745 2.400608 2.486793 2.547357 2.614375 2.647527 2.657083 2.678213 2.696188 2.681190 2.676579 2.670430 2.661415 2.642608 2.588066 0.000000 0.7362170 1.220027 1.555635 1.780984 1.960491 2.095999 2.195773 2.267880 2.339718 2.377167 2.392863 2.390653 2.401225 2.408543 2.386718 2.376648 2.364998 2.348943 2.322612 2.264713 0.000000 0.6876276 1.133970 1.427822 1.648061 1.809587 1.924506 2.009881 2.069419 2.106587 2.125646 2.128899 2.117906 2.119256 2.096522 2.084537 2.069425 2.048512 2.005355 1.969225 1.905797 0.000000 0.6391458 1.047826 1.316481 1.512672 1.636310 1.734244 1.802098 1.842561 1.865329 1.872398 1.865962 1.847315 1.839675 1.810792 1.788893 1.746585 1.715046 1.682681 1.643980 1.580653 0.000000 0.5910518 0.9549932 1.204753 1.362963 1.480732 1.558120 1.593105 1.620191 1.628690 1.624622 1.608413 1.582253 1.563273 1.527361 1.483134 1.447101 1.409388 1.357953 1.312104 1.244578 0.000000 0.5435662 0.8730655 1.082265 1.228325 1.309953 1.369690 1.401761 1.401688 1.399526 1.383041 1.357593 1.324346 1.283839 1.250073 1.202053 1.148879 1.103999 1.058446 1.000583 0.9311039 0.000000 0.4967196 0.7914346 0.9731576 1.082274 1.155617 1.184468 1.202837 1.200585 1.175934 1.148819 1.115290 1.074757 1.028651 0.9784160 0.9246981 0.8771773 0.8201506 0.7690029 0.7097791 0.6488850 0.000000 0.4467935 0.7104431 0.8639876 0.9511809 0.9931481 1.016532 1.008991 0.9938130 0.9601761 0.9243513 0.8818489 0.8337613 0.7830201 0.7296185 0.6733862 0.6149856 0.5603994 0.5006563 0.4438179 0.3784156 0.000000 0.4025488 0.6257610 0.7502490 0.8136159 0.8458372 0.8441554 0.8231839 0.7974457 0.7552282 0.7114177 0.6560894 0.6034583 0.5489545 0.4919524 0.4323564 0.3747340 0.3136901 0.2511011 0.1890722 0.1220596 0.000000 0.3585219 0.5494563 0.6483633 0.6909789 0.6972049 0.6808345 0.6484649 0.6128086 0.5623406 0.5115368 0.4529867 0.3959660 0.3368579 0.2755387 0.2122300 0.1486741 8.5907504E-02 1.8975848E-02 -5.0434198E-02 -0.1230187 0.000000 0.3150496 0.4748221 0.5490762 0.5666186 0.5574926 0.5284963 0.4912304 0.4401476 0.3833466 0.3262471 0.2643990 0.2025968 0.1387971 7.2834767E-02 7.0802509E-03 -5.8849987E-02 -0.1283911 -0.2026428 -0.2731811 -0.3464240 0.000000 0.2722521 0.3990298 0.4515475 0.4567254 0.4334393 0.3926476 0.3408681 0.2822962 0.2202556 0.1574000 9.2880324E-02 2.5204346E-02 -4.2491499E-02 -0.1134188 -0.1811213 -0.2493410 -0.3246370 -0.3974347 -0.4647930 -0.5403913 0.000000 0.2285123 0.3311352 0.3636380 0.3509305 0.3164782 0.2661328 0.2067736 0.1423503 7.5393818E-02 7.8187790E-03 -6.1746985E-02 -0.1335767 -0.2035182 -0.2762863 -0.3437800 -0.4158547 -0.4933971 -0.5610097 -0.6263233 -0.6990141 0.000000 0.1881383 0.2659919 0.2799428 0.2588215 0.2136553 0.1568768 9.2246190E-02 2.3840837E-02 -4.7489196E-02 -0.1191914 -0.1916755 -0.2640417 -0.3371569 -0.4100116 -0.4777028 -0.5503284 -0.6249971 -0.6856192 -0.7521739 -0.8154489 0.000000 0.1475785 0.2031985 0.2044277 0.1763887 0.1272930 6.7885466E-02 1.5826538E-03 -6.9475338E-02 -0.1421092 -0.2145697 -0.2878844 -0.3599386 -0.4333548 -0.5035050 -0.5739154 -0.6439537 -0.7124783 -0.7666211 -0.8290518 -0.8937957 0.000000 0.1107681 0.1444607 0.1396884 0.1080568 6.0274031E-02 3.3797822E-03 -6.0750026E-02 -0.1285960 -0.1983651 -0.2677465 -0.3386744 -0.4074514 -0.4789720 -0.5445778 -0.6121425 -0.6762174 -0.7372146 -0.7878084 -0.8477706 -0.9041532 0.000000 7.1796551E-02 9.2689984E-02 8.2193971E-02 5.4547418E-02 1.4539023E-02 -3.3349667E-02 -8.6764820E-02 -0.1428667 -0.2028782 -0.2618957 -0.3244525 -0.3834856 -0.4415888 -0.4988625 -0.5595527 -0.6137214 -0.6659088 -0.7152270 -0.7703894 -0.8148252 0.000000 3.5186853E-02 4.3509338E-02 3.5853751E-02 1.8200144E-02 -6.2234704E-03 -3.5076804E-02 -6.7725666E-02 -0.1026946 -0.1398060 -0.1773915 -0.2149756 -0.2544939 -0.2947821 -0.3342352 -0.3702812 -0.4081873 -0.4457110 -0.4791370 -0.5139446 -0.5455008 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.7993546 1.340892 1.701221 1.972559 2.178058 2.334375 2.452091 2.565074 2.638814 2.712679 2.750010 2.793194 2.829862 2.858704 2.879567 2.892357 2.897388 2.895669 2.880586 2.826627 0.000000 0.7617981 1.252805 1.602494 1.859655 2.053021 2.199175 2.309482 2.390232 2.472237 2.518809 2.570443 2.588411 2.615178 2.636372 2.651248 2.659816 2.662063 2.658674 2.643777 2.593496 0.000000 0.7099907 1.176670 1.502208 1.738407 1.913037 2.046325 2.147291 2.221839 2.273044 2.330268 2.356311 2.385557 2.386619 2.395021 2.400862 2.401414 2.395167 2.384591 2.364640 2.313310 0.000000 0.6656688 1.099298 1.398129 1.598939 1.757549 1.876036 1.962270 2.023480 2.084477 2.114020 2.123740 2.140274 2.132636 2.132255 2.128704 2.098561 2.078654 2.058781 2.031748 1.974981 0.000000 0.6213524 1.021046 1.282586 1.478214 1.619756 1.719341 1.792108 1.841320 1.869914 1.882260 1.880149 1.886225 1.870049 1.860273 1.829050 1.806530 1.782791 1.755494 1.720033 1.658922 0.000000 0.5772247 0.9339634 1.181889 1.354514 1.461807 1.545102 1.601074 1.631565 1.646709 1.647675 1.635556 1.628814 1.602960 1.583365 1.545976 1.514939 1.480984 1.431334 1.386896 1.320849 0.000000 0.5335094 0.8592693 1.080093 1.218094 1.318586 1.382374 1.407794 1.425223 1.428469 1.416111 1.393609 1.362122 1.338736 1.298890 1.263526 1.213726 1.170172 1.125561 1.077652 1.011261 0.000000 0.4904012 0.7846826 0.9688177 1.094214 1.161623 1.208140 1.229138 1.233314 1.212411 1.188158 1.156300 1.117210 1.082731 1.035887 0.9834583 0.9361354 0.8777720 0.8254288 0.7711372 0.7031034 0.000000 0.4479277 0.7104155 0.8687079 0.9604143 1.018633 1.036193 1.043316 1.032260 1.000986 0.9669092 0.9265382 0.8804672 0.8294646 0.7823545 0.7258723 0.6655628 0.6092925 0.5464766 0.4877910 0.4236835 0.000000 0.4028786 0.6366832 0.7685776 0.8395072 0.8684580 0.8792993 0.8622640 0.8392091 0.7981135 0.7548479 0.7069061 0.6545683 0.5985759 0.5395162 0.4773672 0.4179156 0.3531039 0.2903045 0.2274790 0.1594122 0.000000 0.3627228 0.5598029 0.6647460 0.7131538 0.7317131 0.7190574 0.6896099 0.6559297 0.6051335 0.5542865 0.4996948 0.4415835 0.3806753 0.3168957 0.2505268 0.1851915 0.1169141 4.9620163E-02 -1.9407654E-02 -9.4514422E-02 0.000000 0.3227809 0.4900837 0.5714577 0.6001458 0.5944647 0.5678146 0.5330166 0.4824609 0.4245336 0.3674815 0.3066016 0.2430036 0.1768432 0.1078351 3.8417298E-02 -3.2356963E-02 -0.1040224 -0.1765801 -0.2514110 -0.3300483 0.000000 0.2833559 0.4221032 0.4808320 0.4862629 0.4659611 0.4317295 0.3809901 0.3219135 0.2611170 0.1952291 0.1291328 5.9951413E-02 -1.1447970E-02 -8.5078642E-02 -0.1573872 -0.2311489 -0.3034255 -0.3801403 -0.4566387 -0.5341870 0.000000 0.2445736 0.3533823 0.3922447 0.3859309 0.3525749 0.3028606 0.2429123 0.1772984 0.1102256 4.0231436E-02 -3.1312797E-02 -0.1058542 -0.1822684 -0.2555329 -0.3286004 -0.4017774 -0.4741987 -0.5549500 -0.6278250 -0.7032146 0.000000 0.2048102 0.2919841 0.3128173 0.2903474 0.2469945 0.1886509 0.1218936 5.1691793E-02 -2.1603592E-02 -9.6099496E-02 -0.1717454 -0.2491630 -0.3273656 -0.3994399 -0.4699374 -0.5467041 -0.6173340 -0.6951815 -0.7635038 -0.8426232 0.000000 0.1683765 0.2334305 0.2376456 0.2081303 0.1556424 9.2013568E-02 2.1487735E-02 -5.3624883E-02 -0.1302813 -0.2068726 -0.2847210 -0.3628545 -0.4403029 -0.5117958 -0.5836475 -0.6585683 -0.7273529 -0.8009902 -0.8670943 -0.9419031 0.000000 0.1326879 0.1771814 0.1724400 0.1358631 8.1916124E-02 1.6376847E-02 -5.5826992E-02 -0.1316526 -0.2083845 -0.2846745 -0.3633941 -0.4401458 -0.5149500 -0.5875291 -0.6542331 -0.7255843 -0.7949919 -0.8623748 -0.9307410 -0.9994723 0.000000 9.8394729E-02 0.1261382 0.1144346 7.7781565E-02 2.6215278E-02 -3.5465267E-02 -0.1035352 -0.1738911 -0.2461919 -0.3181691 -0.3949836 -0.4663066 -0.5359938 -0.6032212 -0.6721604 -0.7377065 -0.7999399 -0.8596526 -0.9221207 -0.9811914 0.000000 6.3978747E-02 8.0151774E-02 6.5907910E-02 3.4480188E-02 -8.1764665E-03 -5.8582202E-02 -0.1141603 -0.1722821 -0.2334911 -0.2946120 -0.3586172 -0.4191132 -0.4787481 -0.5370077 -0.5991064 -0.6543844 -0.7075740 -0.7578527 -0.8137390 -0.8610983 0.000000 3.1304203E-02 3.7020974E-02 2.7487904E-02 8.3272317E-03 -1.7273951E-02 -4.7299240E-02 -8.0248393E-02 -0.1167226 -0.1537366 -0.1929795 -0.2313718 -0.2715047 -0.3095081 -0.3491982 -0.3895337 -0.4281673 -0.4664766 -0.4998854 -0.5301858 -0.5646116 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.7015999 1.167252 1.493288 1.732526 1.911889 2.046855 2.146920 2.243521 2.304116 2.365662 2.418238 2.437416 2.461623 2.480893 2.493829 2.499879 2.499123 2.492375 2.473517 2.418633 0.000000 0.6627756 1.100739 1.408653 1.634246 1.802069 1.926571 2.019630 2.087945 2.157970 2.195383 2.237909 2.273089 2.278003 2.289096 2.296768 2.299426 2.296765 2.289405 2.271746 2.221486 0.000000 0.6237435 1.033654 1.319937 1.524293 1.660377 1.770666 1.872245 1.938687 1.981475 2.029028 2.047668 2.069661 2.066136 2.069823 2.070975 2.067966 2.060583 2.049033 2.028111 1.977633 0.000000 0.5845478 0.9655066 1.215720 1.401763 1.539636 1.640971 1.713546 1.763561 1.813341 1.834702 1.837537 1.849822 1.837530 1.832191 1.824773 1.813712 1.797404 1.775818 1.746611 1.691705 0.000000 0.5455885 0.8964372 1.125299 1.294529 1.415547 1.499658 1.559410 1.597814 1.617612 1.622078 1.630581 1.621242 1.597842 1.582123 1.564947 1.543004 1.500290 1.465850 1.427669 1.379935 0.000000 0.5068794 0.8198344 1.034737 1.182935 1.273307 1.341348 1.384727 1.405251 1.411393 1.404912 1.405098 1.384433 1.351674 1.325657 1.296443 1.250531 1.211187 1.171482 1.126881 1.062016 0.000000 0.4684756 0.7528178 0.9428808 1.059954 1.142211 1.191470 1.206592 1.214024 1.208318 1.203449 1.179879 1.146063 1.104079 1.066477 1.016298 0.9720591 0.9254912 0.8761452 0.8234302 0.7556176 0.000000 0.4304045 0.6858376 0.8429813 0.9466952 0.9984148 1.030802 1.040324 1.034691 1.017047 0.9893324 0.9529923 0.9093069 0.8595108 0.8044389 0.7543957 0.7025744 0.6411042 0.5829834 0.5234632 0.4572164 0.000000 0.3926515 0.6191986 0.7520985 0.8246953 0.8662685 0.8717512 0.8673185 0.8474312 0.8173475 0.7781308 0.7317372 0.6795667 0.6229232 0.5624450 0.5045749 0.4403720 0.3767653 0.3119648 0.2463158 0.1756614 0.000000 0.3527300 0.5476713 0.6613165 0.7136582 0.7281039 0.7260365 0.6991470 0.6676342 0.6249501 0.5753844 0.5202159 0.4608671 0.3980982 0.3324478 0.2669984 0.1974295 0.1273465 5.6063659E-02 -1.5158628E-02 -9.2514277E-02 0.000000 0.3169756 0.4844868 0.5674962 0.5984144 0.6020268 0.5781901 0.5442140 0.4955429 0.4423321 0.3841153 0.3215165 0.2560112 0.1873755 0.1164877 4.4083748E-02 -2.9576363E-02 -0.1050546 -0.1812114 -0.2591820 -0.3430902 0.000000 0.2815042 0.4220095 0.4830397 0.4953483 0.4765139 0.4390403 0.3932357 0.3341739 0.2725082 0.2067909 0.1378804 6.6597968E-02 -7.4335947E-03 -8.3410583E-02 -0.1607588 -0.2373981 -0.3140147 -0.3929355 -0.4736965 -0.5602726 0.000000 0.2466109 0.3613475 0.4015413 0.3925922 0.3635675 0.3142236 0.2539137 0.1867993 0.1179255 4.5238532E-02 -2.8660759E-02 -0.1060349 -0.1846694 -0.2627045 -0.3396104 -0.4164964 -0.4931583 -0.5744798 -0.6539862 -0.7416774 0.000000 0.2124029 0.3004150 0.3226825 0.3027728 0.2578294 0.1980983 0.1293888 5.6770619E-02 -1.9275580E-02 -9.8557398E-02 -0.1761713 -0.2577105 -0.3347137 -0.4153264 -0.4916797 -0.5697370 -0.6467227 -0.7290429 -0.8051658 -0.8827788 0.000000 0.1773082 0.2462554 0.2527193 0.2185794 0.1647835 9.7428858E-02 2.3360141E-02 -5.6031920E-02 -0.1372566 -0.2194821 -0.2996088 -0.3822607 -0.4574701 -0.5374783 -0.6146305 -0.6945841 -0.7708595 -0.8412010 -0.9191375 -0.9948753 0.000000 0.1453950 0.1951466 0.1874574 0.1477419 8.7790214E-02 1.5556022E-02 -6.2873892E-02 -0.1455329 -0.2287558 -0.3114487 -0.3945928 -0.4749453 -0.5496899 -0.6289667 -0.7091306 -0.7814549 -0.8603471 -0.9243101 -0.9982992 -1.076766 0.000000 0.1142824 0.1465576 0.1321224 8.7430574E-02 2.6337208E-02 -4.6082687E-02 -0.1236282 -0.2070785 -0.2890489 -0.3704132 -0.4519023 -0.5262548 -0.6041635 -0.6807352 -0.7559811 -0.8297106 -0.9010229 -0.9621994 -1.032117 -1.101024 0.000000 8.4195144E-02 0.1030746 8.4227659E-02 4.1554265E-02 -1.5282132E-02 -8.2288966E-02 -0.1535792 -0.2307315 -0.3058648 -0.3812560 -0.4573470 -0.5307666 -0.6054733 -0.6763452 -0.7445050 -0.8107323 -0.8730844 -0.9389280 -1.000799 -1.058892 0.000000 5.4805961E-02 6.4308278E-02 4.5821920E-02 1.0507929E-02 -3.5579611E-02 -8.9339487E-02 -0.1468730 -0.2092381 -0.2706168 -0.3337052 -0.3994127 -0.4616124 -0.5281972 -0.5878913 -0.6461931 -0.7025785 -0.7560216 -0.8161522 -0.8658349 -0.9133151 0.000000 2.6733914E-02 2.9366527E-02 1.7545084E-02 -3.5187984E-03 -3.0368015E-02 -6.1465379E-02 -9.6067019E-02 -0.1323004 -0.1715509 -0.2117037 -0.2509887 -0.2918938 -0.3308808 -0.3712814 -0.4126512 -0.4474366 -0.4882678 -0.5252035 -0.5564489 -0.5873908 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.6185829 1.018521 1.292930 1.491913 1.639455 1.748916 1.847175 1.913473 1.975734 2.009681 2.045437 2.074846 2.097341 2.112953 2.121872 2.124187 2.120217 2.111083 2.091059 2.038767 0.000000 0.5864247 0.9619069 1.220797 1.408319 1.544936 1.646591 1.721244 1.792672 1.836306 1.878726 1.896682 1.919186 1.936747 1.948454 1.954673 1.955386 1.950643 1.941348 1.922793 1.875394 0.000000 0.5518173 0.9023344 1.142148 1.298942 1.421106 1.511868 1.594625 1.646536 1.677997 1.714373 1.742151 1.746447 1.754017 1.758027 1.756878 1.749729 1.738022 1.722760 1.699663 1.651462 0.000000 0.5164939 0.8408694 1.050303 1.204648 1.317755 1.399269 1.456806 1.494642 1.532572 1.544874 1.557595 1.551682 1.549441 1.543150 1.516449 1.496017 1.474172 1.450123 1.419597 1.379248 0.000000 0.4811466 0.7786759 0.9703435 1.110765 1.207698 1.276456 1.322618 1.349550 1.359965 1.356692 1.359687 1.343403 1.330021 1.299650 1.274355 1.247261 1.217130 1.184626 1.146102 1.086583 0.000000 0.4460939 0.7113725 0.8910258 1.003836 1.085767 1.138451 1.168501 1.178329 1.175331 1.173079 1.156026 1.127354 1.101908 1.062555 1.026843 0.9890667 0.9483101 0.9045265 0.8551500 0.7892535 0.000000 0.4115466 0.6521341 0.8111593 0.9073160 0.9711874 1.005178 1.009083 1.005825 0.9911307 0.9771754 0.9467275 0.9070196 0.8695930 0.8210505 0.7746035 0.7260188 0.6738411 0.6127783 0.5532148 0.4866289 0.000000 0.3776618 0.5935539 0.7249405 0.8078858 0.8437679 0.8610561 0.8580949 0.8420708 0.8155975 0.7801797 0.7369261 0.6868567 0.6380291 0.5807810 0.5242732 0.4654375 0.3992072 0.3340352 0.2668481 0.1960392 0.000000 0.3411425 0.5357355 0.6456926 0.7003523 0.7248514 0.7172305 0.7005676 0.6707514 0.6318179 0.5846881 0.5308404 0.4715911 0.4126506 0.3475477 0.2818514 0.2133709 0.1414522 6.6235885E-02 -8.7031722E-03 -8.9491397E-02 0.000000 0.3094655 0.4740520 0.5660868 0.6009688 0.6004134 0.5841312 0.5471979 0.5054210 0.4540525 0.3961219 0.3328561 0.2659328 0.1980910 0.1256384 5.1334269E-02 -2.5408151E-02 -0.1058409 -0.1890545 -0.2703629 -0.3593210 0.000000 0.2780102 0.4189686 0.4834944 0.4978007 0.4861363 0.4498426 0.4053737 0.3469658 0.2852551 0.2178682 0.1469457 7.4173070E-02 -2.7261362E-03 -8.2141101E-02 -0.1637148 -0.2469824 -0.3306077 -0.4149041 -0.5013421 -0.5937138 0.000000 0.2468418 0.3642786 0.4083290 0.4049644 0.3728487 0.3269607 0.2670255 0.2008955 0.1280708 5.3678885E-02 -2.3577381E-02 -0.1044161 -0.1876634 -0.2704568 -0.3564737 -0.4407617 -0.5242053 -0.6093165 -0.6961777 -0.7866241 0.000000 0.2162350 0.3111423 0.3357723 0.3163198 0.2710291 0.2106814 0.1404710 6.5296054E-02 -1.3525855E-02 -9.5806815E-02 -0.1774104 -0.2635856 -0.3469675 -0.4321853 -0.5196495 -0.6008716 -0.6831322 -0.7686800 -0.8526980 -0.9383494 0.000000 0.1862466 0.2577206 0.2658892 0.2330742 0.1769403 0.1070392 2.9551705E-02 -5.3699974E-02 -0.1387074 -0.2244151 -0.3093162 -0.3981080 -0.4807620 -0.5691646 -0.6476487 -0.7294015 -0.8104020 -0.8964503 -0.9779089 -1.060817 0.000000 0.1568369 0.2099887 0.2042549 0.1609281 9.6639767E-02 1.9955706E-02 -6.4877778E-02 -0.1526998 -0.2413072 -0.3276840 -0.4167558 -0.5042309 -0.5861788 -0.6700041 -0.7460763 -0.8345240 -0.9112268 -0.9870064 -1.074285 -1.155345 0.000000 0.1271687 0.1651420 0.1474841 9.8423429E-02 2.9977392E-02 -4.9987987E-02 -0.1372472 -0.2261671 -0.3150973 -0.4038768 -0.4928206 -0.5744661 -0.6595119 -0.7329590 -0.8143970 -0.8990147 -0.9723815 -1.052229 -1.134156 -1.217372 0.000000 9.9851124E-02 0.1227997 0.1003324 4.8320621E-02 -1.9673811E-02 -9.8080993E-02 -0.1833638 -0.2696130 -0.3556157 -0.4416469 -0.5267949 -0.6092514 -0.6902644 -0.7619269 -0.8440486 -0.9217363 -0.9953838 -1.070003 -1.143382 -1.214671 0.000000 7.2927080E-02 8.5368156E-02 6.0644720E-02 1.2942237E-02 -4.9618538E-02 -0.1205469 -0.1977807 -0.2764425 -0.3548388 -0.4351280 -0.5127319 -0.5880273 -0.6625642 -0.7365205 -0.8165794 -0.8837815 -0.9500659 -1.018608 -1.080977 -1.140005 0.000000 4.7972266E-02 5.2420676E-02 3.0264972E-02 -8.3644548E-03 -5.7621490E-02 -0.1139784 -0.1738580 -0.2385673 -0.3021751 -0.3706362 -0.4345021 -0.4981228 -0.5619854 -0.6275522 -0.6881369 -0.7438119 -0.8012377 -0.8617537 -0.9109719 -0.9596773 0.000000 2.3447789E-02 2.3578275E-02 9.9079609E-03 -1.2692273E-02 -4.0991973E-02 -7.3619358E-02 -0.1092411 -0.1462677 -0.1865588 -0.2252363 -0.2675537 -0.3093295 -0.3486274 -0.3904705 -0.4278336 -0.4684353 -0.5086896 -0.5418998 -0.5811720 -0.6167728 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.5355196 0.8599914 1.077626 1.232590 1.345574 1.427287 1.500597 1.547244 1.591699 1.628298 1.641145 1.656084 1.666783 1.672287 1.672457 1.667188 1.673745 1.668337 1.650788 1.620148 0.000000 0.5093616 0.8172445 1.023178 1.169258 1.273971 1.350054 1.404967 1.457005 1.485035 1.514588 1.537814 1.555014 1.551157 1.550712 1.547488 1.540489 1.529499 1.530712 1.516530 1.475728 0.000000 0.4801854 0.7698654 0.9607595 1.082850 1.175869 1.255251 1.306811 1.339490 1.372976 1.385580 1.399014 1.408446 1.399122 1.393154 1.384774 1.372952 1.357501 1.338914 1.326865 1.287388 0.000000 0.4505181 0.7200013 0.8868965 1.007166 1.091822 1.150304 1.189201 1.225041 1.239822 1.239848 1.244568 1.244191 1.226715 1.212068 1.195098 1.174926 1.151471 1.125255 1.093085 1.051543 0.000000 0.4208436 0.6634595 0.8222257 0.9292053 0.9996567 1.047374 1.077113 1.091418 1.091551 1.091610 1.077944 1.064450 1.037015 1.011955 0.9847841 0.9544645 0.9208785 0.8845104 0.8430364 0.7925078 0.000000 0.3912469 0.6143634 0.7562631 0.8388181 0.8969753 0.9315285 0.9479052 0.9471790 0.9349277 0.9251261 0.8993636 0.8734033 0.8359559 0.7998548 0.7613014 0.7192460 0.6736816 0.6253827 0.5729451 0.5121220 0.000000 0.3619270 0.5646647 0.6817038 0.7569691 0.8002844 0.8195099 0.8130447 0.7993550 0.7838514 0.7535865 0.7149694 0.6765285 0.6288088 0.5808656 0.5298692 0.4752803 0.4170272 0.3558630 0.2913162 0.2197913 0.000000 0.3330340 0.5146199 0.6146186 0.6724608 0.6935446 0.6975304 0.6829396 0.6564676 0.6209779 0.5780821 0.5283133 0.4778009 0.4193945 0.3594418 0.2960428 0.2291522 0.1584363 8.4110275E-02 7.7643404E-03 -7.3847078E-02 0.000000 0.3018617 0.4645806 0.5461836 0.5821105 0.5929927 0.5739322 0.5453864 0.5054997 0.4583062 0.4037975 0.3432293 0.2810642 0.2119637 0.1407863 6.5680660E-02 -1.1677165E-02 -9.4300665E-02 -0.1803287 -0.2674329 -0.3580271 0.000000 0.2742722 0.4113084 0.4778926 0.4985463 0.4865925 0.4573242 0.4100067 0.3586178 0.2995669 0.2337325 0.1646699 8.9768596E-02 1.1798032E-02 -7.0239514E-02 -0.1547544 -0.2401866 -0.3291502 -0.4203628 -0.5085865 -0.6063570 0.000000 0.2466985 0.3632504 0.4079048 0.4112628 0.3871172 0.3389107 0.2834802 0.2192474 0.1479685 7.1845293E-02 -8.2446402E-03 -9.1704577E-02 -0.1782027 -0.2657270 -0.3547109 -0.4418936 -0.5329899 -0.6239772 -0.7172750 -0.8163560 0.000000 0.2191868 0.3155446 0.3442509 0.3313044 0.2878193 0.2295676 0.1601830 8.4730595E-02 3.6765086E-03 -8.0429934E-02 -0.1686564 -0.2569283 -0.3458076 -0.4347264 -0.5259382 -0.6177757 -0.7072042 -0.7967269 -0.8891388 -0.9840695 0.000000 0.1920608 0.2692774 0.2827630 0.2542019 0.1977227 0.1263692 4.7860406E-02 -3.8337089E-02 -0.1267152 -0.2163321 -0.3083797 -0.3996938 -0.4902381 -0.5781389 -0.6738463 -0.7628056 -0.8487595 -0.9396031 -1.028718 -1.115935 0.000000 0.1654800 0.2230119 0.2230786 0.1813999 0.1147404 3.5689011E-02 -5.2673545E-02 -0.1458115 -0.2366989 -0.3312407 -0.4232009 -0.5179960 -0.6081923 -0.6937019 -0.7875662 -0.8714123 -0.9566393 -1.050815 -1.131016 -1.212201 0.000000 0.1394797 0.1816864 0.1695040 0.1181663 4.4479895E-02 -4.1409247E-02 -0.1354433 -0.2310634 -0.3236887 -0.4188134 -0.5143071 -0.6050978 -0.6961274 -0.7799119 -0.8714033 -0.9505413 -1.040504 -1.121413 -1.194244 -1.279584 0.000000 0.1131265 0.1429392 0.1198886 6.3894898E-02 -1.2334757E-02 -0.1006754 -0.1958381 -0.2891308 -0.3834763 -0.4767884 -0.5705578 -0.6634669 -0.7465574 -0.8337011 -0.9203501 -0.9974880 -1.082237 -1.162013 -1.230385 -1.311101 0.000000 8.8970110E-02 0.1062444 7.9061165E-02 2.1841422E-02 -5.2952681E-02 -0.1381650 -0.2280587 -0.3193035 -0.4096530 -0.4991332 -0.5905360 -0.6773799 -0.7622399 -0.8445689 -0.9253426 -1.003976 -1.082107 -1.147574 -1.220404 -1.292611 0.000000 6.5611340E-02 7.3612526E-02 4.5223176E-02 -6.7885513E-03 -7.4008621E-02 -0.1491775 -0.2308356 -0.3126494 -0.3942696 -0.4769858 -0.5633798 -0.6416982 -0.7210534 -0.7956002 -0.8689203 -0.9375541 -1.010104 -1.076797 -1.140894 -1.202088 0.000000 4.2492386E-02 4.4796824E-02 2.0221788E-02 -2.1315584E-02 -7.3889770E-02 -0.1324823 -0.1966254 -0.2615602 -0.3272388 -0.3970804 -0.4642803 -0.5285465 -0.5989758 -0.6603312 -0.7223681 -0.7795160 -0.8459637 -0.8989605 -0.9530006 -1.002251 0.000000 2.0863222E-02 1.9943353E-02 5.0246883E-03 -1.8948602E-02 -4.8482429E-02 -8.1949115E-02 -0.1180239 -0.1571566 -0.1964535 -0.2377879 -0.2809069 -0.3202461 -0.3634128 -0.4060520 -0.4441910 -0.4855820 -0.5213351 -0.5609099 -0.5939883 -0.6305239 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4390048 0.6798913 0.8376486 0.9464021 1.022901 1.075380 1.122563 1.160294 1.178876 1.196766 1.209903 1.218155 1.221664 1.220434 1.214710 1.217035 1.209715 1.209183 1.194902 1.167339 0.000000 0.4268107 0.6547831 0.8037491 0.9043244 0.9747065 1.023183 1.065875 1.090114 1.112199 1.118316 1.126425 1.130844 1.131641 1.128749 1.122134 1.111814 1.109491 1.098953 1.091308 1.058513 0.000000 0.4048387 0.6264485 0.7558679 0.8443266 0.9050514 0.9557779 0.9853483 1.000553 1.017379 1.028057 1.023561 1.021449 1.015826 1.006726 0.9942415 0.9783335 0.9590551 0.9472089 0.9247608 0.8922042 0.000000 0.3807159 0.5864666 0.7106177 0.7916741 0.8459246 0.8805045 0.8996937 0.9166146 0.9165882 0.9156982 0.9112731 0.8937713 0.8771079 0.8579739 0.8359388 0.8107744 0.7826850 0.7522486 0.7251270 0.6860732 0.000000 0.3566948 0.5504845 0.6644312 0.7367237 0.7807652 0.8059179 0.8158269 0.8138548 0.8013967 0.7909760 0.7743981 0.7462492 0.7187685 0.6887711 0.6558793 0.6198570 0.5806999 0.5390317 0.4986327 0.4476849 0.000000 0.3331952 0.5137056 0.6170847 0.6723447 0.7052307 0.7176656 0.7155598 0.7017949 0.6857904 0.6570894 0.6269485 0.5880713 0.5491899 0.5072278 0.4619587 0.4130033 0.3604174 0.3049381 0.2483506 0.1828694 0.000000 0.3093463 0.4763645 0.5633959 0.6120186 0.6307771 0.6299257 0.6153679 0.5897413 0.5559074 0.5150568 0.4732007 0.4234580 0.3721539 0.3168734 0.2575674 0.1941789 0.1266261 5.5631358E-02 -1.8583771E-02 -0.1004823 0.000000 0.2832468 0.4388734 0.5138734 0.5463304 0.5466701 0.5333375 0.5050762 0.4674281 0.4221554 0.3702327 0.3164448 0.2542785 0.1895710 0.1202464 4.6785556E-02 -3.0872392E-02 -0.1144290 -0.2026068 -0.2915796 -0.3890289 0.000000 0.2607882 0.3966908 0.4611728 0.4743406 0.4664567 0.4346816 0.3943916 0.3448416 0.2877568 0.2263269 0.1569295 8.3068974E-02 4.7530932E-03 -7.8105114E-02 -0.1652557 -0.2543949 -0.3479964 -0.4460828 -0.5403968 -0.6432530 0.000000 0.2379260 0.3591390 0.4023528 0.4068029 0.3811055 0.3404011 0.2866803 0.2243395 0.1547536 7.8597099E-02 -2.4747197E-03 -8.8616878E-02 -0.1776789 -0.2694760 -0.3643927 -0.4572580 -0.5558764 -0.6565171 -0.7494372 -0.8536286 0.000000 0.2149798 0.3201744 0.3486875 0.3359785 0.3002730 0.2433754 0.1776097 0.1030771 2.1680729E-02 -6.6192247E-02 -0.1573787 -0.2506339 -0.3455465 -0.4413132 -0.5383292 -0.6362307 -0.7356551 -0.8348406 -0.9267400 -1.041563 0.000000 0.1918332 0.2803516 0.2954628 0.2702464 0.2187705 0.1517861 7.3206626E-02 -1.3196673E-02 -0.1057721 -0.2018120 -0.2998314 -0.3977838 -0.4956568 -0.5922046 -0.6879753 -0.7862681 -0.8830336 -0.9790501 -1.076555 -1.189596 0.000000 0.1687050 0.2408203 0.2413069 0.2063857 0.1433838 6.3667312E-02 -2.5239352E-02 -0.1213709 -0.2210707 -0.3218180 -0.4247119 -0.5253389 -0.6232613 -0.7180631 -0.8109522 -0.9127716 -1.005790 -1.102775 -1.195573 -1.297602 0.000000 0.1457253 0.2006311 0.1930533 0.1454614 7.2606802E-02 -1.5385172E-02 -0.1127725 -0.2146406 -0.3179751 -0.4245720 -0.5240883 -0.6285853 -0.7227165 -0.8167633 -0.9057104 -1.001766 -1.094103 -1.192830 -1.274719 -1.359146 0.000000 0.1230684 0.1641833 0.1472278 9.1623329E-02 1.1931786E-02 -8.2812242E-02 -0.1843873 -0.2885715 -0.3934607 -0.4996960 -0.5989626 -0.6979485 -0.7897356 -0.8869575 -0.9692396 -1.060279 -1.157642 -1.236560 -1.314955 -1.407798 0.000000 9.9881686E-02 0.1298693 0.1040347 4.4617184E-02 -3.7668355E-02 -0.1338002 -0.2349806 -0.3377036 -0.4419030 -0.5448606 -0.6453001 -0.7357091 -0.8307000 -0.9196844 -0.9972426 -1.084717 -1.173576 -1.248589 -1.332638 -1.417910 0.000000 7.8653872E-02 9.7073108E-02 6.8278730E-02 7.8703621E-03 -7.2231933E-02 -0.1631431 -0.2584781 -0.3548558 -0.4568494 -0.5528825 -0.6463863 -0.7377258 -0.8268844 -0.9028539 -0.9841668 -1.066146 -1.145844 -1.223342 -1.298255 -1.372164 0.000000 5.8091827E-02 6.7609966E-02 3.8374323E-02 -1.6426895E-02 -8.7507151E-02 -0.1683940 -0.2527571 -0.3384506 -0.4294681 -0.5144812 -0.5983030 -0.6818590 -0.7616236 -0.8373773 -0.9116718 -0.9869102 -1.057674 -1.124119 -1.188593 -1.250422 0.000000 3.7809312E-02 4.1166067E-02 1.6354552E-02 -2.7372990E-02 -8.2693584E-02 -0.1440590 -0.2106835 -0.2780519 -0.3493415 -0.4174861 -0.4865100 -0.5578710 -0.6239176 -0.6867828 -0.7501537 -0.8164489 -0.8754103 -0.9297851 -0.9847479 -1.035165 0.000000 1.8403722E-02 1.8248677E-02 3.1176871E-03 -2.1833893E-02 -5.2414965E-02 -8.7880068E-02 -0.1248754 -0.1650276 -0.2052558 -0.2474314 -0.2913013 -0.3315364 -0.3752492 -0.4146477 -0.4573900 -0.4947535 -0.5358936 -0.5705999 -0.6098866 -0.6475374 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.2733416 0.4442784 0.5520081 0.6159794 0.6558163 0.6869427 0.7029270 0.7163714 0.7251153 0.7297472 0.7304319 0.7275345 0.7212242 0.7191603 0.7110242 0.7060281 0.6945803 0.6871766 0.6778080 0.6549126 0.000000 0.2588177 0.4192261 0.5219893 0.5811926 0.6181619 0.6393322 0.6574114 0.6705506 0.6784911 0.6757402 0.6733980 0.6687940 0.6683314 0.6622573 0.6524939 0.6461272 0.6339594 0.6254460 0.6089967 0.5825683 0.000000 0.2434482 0.3944013 0.4838701 0.5407219 0.5724127 0.5898107 0.6039644 0.6067470 0.6074424 0.6051612 0.5996020 0.5906608 0.5785798 0.5635092 0.5456732 0.5250019 0.5073667 0.4853170 0.4638888 0.4318158 0.000000 0.2278802 0.3701076 0.4534018 0.4998501 0.5248028 0.5408873 0.5433595 0.5363135 0.5290137 0.5166654 0.5002157 0.4798492 0.4562303 0.4296038 0.4001168 0.3677919 0.3368024 0.3018884 0.2664133 0.2241613 0.000000 0.2155914 0.3475803 0.4254516 0.4675526 0.4852550 0.4871945 0.4774804 0.4649312 0.4407932 0.4150370 0.3848090 0.3512189 0.3145598 0.2747054 0.2317874 0.1874512 0.1385720 8.8035509E-02 3.4505721E-02 -2.5920702E-02 0.000000 0.2013781 0.3264148 0.4009696 0.4326720 0.4403126 0.4287111 0.4101628 0.3795843 0.3449944 0.3039061 0.2606917 0.2143619 0.1643443 0.1099994 5.2394629E-02 -1.0353324E-02 -7.7553853E-02 -0.1495123 -0.2266058 -0.3151200 0.000000 0.1878899 0.3072847 0.3758054 0.4024661 0.3949471 0.3685820 0.3323101 0.2882307 0.2423576 0.1898769 0.1349200 7.4993096E-02 9.6320985E-03 -6.0640790E-02 -0.1359944 -0.2169148 -0.3009873 -0.3945690 -0.4897178 -0.5970406 0.000000 0.1737774 0.2904424 0.3556664 0.3661003 0.3401735 0.3007189 0.2517919 0.1991642 0.1404305 7.7719562E-02 8.5432027E-03 -6.7366377E-02 -0.1483033 -0.2326504 -0.3239140 -0.4156146 -0.5161541 -0.6242079 -0.7282168 -0.8441875 0.000000 0.1626088 0.2755671 0.3327769 0.3219410 0.2867568 0.2338583 0.1739268 0.1095051 4.0612102E-02 -3.6253106E-02 -0.1201711 -0.2105297 -0.3017120 -0.3983858 -0.5004407 -0.6020572 -0.7134929 -0.8261514 -0.9333463 -1.053208 0.000000 0.1522412 0.2601667 0.2987831 0.2793197 0.2286713 0.1655720 9.6461236E-02 2.2600066E-02 -5.9297115E-02 -0.1502909 -0.2461967 -0.3468329 -0.4464540 -0.5506938 -0.6594024 -0.7721127 -0.8877031 -0.9941968 -1.109576 -1.230638 0.000000 0.1426958 0.2471541 0.2653950 0.2328175 0.1736492 0.1007744 2.2449393E-02 -6.3062169E-02 -0.1587211 -0.2595164 -0.3644214 -0.4714334 -0.5791572 -0.6889684 -0.8018382 -0.9144604 -1.026754 -1.138084 -1.251951 -1.370422 0.000000 0.1340311 0.2261658 0.2308525 0.1887083 0.1186758 3.8405176E-02 -4.9268771E-02 -0.1467538 -0.2533275 -0.3607821 -0.4745519 -0.5849430 -0.6956561 -0.8094840 -0.9216419 -1.029773 -1.136755 -1.242876 -1.356714 -1.470569 0.000000 0.1264991 0.1971738 0.1942082 0.1448257 6.8123564E-02 -1.9259721E-02 -0.1177958 -0.2254876 -0.3392022 -0.4495239 -0.5658890 -0.6770929 -0.7897179 -0.9062843 -1.011217 -1.116205 -1.218707 -1.325074 -1.442218 -1.542653 0.000000 0.1118911 0.1677445 0.1603384 0.1026496 2.1292470E-02 -7.2286524E-02 -0.1795411 -0.2945783 -0.4102927 -0.5217180 -0.6389839 -0.7510345 -0.8644744 -0.9680892 -1.066648 -1.176470 -1.274323 -1.386056 -1.476914 -1.566949 0.000000 9.4541542E-02 0.1404465 0.1267326 6.5183297E-02 -1.9647885E-02 -0.1191683 -0.2312891 -0.3477738 -0.4596297 -0.5744967 -0.6889011 -0.8030816 -0.9018013 -1.007707 -1.102204 -1.207564 -1.303475 -1.399948 -1.481598 -1.579016 0.000000 7.6698124E-02 0.1138950 9.3663819E-02 3.1393178E-02 -5.2854281E-02 -0.1543193 -0.2649355 -0.3777809 -0.4896802 -0.6006492 -0.7091539 -0.8153763 -0.9097571 -1.007814 -1.105396 -1.204309 -1.301701 -1.374941 -1.460641 -1.549725 0.000000 6.0452886E-02 8.7423153E-02 6.5129712E-02 4.3121506E-03 -7.6434806E-02 -0.1734857 -0.2786523 -0.3835872 -0.4892137 -0.5921512 -0.6922081 -0.7895260 -0.8835577 -0.9731829 -1.066204 -1.156320 -1.240228 -1.308606 -1.385427 -1.462221 0.000000 4.4777717E-02 6.2471826E-02 4.0109538E-02 -1.3955885E-02 -8.6808555E-02 -0.1722791 -0.2623624 -0.3536773 -0.4495593 -0.5395209 -0.6279331 -0.7155058 -0.7986685 -0.8774197 -0.9687535 -1.044969 -1.117316 -1.186912 -1.254506 -1.319867 0.000000 2.9187594E-02 3.9571580E-02 2.0115338E-02 -2.2821698E-02 -8.0257587E-02 -0.1445585 -0.2149491 -0.2857346 -0.3599410 -0.4309809 -0.5026121 -0.5760269 -0.6441852 -0.7091235 -0.7819512 -0.8422197 -0.9028900 -0.9592529 -1.015793 -1.067774 0.000000 1.4194010E-02 1.8071471E-02 6.1015217E-03 -1.8623972E-02 -5.0938476E-02 -8.6937226E-02 -0.1262767 -0.1680294 -0.2092878 -0.2527122 -0.2976555 -0.3387364 -0.3833584 -0.4235752 -0.4671518 -0.5054287 -0.5473586 -0.5830539 -0.6229735 -0.6550611 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.1055345 0.1525803 0.1770062 0.1927520 0.2010100 0.2061036 0.2074611 0.2061706 0.2038647 0.1960309 0.1852682 0.1743584 0.1610014 0.1475658 0.1334700 0.1186489 0.1029268 8.7329768E-02 7.1807817E-02 5.1829826E-02 0.000000 9.6367247E-02 0.1327536 0.1484713 0.1574946 0.1617967 0.1633381 0.1626417 0.1600761 0.1565422 0.1514286 0.1452924 0.1364441 0.1256466 0.1128860 9.9965677E-02 8.6435750E-02 7.1778595E-02 5.6509584E-02 4.0826790E-02 2.2803079E-02 0.000000 8.5989110E-02 0.1109067 0.1156038 0.1124309 0.1084588 0.1043334 9.8660313E-02 9.1158174E-02 8.1394419E-02 6.8595208E-02 5.4201253E-02 3.7633691E-02 1.8498860E-02 -2.7697582E-03 -2.5412438E-02 -4.8817396E-02 -7.2028942E-02 -0.1010956 -0.1314067 -0.1697451 0.000000 7.6731391E-02 8.9029118E-02 7.7917315E-02 6.3680530E-02 5.1999364E-02 3.9638676E-02 2.4658140E-02 6.3387407E-03 -1.5003973E-02 -3.9439648E-02 -6.6171132E-02 -9.6547954E-02 -0.1323892 -0.1708642 -0.2140947 -0.2598195 -0.3081631 -0.3618501 -0.4181802 -0.4869077 0.000000 6.7007512E-02 6.5667555E-02 4.0428832E-02 1.6617311E-02 -6.1440193E-03 -3.1330444E-02 -6.1368387E-02 -9.4642416E-02 -0.1327511 -0.1747459 -0.2227088 -0.2759964 -0.3340429 -0.3926913 -0.4584003 -0.5300388 -0.6007497 -0.6782554 -0.7640414 -0.8594215 0.000000 5.7723045E-02 4.2506728E-02 5.7807341E-03 -2.9599562E-02 -6.7908846E-02 -0.1113994 -0.1610207 -0.2141714 -0.2716793 -0.3342296 -0.4031706 -0.4758761 -0.5528045 -0.6357427 -0.7229345 -0.8141412 -0.9083306 -1.006753 -1.112072 -1.225887 0.000000 4.9255807E-02 2.0806449E-02 -2.5953995E-02 -7.7275239E-02 -0.1351442 -0.2001907 -0.2681476 -0.3398744 -0.4150009 -0.4997188 -0.5864429 -0.6761004 -0.7693012 -0.8731842 -0.9763450 -1.080871 -1.190292 -1.303897 -1.419791 -1.555253 0.000000 4.0717967E-02 1.4038442E-03 -5.6530826E-02 -0.1264680 -0.2049245 -0.2895755 -0.3760733 -0.4677658 -0.5602774 -0.6637332 -0.7629109 -0.8727450 -0.9783856 -1.087347 -1.207484 -1.320705 -1.454532 -1.576602 -1.699489 -1.844185 0.000000 3.2581102E-02 -1.5421039E-02 -8.5503981E-02 -0.1740966 -0.2722078 -0.3747971 -0.4808779 -0.5855139 -0.6984056 -0.8137623 -0.9217305 -1.042441 -1.158210 -1.281421 -1.395669 -1.526292 -1.666034 -1.784225 -1.920651 -2.069199 0.000000 2.5302317E-02 -2.9917952E-02 -0.1125715 -0.2187424 -0.3334620 -0.4515551 -0.5714087 -0.6950267 -0.8198295 -0.9353563 -1.058885 -1.185309 -1.313768 -1.429402 -1.557809 -1.691847 -1.823610 -1.934275 -2.067681 -2.210590 0.000000 1.8309981E-02 -4.2195939E-02 -0.1375090 -0.2574997 -0.3853544 -0.5158889 -0.6491304 -0.7826449 -0.9124017 -1.040594 -1.168647 -1.295664 -1.420869 -1.547273 -1.676698 -1.806522 -1.914226 -2.036570 -2.165858 -2.299712 0.000000 1.2107892E-02 -5.2733809E-02 -0.1561722 -0.2852170 -0.4253083 -0.5643823 -0.7124171 -0.8508687 -0.9842583 -1.117405 -1.246310 -1.370608 -1.491889 -1.619946 -1.744135 -1.863613 -1.979908 -2.098570 -2.219289 -2.340841 0.000000 7.0746439E-03 -5.9903838E-02 -0.1708684 -0.3046273 -0.4510623 -0.5945578 -0.7458776 -0.8854315 -1.021394 -1.161190 -1.288827 -1.409069 -1.531692 -1.666623 -1.781281 -1.892230 -2.005908 -2.120575 -2.228914 -2.341675 0.000000 3.1103396E-03 -6.4596847E-02 -0.1765114 -0.3131368 -0.4556246 -0.6046823 -0.7547591 -0.8952032 -1.035357 -1.162709 -1.295540 -1.411163 -1.544317 -1.656135 -1.767366 -1.870337 -1.996238 -2.101622 -2.196550 -2.319219 0.000000 -1.4588553E-05 -6.7351520E-02 -0.1764632 -0.3063009 -0.4474390 -0.5925747 -0.7375795 -0.8806656 -1.009081 -1.142272 -1.256970 -1.379056 -1.503815 -1.613147 -1.728179 -1.826077 -1.946460 -2.037988 -2.126745 -2.239714 0.000000 -2.5926409E-03 -6.5622799E-02 -0.1668263 -0.2888625 -0.4208741 -0.5568386 -0.6930413 -0.8266152 -0.9557266 -1.081932 -1.191794 -1.307709 -1.423996 -1.538776 -1.632614 -1.739919 -1.848354 -1.926727 -2.023357 -2.125485 0.000000 -4.0121484E-03 -6.0620677E-02 -0.1501881 -0.2582926 -0.3754875 -0.4970185 -0.6204810 -0.7409446 -0.8582715 -0.9729437 -1.083278 -1.190292 -1.299830 -1.401836 -1.500692 -1.597703 -1.690895 -1.763340 -1.848788 -1.933345 0.000000 -4.2941514E-03 -5.1511794E-02 -0.1241497 -0.2136971 -0.3103022 -0.4121750 -0.5191963 -0.6216667 -0.7242820 -0.8246257 -0.9208691 -1.017794 -1.119882 -1.207470 -1.296891 -1.380575 -1.458886 -1.534571 -1.607238 -1.676569 0.000000 -4.0113893E-03 -3.8233791E-02 -9.1096647E-02 -0.1563541 -0.2264081 -0.3035049 -0.3799693 -0.4570592 -0.5393234 -0.6176919 -0.6929312 -0.7750989 -0.8468815 -0.9185516 -0.9960288 -1.062605 -1.124994 -1.186893 -1.243666 -1.299145 0.000000 -2.5370924E-03 -2.1210425E-02 -4.9661435E-02 -8.4409676E-02 -0.1219007 -0.1630461 -0.2068816 -0.2497474 -0.2956827 -0.3432737 -0.3866185 -0.4340587 -0.4770353 -0.5233623 -0.5647365 -0.6092398 -0.6480392 -0.6903191 -0.7256626 -0.7654671 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 6.7197561E-02 6.4828545E-02 4.1125789E-02 1.3038248E-02 -1.5271548E-02 -4.2202465E-02 -6.9502629E-02 -9.7581059E-02 -0.1254668 -0.1523502 -0.1806621 -0.2129382 -0.2456905 -0.2792251 -0.3102655 -0.3432991 -0.3781267 -0.4139245 -0.4526957 -0.4975566 0.000000 6.1854284E-02 5.8565434E-02 3.5253633E-02 1.0842220E-02 -1.3360252E-02 -3.6881786E-02 -6.0362883E-02 -8.3699688E-02 -0.1064313 -0.1278075 -0.1513839 -0.1767101 -0.2025973 -0.2289438 -0.2556616 -0.2831628 -0.3115728 -0.3374154 -0.3673722 -0.4076161 0.000000 5.6175750E-02 4.8284717E-02 2.1535598E-02 -6.4569949E-03 -3.4586560E-02 -6.0423326E-02 -8.4052376E-02 -0.1069335 -0.1306421 -0.1560803 -0.1827660 -0.2124393 -0.2419859 -0.2724106 -0.3042201 -0.3376714 -0.3733562 -0.4147458 -0.4568233 -0.5089111 0.000000 5.0506819E-02 3.5964333E-02 2.3967891E-03 -3.3995580E-02 -6.7414604E-02 -9.7270817E-02 -0.1242033 -0.1543704 -0.1852406 -0.2201675 -0.2571142 -0.2979261 -0.3386589 -0.3849711 -0.4316120 -0.4847809 -0.5430205 -0.5981315 -0.6618079 -0.7350513 0.000000 4.4080734E-02 2.2642929E-02 -2.0614613E-02 -6.6296272E-02 -0.1055928 -0.1435291 -0.1808471 -0.2220215 -0.2675737 -0.3176641 -0.3726018 -0.4267958 -0.4862037 -0.5506921 -0.6196125 -0.6930548 -0.7704739 -0.8442535 -0.9308643 -1.036347 0.000000 3.7662033E-02 8.7385401E-03 -4.5198396E-02 -0.1000982 -0.1487809 -0.1994288 -0.2528750 -0.3106016 -0.3733463 -0.4404931 -0.5122467 -0.5861054 -0.6655309 -0.7494980 -0.8367582 -0.9279326 -1.024397 -1.125423 -1.242276 -1.370659 0.000000 3.1301904E-02 -5.5555808E-03 -7.0297964E-02 -0.1348488 -0.1962763 -0.2640390 -0.3350679 -0.4110542 -0.4904038 -0.5785120 -0.6656897 -0.7567231 -0.8602949 -0.9623528 -1.066693 -1.172594 -1.294105 -1.409881 -1.528934 -1.666371 0.000000 2.5546534E-02 -1.9645557E-02 -9.3948625E-02 -0.1691412 -0.2478407 -0.3349150 -0.4240420 -0.5213701 -0.6162029 -0.7199280 -0.8210009 -0.9367295 -1.046499 -1.170523 -1.287848 -1.404260 -1.536083 -1.657424 -1.794577 -1.940741 0.000000 1.9823415E-02 -3.2935061E-02 -0.1158777 -0.2044615 -0.3015502 -0.4071310 -0.5143508 -0.6248990 -0.7388659 -0.8495743 -0.9720103 -1.099983 -1.220402 -1.349181 -1.482646 -1.605634 -1.743138 -1.861911 -1.997337 -2.141791 0.000000 1.4517569E-02 -4.4636868E-02 -0.1354800 -0.2365841 -0.3501495 -0.4760779 -0.6021585 -0.7211285 -0.8466830 -0.9756712 -1.108165 -1.241001 -1.376616 -1.499545 -1.633631 -1.765469 -1.899193 -2.014369 -2.148501 -2.288894 0.000000 9.6607469E-03 -5.4732081E-02 -0.1532579 -0.2674899 -0.3963139 -0.5362962 -0.6728939 -0.8081803 -0.9437279 -1.079795 -1.215432 -1.350760 -1.487450 -1.621639 -1.754089 -1.867197 -1.993937 -2.120269 -2.250700 -2.384046 0.000000 5.2159033E-03 -6.2845424E-02 -0.1663911 -0.2937047 -0.4334083 -0.5833356 -0.7278371 -0.8697864 -1.011893 -1.149817 -1.282909 -1.428735 -1.562239 -1.690246 -1.815292 -1.938102 -2.058297 -2.181222 -2.306699 -2.430495 0.000000 1.4723093E-03 -6.8327293E-02 -0.1764827 -0.3088290 -0.4581283 -0.6136025 -0.7628907 -0.9102236 -1.059493 -1.198149 -1.328155 -1.471763 -1.599928 -1.720702 -1.842415 -1.957824 -2.067019 -2.201662 -2.318113 -2.435616 0.000000 -1.4335641E-03 -7.1789421E-02 -0.1798024 -0.3165957 -0.4678552 -0.6243253 -0.7742829 -0.9277690 -1.066959 -1.210406 -1.336563 -1.478484 -1.599263 -1.716534 -1.841465 -1.950665 -2.052224 -2.180491 -2.285612 -2.413184 0.000000 -3.6557231E-03 -7.1812809E-02 -0.1786235 -0.3130644 -0.4554528 -0.6130102 -0.7599850 -0.9054454 -1.048355 -1.175894 -1.309194 -1.446044 -1.558158 -1.679825 -1.782703 -1.896336 -1.993269 -2.114635 -2.206969 -2.320079 0.000000 -5.3934995E-03 -6.8582550E-02 -0.1689673 -0.2933388 -0.4291180 -0.5768540 -0.7203246 -0.8516220 -0.9851931 -1.111972 -1.241311 -1.369295 -1.475899 -1.582723 -1.690783 -1.783392 -1.890368 -1.997925 -2.083379 -2.185171 0.000000 -6.2404643E-03 -6.2282450E-02 -0.1523055 -0.2629113 -0.3835725 -0.5148271 -0.6418014 -0.7668441 -0.8887828 -0.9978032 -1.127157 -1.240921 -1.348470 -1.436423 -1.535941 -1.634895 -1.729285 -1.821201 -1.910950 -1.998309 0.000000 -5.9630247E-03 -5.2583370E-02 -0.1262051 -0.2179405 -0.3173713 -0.4258687 -0.5314322 -0.6366480 -0.7415450 -0.8438428 -0.9551885 -1.052037 -1.144702 -1.233418 -1.325857 -1.410938 -1.491556 -1.568796 -1.641707 -1.711643 0.000000 -4.9705417E-03 -3.9005622E-02 -9.2882261E-02 -0.1597084 -0.2316474 -0.3103707 -0.3885729 -0.4673737 -0.5509048 -0.6306968 -0.7142307 -0.7905747 -0.8638904 -0.9363710 -1.018364 -1.083828 -1.150637 -1.211496 -1.268056 -1.324434 0.000000 -3.0062352E-03 -2.1633998E-02 -5.0703973E-02 -8.6288437E-02 -0.1246936 -0.1666617 -0.2112153 -0.2549135 -0.3014929 -0.3496208 -0.3937732 -0.4417351 -0.4855091 -0.5323416 -0.5801406 -0.6194826 -0.6654244 -0.7018639 -0.7380477 -0.7783064 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 4.4527840E-02 1.3841496E-02 -4.2118002E-02 -9.8989181E-02 -0.1522298 -0.2018430 -0.2533672 -0.3033559 -0.3553484 -0.4048553 -0.4538426 -0.5066899 -0.5569882 -0.6066349 -0.6563527 -0.7060942 -0.7638226 -0.8175203 -0.8724794 -0.9389635 0.000000 4.3591253E-02 2.0923428E-02 -2.8120896E-02 -7.8229167E-02 -0.1236865 -0.1660893 -0.2069507 -0.2506161 -0.2913581 -0.3313608 -0.3702793 -0.4123539 -0.4516996 -0.4900197 -0.5280952 -0.5661708 -0.6045640 -0.6432680 -0.6912048 -0.7467970 0.000000 4.2206030E-02 2.1817829E-02 -2.6897801E-02 -7.5412519E-02 -0.1203929 -0.1613968 -0.2015532 -0.2432658 -0.2849763 -0.3228476 -0.3595902 -0.3995199 -0.4367374 -0.4743477 -0.5172787 -0.5578820 -0.5995517 -0.6476563 -0.6945300 -0.7523136 0.000000 3.9940096E-02 1.7003097E-02 -3.4066446E-02 -8.4707670E-02 -0.1323518 -0.1775165 -0.2229546 -0.2663504 -0.3093512 -0.3498163 -0.3944880 -0.4370243 -0.4850272 -0.5374277 -0.5872996 -0.6442613 -0.7053925 -0.7626558 -0.8297417 -0.9137400 0.000000 3.5495926E-02 9.2494655E-03 -4.6034884E-02 -0.1023336 -0.1569796 -0.2097855 -0.2589975 -0.3071139 -0.3577556 -0.4122841 -0.4652339 -0.5243155 -0.5880947 -0.6547709 -0.7247476 -0.7987060 -0.8778142 -0.9611283 -1.048506 -1.152251 0.000000 3.0670058E-02 1.3074387E-04 -6.1196405E-02 -0.1263500 -0.1910293 -0.2491964 -0.3065524 -0.3673365 -0.4330840 -0.5009225 -0.5717335 -0.6531121 -0.7330332 -0.8175848 -0.9054458 -0.9962895 -1.102561 -1.204751 -1.311461 -1.435575 0.000000 2.5876552E-02 -9.9146133E-03 -7.8511544E-02 -0.1546566 -0.2254270 -0.2956850 -0.3674121 -0.4491655 -0.5300804 -0.6132826 -0.7001342 -0.7968497 -0.8933639 -1.001986 -1.107394 -1.213563 -1.335646 -1.450943 -1.582911 -1.723639 0.000000 2.1148488E-02 -2.0364959E-02 -9.7634926E-02 -0.1831410 -0.2639489 -0.3499246 -0.4404236 -0.5377989 -0.6329320 -0.7374853 -0.8380857 -0.9491152 -1.069291 -1.184443 -1.310438 -1.427932 -1.563433 -1.684784 -1.822575 -1.968679 0.000000 1.6362289E-02 -3.0437471E-02 -0.1174668 -0.2107937 -0.3055490 -0.4093722 -0.5215558 -0.6295844 -0.7444723 -0.8622900 -0.9744090 -1.099360 -1.229487 -1.363536 -1.485663 -1.623441 -1.762220 -1.884374 -2.025712 -2.172005 0.000000 1.2036983E-02 -4.0104762E-02 -0.1361878 -0.2374772 -0.3454667 -0.4697699 -0.5958738 -0.7216178 -0.8501673 -0.9714563 -1.102970 -1.235766 -1.369666 -1.504236 -1.642013 -1.783213 -1.905368 -2.040670 -2.180191 -2.319641 0.000000 7.8609120E-03 -4.8814356E-02 -0.1500201 -0.2600245 -0.3859377 -0.5252767 -0.6620933 -0.7977242 -0.9355063 -1.074455 -1.212404 -1.346140 -1.479947 -1.613697 -1.750615 -1.885711 -2.016208 -2.145490 -2.274717 -2.406661 0.000000 3.9608758E-03 -5.6711677E-02 -0.1605236 -0.2824929 -0.4204341 -0.5705532 -0.7154079 -0.8618435 -1.004621 -1.153033 -1.289561 -1.423889 -1.556733 -1.693845 -1.827885 -1.951446 -2.071091 -2.190016 -2.305985 -2.450855 0.000000 5.2222464E-04 -6.2477972E-02 -0.1684032 -0.2965348 -0.4450550 -0.6012283 -0.7518106 -0.9102038 -1.052258 -1.192484 -1.325430 -1.469629 -1.599596 -1.748026 -1.869459 -1.981294 -2.097773 -2.209253 -2.318535 -2.458359 0.000000 -2.1068426E-03 -6.6102669E-02 -0.1709652 -0.3047306 -0.4562515 -0.6136658 -0.7678723 -0.9217395 -1.062949 -1.208135 -1.337815 -1.479669 -1.609320 -1.742647 -1.848158 -1.955630 -2.078014 -2.183775 -2.297343 -2.426883 0.000000 -4.0362081E-03 -6.6409774E-02 -0.1702142 -0.3028370 -0.4466710 -0.6048958 -0.7614245 -0.9022467 -1.047261 -1.178268 -1.313777 -1.449633 -1.584644 -1.689394 -1.789808 -1.903246 -2.000525 -2.119606 -2.243302 -2.338861 0.000000 -5.4799714E-03 -6.3754626E-02 -0.1619011 -0.2855803 -0.4228498 -0.5716655 -0.7169577 -0.8510997 -0.9871104 -1.118813 -1.247247 -1.374187 -1.496017 -1.590702 -1.698747 -1.792360 -1.898941 -2.005943 -2.111968 -2.197295 0.000000 -6.2627895E-03 -5.8110528E-02 -0.1468261 -0.2574914 -0.3796040 -0.5121669 -0.6409125 -0.7683151 -0.8920743 -1.011831 -1.131937 -1.246499 -1.354755 -1.444371 -1.544699 -1.643923 -1.738553 -1.830098 -1.920951 -2.012476 0.000000 -5.9421924E-03 -4.9367476E-02 -0.1223555 -0.2146060 -0.3153360 -0.4250329 -0.5320238 -0.6402860 -0.7452112 -0.8480126 -0.9597341 -1.057395 -1.150916 -1.240627 -1.333691 -1.419203 -1.500457 -1.576899 -1.658379 -1.735508 0.000000 -4.8835971E-03 -3.6941998E-02 -9.0657093E-02 -0.1580090 -0.2308869 -0.3104689 -0.3895764 -0.4738624 -0.5533559 -0.6338045 -0.7178026 -0.7947720 -0.8687974 -0.9419211 -1.024236 -1.090298 -1.157632 -1.218467 -1.293303 -1.350511 0.000000 -2.9776115E-03 -2.0616163E-02 -4.9713943E-02 -8.5660972E-02 -0.1245518 -0.1669821 -0.2119206 -0.2560431 -0.3029337 -0.3513114 -0.3958566 -0.4440626 -0.4882403 -0.5353228 -0.5833711 -0.6231409 -0.6692962 -0.7062588 -0.7502974 -0.7835670 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -2.5698304E-02 -7.1746372E-02 -0.1354093 -0.2088931 -0.2841528 -0.3611083 -0.4317006 -0.5038239 -0.5710097 -0.6416607 -0.7150805 -0.7813262 -0.8537642 -0.9199727 -0.9938189 -1.060894 -1.136633 -1.204669 -1.283568 -1.380973 0.000000 -1.3527084E-02 -4.4803981E-02 -0.1023895 -0.1672632 -0.2298553 -0.2940658 -0.3523959 -0.4110327 -0.4655766 -0.5226241 -0.5755684 -0.6319373 -0.6832818 -0.7395718 -0.7904527 -0.8395522 -0.8962290 -0.9475104 -1.008876 -1.076061 0.000000 -7.3440670E-04 -2.4477178E-02 -8.1575304E-02 -0.1422834 -0.2006116 -0.2587251 -0.3155570 -0.3673733 -0.4209189 -0.4698890 -0.5206118 -0.5674214 -0.6181709 -0.6646628 -0.7166754 -0.7649925 -0.8199717 -0.8696051 -0.9284081 -1.003585 0.000000 1.2104608E-02 -1.5589404E-02 -7.1483858E-02 -0.1320111 -0.1916806 -0.2502918 -0.3070122 -0.3613153 -0.4149982 -0.4636972 -0.5157269 -0.5701895 -0.6205878 -0.6771491 -0.7377309 -0.8015285 -0.8588339 -0.9241629 -0.9963618 -1.084903 0.000000 1.6368959E-02 -1.1520813E-02 -7.0405029E-02 -0.1343792 -0.2004444 -0.2632794 -0.3216990 -0.3785421 -0.4364318 -0.4962724 -0.5540234 -0.6173007 -0.6847292 -0.7558018 -0.8285094 -0.9041942 -0.9840456 -1.068024 -1.166435 -1.273997 0.000000 1.5584659E-02 -1.2773310E-02 -7.5991452E-02 -0.1458670 -0.2175986 -0.2841155 -0.3502438 -0.4160147 -0.4846928 -0.5574604 -0.6330317 -0.7104902 -0.7994078 -0.8853519 -0.9743168 -1.066085 -1.173479 -1.276022 -1.381570 -1.502923 0.000000 1.4227952E-02 -1.6814131E-02 -8.4894545E-02 -0.1634859 -0.2428719 -0.3157901 -0.3937755 -0.4734889 -0.5571694 -0.6486592 -0.7375130 -0.8297871 -0.9325091 -1.033860 -1.146904 -1.254840 -1.380632 -1.495755 -1.626230 -1.764959 0.000000 1.2564132E-02 -2.2578420E-02 -9.6592069E-02 -0.1852607 -0.2691455 -0.3569742 -0.4507971 -0.5464748 -0.6487050 -0.7472478 -0.8579698 -0.9630947 -1.078756 -1.202799 -1.320074 -1.452847 -1.589493 -1.711246 -1.852268 -1.999539 0.000000 9.5447665E-03 -2.9226674E-02 -0.1107784 -0.2055676 -0.3024114 -0.4058164 -0.5157649 -0.6306846 -0.7401293 -0.8597116 -0.9826053 -1.097767 -1.225000 -1.357275 -1.496199 -1.639575 -1.766543 -1.907185 -2.053644 -2.201403 0.000000 6.4030248E-03 -3.5850294E-02 -0.1253837 -0.2279254 -0.3389699 -0.4577702 -0.5822378 -0.7082325 -0.8365008 -0.9693062 -1.092495 -1.225004 -1.359042 -1.501001 -1.645399 -1.787544 -1.927411 -2.067757 -2.210150 -2.349837 0.000000 3.8244985E-03 -4.2293303E-02 -0.1373536 -0.2478691 -0.3714992 -0.5082591 -0.6442168 -0.7801121 -0.9208133 -1.060222 -1.197385 -1.334331 -1.473888 -1.630630 -1.771128 -1.906631 -2.039791 -2.174404 -2.306849 -2.439096 0.000000 9.9228730E-04 -4.8336744E-02 -0.1471116 -0.2681682 -0.4031262 -0.5517620 -0.6959855 -0.8424960 -0.9959314 -1.136693 -1.278691 -1.414703 -1.567761 -1.706775 -1.836961 -1.962123 -2.092433 -2.219135 -2.338027 -2.485085 0.000000 -1.4684959E-03 -5.3437553E-02 -0.1548711 -0.2814631 -0.4273151 -0.5830212 -0.7329252 -0.8912395 -1.036502 -1.179209 -1.328114 -1.460216 -1.611919 -1.742796 -1.861690 -1.983046 -2.121336 -2.233585 -2.346247 -2.490124 0.000000 -3.3966748E-03 -5.7105210E-02 -0.1582330 -0.2897528 -0.4397772 -0.5972633 -0.7510155 -0.9066085 -1.051279 -1.200802 -1.331412 -1.471632 -1.617423 -1.736112 -1.849858 -1.977798 -2.088420 -2.188468 -2.313745 -2.450446 0.000000 -4.8176656E-03 -5.8062136E-02 -0.1583830 -0.2892290 -0.4372593 -0.5909774 -0.7476756 -0.8935874 -1.038789 -1.182325 -1.307930 -1.444168 -1.579268 -1.686277 -1.808534 -1.914153 -2.026668 -2.119736 -2.237302 -2.360471 0.000000 -5.8325403E-03 -5.6525081E-02 -0.1515400 -0.2744440 -0.4120215 -0.5611287 -0.7071179 -0.8514846 -0.9810439 -1.113803 -1.243503 -1.371035 -1.493316 -1.595179 -1.709223 -1.815481 -1.901362 -2.005056 -2.110026 -2.216519 0.000000 -6.4287595E-03 -5.2019190E-02 -0.1384090 -0.2490426 -0.3716899 -0.5048836 -0.6345899 -0.7633758 -0.8882947 -1.009133 -1.130141 -1.245262 -1.353937 -1.459631 -1.563999 -1.647050 -1.739766 -1.831482 -1.922420 -2.013437 0.000000 -6.0130074E-03 -4.4544250E-02 -0.1160725 -0.2087412 -0.3101660 -0.4205770 -0.5284593 -0.6376976 -0.7435051 -0.8470979 -0.9591501 -1.057484 -1.151201 -1.246158 -1.337280 -1.421295 -1.502511 -1.579925 -1.661389 -1.738216 0.000000 -4.8287851E-03 -3.3740316E-02 -8.6699106E-02 -0.1544488 -0.2279282 -0.3081018 -0.3878408 -0.4726523 -0.5527280 -0.6336492 -0.7179686 -0.7954260 -0.8698617 -0.9525553 -1.025843 -1.092315 -1.159949 -1.221362 -1.296186 -1.353641 0.000000 -2.9551855E-03 -1.8988909E-02 -4.7811065E-02 -8.4021986E-02 -0.1232850 -0.1660800 -0.2113218 -0.2557702 -0.3029000 -0.3514566 -0.3962758 -0.4446439 -0.4890902 -0.5363314 -0.5845373 -0.6245902 -0.6708730 -0.7081872 -0.7524313 -0.7859819 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -8.6381309E-02 -0.1668401 -0.2597937 -0.3547596 -0.4530601 -0.5451338 -0.6374467 -0.7232731 -0.8115662 -0.9014020 -0.9925615 -1.073230 -1.160164 -1.250273 -1.341980 -1.435801 -1.530717 -1.626838 -1.724453 -1.839000 0.000000 -7.7291489E-02 -0.1434166 -0.2194297 -0.2978269 -0.3761502 -0.4522636 -0.5283834 -0.5977457 -0.6693882 -0.7415620 -0.8061367 -0.8741322 -0.9446459 -1.006000 -1.074964 -1.135783 -1.204535 -1.277217 -1.352955 -1.445136 0.000000 -6.8809487E-02 -0.1188036 -0.1776849 -0.2480701 -0.3188058 -0.3862683 -0.4536622 -0.5151058 -0.5785372 -0.6418160 -0.6967090 -0.7558272 -0.8174651 -0.8810951 -0.9359750 -0.9979417 -1.063486 -1.120231 -1.186690 -1.270108 0.000000 -5.9637036E-02 -9.2134625E-02 -0.1453623 -0.2133924 -0.2814758 -0.3461177 -0.4104655 -0.4732780 -0.5351774 -0.5898552 -0.6485315 -0.7097862 -0.7729854 -0.8376611 -0.8960826 -0.9618948 -1.031190 -1.104130 -1.179846 -1.270769 0.000000 -4.8693813E-02 -6.5283597E-02 -0.1237254 -0.1929590 -0.2625837 -0.3296397 -0.3942139 -0.4569575 -0.5196837 -0.5844021 -0.6521133 -0.7208537 -0.7905694 -0.8645472 -0.9411317 -1.018696 -1.110430 -1.199082 -1.290274 -1.397096 0.000000 -3.7214044E-02 -4.6181519E-02 -0.1119627 -0.1849295 -0.2623801 -0.3330144 -0.4012156 -0.4707900 -0.5432130 -0.6236230 -0.7030208 -0.7832381 -0.8662307 -0.9615104 -1.051104 -1.144440 -1.255452 -1.358618 -1.477424 -1.604263 0.000000 -2.4771398E-02 -3.9197788E-02 -0.1081271 -0.1887534 -0.2694544 -0.3459764 -0.4260585 -0.5081893 -0.5975956 -0.6858494 -0.7829844 -0.8753926 -0.9821505 -1.083772 -1.188350 -1.308864 -1.434379 -1.549214 -1.682674 -1.823161 0.000000 -1.1704423E-02 -3.6115482E-02 -0.1091043 -0.1974148 -0.2869502 -0.3723553 -0.4662546 -0.5667512 -0.6654277 -0.7721409 -0.8744479 -0.9886547 -1.110909 -1.227292 -1.354107 -1.486697 -1.609807 -1.748020 -1.894436 -2.042369 0.000000 -3.6810301E-03 -3.6026716E-02 -0.1142844 -0.2101420 -0.3065552 -0.4084313 -0.5170364 -0.6307849 -0.7491071 -0.8622617 -0.9851859 -1.113399 -1.245527 -1.382403 -1.508388 -1.647064 -1.790182 -1.935978 -2.080145 -2.225595 0.000000 -4.2694225E-03 -3.7703551E-02 -0.1217807 -0.2257373 -0.3336780 -0.4499486 -0.5731140 -0.6998104 -0.8299133 -0.9613935 -1.095049 -1.230756 -1.369789 -1.511939 -1.654353 -1.796512 -1.939910 -2.083030 -2.204028 -2.360730 0.000000 -4.9528070E-03 -4.0587764E-02 -0.1303916 -0.2399374 -0.3626591 -0.4925589 -0.6290368 -0.7693164 -0.9095864 -1.047894 -1.186403 -1.323317 -1.475877 -1.618366 -1.757494 -1.894664 -2.031905 -2.165404 -2.296570 -2.428396 0.000000 -6.0174000E-03 -4.3783125E-02 -0.1390871 -0.2551260 -0.3853382 -0.5321016 -0.6789762 -0.8354380 -0.9805074 -1.126087 -1.267399 -1.403084 -1.554525 -1.693705 -1.825950 -1.960907 -2.090047 -2.212220 -2.331965 -2.475180 0.000000 -6.8530068E-03 -4.6737809E-02 -0.1437104 -0.2680708 -0.4067652 -0.5627041 -0.7177846 -0.8756185 -1.023887 -1.178035 -1.318241 -1.450627 -1.599740 -1.731528 -1.859119 -1.998995 -2.114771 -2.232036 -2.343045 -2.478275 0.000000 -7.9146996E-03 -4.9191143E-02 -0.1461019 -0.2720810 -0.4195021 -0.5784775 -0.7419240 -0.8916364 -1.047187 -1.188020 -1.332977 -1.461899 -1.607099 -1.727359 -1.861153 -1.971622 -2.081547 -2.203732 -2.307220 -2.437941 0.000000 -8.3278511E-03 -5.0147146E-02 -0.1457018 -0.2718789 -0.4191725 -0.5749692 -0.7337239 -0.8809737 -1.027231 -1.171704 -1.299109 -1.436097 -1.571219 -1.680337 -1.802838 -1.908515 -2.021186 -2.114344 -2.230700 -2.352491 0.000000 -8.0074631E-03 -4.9328122E-02 -0.1395892 -0.2593066 -0.3974713 -0.5484842 -0.6962770 -0.8415836 -0.9726021 -1.106462 -1.237220 -1.365030 -1.487977 -1.591229 -1.705001 -1.811687 -1.898336 -2.001433 -2.106988 -2.213420 0.000000 -7.8317169E-03 -4.5657586E-02 -0.1281311 -0.2370772 -0.3607128 -0.4956115 -0.6267884 -0.7565308 -0.8823729 -1.004199 -1.125865 -1.241366 -1.350884 -1.456834 -1.561264 -1.645568 -1.737679 -1.831581 -1.923991 -2.013680 0.000000 -6.8224771E-03 -3.9235324E-02 -0.1079663 -0.2002241 -0.3027327 -0.4144354 -0.5233854 -0.6333683 -0.7399084 -0.8441739 -0.9564657 -1.055444 -1.149717 -1.244941 -1.336387 -1.420926 -1.501662 -1.586428 -1.664993 -1.738474 0.000000 -5.2159922E-03 -3.0071350E-02 -8.1360206E-02 -0.1491735 -0.2234706 -0.3044841 -0.3849097 -0.4701682 -0.5507524 -0.6320919 -0.7166961 -0.7946261 -0.8694345 -0.9522371 -1.025828 -1.092648 -1.160571 -1.234463 -1.297154 -1.354666 0.000000 -3.1398290E-03 -1.7057162E-02 -4.5196000E-02 -8.1582047E-02 -0.1213033 -0.1645289 -0.2100967 -0.2548449 -0.3021970 -0.3509240 -0.3959877 -0.4445044 -0.4891819 -0.5365626 -0.5848708 -0.6251860 -0.6715805 -0.7092026 -0.7535495 -0.7875658 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.1260498 -0.2519510 -0.3839870 -0.5186834 -0.6531093 -0.7766655 -0.8938013 -1.006920 -1.116672 -1.224437 -1.330840 -1.436550 -1.542581 -1.649528 -1.755550 -1.862347 -1.969354 -2.076631 -2.203561 -2.334040 0.000000 -0.1157180 -0.2251098 -0.3372883 -0.4503730 -0.5610552 -0.6610188 -0.7561882 -0.8479367 -0.9364531 -1.022643 -1.096422 -1.175937 -1.258202 -1.341093 -1.424925 -1.508929 -1.593698 -1.678646 -1.764008 -1.865254 0.000000 -0.1075358 -0.2017216 -0.2957996 -0.3891474 -0.4807121 -0.5665353 -0.6476152 -0.7252464 -0.8007451 -0.8655231 -0.9335247 -1.003653 -1.075031 -1.146901 -1.219137 -1.292685 -1.367127 -1.442605 -1.518673 -1.611024 0.000000 -0.1001187 -0.1789215 -0.2543651 -0.3318830 -0.4153234 -0.4918681 -0.5654032 -0.6367055 -0.7061411 -0.7735080 -0.8416692 -0.9111304 -0.9808536 -1.051306 -1.123666 -1.197285 -1.270914 -1.346812 -1.425587 -1.520707 0.000000 -9.2742920E-02 -0.1552560 -0.2124198 -0.2890460 -0.3659925 -0.4405656 -0.5136104 -0.5847515 -0.6536507 -0.7296645 -0.8028402 -0.8754960 -0.9492960 -1.025795 -1.104480 -1.183812 -1.266227 -1.365991 -1.458918 -1.567219 0.000000 -8.4801912E-02 -0.1296501 -0.1768027 -0.2552712 -0.3346220 -0.4136809 -0.4938049 -0.5680334 -0.6426764 -0.7261000 -0.8063671 -0.8883996 -0.9724878 -1.069117 -1.160487 -1.255047 -1.366723 -1.470362 -1.588388 -1.714061 0.000000 -7.6186158E-02 -0.1022852 -0.1530167 -0.2350647 -0.3237660 -0.4076678 -0.4894040 -0.5758170 -0.6613007 -0.7550767 -0.8465616 -0.9488217 -1.044867 -1.157236 -1.265426 -1.388947 -1.516107 -1.631422 -1.764228 -1.903798 0.000000 -6.6122651E-02 -7.5758494E-02 -0.1390062 -0.2261912 -0.3211037 -0.4155755 -0.5054054 -0.6034024 -0.7079713 -0.8095745 -0.9213105 -1.027493 -1.147084 -1.274259 -1.407042 -1.543935 -1.667860 -1.807208 -1.953497 -2.101813 0.000000 -5.6088436E-02 -5.7689596E-02 -0.1309240 -0.2276147 -0.3272613 -0.4292599 -0.5349482 -0.6465551 -0.7650088 -0.8882186 -1.005466 -1.133041 -1.265306 -1.401051 -1.540010 -1.680440 -1.825175 -1.972401 -2.121184 -2.267662 0.000000 -4.5189787E-02 -5.0707590E-02 -0.1278153 -0.2318032 -0.3415617 -0.4547327 -0.5739435 -0.7024379 -0.8348466 -0.9684535 -1.104434 -1.241793 -1.380993 -1.520411 -1.660524 -1.802615 -1.948157 -2.090666 -2.232608 -2.376321 0.000000 -3.2909892E-02 -4.7045112E-02 -0.1286758 -0.2412023 -0.3594457 -0.4843048 -0.6182446 -0.7673136 -0.9100983 -1.052319 -1.194855 -1.339056 -1.480339 -1.619596 -1.758948 -1.904681 -2.045980 -2.180605 -2.314622 -2.472059 0.000000 -1.9266346E-02 -4.5768868E-02 -0.1320877 -0.2477746 -0.3740572 -0.5146300 -0.6631627 -0.8196556 -0.9670864 -1.115773 -1.260028 -1.413246 -1.552730 -1.690914 -1.831773 -1.985389 -2.114275 -2.245285 -2.372344 -2.515725 0.000000 -1.5020373E-02 -4.5765635E-02 -0.1337678 -0.2558732 -0.3891873 -0.5407661 -0.7037279 -0.8576177 -1.009272 -1.166260 -1.309954 -1.445915 -1.595770 -1.728834 -1.878668 -2.001505 -2.123841 -2.262650 -2.374570 -2.484746 0.000000 -1.4427793E-02 -4.5707095E-02 -0.1344580 -0.2572523 -0.3988731 -0.5562804 -0.7211981 -0.8747319 -1.033295 -1.177791 -1.325765 -1.457568 -1.602837 -1.731711 -1.865253 -1.978815 -2.107564 -2.216091 -2.315934 -2.437734 0.000000 -1.3556298E-02 -4.4792641E-02 -0.1335334 -0.2556943 -0.3988062 -0.5548838 -0.7158843 -0.8665684 -1.016207 -1.163192 -1.294343 -1.432321 -1.567278 -1.700640 -1.805692 -1.927262 -2.030780 -2.141922 -2.233831 -2.349661 0.000000 -1.2443181E-02 -4.3436915E-02 -0.1275885 -0.2437866 -0.3801212 -0.5320500 -0.6823444 -0.8302650 -0.9642469 -1.101050 -1.234253 -1.361801 -1.484825 -1.604569 -1.703786 -1.816715 -1.920406 -2.003800 -2.107035 -2.212316 0.000000 -1.1301887E-02 -4.0180210E-02 -0.1174663 -0.2237605 -0.3471860 -0.4834580 -0.6168366 -0.7487375 -0.8764652 -1.002703 -1.123867 -1.238638 -1.348882 -1.455469 -1.559931 -1.661120 -1.738757 -1.832089 -1.924308 -2.013848 0.000000 -9.4080037E-03 -3.4402952E-02 -9.9241123E-02 -0.1902651 -0.2934205 -0.4064105 -0.5170161 -0.6284437 -0.7362338 -0.8497321 -0.9541862 -1.053628 -1.148833 -1.244347 -1.336025 -1.420988 -1.502306 -1.587103 -1.665819 -1.739671 0.000000 -6.7664613E-03 -2.6612325E-02 -7.5273871E-02 -0.1427887 -0.2178429 -0.2998368 -0.3812869 -0.4673274 -0.5486301 -0.6305078 -0.7154493 -0.7937569 -0.8691556 -0.9519973 -1.025909 -1.093108 -1.161361 -1.235372 -1.298430 -1.356427 0.000000 -3.8600448E-03 -1.5152006E-02 -4.2088740E-02 -7.8588217E-02 -0.1188389 -0.1625992 -0.2086205 -0.2537706 -0.3014050 -0.3503328 -0.3956525 -0.4443299 -0.4892403 -0.5367667 -0.5851963 -0.6257955 -0.6723160 -0.7102574 -0.7547594 -0.7891847 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.1876317 -0.3678745 -0.5563568 -0.7377680 -0.9140768 -1.072058 -1.219933 -1.360467 -1.510734 -1.647235 -1.779070 -1.905450 -2.029853 -2.173426 -2.300055 -2.444860 -2.594543 -2.744401 -2.891037 -3.034725 0.000000 -0.1676790 -0.3284372 -0.4937296 -0.6472616 -0.7973876 -0.9309326 -1.054680 -1.170925 -1.280048 -1.385910 -1.488570 -1.589441 -1.704399 -1.805954 -1.903680 -1.998916 -2.113572 -2.211649 -2.327695 -2.445195 0.000000 -0.1502100 -0.2974969 -0.4384530 -0.5726020 -0.7021239 -0.8129801 -0.9151008 -1.010903 -1.101562 -1.189475 -1.274856 -1.358258 -1.440617 -1.521817 -1.602214 -1.682819 -1.762673 -1.859935 -1.944044 -2.042344 0.000000 -0.1384348 -0.2684745 -0.3912737 -0.5066194 -0.6125739 -0.7060884 -0.7937409 -0.8770072 -0.9575076 -1.036947 -1.114913 -1.192212 -1.267479 -1.356491 -1.437034 -1.515421 -1.593388 -1.671637 -1.767586 -1.870485 0.000000 -0.1290905 -0.2426772 -0.3474177 -0.4400013 -0.5319774 -0.6165393 -0.6984974 -0.7795737 -0.8662814 -0.9455402 -1.024417 -1.101369 -1.179350 -1.270791 -1.353815 -1.436813 -1.535369 -1.624442 -1.731096 -1.844695 0.000000 -0.1198336 -0.2192435 -0.3014299 -0.3818520 -0.4666888 -0.5506397 -0.6411415 -0.7236177 -0.8064477 -0.8958051 -0.9794300 -1.063263 -1.159346 -1.247962 -1.352852 -1.449075 -1.560677 -1.666005 -1.788756 -1.915940 0.000000 -0.1098354 -0.1957304 -0.2535370 -0.3320286 -0.4191537 -0.5139030 -0.6027607 -0.6974478 -0.7859142 -0.8818698 -0.9748864 -1.078853 -1.175915 -1.289126 -1.410302 -1.522924 -1.651240 -1.783608 -1.919453 -2.061199 0.000000 -0.1010665 -0.1701606 -0.2095667 -0.2959501 -0.3935905 -0.4907424 -0.5916139 -0.6943210 -0.7908652 -0.8972020 -1.011979 -1.120197 -1.242709 -1.370666 -1.504242 -1.643310 -1.787565 -1.914730 -2.059332 -2.228597 0.000000 -9.2017867E-02 -0.1423824 -0.1816479 -0.2722886 -0.3777022 -0.4867839 -0.5957452 -0.7088299 -0.8187855 -0.9396037 -1.066356 -1.197736 -1.331099 -1.468449 -1.613132 -1.760276 -1.909765 -2.059424 -2.210415 -2.359423 0.000000 -8.3504520E-02 -0.1129219 -0.1604733 -0.2588936 -0.3727739 -0.4885462 -0.6117651 -0.7378427 -0.8682077 -1.003665 -1.142220 -1.282916 -1.411505 -1.570463 -1.720919 -1.870981 -2.019103 -2.164674 -2.311626 -2.458795 0.000000 -7.4563287E-02 -8.3694726E-02 -0.1478687 -0.2549036 -0.3761102 -0.5003721 -0.6364952 -0.7758065 -0.9176130 -1.062704 -1.209047 -1.354432 -1.499064 -1.661940 -1.812372 -1.957484 -2.097893 -2.243439 -2.384044 -2.538764 0.000000 -6.5304257E-02 -6.4460762E-02 -0.1389251 -0.2529873 -0.3831664 -0.5153385 -0.6654927 -0.8154033 -0.9683614 -1.118947 -1.275634 -1.424379 -1.567857 -1.729269 -1.873786 -2.009080 -2.146884 -2.299900 -2.423444 -2.546896 0.000000 -5.4177273E-02 -5.7444181E-02 -0.1330296 -0.2537398 -0.3854588 -0.5303760 -0.6916512 -0.8481215 -1.013433 -1.163259 -1.310748 -1.467248 -1.605876 -1.763301 -1.896583 -2.026850 -2.170285 -2.284127 -2.400119 -2.543823 0.000000 -4.2069424E-02 -5.1683225E-02 -0.1299186 -0.2501148 -0.3876952 -0.5405447 -0.7062730 -0.8658181 -1.026141 -1.174909 -1.329624 -1.464867 -1.609864 -1.757153 -1.878802 -2.016197 -2.125302 -2.232151 -2.365468 -2.504415 0.000000 -2.8568130E-02 -4.7160823E-02 -0.1251983 -0.2453171 -0.3833921 -0.5384232 -0.7013582 -0.8641117 -1.012282 -1.161335 -1.308293 -1.436801 -1.572882 -1.707913 -1.823368 -1.943213 -2.044042 -2.163847 -2.288734 -2.414943 0.000000 -2.0504538E-02 -4.3145921E-02 -0.1183346 -0.2322448 -0.3645855 -0.5173877 -0.6704206 -0.8213261 -0.9684916 -1.099712 -1.235473 -1.365194 -1.489702 -1.612282 -1.730632 -1.826602 -1.935636 -2.047197 -2.159177 -2.268921 0.000000 -1.7068412E-02 -3.8502555E-02 -0.1082523 -0.2122514 -0.3341027 -0.4720615 -0.6082224 -0.7427917 -0.8734093 -1.001961 -1.125299 -1.241244 -1.354337 -1.463743 -1.567376 -1.667442 -1.764819 -1.869022 -1.965341 -2.056468 0.000000 -1.3690379E-02 -3.2212302E-02 -9.1323942E-02 -0.1806232 -0.2840948 -0.3987643 -0.5115839 -0.6249775 -0.7346876 -0.8496220 -0.9554814 -1.055376 -1.157299 -1.251537 -1.341193 -1.425477 -1.513931 -1.611880 -1.689014 -1.763418 0.000000 -9.5985373E-03 -2.4760207E-02 -6.9332957E-02 -0.1360909 -0.2120457 -0.2953976 -0.3782839 -0.4654616 -0.5479062 -0.6307467 -0.7163789 -0.7950931 -0.8827673 -0.9554184 -1.028906 -1.096480 -1.176544 -1.239175 -1.302560 -1.360955 0.000000 -5.2461731E-03 -1.3943630E-02 -3.8828272E-02 -7.5378753E-02 -0.1163245 -0.1608389 -0.2075038 -0.2532325 -0.3013014 -0.3505732 -0.3962860 -0.4452084 -0.4952119 -0.5381296 -0.5867089 -0.6276312 -0.6742679 -0.7125713 -0.7571938 -0.7920107 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.3193722 -0.6059284 -0.8668100 -1.100268 -1.321934 -1.517549 -1.715958 -1.895937 -2.084164 -2.252846 -2.433547 -2.589930 -2.763940 -2.942829 -3.120184 -3.296901 -3.469961 -3.641051 -3.804456 -4.001948 0.000000 -0.2893773 -0.5480472 -0.7730486 -0.9710966 -1.163700 -1.334556 -1.508445 -1.661193 -1.803169 -1.954681 -2.088675 -2.234422 -2.358460 -2.498860 -2.617706 -2.754964 -2.895374 -3.035816 -3.172139 -3.304242 0.000000 -0.2650734 -0.4938302 -0.6855305 -0.8640336 -1.036564 -1.185158 -1.333924 -1.461190 -1.577632 -1.703114 -1.810629 -1.913705 -2.012591 -2.127937 -2.226574 -2.342135 -2.438265 -2.552378 -2.668792 -2.783135 0.000000 -0.2442297 -0.4416852 -0.6128910 -0.7739250 -0.9238800 -1.048713 -1.171375 -1.277284 -1.375914 -1.469288 -1.576042 -1.668524 -1.757298 -1.862285 -1.950586 -2.036912 -2.140099 -2.226408 -2.328829 -2.435327 0.000000 -0.2237383 -0.3934038 -0.5516645 -0.6913055 -0.8158311 -0.9192019 -1.025497 -1.120133 -1.211102 -1.313436 -1.402248 -1.489223 -1.588415 -1.675246 -1.777199 -1.864964 -1.968506 -2.059237 -2.168195 -2.282152 0.000000 -0.2036168 -0.3517135 -0.4947844 -0.6094652 -0.7127382 -0.8065638 -0.9071813 -1.000256 -1.102611 -1.191053 -1.291880 -1.380792 -1.481981 -1.571886 -1.677872 -1.773732 -1.887162 -2.008938 -2.134895 -2.262538 0.000000 -0.1833644 -0.3200487 -0.4382344 -0.5333586 -0.6236266 -0.7231426 -0.8204650 -0.9259720 -1.018319 -1.119323 -1.225132 -1.319550 -1.427588 -1.528957 -1.646742 -1.772154 -1.901714 -2.036618 -2.174489 -2.313554 0.000000 -0.1636195 -0.2899408 -0.3806804 -0.4582084 -0.5520763 -0.6575409 -0.7688004 -0.8680380 -0.9730296 -1.080994 -1.195722 -1.302951 -1.424284 -1.552883 -1.685124 -1.822124 -1.964889 -2.110184 -2.259002 -2.410897 0.000000 -0.1440628 -0.2597344 -0.3231805 -0.3997066 -0.5033119 -0.6194060 -0.7284878 -0.8398967 -0.9532696 -1.072835 -1.200628 -1.332393 -1.467440 -1.606340 -1.750596 -1.899757 -2.051993 -2.205581 -2.359163 -2.537779 0.000000 -0.1247830 -0.2288639 -0.2680326 -0.3533287 -0.4660945 -0.5891010 -0.7097700 -0.8301625 -0.9563163 -1.093306 -1.233768 -1.373521 -1.515560 -1.660592 -1.829114 -1.986359 -2.142452 -2.293872 -2.442707 -2.618001 0.000000 -0.1133809 -0.1973500 -0.2214716 -0.3194222 -0.4459593 -0.5752835 -0.7019709 -0.8357575 -0.9791243 -1.136688 -1.283223 -1.429816 -1.580980 -1.730315 -1.903083 -2.060546 -2.209985 -2.353374 -2.501096 -2.667146 0.000000 -0.1019961 -0.1653979 -0.1929299 -0.2975222 -0.4268602 -0.5614860 -0.7038450 -0.8516891 -1.015614 -1.168061 -1.321020 -1.471790 -1.634332 -1.782230 -1.955151 -2.104516 -2.242482 -2.381913 -2.537809 -2.669684 0.000000 -9.0535611E-02 -0.1322510 -0.1700035 -0.2787773 -0.4169100 -0.5551818 -0.7102867 -0.8705844 -1.036545 -1.192011 -1.356277 -1.506669 -1.650102 -1.807394 -1.972617 -2.108442 -2.240040 -2.385057 -2.500381 -2.640565 0.000000 -7.8672163E-02 -9.7973734E-02 -0.1500163 -0.2658058 -0.4020717 -0.5487230 -0.7130930 -0.8841727 -1.040271 -1.205116 -1.355750 -1.509686 -1.646051 -1.795666 -1.948167 -2.069690 -2.208529 -2.316678 -2.424656 -2.557081 0.000000 -6.6396199E-02 -7.1225829E-02 -0.1346429 -0.2487820 -0.3867149 -0.5374203 -0.7020651 -0.8685066 -1.022110 -1.180185 -1.330912 -1.463651 -1.603399 -1.741606 -1.878919 -1.992256 -2.111798 -2.212141 -2.334606 -2.458983 0.000000 -5.3632025E-02 -6.0729735E-02 -0.1215020 -0.2322404 -0.3638820 -0.5125698 -0.6689150 -0.8244525 -0.9766330 -1.124552 -1.254774 -1.387431 -1.515244 -1.640760 -1.761318 -1.878580 -1.973212 -2.085616 -2.196325 -2.304636 0.000000 -3.9728764E-02 -5.0033316E-02 -0.1058565 -0.2070735 -0.3267750 -0.4667525 -0.6069939 -0.7457535 -0.8830420 -1.014460 -1.140763 -1.258945 -1.374463 -1.486186 -1.591480 -1.692981 -1.798066 -1.900009 -1.993910 -2.085082 0.000000 -2.4744341E-02 -3.8869470E-02 -8.8290133E-02 -0.1745237 -0.2778336 -0.3948847 -0.5111903 -0.6277683 -0.7477197 -0.8599232 -0.9669598 -1.068172 -1.171587 -1.267449 -1.358560 -1.444641 -1.548470 -1.632000 -1.710152 -1.785375 0.000000 -1.6552536E-02 -2.8039901E-02 -6.5244928E-02 -0.1305150 -0.2077007 -0.2931413 -0.3784267 -0.4674991 -0.5518553 -0.6424371 -0.7231215 -0.8031401 -0.8914291 -0.9652126 -1.039706 -1.108335 -1.188698 -1.252405 -1.316480 -1.375589 0.000000 -8.4697092E-03 -1.5062420E-02 -3.6248595E-02 -7.2502375E-02 -0.1144998 -0.1602249 -0.2079406 -0.2546242 -0.3034020 -0.3532444 -0.3996142 -0.4489772 -0.4993103 -0.5428079 -0.5916897 -0.6332054 -0.6801099 -0.7190275 -0.7638342 -0.7992477 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.6572287 -1.051221 -1.400720 -1.721607 -2.024950 -2.287162 -2.545197 -2.795031 -3.038183 -3.276512 -3.473490 -3.684210 -3.896436 -4.106014 -4.306531 -4.504039 -4.695960 -4.933328 -5.120025 -5.345265 0.000000 -0.6059226 -0.9560890 -1.267028 -1.553836 -1.802997 -2.043788 -2.272787 -2.465144 -2.664570 -2.862786 -3.059386 -3.217337 -3.390383 -3.563113 -3.735022 -3.902484 -4.063081 -4.219820 -4.369179 -4.556517 0.000000 -0.5559598 -0.8697379 -1.147141 -1.400918 -1.618681 -1.828805 -2.031346 -2.199618 -2.374408 -2.521174 -2.675477 -2.830725 -2.954849 -3.093524 -3.234304 -3.374204 -3.512124 -3.645069 -3.772564 -3.896863 0.000000 -0.5091576 -0.7868240 -1.035258 -1.248398 -1.448674 -1.640754 -1.819601 -1.962164 -2.108199 -2.226579 -2.356498 -2.466639 -2.590640 -2.717819 -2.816288 -2.932723 -3.052754 -3.171433 -3.286049 -3.399019 0.000000 -0.4645148 -0.7146910 -0.9343145 -1.119661 -1.304160 -1.472095 -1.620527 -1.736607 -1.858954 -1.963960 -2.082997 -2.182739 -2.296428 -2.388823 -2.498015 -2.612712 -2.727074 -2.842018 -2.956288 -3.070634 0.000000 -0.4206944 -0.6443815 -0.8389729 -1.014053 -1.169688 -1.307992 -1.430569 -1.534431 -1.650869 -1.750833 -1.864068 -1.956921 -2.064408 -2.175219 -2.290298 -2.408116 -2.525330 -2.646555 -2.768147 -2.889779 0.000000 -0.3831064 -0.5765784 -0.7492474 -0.9078030 -1.037399 -1.153301 -1.265311 -1.382587 -1.485240 -1.599048 -1.692371 -1.800721 -1.913029 -2.030463 -2.152570 -2.277339 -2.403156 -2.533285 -2.665594 -2.800465 0.000000 -0.3423131 -0.5180943 -0.6661505 -0.8052440 -0.9179157 -1.018181 -1.132552 -1.251484 -1.366965 -1.465810 -1.576854 -1.695862 -1.818493 -1.945128 -2.075666 -2.209364 -2.348428 -2.492045 -2.638039 -2.811886 0.000000 -0.3050721 -0.4632113 -0.5945608 -0.7037928 -0.8007233 -0.9156052 -1.037975 -1.148686 -1.264236 -1.381176 -1.508583 -1.642596 -1.775664 -1.911940 -2.050583 -2.193218 -2.368112 -2.526849 -2.684395 -2.865951 0.000000 -0.2721522 -0.4091703 -0.5246735 -0.6056883 -0.7048560 -0.8264728 -0.9545306 -1.078459 -1.200962 -1.333967 -1.488626 -1.631336 -1.774870 -1.921227 -2.072084 -2.229310 -2.414995 -2.579117 -2.737105 -2.916640 0.000000 -0.2442635 -0.3562929 -0.4555026 -0.5158938 -0.6270326 -0.7645539 -0.8974187 -1.025779 -1.162782 -1.323019 -1.473669 -1.621616 -1.776017 -1.930410 -2.108080 -2.272106 -2.458168 -2.617406 -2.765818 -2.936760 0.000000 -0.2131481 -0.3048731 -0.3869781 -0.4448824 -0.5690091 -0.7063242 -0.8433932 -0.9909794 -1.145951 -1.313494 -1.467919 -1.625177 -1.797652 -1.954764 -2.137604 -2.297042 -2.474023 -2.620541 -2.755654 -2.917137 0.000000 -0.1816852 -0.2679647 -0.3192807 -0.3896499 -0.5166939 -0.6648818 -0.8059995 -0.9680158 -1.142733 -1.304184 -1.464493 -1.634421 -1.790307 -1.962654 -2.139999 -2.286797 -2.449004 -2.579679 -2.708850 -2.855843 0.000000 -0.1555759 -0.2312512 -0.2555504 -0.3395007 -0.4763178 -0.6202906 -0.7745367 -0.9460074 -1.122571 -1.286078 -1.454879 -1.608720 -1.773321 -1.937095 -2.102149 -2.231803 -2.377267 -2.492861 -2.631364 -2.744526 0.000000 -0.1309147 -0.1936773 -0.1987804 -0.3000873 -0.4335689 -0.5801525 -0.7413008 -0.9127839 -1.084565 -1.253599 -1.405142 -1.563192 -1.716253 -1.868117 -2.017154 -2.129727 -2.258980 -2.365050 -2.482641 -2.602582 0.000000 -0.1058389 -0.1555022 -0.1667841 -0.2603072 -0.3925026 -0.5353733 -0.6946483 -0.8582164 -1.019232 -1.174771 -1.325282 -1.468856 -1.611041 -1.749335 -1.878914 -1.982958 -2.093570 -2.204655 -2.293218 -2.398067 0.000000 -7.9884402E-02 -0.1165205 -0.1347495 -0.2234973 -0.3448868 -0.4786262 -0.6248915 -0.7738924 -0.9173637 -1.055441 -1.188309 -1.312531 -1.452111 -1.571664 -1.682511 -1.791114 -1.876380 -1.974348 -2.068400 -2.160839 0.000000 -5.9230763E-02 -7.3514573E-02 -0.1040360 -0.1802103 -0.2834411 -0.4019803 -0.5245011 -0.6537197 -0.7726233 -0.8900975 -1.001961 -1.107733 -1.225580 -1.324767 -1.418956 -1.514056 -1.602450 -1.685542 -1.765452 -1.842604 0.000000 -3.9192669E-02 -4.7345735E-02 -7.2242491E-02 -0.1310388 -0.2089759 -0.2976898 -0.3876210 -0.4805504 -0.5687572 -0.6619231 -0.7456460 -0.8281688 -0.9177019 -0.9936481 -1.069989 -1.151439 -1.221488 -1.287119 -1.352626 -1.413358 0.000000 -1.8574592E-02 -2.4379246E-02 -3.8517866E-02 -7.1852937E-02 -0.1152028 -0.1631356 -0.2129735 -0.2616251 -0.3118518 -0.3628467 -0.4105273 -0.4607226 -0.5116912 -0.5563009 -0.6057001 -0.6483772 -0.6957288 -0.7358114 -0.7809566 -0.8175685 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -1.503876 -2.533724 -3.355088 -4.080226 -4.693715 -5.287958 -5.849341 -6.378745 -6.809380 -7.264380 -7.709004 -8.137908 -8.553416 -8.954841 -9.257985 -9.626449 -10.00025 -10.37120 -10.72847 -11.07646 0.000000 -1.427461 -2.376266 -3.133123 -3.801047 -4.358942 -4.898226 -5.404956 -5.820425 -6.244376 -6.654248 -7.048007 -7.349295 -7.691762 -8.030757 -8.367036 -8.694613 -8.923665 -9.216996 -9.513998 -9.806518 0.000000 -1.350616 -2.217789 -2.914288 -3.526215 -4.028426 -4.515902 -4.971703 -5.334443 -5.708402 -6.070017 -6.348065 -6.657897 -6.964704 -7.187267 -7.453444 -7.722895 -7.988620 -8.163620 -8.396947 -8.633277 0.000000 -1.273292 -2.060706 -2.699423 -3.223131 -3.703771 -4.145901 -4.507656 -4.864537 -5.201261 -5.460526 -5.748614 -6.029103 -6.229705 -6.464936 -6.699042 -6.861909 -7.067876 -7.276617 -7.412138 -7.598370 0.000000 -1.195438 -1.905978 -2.489210 -2.962159 -3.393680 -3.791754 -4.111167 -4.429052 -4.681777 -4.945945 -5.201053 -5.384745 -5.597868 -5.810214 -5.954864 -6.141432 -6.331697 -6.453334 -6.625386 -6.803486 0.000000 -1.116992 -1.754998 -2.284033 -2.708464 -3.096649 -3.451576 -3.733672 -4.019939 -4.238765 -4.467007 -4.641969 -4.838282 -5.031709 -5.168088 -5.345109 -5.523343 -5.639546 -5.803040 -5.974043 -6.082383 0.000000 -1.037879 -1.607934 -2.086387 -2.465490 -2.809686 -3.098630 -3.377083 -3.629953 -3.817217 -4.019316 -4.174338 -4.352250 -4.488199 -4.650907 -4.823125 -4.943855 -5.100002 -5.264543 -5.373849 -5.526135 0.000000 -0.9580020 -1.463069 -1.894376 -2.229562 -2.538320 -2.794894 -3.036819 -3.257042 -3.426014 -3.612548 -3.758473 -3.927783 -4.056041 -4.211456 -4.376864 -4.501097 -4.659565 -4.774510 -4.933609 -5.101745 0.000000 -0.8772479 -1.326019 -1.688031 -2.002139 -2.281248 -2.502539 -2.710222 -2.912496 -3.071553 -3.249922 -3.392818 -3.555816 -3.684033 -3.842347 -4.009741 -4.136683 -4.301990 -4.472342 -4.650599 -4.829810 0.000000 -0.7958224 -1.190409 -1.514673 -1.788243 -2.033412 -2.219114 -2.410936 -2.599330 -2.756163 -2.931000 -3.072200 -3.234093 -3.399590 -3.538054 -3.708007 -3.882826 -4.063659 -4.246857 -4.430680 -4.613201 0.000000 -0.7142402 -1.060349 -1.345096 -1.588297 -1.791094 -1.971756 -2.136790 -2.318767 -2.479755 -2.651496 -2.817620 -2.960184 -3.137272 -3.315360 -3.496781 -3.682775 -3.870154 -4.058791 -4.245509 -4.430221 0.000000 -0.6331465 -0.9361036 -1.179120 -1.393943 -1.554848 -1.726896 -1.891824 -2.073209 -2.253943 -2.402241 -2.575179 -2.759717 -2.943452 -3.126732 -3.315080 -3.504154 -3.695036 -3.883681 -4.067133 -4.245096 0.000000 -0.5533232 -0.8123676 -1.018536 -1.203701 -1.333212 -1.505298 -1.687014 -1.853000 -2.026383 -2.202827 -2.391282 -2.579492 -2.765044 -2.951545 -3.138610 -3.326117 -3.509822 -3.687796 -3.861140 -4.026122 0.000000 -0.4755453 -0.6950024 -0.8870402 -1.015884 -1.140432 -1.304567 -1.482540 -1.661598 -1.835077 -2.023762 -2.214506 -2.399965 -2.583312 -2.765335 -2.946967 -3.121271 -3.291423 -3.453061 -3.609042 -3.757832 0.000000 -0.4000487 -0.5850170 -0.7471361 -0.8388724 -0.9701085 -1.130711 -1.305377 -1.475516 -1.653024 -1.842535 -2.026181 -2.204029 -2.378109 -2.551595 -2.716004 -2.877511 -3.032605 -3.175134 -3.313903 -3.448249 0.000000 -0.3276338 -0.4756617 -0.6083865 -0.6690725 -0.8000475 -0.9510886 -1.113647 -1.274384 -1.464558 -1.641050 -1.810084 -1.973578 -2.138377 -2.293835 -2.437785 -2.599597 -2.731349 -2.862427 -2.988239 -3.104058 0.000000 -0.2579375 -0.3667735 -0.4704087 -0.5293987 -0.6408507 -0.7789320 -0.9291566 -1.078646 -1.250660 -1.404452 -1.551682 -1.699067 -1.854016 -1.984661 -2.112049 -2.231956 -2.342860 -2.480625 -2.585850 -2.684062 0.000000 -0.1899276 -0.2721114 -0.3319229 -0.3946038 -0.4910278 -0.6063085 -0.7257358 -0.8595179 -0.9994631 -1.122809 -1.245287 -1.373453 -1.485940 -1.593179 -1.713066 -1.810741 -1.902829 -2.014784 -2.101412 -2.187407 0.000000 -0.1242725 -0.1787491 -0.2126695 -0.2646827 -0.3336950 -0.4210171 -0.5104223 -0.6068008 -0.7053062 -0.7937951 -0.8879749 -0.9709013 -1.063254 -1.140481 -1.228638 -1.303023 -1.373420 -1.455048 -1.524913 -1.603170 0.000000 -6.1191890E-02 -8.5221082E-02 -0.1070599 -0.1330282 -0.1725416 -0.2202914 -0.2683345 -0.3186464 -0.3690939 -0.4198295 -0.4649941 -0.5137817 -0.5629820 -0.6057708 -0.6530970 -0.7009953 -0.7408575 -0.7867370 -0.8332976 -0.8692572 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -1.571720 -2.787997 -3.729656 -4.562078 -5.313726 -6.009639 -6.657831 -7.263496 -7.833025 -8.372377 -8.965956 -9.447593 -9.905377 -10.34117 -10.76782 -11.18138 -11.57799 -11.96598 -12.34141 -12.69807 0.000000 -1.494447 -2.632613 -3.507374 -4.281149 -4.976470 -5.616804 -6.209745 -6.760477 -7.273484 -7.758645 -8.211559 -8.638900 -9.128447 -9.510537 -9.881482 -10.23763 -10.57995 -10.91264 -11.23336 -11.53552 0.000000 -1.416996 -2.476089 -3.286063 -4.003383 -4.644039 -5.230651 -5.771058 -6.269981 -6.730217 -7.162034 -7.564855 -7.942631 -8.294889 -8.625987 -8.945306 -9.246825 -9.539293 -9.819972 -10.09200 -10.34959 0.000000 -1.339352 -2.318463 -3.067713 -3.729855 -4.318164 -4.853576 -5.343977 -5.795979 -6.208475 -6.591786 -6.948050 -7.281953 -7.596541 -7.886384 -8.164553 -8.427161 -8.680026 -8.921502 -9.152057 -9.370325 0.000000 -1.261501 -2.161052 -2.851841 -3.461612 -3.999994 -4.485660 -4.932006 -5.339356 -5.709025 -6.051274 -6.369044 -6.664501 -6.941335 -7.194305 -7.436368 -7.663730 -7.877508 -8.087390 -8.289599 -8.481606 0.000000 -1.183426 -2.004856 -2.639466 -3.197243 -3.687666 -4.130605 -4.532032 -4.900109 -5.236350 -5.541515 -5.824568 -6.080687 -6.318875 -6.540516 -6.753807 -6.957860 -7.151722 -7.340242 -7.522606 -7.693439 0.000000 -1.105111 -1.830644 -2.431638 -2.940699 -3.385883 -3.783627 -4.146414 -4.481392 -4.783896 -5.052586 -5.301148 -5.525138 -5.737907 -5.942817 -6.134346 -6.323971 -6.501660 -6.674152 -6.842150 -6.999491 0.000000 -1.026533 -1.678705 -2.204295 -2.687227 -3.091392 -3.446949 -3.777527 -4.077668 -4.344026 -4.580509 -4.802103 -5.009408 -5.208573 -5.399364 -5.580063 -5.753353 -5.919074 -6.079614 -6.242812 -6.397853 0.000000 -0.9476675 -1.528656 -2.004002 -2.417646 -2.773672 -3.094431 -3.420330 -3.681873 -3.917828 -4.136642 -4.341456 -4.540928 -4.726907 -4.908923 -5.078545 -5.240591 -5.402192 -5.563762 -5.724831 -5.877862 0.000000 -0.8684856 -1.383125 -1.809835 -2.181101 -2.496970 -2.814778 -3.068587 -3.297094 -3.517196 -3.724135 -3.922265 -4.112201 -4.290584 -4.462160 -4.627150 -4.787761 -4.949636 -5.115019 -5.277809 -5.434557 0.000000 -0.7889484 -1.239935 -1.617415 -1.947593 -2.234513 -2.507770 -2.722374 -2.937688 -3.144408 -3.346053 -3.537627 -3.720027 -3.890156 -4.057920 -4.223927 -4.392406 -4.564892 -4.732275 -4.897011 -5.106614 0.000000 -0.7090023 -1.101915 -1.432745 -1.718967 -1.997485 -2.202778 -2.396976 -2.600734 -2.800842 -2.996817 -3.183459 -3.358075 -3.525517 -3.700749 -3.872483 -4.089180 -4.257931 -4.430969 -4.595293 -4.752939 0.000000 -0.6285713 -0.9634061 -1.256133 -1.508068 -1.739133 -1.903807 -2.095481 -2.289045 -2.483254 -2.673723 -2.853858 -3.023802 -3.228297 -3.405329 -3.587637 -3.763399 -3.972455 -4.138444 -4.299378 -4.455157 0.000000 -0.5475495 -0.8334769 -1.080889 -1.316790 -1.482023 -1.631338 -1.812578 -1.998256 -2.186407 -2.389677 -2.557316 -2.731474 -2.915323 -3.125380 -3.304481 -3.472485 -3.673406 -3.833404 -3.989293 -4.134944 0.000000 -0.4660308 -0.7038403 -0.9070371 -1.110690 -1.228356 -1.379624 -1.546701 -1.738454 -1.915059 -2.081780 -2.250974 -2.448417 -2.629047 -2.830538 -2.997320 -3.153368 -3.342845 -3.493481 -3.634024 -3.775739 0.000000 -0.3845554 -0.5764459 -0.7449158 -0.9053200 -0.9930260 -1.139167 -1.303877 -1.464230 -1.626736 -1.797029 -1.960082 -2.149029 -2.312804 -2.496605 -2.645455 -2.786345 -2.958126 -3.090719 -3.223651 -3.383507 0.000000 -0.3037301 -0.4561449 -0.5968963 -0.7005221 -0.7881510 -0.9171839 -1.051423 -1.206648 -1.342206 -1.487364 -1.646713 -1.811702 -1.950690 -2.108194 -2.235580 -2.361623 -2.503078 -2.621116 -2.758241 -2.862931 0.000000 -0.2248673 -0.3359375 -0.4417066 -0.5001103 -0.5936102 -0.6896830 -0.8084384 -0.9231287 -1.047170 -1.166404 -1.294758 -1.426225 -1.535396 -1.660065 -1.761592 -1.879609 -1.977303 -2.090508 -2.178579 -2.287131 0.000000 -0.1481178 -0.2203601 -0.2865978 -0.3324354 -0.3939486 -0.4689606 -0.5483073 -0.6355953 -0.7271509 -0.8099148 -0.8999164 -0.9905820 -1.068269 -1.153190 -1.226464 -1.308748 -1.392194 -1.457920 -1.536044 -1.600313 0.000000 -7.3162250E-02 -0.1101039 -0.1382542 -0.1671902 -0.1978278 -0.2370235 -0.2817126 -0.3285404 -0.3764446 -0.4189938 -0.4648762 -0.5104650 -0.5560786 -0.5951642 -0.6385290 -0.6819109 -0.7256057 -0.7613536 -0.8029280 -0.8448500 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -1.364432 -2.559150 -3.480248 -4.310288 -5.045830 -5.783695 -6.410093 -7.012425 -7.648415 -8.184910 -8.786920 -9.270354 -9.734693 -10.27238 -10.69387 -11.10644 -11.60260 -11.98135 -12.47424 -12.82089 0.000000 -1.297461 -2.426247 -3.286590 -4.063051 -4.748980 -5.438708 -6.017332 -6.572144 -7.161027 -7.650633 -8.120542 -8.640545 -9.055212 -9.549819 -9.925112 -10.28783 -10.73939 -11.06771 -11.40023 -11.82134 0.000000 -1.230381 -2.292648 -3.091704 -3.816748 -4.455095 -5.046503 -5.631020 -6.138341 -6.683907 -7.127482 -7.550555 -8.027643 -8.399173 -8.756071 -9.182045 -9.497655 -9.810025 -10.19669 -10.47880 -10.74908 0.000000 -1.163192 -2.158255 -2.896752 -3.573084 -4.164756 -4.711181 -5.251359 -5.714462 -6.153524 -6.619171 -7.000062 -7.437793 -7.770694 -8.084174 -8.472490 -8.751642 -9.022656 -9.284554 -9.621769 -9.855431 0.000000 -1.095884 -2.022956 -2.703012 -3.331617 -3.878237 -4.379889 -4.880330 -5.300307 -5.701080 -6.127672 -6.470921 -6.796567 -7.168550 -7.447821 -7.719932 -8.051958 -8.286938 -8.516007 -8.820700 -9.020892 0.000000 -1.028456 -1.886621 -2.510722 -3.093200 -3.595493 -4.056671 -4.515700 -4.899280 -5.261528 -5.651431 -5.963437 -6.252657 -6.595971 -6.846903 -7.084161 -7.309967 -7.587504 -7.782907 -7.977308 -8.238754 0.000000 -0.9609051 -1.749382 -2.321226 -2.858716 -3.318817 -3.737341 -4.161888 -4.506856 -4.833988 -5.141150 -5.475710 -5.736497 -5.986043 -6.265774 -6.473164 -6.672412 -6.928394 -7.105319 -7.280447 -7.445908 0.000000 -0.8932239 -1.612012 -2.134048 -2.626518 -3.046236 -3.427914 -3.775501 -4.123753 -4.423988 -4.701647 -5.004191 -5.235354 -5.454307 -5.706844 -5.895515 -6.080354 -6.315770 -6.483286 -6.645512 -6.799742 0.000000 -0.8254117 -1.475121 -1.948610 -2.398820 -2.775656 -3.124731 -3.433641 -3.755473 -4.026085 -4.274321 -4.541075 -4.745798 -4.944928 -5.182450 -5.360211 -5.536770 -5.757195 -5.913524 -6.064867 -6.209277 0.000000 -0.7574606 -1.339334 -1.767937 -2.176039 -2.517603 -2.824711 -3.108222 -3.396407 -3.636320 -3.851688 -4.089049 -4.282747 -4.472029 -4.694972 -4.866154 -5.034789 -5.240355 -5.389927 -5.532220 -5.729398 0.000000 -0.6893727 -1.204804 -1.589278 -1.933005 -2.261656 -2.531404 -2.790271 -3.042405 -3.247175 -3.473800 -3.662625 -3.850383 -4.031629 -4.243411 -4.406883 -4.566986 -4.762441 -4.903739 -5.092696 -5.228301 0.000000 -0.6211370 -1.072785 -1.413035 -1.718765 -2.006978 -2.254786 -2.502568 -2.688173 -2.865521 -3.083576 -3.264781 -3.444317 -3.653506 -3.818107 -3.976247 -4.171806 -4.310634 -4.498566 -4.634661 -4.775351 0.000000 -0.5527541 -0.9441552 -1.243291 -1.511895 -1.755193 -1.982544 -2.185738 -2.336797 -2.513649 -2.715333 -2.889257 -3.094178 -3.255454 -3.416900 -3.604178 -3.746161 -3.929420 -4.071733 -4.222540 -4.401101 0.000000 -0.4842235 -0.8166400 -1.073703 -1.305844 -1.523658 -1.711849 -1.867383 -2.012108 -2.201421 -2.365530 -2.533189 -2.719045 -2.877121 -3.060848 -3.198302 -3.379412 -3.521851 -3.709413 -3.848022 -3.993649 0.000000 -0.4155349 -0.6937956 -0.9084345 -1.100540 -1.294671 -1.440486 -1.554353 -1.710233 -1.875946 -2.029893 -2.206356 -2.357696 -2.531090 -2.667432 -2.837251 -2.977631 -3.154855 -3.293427 -3.465543 -3.605514 0.000000 -0.3466918 -0.5709283 -0.7498890 -0.9148877 -1.066412 -1.179715 -1.283746 -1.431981 -1.563279 -1.722024 -1.858822 -2.019449 -2.148008 -2.301930 -2.437068 -2.594681 -2.730435 -2.884243 -3.042544 -3.167693 0.000000 -0.2776859 -0.4529502 -0.5917942 -0.7264587 -0.8378596 -0.9116295 -1.022070 -1.141481 -1.258900 -1.390215 -1.528819 -1.645849 -1.777578 -1.899948 -2.034118 -2.173206 -2.288839 -2.421684 -2.556823 -2.661016 0.000000 -0.2085181 -0.3349217 -0.4360405 -0.5390658 -0.6078651 -0.6805040 -0.7722248 -0.8580921 -0.9616102 -1.070979 -1.167575 -1.272984 -1.385458 -1.480375 -1.589331 -1.699641 -1.793174 -1.896546 -2.000002 -2.084320 0.000000 -0.1391812 -0.2215514 -0.2891390 -0.3516710 -0.4001765 -0.4529478 -0.5134382 -0.5816637 -0.6493926 -0.7249992 -0.8001151 -0.8778889 -0.9467518 -1.021823 -1.097460 -1.173120 -1.248986 -1.309201 -1.380078 -1.450718 0.000000 -6.9675840E-02 -0.1092494 -0.1426280 -0.1708648 -0.1990412 -0.2282150 -0.2579531 -0.2934774 -0.3318425 -0.3712587 -0.4113514 -0.4515962 -0.4867309 -0.5251433 -0.5632666 -0.6011305 -0.6387606 -0.6764687 -0.7069774 -0.7426749 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -1.005646 -1.984583 -2.809215 -3.521293 -4.141879 -4.752661 -5.302083 -5.856671 -6.405977 -6.865778 -7.373414 -7.883674 -8.281625 -8.759334 -9.140104 -9.586357 -10.04080 -10.36336 -10.79113 -11.10333 0.000000 -0.9560201 -1.887383 -2.664775 -3.333134 -3.913469 -4.486649 -5.000046 -5.519429 -6.033817 -6.458856 -6.931869 -7.331485 -7.771017 -8.214475 -8.557542 -8.971871 -9.294106 -9.680908 -10.07508 -10.35140 0.000000 -0.9063332 -1.789946 -2.519595 -3.143821 -3.684261 -4.221559 -4.700346 -5.185575 -5.666644 -6.057293 -6.497672 -6.862511 -7.270155 -7.681718 -7.989729 -8.373408 -8.662415 -9.018136 -9.285890 -9.622307 0.000000 -0.8565843 -1.692251 -2.373571 -2.953369 -3.456016 -3.958955 -4.403617 -4.855835 -5.304875 -5.662567 -6.071633 -6.403214 -6.781188 -7.087589 -7.438790 -7.793852 -8.050499 -8.379452 -8.614347 -8.922183 0.000000 -0.8067721 -1.594282 -2.226597 -2.762940 -3.229246 -3.698352 -4.109459 -4.531050 -4.895016 -5.275670 -5.654295 -5.953965 -6.305493 -6.582716 -6.906117 -7.159396 -7.460393 -7.763695 -7.970474 -8.255649 0.000000 -0.7568944 -1.496022 -2.078541 -2.573375 -3.004760 -3.440552 -3.820407 -4.209663 -4.544990 -4.894479 -5.245517 -5.518470 -5.841628 -6.089909 -6.387851 -6.616239 -6.894449 -7.100646 -7.357234 -7.620120 0.000000 -0.7069501 -1.397451 -1.929529 -2.385417 -2.782489 -3.186315 -3.532319 -3.894985 -4.198643 -4.522944 -4.796712 -5.091311 -5.386615 -5.612478 -5.887895 -6.096042 -6.349977 -6.535787 -6.768287 -6.935471 0.000000 -0.6569349 -1.298545 -1.780300 -2.199655 -2.561172 -2.933936 -3.252529 -3.582342 -3.862067 -4.157936 -4.403394 -4.672713 -4.946632 -5.151507 -5.404290 -5.591789 -5.820550 -5.983349 -6.189992 -6.339194 0.000000 -0.6068531 -1.199278 -1.631443 -2.015078 -2.345300 -2.685580 -2.973508 -3.277415 -3.530828 -3.796665 -4.018881 -4.267978 -4.517191 -4.702315 -4.929120 -5.093092 -5.295003 -5.442698 -5.632876 -5.769843 0.000000 -0.5567003 -1.099616 -1.483551 -1.815024 -2.130036 -2.441648 -2.698398 -2.977622 -3.202053 -3.442073 -3.646805 -3.871617 -4.094958 -4.257541 -4.454498 -4.600238 -4.789290 -4.926981 -5.105615 -5.236039 0.000000 -0.5064760 -0.9995180 -1.336762 -1.634935 -1.918888 -2.197590 -2.432940 -2.679413 -2.877087 -3.100608 -3.282655 -3.479967 -3.672110 -3.811228 -3.991874 -4.133883 -4.310550 -4.442177 -4.610382 -4.784532 0.000000 -0.4561781 -0.8989358 -1.192276 -1.459005 -1.712243 -1.959490 -2.168783 -2.381499 -2.568377 -2.764184 -2.921062 -3.086049 -3.247216 -3.385369 -3.555779 -3.691748 -3.855020 -4.024274 -4.144273 -4.305806 0.000000 -0.4058054 -0.7977911 -1.050959 -1.282384 -1.505536 -1.727680 -1.905030 -2.099230 -2.263842 -2.429172 -2.581960 -2.690981 -2.848770 -2.983641 -3.139965 -3.302369 -3.425423 -3.581635 -3.700404 -3.848476 0.000000 -0.3553579 -0.6959788 -0.9106010 -1.113623 -1.304197 -1.495797 -1.646345 -1.823195 -1.961352 -2.090895 -2.209822 -2.324116 -2.474357 -2.624707 -2.741522 -2.892851 -3.011436 -3.154609 -3.300926 -3.408495 0.000000 -0.3048325 -0.5935908 -0.7747062 -0.9449090 -1.109130 -1.263521 -1.403373 -1.548886 -1.656933 -1.750865 -1.863017 -1.981432 -2.111982 -2.244141 -2.359005 -2.492829 -2.629469 -2.736429 -2.870203 -3.002219 0.000000 -0.2542296 -0.4911580 -0.6386715 -0.7782232 -0.9139235 -1.041859 -1.161920 -1.274215 -1.360323 -1.428321 -1.544324 -1.660558 -1.758714 -1.876137 -1.998462 -2.100159 -2.217964 -2.340632 -2.437152 -2.547778 0.000000 -0.2035478 -0.3892628 -0.5073612 -0.6181895 -0.7185819 -0.8284080 -0.9207962 -0.9969922 -1.055775 -1.139229 -1.232468 -1.325694 -1.425629 -1.513321 -1.614173 -1.717210 -1.823685 -1.906832 -2.004221 -2.098318 0.000000 -0.1527847 -0.2891945 -0.3758991 -0.4579297 -0.5365290 -0.6160309 -0.6845469 -0.7224581 -0.7886899 -0.8600463 -0.9333967 -0.9975979 -1.075585 -1.155686 -1.238507 -1.309341 -1.389935 -1.468776 -1.546743 -1.626244 0.000000 -0.1019407 -0.1911076 -0.2489645 -0.3019585 -0.3553256 -0.4032230 -0.4401075 -0.4855343 -0.5253707 -0.5726827 -0.6216476 -0.6749560 -0.7306681 -0.7796099 -0.8364813 -0.8933017 -0.9493384 -1.005644 -1.062276 -1.118834 0.000000 -5.1013842E-02 -9.4706319E-02 -0.1230037 -0.1509823 -0.1736618 -0.1966777 -0.2192549 -0.2416274 -0.2647151 -0.2894190 -0.3125910 -0.3397619 -0.3682111 -0.3973670 -0.4267199 -0.4560711 -0.4854709 -0.5147793 -0.5439068 -0.5672346 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.5435632 -1.081397 -1.612453 -2.127995 -2.592959 -3.010497 -3.399886 -3.776212 -4.106828 -4.441535 -4.768661 -5.091616 -5.413033 -5.671635 -5.963332 -6.251617 -6.537842 -6.822063 -7.027896 -7.282268 0.000000 -0.5165744 -1.028090 -1.533546 -2.024027 -2.463894 -2.856924 -3.222918 -3.576984 -3.886079 -4.200124 -4.507148 -4.810512 -5.112722 -5.352294 -5.625170 -5.894752 -6.162333 -6.427910 -6.615125 -6.850901 0.000000 -0.4895696 -0.9747102 -1.454488 -1.919787 -2.334315 -2.702564 -3.044922 -3.376565 -3.664072 -3.957901 -4.245750 -4.530323 -4.814295 -5.035307 -5.290076 -5.541355 -5.791048 -6.038779 -6.207252 -6.425003 0.000000 -0.4625428 -0.9212592 -1.375274 -1.815254 -2.204168 -2.547308 -2.865752 -3.174961 -3.441863 -3.716533 -3.985959 -4.252484 -4.518349 -4.721249 -4.958430 -5.192100 -5.424392 -5.655047 -5.805538 -6.005921 0.000000 -0.4354959 -0.8677346 -1.295902 -1.710406 -2.073393 -2.391048 -2.685361 -2.973308 -3.220555 -3.476434 -3.727977 -3.976506 -4.225443 -4.409800 -4.630385 -4.847704 -5.062850 -5.221093 -5.409783 -5.594248 0.000000 -0.4084334 -0.8141331 -1.216359 -1.605229 -1.941923 -2.233654 -2.504647 -2.772388 -3.000225 -3.238330 -3.471939 -3.703137 -3.895363 -4.103076 -4.306115 -4.506858 -4.706989 -4.848877 -5.021195 -5.189205 0.000000 -0.3813474 -0.7604545 -1.136644 -1.499696 -1.809679 -2.075242 -2.324330 -2.572890 -2.782005 -3.002124 -3.217266 -3.432979 -3.607896 -3.797688 -3.986998 -4.172630 -4.356176 -4.481275 -4.639129 -4.793118 0.000000 -0.3542457 -0.7066929 -1.056752 -1.393789 -1.676566 -1.916542 -2.144973 -2.375347 -2.565466 -2.766656 -2.967116 -3.164652 -3.322974 -3.499828 -3.672125 -3.841141 -4.009584 -4.122608 -4.266445 -4.405890 0.000000 -0.3271199 -0.6528547 -0.9766771 -1.287479 -1.542477 -1.758107 -1.966626 -2.178760 -2.350060 -2.536162 -2.717713 -2.900164 -3.043860 -3.203588 -3.359109 -3.516618 -3.671690 -3.771099 -3.900301 -4.023529 0.000000 -0.2999750 -0.5989336 -0.8964176 -1.180729 -1.407587 -1.600510 -1.790070 -1.985254 -2.138578 -2.306115 -2.472709 -2.639718 -2.765819 -2.911019 -3.056586 -3.198381 -3.303934 -3.423589 -3.536452 -3.647151 0.000000 -0.2728111 -0.5449299 -0.8159651 -1.073504 -1.272353 -1.443880 -1.616551 -1.772844 -1.928639 -2.080044 -2.231456 -2.379392 -2.493223 -2.627235 -2.757087 -2.882770 -2.973165 -3.080043 -3.184598 -3.284546 0.000000 -0.2456243 -0.4908404 -0.7353159 -0.9657453 -1.137333 -1.289367 -1.443940 -1.583818 -1.720671 -1.858205 -1.990154 -2.124601 -2.227906 -2.345889 -2.458996 -2.566634 -2.652170 -2.750555 -2.843499 -2.929792 0.000000 -0.2184196 -0.4366621 -0.6544673 -0.8573831 -1.003210 -1.137822 -1.275281 -1.393836 -1.518632 -1.636330 -1.754893 -1.875708 -1.964443 -2.065040 -2.161391 -2.264991 -2.364802 -2.428202 -2.507151 -2.578301 0.000000 -0.1911916 -0.3823987 -0.5734133 -0.7483087 -0.8706535 -0.9870918 -1.107322 -1.211529 -1.316292 -1.419530 -1.525121 -1.627089 -1.700708 -1.788629 -1.881710 -1.969711 -2.054886 -2.108507 -2.172430 -2.226064 0.000000 -0.1639418 -0.3280472 -0.4921539 -0.6386130 -0.7398745 -0.8406304 -0.9419664 -1.029209 -1.117823 -1.208772 -1.295629 -1.377437 -1.444846 -1.527333 -1.604342 -1.677232 -1.745412 -1.788607 -1.833746 -1.865731 0.000000 -0.1366737 -0.2736052 -0.4106792 -0.5288247 -0.6116729 -0.6939229 -0.7792946 -0.8488501 -0.9255143 -0.9981275 -1.064908 -1.138195 -1.200445 -1.266828 -1.328276 -1.384012 -1.434708 -1.475323 -1.490194 -1.519451 0.000000 -0.1093815 -0.2190714 -0.3289892 -0.4195194 -0.4857544 -0.5517749 -0.6166767 -0.6749933 -0.7333966 -0.7868185 -0.8467149 -0.9070121 -0.9649104 -1.006627 -1.050710 -1.088829 -1.119254 -1.150025 -1.186843 -1.210190 0.000000 -8.2070217E-02 -0.1644431 -0.2470786 -0.3119756 -0.3612071 -0.4093758 -0.4596037 -0.5009302 -0.5431234 -0.5882642 -0.6326357 -0.6760255 -0.7157683 -0.7509315 -0.7703720 -0.7940011 -0.8295535 -0.8604756 -0.8893923 -0.9187338 0.000000 -5.4734509E-02 -0.1097238 -0.1649455 -0.2063512 -0.2387086 -0.2713756 -0.3021811 -0.3309096 -0.3610305 -0.3903831 -0.4184259 -0.4439935 -0.4645307 -0.4857686 -0.5107940 -0.5309795 -0.5553623 -0.5755928 -0.5966628 -0.6192781 0.000000 -2.7376141E-02 -5.4909632E-02 -8.2589149E-02 -0.1023517 -0.1185125 -0.1342554 -0.1501167 -0.1657126 -0.1788708 -0.1915008 -0.2044201 -0.2175112 -0.2302744 -0.2429150 -0.2554598 -0.2680227 -0.2808293 -0.2922968 -0.3049268 -0.3150117 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 13.15758 14.44664 15.21722 15.79023 16.17077 16.37795 16.51295 16.68434 16.83354 16.88316 17.04739 17.11966 17.06704 17.02221 17.06236 17.10906 17.08899 17.12473 17.09569 17.01382 0.000000 13.12449 14.34230 15.07940 15.48724 15.82175 16.08902 16.33618 16.44456 16.58508 16.63243 16.73671 16.74075 16.82649 16.84813 16.74594 16.83132 16.82857 16.73064 16.73021 16.62977 0.000000 13.02847 14.24971 14.92457 15.35509 15.64447 15.97009 16.10273 16.25911 16.37097 16.39981 16.41611 16.51481 16.49113 16.46921 16.50302 16.51708 16.38130 16.28737 16.26213 16.13273 0.000000 12.79957 14.12178 14.76630 15.17778 15.51718 15.67840 15.75485 15.85206 15.93795 15.99393 16.11980 16.13360 16.05403 16.06678 16.01383 16.01585 15.96508 15.85213 15.80182 15.81022 0.000000 12.70964 13.84638 14.45965 14.99948 15.25298 15.42316 15.52849 15.67403 15.72860 15.80187 15.76162 15.70504 15.74127 15.64126 15.58527 15.59714 15.53649 15.52578 15.37926 15.35947 0.000000 12.61224 13.71220 14.34277 14.70361 14.93625 15.08871 15.32865 15.41275 15.34820 15.34447 15.42510 15.38970 15.36178 15.22513 15.20738 15.23137 15.13165 15.08649 15.05164 14.92957 0.000000 12.50736 13.56814 14.16259 14.50377 14.72808 14.91544 14.94279 15.03410 15.02050 15.00214 15.07689 15.04562 14.94686 14.87688 14.86858 14.78075 14.74680 14.62303 14.54829 14.56285 0.000000 12.39469 13.44714 13.98845 14.31530 14.53370 14.54933 14.74614 14.81700 14.70174 14.66267 14.70337 14.68912 14.64588 14.53399 14.49543 14.32563 14.23115 14.24651 14.19728 14.07999 0.000000 12.27361 13.28331 13.66624 14.01666 14.20426 14.36823 14.40727 14.45683 14.35772 14.32262 14.34720 14.31719 14.26640 14.15626 13.99849 13.96849 13.93422 13.81353 13.76928 13.71220 0.000000 12.16731 12.99329 13.51649 13.80436 13.99715 13.99380 14.06289 14.10817 14.01786 13.97785 13.98154 13.94824 13.79328 13.79420 13.64180 13.62455 13.56517 13.43774 13.39528 13.22118 0.000000 11.91566 12.82408 13.31703 13.50309 13.66885 13.77211 13.72659 13.77124 13.67693 13.62047 13.63269 13.52029 13.47554 13.41979 13.31095 13.18877 13.16384 12.99247 12.97096 12.81121 0.000000 11.78035 12.67057 12.98281 13.27179 13.34356 13.43375 13.39136 13.43470 13.31359 13.37771 13.29159 13.12105 13.12050 12.98168 12.89472 12.81413 12.75704 12.66827 12.53580 12.54567 0.000000 11.62941 12.34910 12.80235 12.96191 13.09375 13.09874 13.05246 13.09174 13.04044 12.99941 12.80995 12.82732 12.67397 12.66632 12.59248 12.41637 12.39072 12.35168 12.28155 12.19581 0.000000 11.45961 12.15310 12.45201 12.71649 12.76124 12.75843 12.71384 12.74373 12.66841 12.55994 12.51638 12.40914 12.33367 12.26573 12.21344 12.11904 12.08753 11.99737 11.95587 11.87000 0.000000 11.26602 11.93128 12.24913 12.37357 12.41896 12.41380 12.37119 12.39184 12.21904 12.13457 12.19905 12.12340 11.96467 11.90548 11.86770 11.79654 11.75967 11.68596 11.61408 11.46924 0.000000 10.94870 11.59022 11.86496 11.98674 12.02906 12.06936 12.01368 12.02293 11.89583 11.83506 11.82201 11.72862 11.58953 11.56533 11.51683 11.44749 11.46039 11.36856 11.29300 11.25065 0.000000 10.71101 11.32603 11.58541 11.73476 11.67077 11.72415 11.69840 11.60005 11.55107 11.51729 11.46540 11.42999 11.30815 11.36421 11.34534 11.21815 11.22406 11.24596 11.18033 11.09568 0.000000 10.40531 10.99161 11.17713 11.34079 11.30801 11.37852 11.28241 11.30440 11.33084 11.23618 11.24793 11.15792 11.16821 11.20123 11.19088 11.10287 11.10386 11.14992 11.08015 11.09581 0.000000 9.980562 10.49308 10.78358 10.88539 10.91252 10.99894 10.97419 11.05839 11.00418 10.94460 10.99621 10.93859 10.98292 11.03626 10.98297 11.00735 10.96180 10.99078 11.03636 10.97905 0.000000 9.225478 9.717116 9.906929 9.981739 9.995383 9.969752 9.916174 9.948488 9.886859 9.811372 9.838410 9.735725 9.749757 9.687881 9.675714 9.603725 9.600373 9.527756 9.516774 9.460856 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 12.09401 13.33677 14.02611 14.51105 14.92473 15.17338 15.41176 15.54777 15.71443 15.75125 15.77712 15.87135 15.89249 15.95696 15.89581 15.93021 15.90812 15.78910 15.76068 15.79807 0.000000 12.05856 13.23532 13.94407 14.33276 14.65281 14.90478 15.11374 15.23335 15.36070 15.40149 15.48271 15.49542 15.55026 15.61582 15.62111 15.62225 15.50737 15.52747 15.48689 15.39202 0.000000 11.96351 13.14291 13.79122 14.20335 14.47814 14.78733 14.95770 15.00148 15.04635 15.13734 15.16085 15.21996 15.15836 15.17354 15.15143 15.18610 15.14455 15.14352 15.08655 14.97040 0.000000 11.74863 13.01769 13.63863 14.03089 14.35353 14.43757 14.60902 14.76142 14.80822 14.79062 14.83824 14.79924 14.80201 14.84549 14.81133 14.81512 14.82872 14.78454 14.65837 14.66833 0.000000 11.66032 12.75874 13.34731 13.85355 14.10049 14.25814 14.32720 14.41782 14.48285 14.50325 14.54345 14.57536 14.54662 14.55611 14.43954 14.40182 14.34149 14.37206 14.33674 14.27130 0.000000 11.56468 12.62815 13.19036 13.57830 13.79766 13.94526 14.16663 14.24782 14.17090 14.28318 14.31501 14.24231 14.24347 14.17209 14.03555 14.00140 13.98045 13.99719 13.93454 13.80802 0.000000 11.46175 12.48802 13.05746 13.38381 13.59553 13.76631 13.79318 13.88762 13.87129 13.95329 13.95360 13.82460 13.83118 13.73693 13.73205 13.63172 13.61672 13.55512 13.38303 13.34583 0.000000 11.35121 12.36805 12.88906 13.19992 13.40180 13.41418 13.47285 13.59678 13.55779 13.60273 13.60060 13.46679 13.48535 13.39636 13.38752 13.26824 13.20694 13.08737 13.04560 12.93114 0.000000 11.23251 12.20811 12.58052 12.91391 13.09598 13.19722 13.25274 13.29397 13.22652 13.25112 13.25961 13.13431 13.13603 13.04523 12.88923 12.82915 12.81065 12.74797 12.57026 12.57191 0.000000 11.12626 11.93186 12.43258 12.71587 12.78866 12.88199 12.94500 12.96674 12.89598 12.91981 12.92183 12.77779 12.76560 12.65093 12.54562 12.42953 12.39779 12.25803 12.22561 12.17965 0.000000 10.88515 11.76662 12.23901 12.37655 12.56904 12.66702 12.61890 12.63685 12.56462 12.58531 12.55509 12.44702 12.29759 12.21817 12.23214 12.08745 11.98317 11.91993 11.82804 11.71898 0.000000 10.75201 11.61464 11.91829 12.18607 12.25506 12.33847 12.29255 12.30062 12.23101 12.23063 12.14171 12.01750 11.96380 11.92513 11.81868 11.70292 11.65747 11.49971 11.44331 11.40727 0.000000 10.60336 11.30525 11.73861 11.84639 12.01229 12.01292 11.96139 11.94686 11.88703 11.83351 11.77767 11.72423 11.65789 11.52253 11.44493 11.40162 11.30113 11.16074 11.11408 10.97847 0.000000 10.43598 11.11304 11.40106 11.63936 11.69041 11.68010 11.62967 11.62931 11.57428 11.47170 11.36730 11.29701 11.29337 11.22295 11.10228 10.99501 10.91990 10.79415 10.77649 10.65870 0.000000 10.24499 10.89530 11.16820 11.31906 11.35621 11.33892 11.29593 11.30052 11.14575 11.16842 11.07324 10.91995 10.93927 10.82371 10.77211 10.70225 10.61280 10.51514 10.42640 10.36530 0.000000 10.03598 10.56306 10.82805 10.94430 10.97728 10.96611 10.94932 10.85936 10.82723 10.75938 10.68497 10.63776 10.57836 10.51442 10.48666 10.36306 10.28322 10.22442 10.17660 10.21173 0.000000 9.698576 10.30193 10.55245 10.69050 10.62875 10.63298 10.64064 10.54013 10.48576 10.44290 10.38570 10.34738 10.30684 10.29103 10.22884 10.11242 10.08172 10.06882 10.06449 10.07199 0.000000 9.394378 9.970273 10.15081 10.27972 10.26717 10.30044 10.22767 10.24279 10.25902 10.15896 10.14721 10.17694 10.04853 10.07076 10.06754 9.978470 10.02298 10.00556 10.02987 10.05707 0.000000 8.970449 9.476171 9.753407 9.847862 9.868853 9.941596 9.910686 9.982147 9.919968 9.854796 9.894336 9.930470 9.863403 9.898657 9.830429 9.870672 9.899159 9.831530 9.870716 9.900716 0.000000 8.221788 8.711132 8.900948 8.976201 8.990567 8.965973 8.913276 8.942268 8.881598 8.807178 8.830304 8.730555 8.741290 8.645338 8.656159 8.597013 8.578937 8.521759 8.510704 8.455764 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 11.02959 12.22397 12.88243 13.34149 13.73194 13.94735 14.15195 14.33382 14.42077 14.44728 14.53424 14.54441 14.61151 14.61101 14.65869 14.65141 14.68788 14.55799 14.58746 14.52017 0.000000 10.95650 12.12515 12.76463 13.20733 13.58104 13.79339 13.90320 14.03297 14.15506 14.20849 14.32994 14.37143 14.30111 14.34654 14.33578 14.36969 14.30997 14.25716 14.13745 14.14209 0.000000 10.89792 12.03408 12.65472 13.04716 13.30514 13.57014 13.69809 13.83606 13.91131 13.91533 13.96426 13.95401 13.99207 13.95101 13.94511 13.87959 13.88052 13.81943 13.86630 13.79692 0.000000 10.69706 11.91255 12.50738 12.88394 13.10774 13.25542 13.40201 13.56158 13.61023 13.71202 13.76075 13.77940 13.69882 13.65202 13.64181 13.67085 13.64493 13.55398 13.53177 13.49765 0.000000 10.61062 11.66956 12.23249 12.57995 12.84047 13.08188 13.20708 13.31673 13.40481 13.45226 13.44008 13.33835 13.33918 13.29498 13.32425 13.29167 13.21061 13.07877 13.02317 13.01370 0.000000 10.51698 11.54280 12.08076 12.41400 12.65116 12.88873 12.99904 13.02067 13.11232 13.14173 13.08221 13.01462 12.99597 12.95140 12.97176 12.80463 12.72509 12.75742 12.72119 12.64348 0.000000 10.41614 11.40673 11.95020 12.26028 12.45525 12.59174 12.72472 12.81486 12.81060 12.82025 12.75351 12.67619 12.65527 12.61050 12.49071 12.43596 12.40469 12.39838 12.30955 12.17726 0.000000 10.30783 11.28794 11.77396 12.08032 12.17951 12.38054 12.44454 12.50766 12.49265 12.49479 12.42386 12.33935 12.30223 12.25321 12.14658 12.02970 12.04353 11.99004 11.85616 11.80808 0.000000 10.19152 11.13196 11.49368 11.77683 11.97123 12.07784 12.12836 12.20125 12.17273 12.17023 12.08012 11.98268 11.97038 11.91204 11.76786 11.68663 11.59076 11.57042 11.44977 11.41669 0.000000 10.08536 10.86970 11.34929 11.60153 11.76731 11.77004 11.82852 11.88521 11.85177 11.83897 11.75225 11.65161 11.51484 11.51033 11.44590 11.38461 11.28729 11.21834 11.14993 10.97743 0.000000 9.854641 10.70864 11.14960 11.29160 11.47036 11.54704 11.51593 11.55982 11.52831 11.47966 11.31479 11.27165 11.19580 11.17183 11.10106 11.05052 10.89449 10.86792 10.70627 10.58171 0.000000 9.723652 10.55942 10.85254 11.10278 11.16873 11.24080 11.19580 11.21715 11.17637 11.08355 11.00639 10.95661 10.83246 10.80357 10.72875 10.66717 10.58687 10.47868 10.32372 10.21528 0.000000 9.577351 10.26146 10.67582 10.78068 10.92872 10.92334 10.87360 10.90094 10.74595 10.75690 10.68861 10.61506 10.51057 10.46126 10.41012 10.25463 10.19795 10.07212 9.974028 9.883921 0.000000 9.412448 10.07314 10.35027 10.58038 10.61059 10.59678 10.55255 10.47811 10.40142 10.42191 10.34500 10.24703 10.14635 10.12481 10.02037 9.877167 9.854533 9.753426 9.700207 9.626291 0.000000 9.224076 9.859579 10.12264 10.23104 10.26100 10.23663 10.23065 10.16437 10.08014 10.06511 9.976103 9.940151 9.888829 9.705901 9.706372 9.597535 9.507979 9.487223 9.337506 9.348453 0.000000 9.017118 9.632520 9.791457 9.899838 9.926643 9.910102 9.908267 9.849968 9.783815 9.746513 9.712271 9.589735 9.557971 9.396449 9.409324 9.327836 9.266074 9.178096 9.160251 9.162165 0.000000 8.686146 9.278112 9.520049 9.641050 9.585316 9.583218 9.568398 9.526484 9.486450 9.389159 9.389771 9.266741 9.225506 9.163708 9.129649 9.097391 9.053870 9.019278 8.994018 8.985332 0.000000 8.383537 8.949461 9.125129 9.245089 9.227704 9.252358 9.269123 9.203407 9.176068 9.149198 9.072231 9.050754 8.962866 8.951922 8.975678 8.954702 8.927731 8.835305 8.852925 8.871523 0.000000 7.960644 8.459862 8.724813 8.812281 8.827388 8.887374 8.850534 8.901752 8.840555 8.860060 8.798530 8.818859 8.751592 8.774881 8.793424 8.730992 8.749845 8.701158 8.707911 8.743497 0.000000 7.218423 7.705533 7.895340 7.971090 7.986254 7.962839 7.910956 7.937170 7.877554 7.804266 7.799984 7.727193 7.735185 7.642342 7.650424 7.560116 7.573648 7.564905 7.506310 7.497490 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 9.964192 11.10711 11.73318 12.16951 12.53382 12.75130 12.97145 13.09004 13.22617 13.30752 13.28460 13.39274 13.43645 13.46285 13.39003 13.42870 13.41555 13.32360 13.30646 13.21632 0.000000 9.892631 11.01221 11.62085 12.00764 12.29550 12.55634 12.67649 12.80359 12.92494 13.04342 13.09755 13.17469 13.09012 13.07740 13.10613 13.08088 13.01911 13.01998 13.01890 12.93286 0.000000 9.831956 10.92219 11.51366 11.88913 12.22231 12.41250 12.50515 12.62263 12.68263 12.76675 12.87198 12.83902 12.85322 12.79460 12.79409 12.80805 12.72810 12.65509 12.62505 12.63139 0.000000 9.645073 10.80486 11.37477 11.71275 11.93579 12.13768 12.31707 12.32010 12.48964 12.53275 12.56432 12.56429 12.48654 12.51147 12.49423 12.46768 12.37705 12.33789 12.26296 12.26790 0.000000 9.560634 10.57838 11.11458 11.44381 11.78464 11.92164 12.00699 12.14154 12.18941 12.15397 12.23696 12.26643 12.21044 12.14136 12.12458 12.07470 11.99265 12.00089 11.96179 11.85081 0.000000 9.469216 10.45578 10.96866 11.28448 11.50885 11.71822 11.83108 11.82329 11.86820 11.89594 11.92281 11.92933 11.86083 11.74831 11.66312 11.61178 11.64169 11.60475 11.50318 11.49241 0.000000 9.370651 10.32409 10.84245 11.13485 11.31242 11.43508 11.57120 11.63179 11.65360 11.56905 11.60145 11.61018 11.49524 11.40626 11.31983 11.26690 11.19873 11.15414 11.14622 11.00166 0.000000 9.264687 10.20665 10.67111 10.96152 11.13488 11.24023 11.30060 11.31755 11.33602 11.26196 11.28576 11.18242 11.18595 11.08516 11.01753 10.94893 10.85701 10.81673 10.69460 10.65719 0.000000 9.150859 10.05557 10.40574 10.67278 10.85415 10.94530 11.00255 10.99798 11.02721 10.95218 10.97220 10.86923 10.76314 10.77838 10.68383 10.59307 10.53945 10.45754 10.33977 10.22484 0.000000 9.045373 9.807076 10.23440 10.50184 10.65450 10.73748 10.70248 10.69066 10.71651 10.64340 10.65679 10.53752 10.45999 10.35424 10.27997 10.22446 10.16150 9.997817 9.923895 9.824027 0.000000 8.824378 9.650475 10.07216 10.20620 10.36477 10.43770 10.40030 10.38156 10.40527 10.32930 10.32709 10.25223 10.12124 9.997929 9.984389 9.863936 9.688132 9.637371 9.573037 9.464196 0.000000 8.695479 9.479442 9.787453 10.02466 10.14854 10.14332 10.09072 10.07139 10.08986 9.992240 9.982924 9.907313 9.737745 9.723832 9.575131 9.442664 9.334453 9.276638 9.171833 9.059031 0.000000 8.551529 9.313493 9.614023 9.712541 9.846828 9.832596 9.781389 9.753905 9.764423 9.712124 9.616212 9.527599 9.452097 9.349557 9.191849 9.074034 9.034533 8.914914 8.841516 8.741202 0.000000 8.389149 9.033855 9.300058 9.505601 9.542023 9.489369 9.473226 9.417705 9.436018 9.329605 9.249469 9.137549 9.072477 9.001619 8.872531 8.760619 8.724942 8.655216 8.555051 8.488407 0.000000 8.203438 8.824520 9.077833 9.178987 9.202859 9.173723 9.161207 9.092155 9.097629 8.934587 8.943913 8.851315 8.749397 8.641497 8.551221 8.460775 8.401439 8.368052 8.284643 8.235564 0.000000 7.987046 8.596963 8.755665 8.856683 8.877399 8.855526 8.847318 8.785232 8.716410 8.638333 8.631746 8.550678 8.417086 8.363416 8.286467 8.226107 8.134837 8.090079 8.102179 8.072369 0.000000 7.673824 8.254769 8.488623 8.601700 8.543311 8.534978 8.515590 8.466969 8.423928 8.364205 8.306664 8.249002 8.141199 8.101485 8.021685 7.980352 7.957779 7.907200 7.942742 7.855535 0.000000 7.372930 7.929376 8.100341 8.212059 8.189874 8.206115 8.213372 8.185924 8.106743 8.087746 7.997848 7.961994 7.948542 7.913014 7.832964 7.806314 7.800265 7.814357 7.792463 7.717444 0.000000 6.951368 7.444256 7.697992 7.778831 7.788189 7.836423 7.794549 7.835941 7.766059 7.772521 7.712029 7.711857 7.726025 7.654486 7.664318 7.615694 7.612446 7.626928 7.569477 7.583289 0.000000 6.215890 6.700642 6.890390 6.966673 6.982808 6.960473 6.981709 6.933653 6.875204 6.872018 6.797727 6.726365 6.732076 6.642357 6.648544 6.628886 6.573164 6.555633 6.507396 6.498335 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 8.896158 9.983935 10.57654 11.07075 11.36998 11.59402 11.68258 11.82421 11.87473 11.95254 12.03555 12.05501 12.10781 12.10187 12.13322 12.08148 12.09548 12.06468 12.07487 12.00459 0.000000 8.827212 9.894294 10.47075 10.83427 11.10101 11.34517 11.46147 11.57779 11.66884 11.69113 11.75838 11.75027 11.77882 11.86647 11.88189 11.87590 11.89588 11.89378 11.80385 11.69671 0.000000 8.765136 9.806085 10.37009 10.69474 10.94770 11.17967 11.28358 11.42573 11.48243 11.56055 11.53670 11.63543 11.66981 11.62019 11.57156 11.54543 11.53287 11.43940 11.40155 11.40673 0.000000 8.592089 9.695473 10.22449 10.55469 10.76493 10.91723 11.09286 11.20944 11.22656 11.26613 11.34310 11.38217 11.37848 11.36973 11.28087 11.21219 11.18135 11.12439 11.09798 11.10501 0.000000 8.509781 9.483718 9.992416 10.30384 10.60585 10.79836 10.91462 10.97267 10.97166 11.03883 11.03904 11.05120 11.04527 10.92758 10.87927 10.86721 10.86191 10.77385 10.73678 10.68618 0.000000 8.420787 9.365824 9.853912 10.15028 10.44007 10.55593 10.62295 10.67407 10.78491 10.71950 10.76381 10.68449 10.63874 10.64824 10.61759 10.54035 10.50238 10.37747 10.32972 10.23521 0.000000 8.324731 9.238992 9.706357 10.00564 10.18147 10.28493 10.42816 10.47025 10.47994 10.42540 10.45497 10.36254 10.30247 10.30658 10.26772 10.14102 10.12613 10.00700 9.946056 9.856058 0.000000 8.221351 9.124496 9.565879 9.835329 10.00074 10.08724 10.15084 10.16138 10.14028 10.10726 10.12857 10.04317 10.02431 9.950566 9.839723 9.770079 9.650316 9.637810 9.568474 9.541747 0.000000 8.110189 8.973430 9.315783 9.566176 9.735086 9.816113 9.866060 9.854771 9.842126 9.807201 9.762819 9.747215 9.693243 9.581964 9.455737 9.399433 9.312593 9.309258 9.237033 9.125751 0.000000 7.990489 8.743289 9.151578 9.400683 9.541468 9.616706 9.580169 9.561481 9.545481 9.509354 9.473505 9.413769 9.311625 9.217034 9.139643 9.076547 9.035179 8.906826 8.801323 8.676571 0.000000 7.794286 8.591359 8.991042 9.119275 9.265830 9.335318 9.289920 9.265799 9.248833 9.208615 9.142907 8.995473 8.993740 8.906163 8.791374 8.727378 8.637227 8.491212 8.438258 8.338350 0.000000 7.667463 8.425386 8.720474 8.944562 9.052624 9.043243 8.993337 8.967902 8.947586 8.889977 8.769990 8.686816 8.686074 8.540925 8.423593 8.369134 8.284202 8.157284 8.073783 8.045187 0.000000 7.525886 8.258764 8.527289 8.644176 8.767711 8.818969 8.693805 8.668115 8.627752 8.544754 8.478683 8.410337 8.355554 8.219533 8.137726 8.018209 7.910157 7.863498 7.804765 7.747214 0.000000 7.366104 7.994097 8.334357 8.443636 8.475494 8.523125 8.393334 8.362968 8.330747 8.218798 8.190236 8.111951 8.032259 7.927108 7.832286 7.735085 7.655391 7.557081 7.499891 7.453775 0.000000 7.183140 7.789261 8.033214 8.127389 8.232203 8.211624 8.093050 8.039084 7.951434 7.933412 7.827478 7.777236 7.701887 7.624123 7.517761 7.454225 7.389827 7.293262 7.240760 7.159487 0.000000 6.969660 7.565896 7.801581 7.897146 7.920571 7.881570 7.789801 7.723511 7.643884 7.563804 7.539747 7.447598 7.379338 7.305797 7.226319 7.185819 7.126359 7.065341 6.938458 6.882528 0.000000 6.661899 7.231919 7.457996 7.563886 7.589713 7.487750 7.478198 7.412837 7.353438 7.293277 7.247610 7.194248 7.111497 7.056433 7.007895 6.968705 6.909154 6.806567 6.764871 6.736605 0.000000 6.362959 6.910150 7.076560 7.180477 7.226370 7.161809 7.155355 7.133166 7.044213 7.006489 6.987885 6.933277 6.846176 6.815739 6.782888 6.783624 6.684180 6.668418 6.653207 6.668431 0.000000 5.943251 6.429691 6.673126 6.747583 6.751285 6.788080 6.752842 6.758086 6.696298 6.693246 6.694863 6.620886 6.616167 6.604526 6.544610 6.549107 6.486576 6.486235 6.488621 6.502353 0.000000 5.215541 5.697286 5.886768 5.963555 5.980810 5.959431 5.974273 5.932251 5.875139 5.869915 5.798483 5.728770 5.713717 5.704608 5.631361 5.625527 5.556345 5.559496 5.549235 5.503891 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 7.821029 8.852685 9.412012 9.866092 10.12900 10.29274 10.47886 10.57222 10.67574 10.71860 10.78826 10.80040 10.84229 10.83268 10.86170 10.84285 10.85142 10.77114 10.75098 10.66903 0.000000 7.758262 8.769691 9.313289 9.656706 9.910041 10.13080 10.24834 10.38109 10.42172 10.47848 10.52682 10.62093 10.65964 10.67600 10.63150 10.63566 10.59292 10.58769 10.53522 10.54298 0.000000 7.695950 8.687667 9.197765 9.525253 9.736309 9.976044 10.07249 10.19670 10.25432 10.31575 10.32406 10.38023 10.38020 10.39859 10.39782 10.39532 10.34384 10.29468 10.21827 10.21904 0.000000 7.537126 8.575992 9.081419 9.391473 9.587234 9.723113 9.877166 10.01455 10.00177 10.05026 10.04984 10.06416 10.03767 10.01028 9.999251 10.02862 9.999735 10.00392 9.903072 9.817029 0.000000 7.457377 8.385222 8.866027 9.251383 9.439257 9.559875 9.723654 9.748818 9.746527 9.801733 9.768826 9.745984 9.735378 9.777861 9.762383 9.712045 9.668868 9.640762 9.585415 9.504662 0.000000 7.371143 8.272760 8.734425 9.011953 9.274511 9.387218 9.444664 9.489580 9.564734 9.528274 9.543986 9.501806 9.487602 9.404511 9.377587 9.306819 9.271546 9.242688 9.174771 9.140020 0.000000 7.277878 8.151461 8.593471 8.874389 9.036138 9.129452 9.254792 9.268599 9.256693 9.238685 9.226662 9.194913 9.154558 9.160029 9.063020 9.051286 8.999719 8.892067 8.836406 8.718678 0.000000 7.177356 8.021439 8.458179 8.708682 8.859161 8.939208 8.980127 8.986654 8.966414 8.957829 8.925058 8.899437 8.859989 8.844302 8.770080 8.696910 8.599309 8.494474 8.382838 8.329933 0.000000 7.069186 7.895337 8.223423 8.457506 8.591371 8.683081 8.715904 8.723303 8.685994 8.674804 8.622462 8.608971 8.549059 8.497672 8.354403 8.282269 8.214319 8.097733 7.983013 7.923423 0.000000 6.952541 7.678353 8.065830 8.297859 8.422171 8.490181 8.511141 8.445875 8.403568 8.385833 8.374683 8.300282 8.185612 8.165752 8.018090 7.972613 7.883970 7.752362 7.649639 7.590936 0.000000 6.834988 7.531723 7.910522 8.032603 8.143545 8.215990 8.232670 8.168101 8.115748 8.076008 8.071750 7.998862 7.878187 7.807175 7.740420 7.621373 7.489777 7.388735 7.308258 7.178297 0.000000 6.639835 7.371347 7.653307 7.861979 7.957837 7.922855 7.959716 7.881102 7.821453 7.809884 7.748207 7.617188 7.507305 7.463053 7.380084 7.220332 7.129524 7.033971 6.924685 6.887328 0.000000 6.500713 7.208084 7.466532 7.576617 7.682432 7.722052 7.671336 7.591248 7.505949 7.505099 7.376081 7.294846 7.215878 7.098199 7.017102 6.922369 6.837193 6.725742 6.671316 6.548319 0.000000 6.343665 6.954835 7.273606 7.383689 7.382401 7.440495 7.373907 7.297271 7.200538 7.194159 7.077907 6.998223 6.889756 6.785153 6.703047 6.604296 6.550249 6.457057 6.358806 6.266384 0.000000 6.163647 6.754752 6.990046 7.078790 7.165132 7.145142 7.059907 7.000227 6.909523 6.868918 6.767902 6.700642 6.549450 6.465544 6.388710 6.365201 6.250625 6.167156 6.106688 6.030641 0.000000 5.953300 6.522977 6.758660 6.843243 6.858112 6.835961 6.779549 6.689850 6.611822 6.540310 6.453510 6.392081 6.263198 6.195229 6.175808 6.101514 6.010825 5.949797 5.907419 5.853642 0.000000 5.651203 6.210226 6.428906 6.509080 6.538072 6.508162 6.455812 6.356969 6.294407 6.210448 6.145830 6.099316 6.017528 5.972107 5.911759 5.853665 5.818415 5.754624 5.701376 5.669572 0.000000 5.354776 5.892556 6.054534 6.151075 6.182584 6.120495 6.107951 6.072984 6.028351 5.944190 5.898977 5.848252 5.808438 5.730339 5.687768 5.654243 5.637214 5.610336 5.583805 5.578146 0.000000 4.938063 5.417205 5.651143 5.719337 5.778125 5.744475 5.703044 5.699023 5.688100 5.620979 5.609907 5.535607 5.522021 5.509636 5.444160 5.433104 5.420043 5.364790 5.366950 5.373183 0.000000 4.221023 4.697686 4.886242 4.963361 4.981549 4.961061 4.975261 4.934515 4.878926 4.862926 4.803921 4.789581 4.721312 4.708498 4.641491 4.634957 4.569203 4.557096 4.556166 4.548800 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 6.739146 7.714107 8.240237 8.659492 8.899633 9.039795 9.204612 9.328173 9.449026 9.537298 9.547174 9.517412 9.536043 9.578767 9.577826 9.600508 9.577378 9.526863 9.523843 9.456706 0.000000 6.681777 7.637036 8.148949 8.469208 8.766172 8.918111 9.098825 9.205000 9.279332 9.342936 9.354281 9.395025 9.385298 9.342367 9.338548 9.293582 9.286465 9.235335 9.212065 9.218007 0.000000 6.623086 7.544197 8.042234 8.348148 8.633388 8.754779 8.825131 8.900405 9.049365 9.088523 9.099155 9.096161 9.106485 9.134606 9.127170 9.082077 9.081222 9.043365 8.968120 8.967233 0.000000 6.479681 7.457520 7.932989 8.222320 8.406015 8.530171 8.669769 8.801286 8.791666 8.795623 8.823400 8.798633 8.812178 8.780992 8.788904 8.751068 8.732249 8.672794 8.641563 8.631742 0.000000 6.403294 7.282676 7.734590 8.092292 8.266300 8.373590 8.499866 8.538039 8.594177 8.562828 8.577579 8.543065 8.541628 8.564337 8.528679 8.505292 8.457096 8.436157 8.371277 8.273500 0.000000 6.320104 7.176126 7.610641 7.869261 8.107850 8.203469 8.247345 8.298317 8.349171 8.323688 8.314541 8.333133 8.337185 8.313676 8.228937 8.203476 8.112144 7.995463 7.932765 7.854271 0.000000 6.230074 7.060918 7.477556 7.721310 7.888156 7.971661 8.075235 8.090436 8.064491 8.072692 8.047365 8.043915 8.033503 7.940857 7.919026 7.794958 7.712879 7.658323 7.566056 7.526972 0.000000 6.132826 6.937179 7.348135 7.582193 7.719997 7.787816 7.820764 7.823991 7.880492 7.802745 7.771885 7.763945 7.660542 7.632370 7.571033 7.438582 7.379499 7.295309 7.235048 7.156533 0.000000 6.027936 6.815351 7.129439 7.346526 7.468180 7.549478 7.637373 7.578170 7.611374 7.530446 7.493111 7.402309 7.342618 7.278502 7.200463 7.124734 7.028832 6.955494 6.857546 6.791572 0.000000 5.914752 6.612640 6.979150 7.193917 7.306000 7.355428 7.380648 7.314384 7.335537 7.251533 7.204114 7.106404 7.064892 6.985332 6.900450 6.789267 6.697598 6.584764 6.513350 6.437680 0.000000 5.799353 6.471725 6.829717 6.943896 7.042912 7.105540 7.116467 7.049401 7.060075 6.955907 6.905868 6.845806 6.761662 6.642710 6.524747 6.470248 6.338861 6.227654 6.181310 6.047239 0.000000 5.613264 6.317317 6.586561 6.761652 6.864308 6.828256 6.855665 6.775326 6.763612 6.672128 6.629083 6.533836 6.424250 6.316048 6.234579 6.133742 6.030059 5.942973 5.845106 5.728559 0.000000 5.476890 6.158853 6.406776 6.508826 6.604719 6.626936 6.581864 6.497297 6.417137 6.401297 6.283593 6.208207 6.077939 6.019305 5.930029 5.803344 5.736081 5.655249 5.550824 5.460708 0.000000 5.322902 5.916945 6.219599 6.302999 6.317639 6.355759 6.299179 6.216046 6.131922 6.101538 5.991861 5.909947 5.786786 5.721625 5.592993 5.539572 5.438419 5.355868 5.287170 5.211420 0.000000 5.146273 5.722063 5.948149 6.030602 6.100260 6.071450 6.007748 5.929617 5.839382 5.778827 5.673351 5.600162 5.494482 5.410246 5.311667 5.268645 5.179936 5.090042 5.007407 4.952361 0.000000 4.939641 5.495999 5.723917 5.801691 5.810670 5.773964 5.701527 5.635959 5.559604 5.449790 5.355403 5.281578 5.197330 5.150821 5.073333 4.992476 4.914025 4.874085 4.819438 4.798561 0.000000 4.691381 5.191067 5.402643 5.476741 5.500312 5.458061 5.409537 5.338775 5.272144 5.167542 5.090136 5.008196 4.945649 4.891011 4.821010 4.758381 4.700170 4.647973 4.647731 4.618168 0.000000 4.351550 4.878493 5.088813 5.125320 5.157589 5.134797 5.046216 5.017779 4.964966 4.865180 4.814670 4.779607 4.720314 4.677668 4.606631 4.560299 4.524601 4.494428 4.466804 4.451753 0.000000 3.940615 4.409701 4.634412 4.696139 4.743335 4.706923 4.709605 4.646691 4.623909 4.555661 4.532057 4.505520 4.427844 4.411974 4.383830 4.331070 4.319008 4.302608 4.288616 4.288063 0.000000 3.241946 3.707759 3.893473 3.970146 3.988576 3.968729 3.983134 3.943674 3.889691 3.874235 3.817187 3.794304 3.737589 3.715481 3.661095 3.643647 3.632553 3.581365 3.570557 3.569648 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 5.658283 6.572767 7.063716 7.448886 7.669860 7.877233 7.946578 8.090893 8.175406 8.208251 8.262743 8.270546 8.308850 8.310096 8.331999 8.319869 8.294024 8.247766 8.242792 8.184304 0.000000 5.600894 6.498242 6.976909 7.273971 7.545750 7.690169 7.833514 7.954994 7.970481 7.996241 8.033537 8.052732 8.081385 8.073853 8.082006 8.108326 8.098298 8.073077 8.002923 7.994997 0.000000 5.536796 6.412357 6.878437 7.163235 7.423815 7.528564 7.686084 7.702453 7.796262 7.841507 7.835591 7.838427 7.890545 7.884120 7.912009 7.851501 7.828136 7.766860 7.736554 7.733284 0.000000 5.417471 6.331869 6.779010 7.048673 7.273849 7.392471 7.448691 7.543882 7.639038 7.666109 7.658971 7.679755 7.689908 7.674570 7.594662 7.583904 7.550552 7.461390 7.434164 7.433468 0.000000 5.346991 6.174767 6.597661 6.921932 7.077875 7.172837 7.318913 7.395789 7.395882 7.385573 7.377005 7.410592 7.392518 7.336745 7.293882 7.225879 7.194911 7.197745 7.158018 7.119039 0.000000 5.268652 6.075709 6.482557 6.721923 6.939981 7.027471 7.131034 7.151325 7.122284 7.158110 7.124156 7.113277 7.051581 7.005063 6.985353 6.939729 6.907785 6.860168 6.781497 6.692916 0.000000 5.182492 5.967575 6.358151 6.583627 6.718977 6.862552 6.902469 6.897189 6.958271 6.919716 6.863544 6.835201 6.771550 6.728326 6.699578 6.618185 6.590882 6.466358 6.423624 6.355910 0.000000 5.088923 5.850849 6.236276 6.446353 6.568528 6.633999 6.658458 6.721794 6.714810 6.662125 6.599088 6.562926 6.499233 6.450692 6.413341 6.291423 6.200054 6.123785 6.058522 6.017122 0.000000 4.987713 5.734610 6.033645 6.234246 6.343142 6.464153 6.486435 6.477779 6.456348 6.402876 6.325390 6.293753 6.215047 6.157631 6.037657 5.950244 5.875863 5.807122 5.730881 5.637031 0.000000 4.878487 5.546484 5.891614 6.074920 6.186085 6.226391 6.239717 6.222113 6.198829 6.140719 6.083041 6.009492 5.943452 5.809448 5.744850 5.637592 5.542137 5.449240 5.349587 5.232276 0.000000 4.759856 5.411732 5.735559 5.915832 5.942865 5.979878 6.001629 5.967521 5.937726 5.870876 5.804735 5.696285 5.607348 5.498312 5.445078 5.329024 5.237049 5.109305 5.023185 4.903595 0.000000 4.589773 5.264078 5.521676 5.681499 5.764921 5.791898 5.748881 5.707280 5.669002 5.585941 5.509112 5.403273 5.324894 5.192380 5.134754 4.998904 4.862535 4.795071 4.705311 4.630984 0.000000 4.456895 5.101294 5.349393 5.501345 5.510360 5.540032 5.489654 5.440988 5.382079 5.287715 5.188973 5.110651 4.985924 4.926955 4.796692 4.681944 4.587727 4.519579 4.457597 4.394247 0.000000 4.306901 4.881757 5.167980 5.246760 5.256317 5.281855 5.222196 5.166713 5.055582 4.969554 4.872629 4.816473 4.702748 4.619955 4.503971 4.438842 4.345284 4.282770 4.223254 4.146782 0.000000 4.134827 4.692980 4.910066 4.986030 5.042168 5.010307 4.947383 4.880521 4.779321 4.701118 4.602505 4.516315 4.412607 4.352294 4.251664 4.186819 4.100915 4.057009 3.984033 3.911927 0.000000 3.933446 4.473773 4.680827 4.751005 4.750913 4.726637 4.661853 4.572933 4.496333 4.426327 4.341135 4.253816 4.153938 4.076666 3.994178 3.954982 3.892916 3.822685 3.757479 3.698411 0.000000 3.691667 4.178066 4.382084 4.450187 4.450358 4.426884 4.360802 4.294530 4.214040 4.141729 4.067628 3.982501 3.915055 3.846160 3.781505 3.721299 3.663564 3.608797 3.552997 3.512683 0.000000 3.361929 3.872967 4.067456 4.106694 4.117314 4.098347 4.017532 3.960800 3.915933 3.858028 3.795314 3.701626 3.648822 3.601874 3.552114 3.511477 3.468736 3.435385 3.402845 3.379080 0.000000 2.963795 3.451591 3.629114 3.683439 3.713098 3.684098 3.665487 3.604458 3.572912 3.541125 3.467713 3.435523 3.398868 3.329393 3.307895 3.275623 3.253860 3.237775 3.192910 3.181205 0.000000 2.302656 2.742942 2.920712 2.994291 3.011322 3.028351 3.006031 2.967387 2.946994 2.900254 2.874106 2.823451 2.798316 2.748303 2.724967 2.680506 2.663870 2.652048 2.613519 2.606211 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 4.585131 5.433364 5.885845 6.226449 6.420317 6.597384 6.687540 6.787039 6.824968 6.884448 6.925714 6.925618 6.937112 6.911460 6.905025 6.935323 6.927954 6.890957 6.882546 6.897005 0.000000 4.526872 5.359852 5.802571 6.074615 6.314257 6.429697 6.553889 6.661819 6.697412 6.743984 6.797119 6.798347 6.780375 6.785676 6.755244 6.736004 6.728529 6.692273 6.673084 6.675142 0.000000 4.462777 5.277499 5.709552 5.972481 6.201500 6.312490 6.434931 6.465335 6.528967 6.582692 6.591456 6.605975 6.628563 6.598778 6.560756 6.572837 6.552480 6.498767 6.484836 6.450691 0.000000 4.353570 5.201082 5.607000 5.853854 6.015605 6.177241 6.232274 6.314331 6.387320 6.358245 6.372596 6.380360 6.389664 6.355350 6.374527 6.346646 6.314521 6.265801 6.227508 6.209318 0.000000 4.288105 5.060193 5.511815 5.748580 5.894780 6.027194 6.080365 6.155473 6.148866 6.183438 6.190559 6.182419 6.174554 6.153881 6.091311 6.056652 6.038296 5.971571 5.899505 5.860805 0.000000 4.216252 4.970779 5.350698 5.571423 5.763073 5.837687 5.932529 5.925828 5.981032 5.947609 5.952235 5.942167 5.923605 5.887735 5.810361 5.777150 5.709757 5.651484 5.619976 5.567592 0.000000 4.136775 4.872262 5.236599 5.444059 5.566424 5.691604 5.718677 5.723875 5.768301 5.724734 5.710730 5.693633 5.659098 5.610227 5.562742 5.486588 5.424521 5.317838 5.250566 5.195402 0.000000 4.049545 4.764296 5.112959 5.319869 5.427757 5.482282 5.547694 5.551242 5.540660 5.485476 5.463755 5.432546 5.347438 5.315058 5.260667 5.158448 5.041047 4.985924 4.888966 4.803760 0.000000 3.953614 4.647101 4.988661 5.122720 5.221204 5.321405 5.327639 5.324105 5.304312 5.242828 5.212625 5.125275 5.086252 5.026845 4.917097 4.802698 4.723116 4.631142 4.545073 4.466767 0.000000 3.849138 4.481793 4.805505 4.974789 5.059916 5.101782 5.105276 5.091710 5.063125 4.993935 4.955239 4.859303 4.777030 4.719915 4.591023 4.508238 4.436193 4.339402 4.219162 4.098417 0.000000 3.735656 4.354704 4.659874 4.819775 4.896246 4.873873 4.869565 4.852468 4.816037 4.732804 4.685079 4.603823 4.508321 4.398736 4.290597 4.224357 4.114884 3.973376 3.865256 3.778634 0.000000 3.614529 4.215224 4.506641 4.605025 4.678132 4.691699 4.630151 4.607210 4.553126 4.482151 4.388985 4.291543 4.205895 4.118703 4.006159 3.910556 3.772774 3.693989 3.594553 3.487360 0.000000 3.448013 4.061226 4.296738 4.431444 4.440506 4.456058 4.383997 4.355688 4.297096 4.178420 4.119691 3.992863 3.910979 3.824452 3.723584 3.598485 3.509052 3.422837 3.328560 3.270930 0.000000 3.304191 3.894647 4.114350 4.194988 4.241994 4.199308 4.131279 4.095789 3.994123 3.912298 3.840405 3.714904 3.639674 3.533579 3.432437 3.327127 3.274650 3.176348 3.121475 3.039605 0.000000 3.139753 3.673871 3.880124 3.990029 3.984680 3.941393 3.870247 3.822180 3.729816 3.656439 3.551636 3.435688 3.371237 3.266878 3.173812 3.101527 3.041417 2.972463 2.884497 2.798964 0.000000 2.947682 3.463948 3.660605 3.723155 3.718132 3.671176 3.601138 3.518359 3.459779 3.360084 3.267045 3.184144 3.115250 3.027981 2.942697 2.866100 2.817740 2.745806 2.667659 2.632498 0.000000 2.718125 3.214117 3.374531 3.435150 3.429307 3.385354 3.316490 3.241781 3.172807 3.089658 3.009418 2.924129 2.856362 2.797262 2.732135 2.669463 2.609169 2.545612 2.495165 2.475833 0.000000 2.434033 2.889666 3.072241 3.136387 3.107072 3.070850 3.027474 2.962418 2.869354 2.804613 2.740841 2.679009 2.619416 2.564735 2.512821 2.460698 2.416489 2.374050 2.342783 2.319516 0.000000 2.039719 2.489452 2.651492 2.723983 2.715232 2.705661 2.650892 2.612747 2.544426 2.495497 2.455014 2.382010 2.340785 2.301147 2.263734 2.236204 2.180348 2.161325 2.144756 2.133451 0.000000 1.456985 1.840494 1.998438 2.062197 2.073817 2.088633 2.064177 2.024678 2.004226 1.957980 1.930438 1.883084 1.856303 1.810946 1.788994 1.767340 1.732112 1.718290 1.706535 1.697477 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 3.531146 4.303128 4.711366 5.012033 5.182573 5.330948 5.402211 5.487649 5.565922 5.603936 5.604251 5.613013 5.617336 5.647848 5.639561 5.617145 5.622488 5.603666 5.595018 5.550459 0.000000 3.473696 4.232718 4.634023 4.927065 5.080887 5.227439 5.295595 5.378399 5.455309 5.500706 5.530082 5.524170 5.533285 5.512583 5.503053 5.466265 5.445896 5.457911 5.446807 5.402496 0.000000 3.409856 4.154292 4.545505 4.780637 4.978823 5.072206 5.164902 5.244760 5.311751 5.339087 5.324355 5.344493 5.328135 5.312572 5.295621 5.287763 5.286430 5.256620 5.242868 5.190102 0.000000 3.341870 4.070811 4.450686 4.676644 4.872114 4.959352 5.060948 5.115854 5.115810 5.145613 5.162755 5.162870 5.144263 5.138348 5.097025 5.051956 5.039270 4.997778 4.960203 4.937172 0.000000 3.243266 3.989075 4.357530 4.566942 4.744402 4.828815 4.863764 4.920349 4.959793 4.937750 4.947449 4.940421 4.903374 4.872751 4.871249 4.828771 4.766737 4.717036 4.682284 4.627563 0.000000 3.174469 3.865247 4.216085 4.464081 4.585957 4.644054 4.720622 4.725337 4.755835 4.772283 4.773190 4.713964 4.706470 4.666132 4.600711 4.529807 4.485739 4.462006 4.390211 4.317700 0.000000 3.101233 3.776989 4.115029 4.305834 4.414278 4.516594 4.534861 4.567390 4.548519 4.556762 4.547966 4.475797 4.443046 4.370022 4.323711 4.294074 4.235357 4.138111 4.060532 3.968761 0.000000 3.022498 3.681053 4.004704 4.182881 4.280444 4.325402 4.381520 4.369123 4.337618 4.338179 4.309367 4.248061 4.187019 4.111522 4.069208 3.990066 3.903435 3.829858 3.733672 3.619910 0.000000 2.936458 3.575861 3.890083 4.054612 4.139854 4.174006 4.179754 4.163435 4.123679 4.105281 4.045352 3.993498 3.932411 3.860082 3.764049 3.683217 3.594194 3.484839 3.373309 3.275683 0.000000 2.841164 3.465063 3.726341 3.878903 3.950253 3.971354 3.971890 3.955553 3.902828 3.837611 3.801088 3.718012 3.659194 3.561153 3.479800 3.355858 3.255996 3.144806 3.053471 2.954395 0.000000 2.737347 3.310985 3.593086 3.736157 3.795625 3.809230 3.799030 3.735414 3.676785 3.607491 3.528848 3.475136 3.375394 3.276392 3.163005 3.083905 2.967237 2.865237 2.780804 2.691951 0.000000 2.622546 3.182089 3.445546 3.540495 3.588754 3.599841 3.579956 3.509188 3.444847 3.371455 3.287524 3.194530 3.089899 2.991441 2.890885 2.793823 2.684093 2.603804 2.513694 2.405530 0.000000 2.473454 3.039874 3.259934 3.371448 3.413983 3.375855 3.352883 3.275602 3.205683 3.126537 3.032709 2.939185 2.827447 2.734051 2.625150 2.533720 2.436695 2.350731 2.262952 2.181055 0.000000 2.340307 2.881001 3.090065 3.159995 3.194346 3.146339 3.116111 3.033652 2.957722 2.869212 2.763772 2.679105 2.582610 2.471345 2.378598 2.278153 2.191547 2.122722 2.042223 1.960068 0.000000 2.189620 2.682503 2.903605 2.961732 2.955864 2.905810 2.868135 2.782262 2.698867 2.599905 2.519265 2.418142 2.312713 2.226389 2.130796 2.058563 1.988002 1.915668 1.835530 1.752066 0.000000 2.015704 2.487998 2.668314 2.720345 2.706377 2.652629 2.605733 2.518977 2.431318 2.350614 2.251548 2.159236 2.066123 1.977042 1.911999 1.835683 1.778535 1.704974 1.634115 1.583880 0.000000 1.810804 2.257975 2.430334 2.476902 2.436318 2.384118 2.313844 2.234476 2.168331 2.085710 1.999944 1.913112 1.833652 1.763193 1.704083 1.640134 1.574666 1.516504 1.465621 1.434049 0.000000 1.562095 1.963200 2.123855 2.168452 2.135154 2.091534 2.028565 1.959693 1.890947 1.813790 1.744230 1.657019 1.593353 1.547516 1.493057 1.440737 1.388602 1.346270 1.308643 1.279690 0.000000 1.234300 1.608811 1.742556 1.793018 1.775699 1.746497 1.703624 1.637059 1.581118 1.527357 1.456587 1.403741 1.351972 1.307437 1.266384 1.225719 1.179968 1.154437 1.130607 1.111419 0.000000 0.7904570 1.073460 1.191571 1.245879 1.252676 1.236625 1.205246 1.179115 1.137320 1.103452 1.059382 1.025958 0.9838267 0.9551905 0.9181755 0.8957612 0.8763987 0.8513470 0.8382805 0.8299814 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 2.519481 3.194767 3.549353 3.801374 3.938950 4.068907 4.167691 4.229458 4.247465 4.277640 4.313758 4.320070 4.344676 4.345902 4.322761 4.297380 4.300577 4.284394 4.274447 4.236195 0.000000 2.467708 3.132503 3.481539 3.727345 3.860165 3.984431 4.040334 4.099574 4.146701 4.182858 4.210877 4.211733 4.211121 4.228698 4.216926 4.224494 4.196993 4.165849 4.159902 4.163523 0.000000 2.409002 3.059940 3.399917 3.600270 3.761752 3.875795 3.924049 3.970996 4.017567 4.054734 4.067935 4.075228 4.057510 4.045364 4.047151 4.012700 3.998058 3.997033 3.974218 3.953372 0.000000 2.344629 2.980509 3.309526 3.502339 3.655974 3.723536 3.806085 3.848577 3.888923 3.904506 3.909084 3.899427 3.896337 3.873702 3.856991 3.806104 3.769269 3.739657 3.723792 3.696577 0.000000 2.255727 2.897900 3.214544 3.402892 3.515221 3.613049 3.676882 3.688408 3.707411 3.715852 3.719995 3.703352 3.688596 3.647563 3.605887 3.575310 3.519880 3.469540 3.450612 3.411774 0.000000 2.189545 2.786944 3.123767 3.300617 3.403668 3.495868 3.517887 3.549181 3.529443 3.522326 3.520379 3.476686 3.440281 3.408924 3.361673 3.312534 3.264304 3.216808 3.144578 3.091546 0.000000 2.119979 2.704155 3.001438 3.168802 3.292963 3.333250 3.377598 3.363398 3.379070 3.364505 3.309270 3.276196 3.231393 3.161500 3.109601 3.042610 2.989426 2.905704 2.831765 2.761388 0.000000 2.046959 2.617915 2.906051 3.061020 3.140526 3.205236 3.203460 3.215299 3.178349 3.153651 3.097350 3.044519 2.963612 2.901241 2.826709 2.762391 2.689445 2.605191 2.499825 2.410615 0.000000 1.970198 2.527241 2.802739 2.943764 3.010417 3.031445 3.053619 3.029353 2.981716 2.917164 2.850928 2.791626 2.730814 2.656862 2.580248 2.470759 2.390586 2.297156 2.188826 2.082340 0.000000 1.889040 2.430692 2.666741 2.795082 2.848171 2.887379 2.870875 2.838153 2.781173 2.708386 2.631210 2.563445 2.476601 2.402222 2.288872 2.201602 2.093192 1.995441 1.881517 1.789917 0.000000 1.802559 2.304662 2.551068 2.663526 2.703566 2.708107 2.680806 2.641352 2.574020 2.494002 2.414335 2.340350 2.236140 2.132285 2.026084 1.933248 1.825312 1.715317 1.621732 1.523827 0.000000 1.709262 2.194163 2.422293 2.523479 2.528510 2.519617 2.484965 2.437245 2.356984 2.272165 2.188572 2.089309 1.987055 1.877744 1.770162 1.667840 1.561673 1.472662 1.375610 1.280378 0.000000 1.603616 2.071868 2.260431 2.348446 2.369554 2.326934 2.285425 2.221371 2.144718 2.040507 1.940431 1.843370 1.732447 1.633064 1.528854 1.427355 1.331691 1.239068 1.148732 1.057304 0.000000 1.475424 1.934515 2.111583 2.185855 2.172984 2.148378 2.074669 2.003098 1.913447 1.811012 1.709348 1.595410 1.495223 1.397366 1.288765 1.198751 1.112207 1.028424 0.9442376 0.8641550 0.000000 1.351597 1.764033 1.944497 1.988368 1.969189 1.936352 1.853968 1.759243 1.672299 1.576050 1.470872 1.357243 1.263295 1.165340 1.079084 0.9967600 0.9167587 0.8322005 0.7605235 0.6977798 0.000000 1.210737 1.597771 1.744750 1.776581 1.769356 1.710584 1.623108 1.528225 1.425319 1.337221 1.231137 1.130824 1.048113 0.9581574 0.8802491 0.7980424 0.7299094 0.6555633 0.5987118 0.5482633 0.000000 1.049878 1.405152 1.537435 1.561260 1.530487 1.469513 1.380350 1.288684 1.192182 1.097997 1.003012 0.9138841 0.8391858 0.7608712 0.6850505 0.6215469 0.5546342 0.4975142 0.4531372 0.4088628 0.000000 0.8638374 1.166188 1.284686 1.303696 1.270475 1.209116 1.131166 1.035994 0.9597936 0.8648341 0.7829484 0.7054200 0.6401368 0.5702206 0.5071244 0.4485793 0.3954400 0.3544280 0.3177848 0.2852043 0.000000 0.6365713 0.8949864 0.9916556 1.000750 0.9725782 0.9130551 0.8505409 0.7802204 0.7114692 0.6331498 0.5671992 0.5010612 0.4413866 0.3843066 0.3343672 0.2866467 0.2464579 0.2147451 0.1886299 0.1654249 0.000000 0.3657198 0.5295838 0.6006978 0.6125290 0.5950054 0.5601242 0.5227973 0.4749257 0.4294713 0.3756675 0.3298610 0.2837164 0.2410705 0.1994140 0.1632970 0.1292243 0.1035441 8.3308078E-02 6.5729521E-02 5.0540432E-02 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 1.600329 2.146770 2.436758 2.635342 2.749256 2.842950 2.908613 2.962096 2.988699 3.014126 3.018414 3.018206 3.013156 3.020683 3.007315 2.984209 2.973193 2.948848 2.929565 2.917963 0.000000 1.557879 2.094027 2.379220 2.573658 2.685296 2.776639 2.841748 2.893864 2.920475 2.942605 2.952986 2.960858 2.949353 2.942260 2.946196 2.939968 2.931816 2.913465 2.898069 2.872660 0.000000 1.510169 2.031415 2.307167 2.493078 2.589802 2.674936 2.733571 2.777281 2.802744 2.800877 2.816407 2.809857 2.808589 2.814694 2.807620 2.781631 2.762882 2.748398 2.716837 2.696041 0.000000 1.458042 1.962119 2.225354 2.374415 2.486846 2.569180 2.598247 2.627149 2.648461 2.656687 2.650676 2.664572 2.655079 2.631764 2.599243 2.574908 2.558811 2.527477 2.481286 2.446709 0.000000 1.386004 1.888011 2.136539 2.278973 2.386688 2.429854 2.476087 2.501225 2.510170 2.506772 2.491560 2.473492 2.439516 2.405604 2.381746 2.341820 2.314557 2.256100 2.201155 2.152987 0.000000 1.329188 1.809205 2.045989 2.182084 2.257294 2.313743 2.351871 2.338145 2.336776 2.321498 2.294570 2.263391 2.217596 2.170003 2.135133 2.083304 2.029947 1.964754 1.893005 1.831104 0.000000 1.270257 1.713197 1.956802 2.083057 2.147008 2.192677 2.187525 2.189974 2.173852 2.124585 2.084120 2.041776 1.985914 1.927538 1.856852 1.789639 1.723579 1.645160 1.560459 1.464658 0.000000 1.208545 1.634604 1.850152 1.963941 2.033665 2.039823 2.044121 2.010426 1.983773 1.923768 1.871702 1.817851 1.753174 1.666656 1.596784 1.506257 1.409613 1.316535 1.222193 1.125986 0.000000 1.144559 1.554067 1.760838 1.861024 1.892585 1.904801 1.874603 1.830593 1.792044 1.720559 1.657297 1.589760 1.498634 1.417287 1.317304 1.218769 1.121991 1.019816 0.9201950 0.8195149 0.000000 1.078336 1.471739 1.667508 1.750061 1.765475 1.746434 1.706830 1.650297 1.596804 1.515452 1.444227 1.353397 1.263697 1.165279 1.055170 0.9532489 0.8518273 0.7478021 0.6393005 0.5368952 0.000000 1.010045 1.387099 1.557112 1.619836 1.620860 1.587866 1.538384 1.470624 1.392701 1.320099 1.226318 1.135508 1.030734 0.9216812 0.8108193 0.7075203 0.5984649 0.4957166 0.3946202 0.2935320 0.000000 0.9390174 1.289287 1.457050 1.500125 1.488573 1.443033 1.369276 1.292707 1.207536 1.114287 1.014397 0.9173643 0.8068964 0.6949627 0.5851948 0.4814801 0.3754499 0.2740665 0.1745103 7.4405976E-02 0.000000 0.8656073 1.202722 1.344439 1.363136 1.338153 1.282198 1.201076 1.116622 1.023954 0.9228951 0.8171406 0.7057873 0.5951227 0.4858584 0.3784845 0.2757317 0.1729077 7.4181028E-02 -2.3585442E-02 -0.1223646 0.000000 0.7814936 1.110969 1.216019 1.234304 1.185983 1.122567 1.033189 0.9415612 0.8405250 0.7362978 0.6193213 0.5084540 0.3994392 0.2932504 0.1898910 8.7876849E-02 -9.2685027E-03 -0.1056225 -0.2006259 -0.2925425 0.000000 0.7038158 0.9988877 1.092748 1.088893 1.041311 0.9611555 0.8648247 0.7666598 0.6612832 0.5469630 0.4356944 0.3255383 0.2196728 0.1164567 1.4734394E-02 -8.0701053E-02 -0.1728686 -0.2635221 -0.3497467 -0.4266865 0.000000 0.6208227 0.8694673 0.9502531 0.9457935 0.8833573 0.7972090 0.6957085 0.5914860 0.4796674 0.3703077 0.2581989 0.1531454 5.2001089E-02 -4.6429887E-02 -0.1409866 -0.2282988 -0.3126495 -0.3947906 -0.4655362 -0.5333782 0.000000 0.5191077 0.7382675 0.8077602 0.7863509 0.7203349 0.6298609 0.5264129 0.4205921 0.3103105 0.2008801 9.6822150E-02 -2.1048863E-03 -9.8268084E-02 -0.1889775 -0.2734112 -0.3514737 -0.4279880 -0.4976292 -0.5583883 -0.6136820 0.000000 0.4084883 0.5916747 0.6418735 0.6170661 0.5507351 0.4608216 0.3605131 0.2551638 0.1532667 5.0204288E-02 -4.5975044E-02 -0.1377430 -0.2240539 -0.3051890 -0.3789569 -0.4472341 -0.5166520 -0.5719895 -0.6197087 -0.6626961 0.000000 0.2841619 0.4231232 0.4630891 0.4341615 0.3738444 0.2938411 0.2049055 0.1123036 2.1787126E-02 -6.9104940E-02 -0.1515006 -0.2338483 -0.3062106 -0.3783119 -0.4397258 -0.4972175 -0.5516324 -0.5926552 -0.6305236 -0.6616520 0.000000 0.1515053 0.2307547 0.2522552 0.2326361 0.1917626 0.1370690 7.6213643E-02 1.1468753E-02 -5.1891346E-02 -0.1152069 -0.1758229 -0.2332726 -0.2865310 -0.3382605 -0.3813898 -0.4246697 -0.4589367 -0.4875342 -0.5156094 -0.5344033 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.8503405 1.249907 1.477665 1.609771 1.686029 1.742201 1.781191 1.796674 1.814868 1.823820 1.819165 1.803674 1.786976 1.767146 1.759112 1.736695 1.725903 1.706359 1.677905 1.660792 0.000000 0.8140429 1.204358 1.414999 1.557159 1.636992 1.696716 1.738028 1.764516 1.773178 1.785274 1.788684 1.777268 1.779884 1.766750 1.747808 1.730190 1.726759 1.710803 1.694899 1.674370 0.000000 0.7747316 1.149464 1.351532 1.485623 1.560574 1.616886 1.655562 1.678862 1.689788 1.691696 1.687441 1.680964 1.676643 1.656340 1.653563 1.639919 1.630561 1.615071 1.589015 1.562504 0.000000 0.7344278 1.088774 1.276503 1.399508 1.468774 1.518979 1.553527 1.569335 1.572421 1.573433 1.558971 1.545101 1.532307 1.514737 1.497946 1.478732 1.446262 1.421149 1.388115 1.347167 0.000000 0.6927349 1.022874 1.193967 1.306209 1.365637 1.410416 1.419668 1.426705 1.424155 1.415250 1.405605 1.381551 1.360147 1.323432 1.285868 1.248023 1.198455 1.158759 1.105065 1.055197 0.000000 0.6507226 0.9527986 1.107425 1.196317 1.256596 1.277333 1.287238 1.284503 1.268830 1.243576 1.212211 1.183688 1.139515 1.085084 1.031578 0.9772559 0.9132991 0.8531445 0.7811157 0.7141655 0.000000 0.6079473 0.8799586 1.018469 1.093470 1.137995 1.143451 1.140029 1.120115 1.091296 1.051793 1.004871 0.9477156 0.8880309 0.8187699 0.7468556 0.6766081 0.5938802 0.5084322 0.4214373 0.3292342 0.000000 0.5640813 0.7983273 0.9267105 0.9834653 0.9995961 0.9985287 0.9671006 0.9331205 0.8882281 0.8308545 0.7666891 0.6935486 0.6152174 0.5312299 0.4420686 0.3508507 0.2502768 0.1465829 3.8767092E-02 -7.4725620E-02 0.000000 0.5192119 0.7262442 0.8234789 0.8668910 0.8632795 0.8340514 0.7952152 0.7433211 0.6722380 0.5987086 0.5156412 0.4263190 0.3311454 0.2308473 0.1253890 1.2876973E-02 -0.1043403 -0.2244226 -0.3451137 -0.4663290 0.000000 0.4735611 0.6534852 0.7271196 0.7374083 0.7197000 0.6715497 0.6129901 0.5366148 0.4535707 0.3584956 0.2594141 0.1543198 4.4715770E-02 -7.1501628E-02 -0.1944482 -0.3171858 -0.4418478 -0.5646530 -0.6848365 -0.8063635 0.000000 0.4276986 0.5801519 0.6272517 0.6126719 0.5657809 0.5030043 0.4208205 0.3269008 0.2270301 0.1193933 5.5695446E-03 -0.1125569 -0.2351974 -0.3628634 -0.4882119 -0.6133668 -0.7360398 -0.8519611 -0.9755087 -1.088530 0.000000 0.3820091 0.5068153 0.5254512 0.4854488 0.4167533 0.3294773 0.2293192 0.1215641 5.3204503E-03 -0.1142623 -0.2367135 -0.3644097 -0.4908572 -0.6195616 -0.7414933 -0.8696699 -0.9814908 -1.088311 -1.206415 -1.306246 0.000000 0.3369005 0.4342366 0.4200044 0.3558748 0.2661835 0.1619940 4.5128539E-02 -7.8474902E-02 -0.2038736 -0.3310375 -0.4582907 -0.5908252 -0.7130213 -0.8383759 -0.9614965 -1.068634 -1.170773 -1.282451 -1.384552 -1.486942 0.000000 0.2923593 0.3596516 0.3232640 0.2359227 0.1258665 2.6482360E-03 -0.1280759 -0.2619687 -0.3900308 -0.5200823 -0.6523303 -0.7816653 -0.8972991 -1.016191 -1.128370 -1.225610 -1.330828 -1.437755 -1.528662 -1.623659 0.000000 0.2482806 0.2903831 0.2318608 0.1246272 -2.7904655E-03 -0.1402164 -0.2800268 -0.4182001 -0.5470862 -0.6774836 -0.8062809 -0.9277974 -1.043271 -1.147397 -1.248786 -1.347594 -1.446035 -1.543775 -1.622625 -1.708190 0.000000 0.2031141 0.2243427 0.1473730 2.7611995E-02 -0.1110898 -0.2558146 -0.3994047 -0.5374141 -0.6685200 -0.8029449 -0.9255359 -1.039119 -1.149270 -1.240165 -1.333431 -1.428783 -1.518561 -1.605083 -1.687296 -1.762749 0.000000 0.1609109 0.1633314 7.8370877E-02 -4.8324473E-02 -0.1907141 -0.3388606 -0.4818685 -0.6173558 -0.7432941 -0.8741275 -0.9884725 -1.095013 -1.200440 -1.292091 -1.381783 -1.466573 -1.550000 -1.622682 -1.693562 -1.754766 0.000000 0.1191892 0.1080161 2.5027234E-02 -9.5510066E-02 -0.2323338 -0.3707171 -0.5099800 -0.6393700 -0.7613369 -0.8840296 -0.9907971 -1.091655 -1.184956 -1.272667 -1.366374 -1.442960 -1.512505 -1.578544 -1.634070 -1.682220 0.000000 7.7997424E-02 6.2367197E-02 -8.4486520E-03 -0.1083127 -0.2222013 -0.3422305 -0.4588528 -0.5774566 -0.6874155 -0.7966908 -0.8922195 -0.9951419 -1.076871 -1.156325 -1.239595 -1.302950 -1.381299 -1.432558 -1.476059 -1.517815 0.000000 3.8031612E-02 2.5571512E-02 -1.7663863E-02 -7.8041464E-02 -0.1479396 -0.2233153 -0.3018782 -0.3821283 -0.4630931 -0.5366969 -0.6134119 -0.6884696 -0.7523032 -0.8193429 -0.8747973 -0.9325266 -0.9872851 -1.025740 -1.060069 -1.098455 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.5586118 0.8268853 0.9612616 1.042280 1.077083 1.095949 1.101720 1.096124 1.083849 1.066965 1.047643 1.029324 1.002291 0.9762009 0.9474643 0.9238433 0.9008141 0.8690073 0.8420880 0.8157792 0.000000 0.5364496 0.8032932 0.9430731 1.031075 1.074546 1.101939 1.114777 1.119314 1.110654 1.101751 1.087668 1.074413 1.052556 1.031395 1.012138 0.9959833 0.9699527 0.9490040 0.9278877 0.9025031 0.000000 0.5111309 0.7702759 0.9090417 0.9966440 1.040125 1.067255 1.079944 1.082899 1.077042 1.061437 1.047783 1.035818 1.016255 0.9978346 0.9773806 0.9587431 0.9309602 0.9081203 0.8858373 0.8639323 0.000000 0.4849838 0.7313033 0.8638440 0.9449790 0.9839926 1.007283 1.018566 1.016733 1.006934 0.9919948 0.9744192 0.9591861 0.9346968 0.9161807 0.8848460 0.8517456 0.8213374 0.7910254 0.7591050 0.7274096 0.000000 0.4567728 0.6877628 0.8093780 0.8812509 0.9132960 0.9338394 0.9302805 0.9248645 0.9124378 0.8924360 0.8748223 0.8442968 0.8158079 0.7778912 0.7391211 0.6997702 0.6620088 0.6150519 0.5690476 0.5220276 0.000000 0.4272023 0.6401512 0.7477131 0.8020414 0.8353845 0.8415135 0.8399920 0.8278328 0.8049948 0.7742219 0.7374237 0.7024799 0.6551254 0.6103913 0.5571753 0.5009418 0.4444467 0.3843094 0.3181818 0.2462162 0.000000 0.3966098 0.5829871 0.6807959 0.7252698 0.7495228 0.7463530 0.7347690 0.7076559 0.6722820 0.6287240 0.5787025 0.5230569 0.4623505 0.4013861 0.3315177 0.2582623 0.1784821 9.1771074E-02 -2.0233940E-03 -0.1037699 0.000000 0.3654014 0.5302010 0.6097265 0.6429155 0.6485489 0.6388726 0.6055637 0.5651422 0.5154909 0.4573446 0.3915722 0.3196936 0.2444515 0.1598147 6.8832822E-02 -2.9560383E-02 -0.1353908 -0.2495356 -0.3682376 -0.4900568 0.000000 0.3335908 0.4750457 0.5307055 0.5549209 0.5452651 0.5177341 0.4691301 0.4128691 0.3457336 0.2704770 0.1866192 9.5907204E-02 -3.2254944E-03 -0.1096075 -0.2237176 -0.3427914 -0.4665895 -0.5926377 -0.7192230 -0.8465487 0.000000 0.3015360 0.4184809 0.4556944 0.4564770 0.4325513 0.3817575 0.3196533 0.2428534 0.1587561 6.5227531E-02 -3.7404809E-02 -0.1482882 -0.2682425 -0.3903019 -0.5167744 -0.6464794 -0.7744034 -0.9030646 -1.025788 -1.152256 0.000000 0.2695841 0.3612300 0.3781181 0.3581526 0.3084645 0.2414567 0.1581505 6.5457925E-02 -3.7343372E-02 -0.1501195 -0.2704210 -0.3983311 -0.5262616 -0.6575884 -0.7908241 -0.9201331 -1.045099 -1.165902 -1.286482 -1.415136 0.000000 0.2377716 0.3038505 0.2990646 0.2552822 0.1833067 9.3309209E-02 -7.6501979E-03 -0.1191144 -0.2384855 -0.3677688 -0.4997230 -0.6328828 -0.7641414 -0.9067011 -1.032759 -1.153791 -1.274009 -1.398348 -1.512001 -1.629786 0.000000 0.2063061 0.2479241 0.2198605 0.1507068 5.5418812E-02 -5.4690588E-02 -0.1744822 -0.3011252 -0.4344886 -0.5733438 -0.7091996 -0.8441432 -0.9846082 -1.115502 -1.237690 -1.349448 -1.469535 -1.586539 -1.692263 -1.808873 0.000000 0.1755586 0.1926952 0.1414251 4.8081357E-02 -6.9317654E-02 -0.1985977 -0.3351483 -0.4731303 -0.6147732 -0.7589536 -0.8949121 -1.033929 -1.167310 -1.278761 -1.399218 -1.505421 -1.611694 -1.724254 -1.838951 -1.948047 0.000000 0.1457168 0.1428738 6.9643371E-02 -4.6591733E-02 -0.1835396 -0.3285531 -0.4762585 -0.6252375 -0.7689414 -0.9131681 -1.051612 -1.182677 -1.294630 -1.414124 -1.525858 -1.615468 -1.720982 -1.829237 -1.930173 -2.022649 0.000000 0.1159250 9.7622290E-02 6.1911205E-03 -0.1264193 -0.2790588 -0.4352529 -0.5906622 -0.7346815 -0.8857349 -1.024691 -1.154372 -1.276703 -1.382784 -1.492680 -1.594142 -1.689315 -1.801536 -1.898288 -1.986331 -2.065708 0.000000 8.8816933E-02 5.8671698E-02 -4.3326341E-02 -0.1836964 -0.3416954 -0.5002047 -0.6558458 -0.8005974 -0.9494003 -1.080748 -1.202967 -1.317736 -1.423893 -1.525665 -1.618745 -1.708752 -1.812475 -1.897363 -1.971207 -2.039760 0.000000 6.3414142E-02 2.6593063E-02 -7.3653139E-02 -0.2078970 -0.3580612 -0.5090594 -0.6616650 -0.7998829 -0.9399475 -1.063602 -1.177863 -1.295314 -1.394439 -1.488494 -1.573031 -1.667880 -1.746105 -1.813773 -1.879371 -1.934284 0.000000 3.9824378E-02 4.8126238E-03 -7.9783462E-02 -0.1905389 -0.3155080 -0.4452951 -0.5703744 -0.6975708 -0.8211806 -0.9312542 -1.043357 -1.138325 -1.242493 -1.323087 -1.399172 -1.486129 -1.549668 -1.622285 -1.673161 -1.720064 0.000000 1.8452512E-02 -4.7977809E-03 -5.6047283E-02 -0.1234031 -0.1999176 -0.2786292 -0.3617545 -0.4461165 -0.5307427 -0.6149494 -0.6897352 -0.7680171 -0.8439814 -0.9075409 -0.9746341 -1.038585 -1.086663 -1.140512 -1.178298 -1.222101 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.4630724 0.6560697 0.7453263 0.7864800 0.7909289 0.7826674 0.7641290 0.7397636 0.7093967 0.6781746 0.6476250 0.6148561 0.5819256 0.5507165 0.5162295 0.4809261 0.4502964 0.4192352 0.3871939 0.3572592 0.000000 0.4482546 0.6499593 0.7505867 0.8012706 0.8163317 0.8185797 0.8103049 0.7960033 0.7754743 0.7506099 0.7251783 0.7004812 0.6738625 0.6470860 0.6184025 0.5944003 0.5664396 0.5390099 0.5126957 0.4881577 0.000000 0.4330738 0.6409655 0.7364360 0.7891985 0.8073300 0.8121801 0.8066826 0.7931480 0.7717206 0.7481294 0.7220952 0.7016228 0.6746676 0.6524704 0.6235682 0.5978391 0.5721726 0.5452540 0.5211515 0.4926027 0.000000 0.4154376 0.6155619 0.7081406 0.7593685 0.7753236 0.7800046 0.7664084 0.7492662 0.7284512 0.7118978 0.6858559 0.6622810 0.6319189 0.6017609 0.5711827 0.5406091 0.5100248 0.4764881 0.4429622 0.4085026 0.000000 0.3928051 0.5839180 0.6708273 0.7113923 0.7294032 0.7306972 0.7131445 0.6956146 0.6733536 0.6455925 0.6199206 0.5848975 0.5509132 0.5110045 0.4718572 0.4280344 0.3864314 0.3424392 0.2965919 0.2482895 0.000000 0.3686351 0.5424455 0.6270270 0.6603019 0.6718409 0.6609718 0.6470793 0.6246874 0.5941894 0.5579231 0.5172585 0.4721146 0.4270190 0.3758035 0.3247841 0.2713777 0.2132587 0.1502696 8.1537083E-02 6.6359085E-03 0.000000 0.3443336 0.5036574 0.5766317 0.5999985 0.5987675 0.5884917 0.5660294 0.5316014 0.4909236 0.4437920 0.3910453 0.3331844 0.2715922 0.2082088 0.1397110 6.4146630E-02 -1.7850967E-02 -0.1082825 -0.2060350 -0.3110769 0.000000 0.3180533 0.4612117 0.5150282 0.5330273 0.5244853 0.5033523 0.4630545 0.4179268 0.3644938 0.3036154 0.2362526 0.1652190 8.7426037E-02 3.7589108E-03 -8.9257389E-02 -0.1894340 -0.2968476 -0.4111666 -0.5308869 -0.6535460 0.000000 0.2911435 0.4161521 0.4546689 0.4603498 0.4404605 0.4010317 0.3518739 0.2918369 0.2222641 0.1452593 6.1025772E-02 -2.8536433E-02 -0.1268618 -0.2332203 -0.3464735 -0.4650309 -0.5901123 -0.7179641 -0.8466020 -0.9715710 0.000000 0.2635036 0.3690298 0.3901474 0.3791256 0.3469803 0.2919961 0.2260630 0.1475313 6.1919775E-02 -3.2518763E-02 -0.1340935 -0.2423713 -0.3597463 -0.4836062 -0.6077706 -0.7427335 -0.8734089 -1.005946 -1.135018 -1.262307 0.000000 0.2356856 0.3200144 0.3230687 0.2961133 0.2424969 0.1719742 8.6905703E-02 -7.1828328E-03 -0.1105956 -0.2229730 -0.3403399 -0.4669739 -0.5976766 -0.7282704 -0.8587683 -0.9976808 -1.126832 -1.254052 -1.391142 -1.515218 0.000000 0.2077800 0.2693448 0.2545802 0.2078808 0.1340601 4.2739529E-02 -5.9668455E-02 -0.1710989 -0.2905304 -0.4171748 -0.5489135 -0.6911724 -0.8251754 -0.9571044 -1.086677 -1.223527 -1.347220 -1.478526 -1.609555 -1.739422 0.000000 0.1799339 0.2190843 0.1840684 0.1165482 2.0869164E-02 -9.0438932E-02 -0.2098401 -0.3389449 -0.4699662 -0.6087886 -0.7545941 -0.8916419 -1.025824 -1.160425 -1.288020 -1.418271 -1.533607 -1.663270 -1.785957 -1.895632 0.000000 0.1527274 0.1696016 0.1167109 2.4743723E-02 -9.2511676E-02 -0.2222534 -0.3581935 -0.5017627 -0.6407562 -0.7870488 -0.9346051 -1.068102 -1.202691 -1.323241 -1.447306 -1.572923 -1.693037 -1.812182 -1.908228 -2.011689 0.000000 0.1251872 0.1246117 5.1657259E-02 -6.2010773E-02 -0.2004115 -0.3469273 -0.4928090 -0.6444863 -0.7918282 -0.9396473 -1.082467 -1.217117 -1.333761 -1.457958 -1.573919 -1.687876 -1.798180 -1.904338 -2.004652 -2.097506 0.000000 0.1003793 8.3652891E-02 -6.8158214E-03 -0.1369377 -0.2901753 -0.4473900 -0.6055472 -0.7541847 -0.9093192 -1.052202 -1.186902 -1.312789 -1.430235 -1.542648 -1.656872 -1.758109 -1.857435 -1.948920 -2.034811 -2.114029 0.000000 7.6502435E-02 4.8369747E-02 -5.2816574E-02 -0.1920066 -0.3516955 -0.5126663 -0.6722459 -0.8215199 -0.9747609 -1.110057 -1.232840 -1.354062 -1.463063 -1.566424 -1.678369 -1.774029 -1.860907 -1.938780 -2.012559 -2.081112 0.000000 5.4207169E-02 1.9160928E-02 -8.0919780E-02 -0.2156647 -0.3684126 -0.5227008 -0.6793318 -0.8214820 -0.9650416 -1.091762 -1.207242 -1.328241 -1.429637 -1.525487 -1.628897 -1.714132 -1.787567 -1.859694 -1.922403 -2.001994 0.000000 3.3705000E-02 -2.6139847E-04 -8.5515931E-02 -0.1976704 -0.3252485 -0.4579359 -0.5858834 -0.7157266 -0.8416055 -0.9538315 -1.067631 -1.164503 -1.269842 -1.352352 -1.444032 -1.515787 -1.581895 -1.655450 -1.713832 -1.778312 0.000000 1.5379213E-02 -7.5125550E-03 -5.9597392E-02 -0.1282222 -0.2062731 -0.2864564 -0.3709460 -0.4565200 -0.5422153 -0.6273569 -0.7034070 -0.7825859 -0.8593345 -0.9242412 -0.9920988 -1.056668 -1.106221 -1.160620 -1.211619 -1.244198 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.3458002 0.5148606 0.5904056 0.6020664 0.5813835 0.5498424 0.5107872 0.4671928 0.4213340 0.3780810 0.3334928 0.2867832 0.2420152 0.1990875 0.1567142 0.1165755 7.7133812E-02 3.8931083E-02 1.6103017E-03 -3.6060799E-02 0.000000 0.3490947 0.5305929 0.6133836 0.6367266 0.6294690 0.6116094 0.5862244 0.5561357 0.5225606 0.4870463 0.4545771 0.4180204 0.3837048 0.3511840 0.3162473 0.2833773 0.2523504 0.2214817 0.1924830 0.1631341 0.000000 0.3512561 0.5376369 0.6192307 0.6425565 0.6454595 0.6337554 0.6141596 0.5874978 0.5552475 0.5230173 0.4932342 0.4596815 0.4289137 0.3951390 0.3646834 0.3342450 0.3036267 0.2742362 0.2439375 0.2138277 0.000000 0.3598319 0.5292420 0.6112649 0.6356381 0.6393072 0.6294863 0.6038167 0.5765799 0.5467066 0.5199275 0.4860577 0.4538541 0.4184089 0.3859194 0.3485645 0.3121078 0.2770368 0.2408134 0.2062861 0.1700956 0.000000 0.3503214 0.5141034 0.5918593 0.6141083 0.6167718 0.5995960 0.5776737 0.5506167 0.5193599 0.4833401 0.4483272 0.4076019 0.3687565 0.3246735 0.2823524 0.2385356 0.1929684 0.1455049 9.6080303E-02 4.1879151E-02 0.000000 0.3321140 0.4918100 0.5632011 0.5815647 0.5803822 0.5593382 0.5352998 0.5037517 0.4642888 0.4209917 0.3753949 0.3293717 0.2767442 0.2242780 0.1693699 0.1111443 4.8674744E-02 -1.9345755E-02 -9.3767039E-02 -0.1748088 0.000000 0.3126814 0.4642059 0.5221654 0.5395841 0.5274011 0.5065764 0.4755093 0.4302846 0.3830342 0.3341132 0.2770526 0.2150501 0.1513675 8.3662473E-02 1.0460862E-02 -7.0147216E-02 -0.1575198 -0.2504512 -0.3500212 -0.4540198 0.000000 0.2937854 0.4316142 0.4807085 0.4888119 0.4698903 0.4399194 0.3949459 0.3441146 0.2856015 0.2201855 0.1485973 7.3178977E-02 -7.7680494E-03 -9.5496148E-02 -0.1928661 -0.2968569 -0.4028158 -0.5165029 -0.6355697 -0.7541835 0.000000 0.2705111 0.3953284 0.4330480 0.4267525 0.4019742 0.3569209 0.3037690 0.2395384 0.1659776 8.5280567E-02 -2.6635779E-03 -9.6164815E-02 -0.1966547 -0.3052421 -0.4203095 -0.5405461 -0.6645172 -0.7905336 -0.9204329 -1.044542 0.000000 0.2464736 0.3565961 0.3799326 0.3623450 0.3206100 0.2654532 0.1971098 0.1160018 2.7256818E-02 -7.0250385E-02 -0.1749159 -0.2859196 -0.4051218 -0.5297957 -0.6568272 -0.7861658 -0.9179303 -1.052141 -1.179271 -1.318626 0.000000 0.2236606 0.3153846 0.3222814 0.2904215 0.2338871 0.1615504 7.6004587E-02 -2.0311713E-02 -0.1269033 -0.2398521 -0.3585034 -0.4896690 -0.6216117 -0.7555622 -0.8893886 -1.021251 -1.154141 -1.282884 -1.418338 -1.555379 0.000000 0.1987226 0.2718513 0.2590091 0.2122616 0.1380693 4.7080174E-02 -5.5260591E-02 -0.1679343 -0.2908173 -0.4158543 -0.5524039 -0.6922855 -0.8291791 -0.9669093 -1.109212 -1.235280 -1.371784 -1.494438 -1.635062 -1.746641 0.000000 0.1743076 0.2252158 0.1973629 0.1285344 3.5530288E-02 -7.4062996E-02 -0.1941018 -0.3217621 -0.4578870 -0.5935392 -0.7405964 -0.8824034 -1.029969 -1.158964 -1.295376 -1.416499 -1.547044 -1.679198 -1.788919 -1.894689 0.000000 0.1481944 0.1810872 0.1339784 4.4316947E-02 -6.9923647E-02 -0.1972170 -0.3321723 -0.4751610 -0.6160024 -0.7644129 -0.9143263 -1.062212 -1.192174 -1.325241 -1.439537 -1.566823 -1.689957 -1.811072 -1.908799 -2.013051 0.000000 0.1240545 0.1376825 7.1720935E-02 -3.8110580E-02 -0.1733069 -0.3170441 -0.4611011 -0.6143025 -0.7640297 -0.9153141 -1.060718 -1.200572 -1.319494 -1.443259 -1.563375 -1.681053 -1.793476 -1.900636 -2.002016 -2.095553 0.000000 0.1001916 9.7017333E-02 1.4272084E-02 -0.1123226 -0.2625657 -0.4175325 -0.5745772 -0.7256487 -0.8837371 -1.030715 -1.167884 -1.294164 -1.410668 -1.522901 -1.647141 -1.751495 -1.851028 -1.943840 -2.030598 -2.110731 0.000000 7.6952823E-02 6.1078813E-02 -3.2962281E-02 -0.1697469 -0.3271033 -0.4868811 -0.6465823 -0.7984428 -0.9546329 -1.092871 -1.221130 -1.339923 -1.452529 -1.557653 -1.671167 -1.767076 -1.853732 -1.933460 -2.007925 -2.078081 0.000000 5.4890513E-02 3.0051578E-02 -6.4440615E-02 -0.1979268 -0.3498399 -0.5041462 -0.6616678 -0.8058000 -0.9515781 -1.080138 -1.198614 -1.319679 -1.422222 -1.519181 -1.624106 -1.705189 -1.782681 -1.849552 -1.919773 -1.999079 0.000000 3.4414645E-02 7.8122607E-03 -7.4374400E-02 -0.1864843 -0.3139057 -0.4472336 -0.5759616 -0.7071200 -0.8342037 -0.9472631 -1.061975 -1.159508 -1.265585 -1.348669 -1.440909 -1.515177 -1.579704 -1.653698 -1.712274 -1.776898 0.000000 1.5855793E-02 -3.1870035E-03 -5.4255605E-02 -0.1231006 -0.2016248 -0.2822418 -0.3672589 -0.4533668 -0.5395218 -0.6250643 -0.7013475 -0.7808355 -0.8578702 -0.9229640 -0.9910654 -1.055867 -1.105592 -1.160199 -1.211404 -1.244083 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.2596990 0.3808402 0.4137945 0.3961964 0.3527446 0.2983907 0.2373725 0.1758397 0.1139294 5.2519538E-02 -7.8925537E-03 -6.7737170E-02 -0.1275438 -0.1853824 -0.2440281 -0.2999189 -0.3561261 -0.4145803 -0.4695305 -0.5260214 0.000000 0.2574855 0.3903871 0.4417751 0.4447532 0.4190943 0.3830713 0.3399712 0.2937032 0.2461107 0.2003256 0.1549044 0.1105589 6.7615271E-02 2.6291059E-02 -1.3794957E-02 -5.3538579E-02 -9.3557768E-02 -0.1326451 -0.1712655 -0.2088817 0.000000 0.2526088 0.3955233 0.4662992 0.4732600 0.4601630 0.4336229 0.3993835 0.3594161 0.3173839 0.2747807 0.2352635 0.1967809 0.1586898 0.1217038 8.5220538E-02 4.9744844E-02 1.5130630E-02 -1.9305576E-02 -5.4200951E-02 -8.9763261E-02 0.000000 0.2482407 0.4047505 0.4811448 0.4895308 0.4795721 0.4580026 0.4215998 0.3842456 0.3454136 0.3086240 0.2684865 0.2301134 0.1914951 0.1525531 0.1136400 7.5213328E-02 3.6209129E-02 -3.7675411E-03 -4.5491282E-02 -8.9713000E-02 0.000000 0.2456544 0.4174202 0.4820425 0.4903251 0.4825773 0.4559359 0.4248237 0.3889872 0.3497167 0.3071749 0.2653214 0.2204026 0.1762582 0.1312161 8.5430861E-02 3.7087634E-02 -1.3519644E-02 -6.7894019E-02 -0.1265238 -0.1880976 0.000000 0.2474682 0.4220503 0.4680158 0.4802624 0.4654973 0.4417250 0.4093558 0.3698215 0.3244205 0.2759053 0.2257017 0.1748656 0.1211874 6.4287573E-02 4.0809470E-03 -6.0246248E-02 -0.1299095 -0.2054193 -0.2846232 -0.3711523 0.000000 0.2486055 0.4075218 0.4513546 0.4589042 0.4392218 0.4124887 0.3736354 0.3240346 0.2716548 0.2176061 0.1569981 9.3362384E-02 2.5027800E-02 -4.8194617E-02 -0.1265116 -0.2108213 -0.3026125 -0.4016849 -0.5063287 -0.6156278 0.000000 0.2521901 0.3877850 0.4267484 0.4222898 0.4016280 0.3640030 0.3179832 0.2622476 0.1997448 0.1312594 5.7456657E-02 -2.2226784E-02 -0.1079543 -0.1987857 -0.2969983 -0.4029630 -0.5171044 -0.6354114 -0.7568077 -0.8780401 0.000000 0.2479508 0.3636408 0.3943384 0.3815310 0.3523524 0.3059981 0.2486276 0.1805120 0.1044911 2.0912450E-02 -7.0244171E-02 -0.1664065 -0.2684072 -0.3775582 -0.4952819 -0.6209480 -0.7480066 -0.8750175 -1.006526 -1.144259 0.000000 0.2273456 0.3348001 0.3548479 0.3321996 0.2895492 0.2339559 0.1607200 7.9284407E-02 -1.2372876E-02 -0.1122878 -0.2190298 -0.3302960 -0.4493368 -0.5772257 -0.7107807 -0.8432555 -0.9769512 -1.111314 -1.251033 -1.390078 0.000000 0.2062986 0.3028902 0.3088286 0.2748250 0.2198165 0.1465502 6.0211997E-02 -3.8722750E-02 -0.1461972 -0.2611578 -0.3804793 -0.5069959 -0.6409675 -0.7868779 -0.9216830 -1.060554 -1.195912 -1.323021 -1.464115 -1.603523 0.000000 0.1843823 0.2660269 0.2565250 0.2084737 0.1397563 4.9512196E-02 -5.4964714E-02 -0.1707359 -0.2916194 -0.4164394 -0.5529861 -0.6914293 -0.8414420 -0.9794794 -1.113674 -1.259262 -1.384460 -1.514960 -1.652050 -1.788488 0.000000 0.1635466 0.2294615 0.2036561 0.1393261 5.0747432E-02 -5.8477879E-02 -0.1806426 -0.3098146 -0.4420271 -0.5809491 -0.7278737 -0.8786790 -1.018018 -1.156138 -1.294171 -1.428129 -1.551183 -1.682281 -1.813578 -1.939627 0.000000 0.1399697 0.1908104 0.1478543 6.5722302E-02 -4.4111326E-02 -0.1718681 -0.3092358 -0.4530104 -0.5931038 -0.7424750 -0.8933124 -1.041754 -1.176242 -1.313976 -1.437132 -1.563640 -1.689793 -1.810425 -1.929374 -2.039739 0.000000 0.1182678 0.1507112 9.1734357E-02 -9.2216199E-03 -0.1403239 -0.2854902 -0.4368803 -0.5859146 -0.7361301 -0.8884779 -1.036323 -1.176752 -1.313391 -1.429102 -1.549683 -1.668080 -1.782154 -1.896629 -1.998058 -2.092489 0.000000 9.7979397E-02 0.1114980 3.8017139E-02 -7.9693966E-02 -0.2273797 -0.3846376 -0.5443581 -0.6960028 -0.8548430 -1.003618 -1.142959 -1.274519 -1.397127 -1.514555 -1.632520 -1.738279 -1.840098 -1.931243 -2.019071 -2.100807 0.000000 7.6827161E-02 7.5265758E-02 -8.4805675E-03 -0.1381568 -0.2942112 -0.4564939 -0.6184944 -0.7712914 -0.9285984 -1.068661 -1.198873 -1.320954 -1.433872 -1.540777 -1.655713 -1.753231 -1.842103 -1.922813 -1.999166 -2.069454 0.000000 5.5791728E-02 4.3915808E-02 -4.2144593E-02 -0.1715984 -0.3234094 -0.4799628 -0.6390867 -0.7841544 -0.9311552 -1.060800 -1.180597 -1.302912 -1.406529 -1.504642 -1.610499 -1.692486 -1.771168 -1.845342 -1.909274 -1.964907 0.000000 3.5536889E-02 1.8487403E-02 -5.8041893E-02 -0.1684080 -0.2962132 -0.4312757 -0.5609432 -0.6928153 -0.8206276 -0.9340730 -1.049611 -1.147645 -1.254461 -1.337896 -1.430682 -1.505299 -1.570138 -1.645393 -1.698578 -1.744034 0.000000 1.6591437E-02 2.7675866E-03 -4.5977596E-02 -0.1145523 -0.1917565 -0.2749195 -0.3604206 -0.4468595 -0.5333150 -0.6191463 -0.6954823 -0.7751927 -0.8524377 -0.9174907 -0.9857455 -1.050718 -1.100347 -1.155107 -1.194480 -1.239076 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.1928929 0.2406556 0.2143931 0.1501872 6.9968067E-02 -1.9791383E-02 -0.1109276 -0.2014851 -0.2909467 -0.3791115 -0.4657469 -0.5495752 -0.6301217 -0.7095542 -0.7917212 -0.8668064 -0.9463740 -1.027347 -1.108463 -1.185602 0.000000 0.1933065 0.2581449 0.2517138 0.2110852 0.1540422 8.9347742E-02 2.1254117E-02 -4.5439109E-02 -0.1115049 -0.1767020 -0.2413988 -0.3024932 -0.3613423 -0.4207839 -0.4753068 -0.5319034 -0.5900294 -0.6428353 -0.6931939 -0.7459480 0.000000 0.1886013 0.2640758 0.2767015 0.2547244 0.2141935 0.1629262 0.1095696 5.4194771E-02 -6.7751098E-04 -5.3131174E-02 -0.1054047 -0.1558253 -0.2049028 -0.2528034 -0.3024379 -0.3496740 -0.3959618 -0.4451207 -0.4911220 -0.5403955 0.000000 0.1843583 0.2682486 0.2981749 0.2910844 0.2582443 0.2165088 0.1691771 0.1194720 7.1058936E-02 2.2934774E-02 -2.4007190E-02 -7.1198024E-02 -0.1181557 -0.1669779 -0.2154534 -0.2645502 -0.3140995 -0.3644784 -0.4157275 -0.4711488 0.000000 0.1769463 0.2745018 0.3233331 0.3152844 0.2884325 0.2490211 0.2041202 0.1565923 0.1082985 6.0651779E-02 1.1839439E-02 -3.7594423E-02 -8.9613497E-02 -0.1429521 -0.2001309 -0.2576719 -0.3164591 -0.3773204 -0.4421856 -0.5103898 0.000000 0.1701587 0.2799678 0.3365059 0.3295558 0.2994399 0.2606078 0.2157325 0.1668532 0.1169388 6.4062044E-02 9.9959914E-03 -4.6902169E-02 -0.1079830 -0.1732811 -0.2402153 -0.3096024 -0.3855552 -0.4621280 -0.5469198 -0.6360552 0.000000 0.1639993 0.2892538 0.3397695 0.3311038 0.2984589 0.2571722 0.2089580 0.1549737 9.7802013E-02 3.8820233E-02 -2.4999714E-02 -9.4193392E-02 -0.1684770 -0.2472800 -0.3277568 -0.4167636 -0.5075030 -0.6061993 -0.7107857 -0.8252510 0.000000 0.1604387 0.3023953 0.3348302 0.3182949 0.2835602 0.2370345 0.1812719 0.1208174 5.6347057E-02 -1.4493115E-02 -9.1752023E-02 -0.1753876 -0.2635754 -0.3578920 -0.4565020 -0.5641028 -0.6770055 -0.7919769 -0.9213106 -1.042068 0.000000 0.1563780 0.3044761 0.3202794 0.2977726 0.2558527 0.2007605 0.1389701 6.8660311E-02 -9.0676546E-03 -9.4163358E-02 -0.1868636 -0.2845604 -0.3885905 -0.5024394 -0.6219053 -0.7451588 -0.8712375 -1.005201 -1.139069 -1.278878 0.000000 0.1541987 0.2871313 0.2984186 0.2669497 0.2147997 0.1531777 7.9605967E-02 -3.9345585E-03 -9.6840546E-02 -0.1981227 -0.3050176 -0.4176068 -0.5443473 -0.6731333 -0.8049688 -0.9397954 -1.078207 -1.213037 -1.351045 -1.492977 0.000000 0.1551999 0.2635664 0.2662880 0.2269705 0.1653990 9.0523742E-02 3.4441303E-03 -9.4804198E-02 -0.2048143 -0.3206571 -0.4416307 -0.5740963 -0.7109150 -0.8490107 -0.9872813 -1.135574 -1.277994 -1.409910 -1.554067 -1.693809 0.000000 0.1601238 0.2399484 0.2311844 0.1776435 0.1054435 1.6124226E-02 -8.7063767E-02 -0.2035391 -0.3264848 -0.4579204 -0.5915710 -0.7379590 -0.8804760 -1.024377 -1.172066 -1.310773 -1.455117 -1.581662 -1.718376 -1.854165 0.000000 0.1475520 0.2121981 0.1907170 0.1234691 3.5872348E-02 -7.0402995E-02 -0.1915922 -0.3251023 -0.4611619 -0.6005451 -0.7487763 -0.9020910 -1.045402 -1.193838 -1.333942 -1.472087 -1.590553 -1.725288 -1.855281 -1.981843 0.000000 0.1267432 0.1819647 0.1455189 6.3657597E-02 -4.1311339E-02 -0.1662359 -0.3032670 -0.4505285 -0.5998920 -0.7460409 -0.9018989 -1.053457 -1.201589 -1.332964 -1.470510 -1.588194 -1.710043 -1.832331 -1.955666 -2.065392 0.000000 0.1073597 0.1494846 9.7655453E-02 5.4681354E-04 -0.1235157 -0.2664994 -0.4187301 -0.5710183 -0.7276754 -0.8838767 -1.036294 -1.180235 -1.319906 -1.454363 -1.563452 -1.685483 -1.800374 -1.909169 -2.009972 -2.109027 0.000000 8.7941788E-02 0.1155108 5.0149146E-02 -6.0777344E-02 -0.2023099 -0.3584716 -0.5204085 -0.6835124 -0.8406298 -0.9938385 -1.138057 -1.272614 -1.402027 -1.524826 -1.633814 -1.742360 -1.844886 -1.936661 -2.039124 -2.122241 0.000000 6.8602800E-02 8.2229637E-02 7.5743161E-03 -0.1147953 -0.2668170 -0.4291440 -0.5939661 -0.7518810 -0.9135796 -1.057668 -1.188753 -1.315998 -1.444636 -1.542153 -1.659197 -1.753985 -1.843427 -1.924073 -2.006121 -2.078744 0.000000 4.9854092E-02 5.2093133E-02 -2.5244825E-02 -0.1492887 -0.2994173 -0.4571191 -0.6179165 -0.7680343 -0.9185808 -1.050348 -1.171453 -1.295809 -1.400908 -1.498542 -1.606728 -1.689847 -1.769219 -1.838272 -1.924872 -1.985050 0.000000 3.2112215E-02 2.5830450E-02 -4.3995529E-02 -0.1518090 -0.2795990 -0.4161156 -0.5489023 -0.6819690 -0.8114749 -0.9280285 -1.042475 -1.141366 -1.248809 -1.332992 -1.426363 -1.501645 -1.567191 -1.642781 -1.696710 -1.742791 0.000000 1.5269726E-02 7.3231435E-03 -3.8192999E-02 -0.1063373 -0.1841390 -0.2682647 -0.3547336 -0.4419390 -0.5289517 -0.6151724 -0.6917402 -0.7717125 -0.8492222 -0.9144984 -0.9829930 -1.048227 -1.098033 -1.153047 -1.192583 -1.237415 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 6.8870850E-02 3.9666552E-02 -6.1873294E-02 -0.1878294 -0.3237623 -0.4610301 -0.5949751 -0.7236916 -0.8479112 -0.9632488 -1.075701 -1.186488 -1.296640 -1.406842 -1.517201 -1.624127 -1.734930 -1.822362 -1.925450 -2.017660 0.000000 8.6076654E-02 7.7210292E-02 -2.2428327E-03 -9.8363064E-02 -0.2010523 -0.3062146 -0.4106081 -0.5117060 -0.6090155 -0.7025006 -0.7916963 -0.8781391 -0.9573051 -1.036136 -1.116651 -1.193085 -1.271576 -1.336021 -1.404151 -1.468828 0.000000 9.9491850E-02 9.6727423E-02 4.2548086E-02 -3.2855183E-02 -0.1163821 -0.2026964 -0.2864088 -0.3688724 -0.4494021 -0.5269542 -0.5961666 -0.6672507 -0.7303559 -0.7958713 -0.8649119 -0.9220270 -0.9802139 -1.041072 -1.104990 -1.168158 0.000000 0.1028831 0.1130910 7.4968949E-02 1.4015724E-02 -5.0740436E-02 -0.1186745 -0.1893914 -0.2601210 -0.3265154 -0.3937024 -0.4562635 -0.5166935 -0.5812281 -0.6453289 -0.7026269 -0.7626318 -0.8261946 -0.8880836 -0.9534656 -1.010008 0.000000 0.1014049 0.1226724 9.8313294E-02 5.9566487E-02 7.8469878E-03 -5.1619329E-02 -0.1136564 -0.1767130 -0.2409351 -0.3030944 -0.3680041 -0.4296904 -0.4955209 -0.5580249 -0.6259155 -0.6892369 -0.7572497 -0.8220285 -0.8910497 -0.9658023 0.000000 9.7803868E-02 0.1286818 0.1233177 0.1020058 5.3935934E-02 -2.5339625E-03 -6.2307622E-02 -0.1251252 -0.1900362 -0.2542436 -0.3216937 -0.3918458 -0.4605380 -0.5292681 -0.6036773 -0.6773304 -0.7589798 -0.8420409 -0.9291096 -1.022628 0.000000 9.3257152E-02 0.1314944 0.1524597 0.1309073 8.4430367E-02 2.7443305E-02 -3.5358347E-02 -0.1001589 -0.1681354 -0.2388946 -0.3130022 -0.3875908 -0.4663217 -0.5493528 -0.6360749 -0.7288170 -0.8290679 -0.9292669 -1.034941 -1.148964 0.000000 8.9209899E-02 0.1365355 0.1820572 0.1485564 9.9955410E-02 3.8082328E-02 -2.8576458E-02 -9.8096363E-02 -0.1727176 -0.2512228 -0.3355550 -0.4229134 -0.5153825 -0.6128951 -0.7150275 -0.8259271 -0.9398573 -1.058245 -1.176816 -1.305419 0.000000 8.4898874E-02 0.1466885 0.1898244 0.1550860 9.9847779E-02 3.2579083E-02 -3.9397255E-02 -0.1166485 -0.2000124 -0.2906152 -0.3887072 -0.4895337 -0.5951046 -0.7078341 -0.8296207 -0.9539797 -1.086190 -1.213634 -1.350713 -1.492065 0.000000 7.8603946E-02 0.1602498 0.1903483 0.1499539 8.5624911E-02 1.2297437E-02 -6.6901125E-02 -0.1544132 -0.2502227 -0.3579634 -0.4682729 -0.5770187 -0.7033398 -0.8351359 -0.9705375 -1.104437 -1.240944 -1.389880 -1.534842 -1.683487 0.000000 7.4344814E-02 0.1779764 0.1811218 0.1330776 6.0719624E-02 -2.1136321E-02 -0.1111690 -0.2115085 -0.3239985 -0.4432378 -0.5646666 -0.6902867 -0.8354012 -0.9766535 -1.119793 -1.265975 -1.403103 -1.553323 -1.700480 -1.846236 0.000000 7.0405461E-02 0.1820561 0.1656125 0.1055906 2.4237530E-02 -6.7281656E-02 -0.1712512 -0.2888757 -0.4137802 -0.5431247 -0.6768513 -0.8243094 -0.9781723 -1.124761 -1.270055 -1.418643 -1.556614 -1.697790 -1.833522 -1.962185 0.000000 6.8856724E-02 0.1643192 0.1433765 7.0832901E-02 -2.1762747E-02 -0.1269131 -0.2468944 -0.3790959 -0.5215471 -0.6617222 -0.8056906 -0.9614608 -1.120536 -1.265076 -1.420887 -1.547896 -1.687323 -1.827905 -1.937096 -2.057769 0.000000 6.9357470E-02 0.1455235 0.1146014 2.9200956E-02 -7.5801291E-02 -0.1983400 -0.3362395 -0.4806715 -0.6341477 -0.7821857 -0.9398009 -1.096804 -1.249555 -1.400935 -1.529755 -1.660310 -1.793702 -1.901282 -2.018727 -2.137626 0.000000 7.4549720E-02 0.1238623 7.9508327E-02 -1.7868053E-02 -0.1367777 -0.2768154 -0.4287678 -0.5885142 -0.7424771 -0.9020495 -1.058926 -1.212144 -1.356391 -1.492985 -1.615034 -1.733030 -1.849517 -1.959210 -2.069280 -2.175188 0.000000 6.9138922E-02 9.8773852E-02 4.3724678E-02 -6.5684304E-02 -0.1994130 -0.3543650 -0.5175450 -0.6835328 -0.8458406 -1.003705 -1.154099 -1.292282 -1.429375 -1.553226 -1.667765 -1.782761 -1.887298 -1.985743 -2.100930 -2.187258 0.000000 5.4103319E-02 7.4255913E-02 9.3560172E-03 -0.1087553 -0.2546637 -0.4172009 -0.5845549 -0.7542048 -0.9130769 -1.062792 -1.199443 -1.330258 -1.463368 -1.572080 -1.679515 -1.778784 -1.869807 -1.975377 -2.056087 -2.127548 0.000000 3.9007805E-02 4.9101681E-02 -1.8520927E-02 -0.1372727 -0.2849714 -0.4439005 -0.6078275 -0.7623393 -0.9170775 -1.053143 -1.178151 -1.305223 -1.413073 -1.512765 -1.621526 -1.710575 -1.788889 -1.876405 -1.942507 -2.003141 0.000000 2.4836097E-02 2.5882488E-02 -3.5875916E-02 -0.1400918 -0.2678761 -0.4063591 -0.5419782 -0.6780532 -0.8103179 -0.9292017 -1.045811 -1.146403 -1.255005 -1.340586 -1.434592 -1.508808 -1.592485 -1.651657 -1.710793 -1.777831 0.000000 1.1614147E-02 8.4757367E-03 -3.2450926E-02 -9.9885717E-02 -0.1785345 -0.2641132 -0.3520381 -0.4405099 -0.5285843 -0.6156934 -0.6930915 -0.7736360 -0.8515915 -0.9174238 -0.9861966 -1.051621 -1.101859 -1.156931 -1.208762 -1.242003 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.1463285 -0.3138213 -0.5181500 -0.7206720 -0.9179054 -1.117408 -1.300705 -1.468788 -1.643903 -1.795603 -1.950285 -2.109035 -2.256601 -2.381476 -2.524200 -2.642467 -2.754899 -2.861945 -2.992805 -3.107201 0.000000 -0.1163525 -0.2576753 -0.4115757 -0.5724976 -0.7320503 -0.8858404 -1.033597 -1.172168 -1.302240 -1.433843 -1.551668 -1.673971 -1.788842 -1.886202 -1.996148 -2.086549 -2.171765 -2.252465 -2.352695 -2.439112 0.000000 -9.5387392E-02 -0.2066398 -0.3203719 -0.4560513 -0.5919545 -0.7247878 -0.8517557 -0.9694112 -1.079756 -1.181727 -1.288935 -1.380343 -1.476962 -1.562067 -1.639940 -1.713741 -1.796186 -1.872111 -1.962567 -2.032241 0.000000 -8.1401572E-02 -0.1588993 -0.2558336 -0.3760845 -0.4946740 -0.6060348 -0.7120712 -0.8118983 -0.9058328 -0.9942570 -1.078322 -1.157603 -1.238271 -1.315019 -1.385122 -1.461204 -1.532772 -1.611899 -1.688646 -1.760128 0.000000 -6.7842416E-02 -0.1155072 -0.2076705 -0.3115372 -0.4063089 -0.4962631 -0.5874287 -0.6688466 -0.7544240 -0.8348902 -0.9151157 -0.9863582 -1.064284 -1.141769 -1.216207 -1.294025 -1.377952 -1.455998 -1.538021 -1.621885 0.000000 -5.4811537E-02 -8.0922440E-02 -0.1694188 -0.2490224 -0.3207689 -0.4012479 -0.4839058 -0.5613356 -0.6436101 -0.7259502 -0.7992244 -0.8811944 -0.9625670 -1.046014 -1.130803 -1.210496 -1.294688 -1.385755 -1.483698 -1.584974 0.000000 -4.0718939E-02 -6.4590916E-02 -0.1338906 -0.1853528 -0.2499332 -0.3247178 -0.4054528 -0.4845765 -0.5680450 -0.6502216 -0.7285526 -0.8135083 -0.9032408 -0.9938319 -1.083315 -1.180362 -1.278597 -1.384049 -1.497791 -1.617680 0.000000 -2.7503934E-02 -5.2423578E-02 -9.6237652E-02 -0.1266285 -0.1934624 -0.2683749 -0.3511099 -0.4364211 -0.5177417 -0.6046699 -0.6966424 -0.7900379 -0.8893285 -0.9879285 -1.094447 -1.202592 -1.317487 -1.443285 -1.575409 -1.710805 0.000000 -1.3865911E-02 -4.0410664E-02 -5.6758650E-02 -8.6163580E-02 -0.1524343 -0.2315976 -0.3177615 -0.4049613 -0.4968749 -0.5916818 -0.6933383 -0.7962525 -0.9056679 -1.018151 -1.142122 -1.266825 -1.405433 -1.537279 -1.678755 -1.807639 0.000000 3.5344393E-04 -2.8520772E-02 -1.4186330E-02 -5.5794366E-02 -0.1268410 -0.2124151 -0.3025442 -0.3985047 -0.4987305 -0.6042986 -0.7163903 -0.8301030 -0.9539034 -1.083878 -1.215358 -1.363046 -1.508432 -1.647286 -1.787872 -1.938122 0.000000 -8.6662592E-04 -1.5319982E-02 2.4009071E-02 -3.6995139E-02 -0.1171855 -0.2098480 -0.3051335 -0.4113581 -0.5233555 -0.6410367 -0.7628273 -0.8888783 -1.034604 -1.177573 -1.321728 -1.466501 -1.615658 -1.767260 -1.930208 -2.080060 0.000000 -2.0726551E-03 -1.7755793E-04 3.2581363E-02 -2.9617168E-02 -0.1190164 -0.2206339 -0.3247997 -0.4435460 -0.5708535 -0.6976510 -0.8327049 -0.9820817 -1.128089 -1.287443 -1.432697 -1.593485 -1.737488 -1.889296 -2.042357 -2.175798 0.000000 -3.0463538E-03 1.9682677E-02 3.7415251E-02 -3.3349246E-02 -0.1342393 -0.2413124 -0.3609914 -0.4946902 -0.6307231 -0.7707661 -0.9245374 -1.084149 -1.231852 -1.398296 -1.545115 -1.698786 -1.850637 -1.996689 -2.115293 -2.240880 0.000000 -3.3059327E-03 4.6782911E-02 3.5644252E-02 -4.7245402E-02 -0.1596852 -0.2771711 -0.4126746 -0.5608125 -0.7077145 -0.8647208 -1.026067 -1.179741 -1.340366 -1.500249 -1.647465 -1.790487 -1.927643 -2.044626 -2.167983 -2.285533 0.000000 -2.3703962E-03 6.6279069E-02 2.5498988E-02 -6.8002433E-02 -0.1897004 -0.3248344 -0.4752994 -0.6367270 -0.7915717 -0.9547173 -1.116900 -1.272728 -1.431484 -1.574476 -1.710917 -1.838571 -1.962401 -2.078265 -2.200184 -2.301440 0.000000 1.4546656E-04 5.2021142E-02 1.0762220E-02 -9.4893217E-02 -0.2256651 -0.3773669 -0.5411723 -0.7074730 -0.8726203 -1.035865 -1.192751 -1.344383 -1.498850 -1.628223 -1.747518 -1.864799 -1.978768 -2.083621 -2.183184 -2.266847 0.000000 5.4561375E-03 3.9814863E-02 -6.5560043E-03 -0.1210328 -0.2599572 -0.4229693 -0.5966845 -0.7645317 -0.9288518 -1.085362 -1.231268 -1.379345 -1.500501 -1.623687 -1.729288 -1.834143 -1.947281 -2.037467 -2.111149 -2.185664 0.000000 1.3986397E-02 2.7685314E-02 -2.2678325E-02 -0.1374709 -0.2797625 -0.4392900 -0.6068974 -0.7665626 -0.9262173 -1.068687 -1.210544 -1.330283 -1.440327 -1.549475 -1.660464 -1.747957 -1.847517 -1.918203 -1.988761 -2.052842 0.000000 9.2432965E-03 1.4866228E-02 -3.2848421E-02 -0.1333940 -0.2596726 -0.4002670 -0.5397626 -0.6799166 -0.8161609 -0.9369041 -1.058371 -1.161880 -1.272192 -1.363067 -1.459036 -1.533001 -1.614680 -1.678139 -1.753283 -1.806127 0.000000 4.0483144E-03 4.5792428E-03 -2.8471364E-02 -9.3995541E-02 -0.1737668 -0.2613948 -0.3514770 -0.4418683 -0.5315675 -0.6200414 -0.6988607 -0.7804981 -0.8594069 -0.9355229 -0.9960896 -1.062242 -1.113675 -1.169382 -1.221581 -1.255729 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.5927599 -0.9230888 -1.238369 -1.547207 -1.829249 -2.106044 -2.366417 -2.586209 -2.808438 -3.025240 -3.205229 -3.400796 -3.562801 -3.747082 -3.897583 -4.077594 -4.221546 -4.357956 -4.528318 -4.717297 0.000000 -0.5404928 -0.8132285 -1.074084 -1.324076 -1.567528 -1.783859 -1.994166 -2.171192 -2.357515 -2.530941 -2.673189 -2.830532 -2.957214 -3.105657 -3.222186 -3.331706 -3.467369 -3.572638 -3.671392 -3.803358 0.000000 -0.4838173 -0.7118728 -0.9410251 -1.150783 -1.349794 -1.543916 -1.712604 -1.883241 -2.028678 -2.178831 -2.300637 -2.432925 -2.539268 -2.662121 -2.758430 -2.846800 -2.930338 -3.039078 -3.124715 -3.208678 0.000000 -0.4363101 -0.6220829 -0.8210049 -1.006807 -1.176424 -1.341240 -1.506477 -1.647235 -1.766982 -1.876307 -1.997778 -2.094388 -2.183830 -2.270018 -2.363384 -2.450317 -2.531602 -2.630550 -2.716276 -2.793497 0.000000 -0.3918247 -0.5533924 -0.7150490 -0.8796663 -1.038063 -1.187252 -1.316358 -1.430872 -1.534064 -1.645150 -1.738594 -1.828312 -1.917049 -1.996643 -2.084731 -2.168753 -2.261641 -2.347600 -2.445436 -2.534909 0.000000 -0.3479617 -0.4860577 -0.6269308 -0.7728837 -0.9203937 -1.043338 -1.149913 -1.249771 -1.345542 -1.440154 -1.530542 -1.623079 -1.710791 -1.797747 -1.884626 -1.972975 -2.072114 -2.186704 -2.283454 -2.382526 0.000000 -0.3137344 -0.4197165 -0.5446334 -0.6851109 -0.8066219 -0.9032819 -1.000341 -1.096903 -1.194050 -1.287615 -1.380439 -1.475522 -1.569006 -1.658797 -1.751190 -1.847772 -1.967858 -2.081127 -2.194513 -2.313543 0.000000 -0.2794253 -0.3706428 -0.4688398 -0.6023263 -0.6924091 -0.7814150 -0.8763110 -0.9739409 -1.071594 -1.168374 -1.265244 -1.363733 -1.461900 -1.560914 -1.669025 -1.794046 -1.909868 -2.037911 -2.175509 -2.294356 0.000000 -0.2439196 -0.3272443 -0.4166612 -0.5182752 -0.5869897 -0.6799244 -0.7766599 -0.8754901 -0.9727023 -1.074319 -1.175969 -1.280154 -1.385264 -1.500833 -1.641282 -1.767247 -1.905060 -2.052878 -2.182128 -2.326197 0.000000 -0.2148783 -0.2827746 -0.3703764 -0.4324502 -0.5035790 -0.5976077 -0.6974786 -0.7966121 -0.9073902 -1.015481 -1.125492 -1.239797 -1.358702 -1.501601 -1.639423 -1.780273 -1.934561 -2.076047 -2.231880 -2.387845 0.000000 -0.1898217 -0.2380365 -0.3188494 -0.3481032 -0.4345785 -0.5378666 -0.6415182 -0.7454782 -0.8565869 -0.9722796 -1.104579 -1.228181 -1.373186 -1.517297 -1.665909 -1.826067 -1.972862 -2.136498 -2.292169 -2.449400 0.000000 -0.1632202 -0.1911413 -0.2661690 -0.2870692 -0.3831998 -0.4880109 -0.5961694 -0.7145154 -0.8351088 -0.9641916 -1.107638 -1.244584 -1.400551 -1.551254 -1.721943 -1.886036 -2.031449 -2.188743 -2.342960 -2.497515 0.000000 -0.1349688 -0.1726647 -0.2097347 -0.2423601 -0.3414860 -0.4542413 -0.5727943 -0.7029727 -0.8364862 -0.9788448 -1.131057 -1.291098 -1.446104 -1.616219 -1.783582 -1.944128 -2.078800 -2.232435 -2.381994 -2.522662 0.000000 -0.1151366 -0.1522012 -0.1469875 -0.2079067 -0.3140758 -0.4375049 -0.5658779 -0.7109464 -0.8579895 -1.015936 -1.171927 -1.340895 -1.507092 -1.670678 -1.825684 -1.977965 -2.112958 -2.272332 -2.402688 -2.530126 0.000000 -9.7132936E-02 -0.1287848 -9.1093369E-02 -0.1820823 -0.3002892 -0.4313126 -0.5753401 -0.7336532 -0.8902061 -1.053593 -1.226013 -1.395415 -1.560190 -1.711739 -1.857097 -1.992818 -2.135842 -2.260964 -2.376118 -2.480323 0.000000 -7.7509955E-02 -0.1025655 -8.0820568E-02 -0.1673466 -0.2958921 -0.4360907 -0.5954101 -0.7642920 -0.9347367 -1.097364 -1.276451 -1.436263 -1.581375 -1.720148 -1.858886 -1.982166 -2.114935 -2.224951 -2.329161 -2.423940 0.000000 -5.5789560E-02 -7.0762321E-02 -6.7359373E-02 -0.1563156 -0.2912011 -0.4440202 -0.6133390 -0.7881834 -0.9579914 -1.121724 -1.290187 -1.436480 -1.568777 -1.693523 -1.830355 -1.936155 -2.038008 -2.130445 -2.236183 -2.318945 0.000000 -4.1718539E-02 -2.9323131E-02 -5.4316752E-02 -0.1473044 -0.2819422 -0.4395239 -0.6074461 -0.7725708 -0.9409274 -1.092704 -1.242588 -1.367352 -1.487950 -1.612622 -1.714341 -1.821497 -1.909220 -1.988837 -2.077877 -2.145515 0.000000 -2.8103396E-02 -1.7964549E-02 -4.4123963E-02 -0.1281751 -0.2483599 -0.3896174 -0.5341631 -0.6814198 -0.8244377 -0.9517208 -1.078124 -1.185796 -1.300336 -1.408037 -1.490487 -1.584700 -1.658507 -1.722647 -1.797387 -1.849344 0.000000 -1.2668325E-02 -1.1395966E-02 -2.9139735E-02 -8.5763454E-02 -0.1653024 -0.2554815 -0.3492724 -0.4431680 -0.5358220 -0.6266943 -0.7079148 -0.7913153 -0.8717347 -0.9491507 -1.011717 -1.078972 -1.142726 -1.188963 -1.241928 -1.277929 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -1.424417 -2.568760 -3.493396 -4.284706 -4.970699 -5.580176 -6.132155 -6.634762 -7.097937 -7.529732 -7.936611 -8.323904 -8.696378 -9.057103 -9.408665 -9.753321 -10.09300 -10.42970 -10.76460 -11.09233 0.000000 -1.358759 -2.392312 -3.225676 -3.907462 -4.491995 -5.006806 -5.467460 -5.883170 -6.261594 -6.611347 -6.939665 -7.251424 -7.548957 -7.836793 -8.118003 -8.395398 -8.584298 -8.822712 -9.067235 -9.311525 0.000000 -1.291870 -2.230129 -2.976563 -3.574086 -4.081007 -4.525095 -4.918322 -5.272852 -5.594639 -5.891992 -6.108895 -6.353466 -6.593882 -6.829793 -7.059139 -7.284727 -7.429700 -7.621361 -7.821856 -8.024690 0.000000 -1.223695 -2.067120 -2.706225 -3.231165 -3.674394 -4.053617 -4.392978 -4.695095 -4.970830 -5.229023 -5.472751 -5.697731 -5.850475 -6.032985 -6.216841 -6.401354 -6.587017 -6.774616 -6.891944 -7.047901 0.000000 -1.154179 -1.905117 -2.473335 -2.944738 -3.336147 -3.677170 -3.976357 -4.252551 -4.508732 -4.692142 -4.883510 -5.065847 -5.241924 -5.414378 -5.585702 -5.757716 -5.931548 -6.040540 -6.190858 -6.347153 0.000000 -1.083258 -1.747220 -2.252261 -2.673080 -3.033989 -3.334146 -3.614147 -3.829583 -4.043119 -4.224410 -4.397456 -4.564985 -4.729489 -4.893236 -5.057442 -5.168024 -5.337022 -5.480238 -5.627973 -5.721187 0.000000 -1.010833 -1.594188 -2.048759 -2.429855 -2.746212 -3.033308 -3.250575 -3.457036 -3.633631 -3.803869 -3.968216 -4.129362 -4.289658 -4.402587 -4.554749 -4.715528 -4.819395 -4.944098 -5.102457 -5.231626 0.000000 -0.9367770 -1.442803 -1.855332 -2.198583 -2.487607 -2.724059 -2.925982 -3.097130 -3.266759 -3.430244 -3.590674 -3.750069 -3.861412 -4.012905 -4.171815 -4.278513 -4.411828 -4.560662 -4.710950 -4.852530 0.000000 -0.8609328 -1.307059 -1.660896 -1.972424 -2.249553 -2.443653 -2.606982 -2.774938 -2.936934 -3.097041 -3.256200 -3.370389 -3.519144 -3.681306 -3.797185 -3.935657 -4.068255 -4.227413 -4.368838 -4.508830 0.000000 -0.7834475 -1.170753 -1.496951 -1.763604 -1.996279 -2.161635 -2.321385 -2.482044 -2.639561 -2.797892 -2.922418 -3.066186 -3.222861 -3.363270 -3.502858 -3.630187 -3.787519 -3.935939 -4.086505 -4.229849 0.000000 -0.7048138 -1.042250 -1.332665 -1.578688 -1.761151 -1.898186 -2.059524 -2.214120 -2.370355 -2.525097 -2.649725 -2.802486 -2.942965 -3.102253 -3.228660 -3.379040 -3.542283 -3.687572 -3.847524 -3.991025 0.000000 -0.6257504 -0.9222029 -1.166345 -1.395527 -1.522597 -1.665220 -1.817529 -1.971542 -2.124758 -2.273969 -2.401230 -2.556890 -2.712142 -2.871045 -3.002687 -3.150947 -3.317936 -3.475890 -3.634352 -3.817565 0.000000 -0.5472594 -0.7991545 -0.9993385 -1.210489 -1.292020 -1.448911 -1.597168 -1.751457 -1.898867 -2.048963 -2.204247 -2.362220 -2.505992 -2.658839 -2.822788 -2.966380 -3.147924 -3.306934 -3.459413 -3.604254 0.000000 -0.4705110 -0.6838963 -0.8704591 -1.021063 -1.117820 -1.260455 -1.397509 -1.549199 -1.695421 -1.850634 -2.010765 -2.169244 -2.336154 -2.491393 -2.649268 -2.797996 -2.982213 -3.118488 -3.261662 -3.380140 0.000000 -0.3959675 -0.5790562 -0.7416201 -0.8238946 -0.9387143 -1.076302 -1.228749 -1.376022 -1.529752 -1.690723 -1.854496 -2.011621 -2.181517 -2.332076 -2.486132 -2.653050 -2.795871 -2.926211 -3.045768 -3.181501 0.000000 -0.3246322 -0.4714884 -0.6094531 -0.6418799 -0.7728360 -0.9105966 -1.062037 -1.209511 -1.367794 -1.544343 -1.708165 -1.861217 -2.021461 -2.172262 -2.332738 -2.467685 -2.612421 -2.724540 -2.833561 -2.963853 0.000000 -0.2559898 -0.3599014 -0.4722611 -0.5128155 -0.6229356 -0.7688496 -0.9127373 -1.066974 -1.226938 -1.400908 -1.558773 -1.706410 -1.867277 -1.998314 -2.146990 -2.260574 -2.389259 -2.487852 -2.604393 -2.693106 0.000000 -0.1887211 -0.2701169 -0.3236462 -0.3861485 -0.4865177 -0.6202065 -0.7582883 -0.9167929 -1.071660 -1.230400 -1.371861 -1.522593 -1.650073 -1.779756 -1.902959 -2.002515 -2.112011 -2.197550 -2.298766 -2.366174 0.000000 -0.1236518 -0.1792166 -0.2027352 -0.2623020 -0.3469658 -0.4633054 -0.5888618 -0.7247075 -0.8636987 -0.9890730 -1.116960 -1.239865 -1.343946 -1.451531 -1.552681 -1.635307 -1.730394 -1.815406 -1.877196 -1.958038 0.000000 -6.1034214E-02 -8.4055431E-02 -0.1043390 -0.1359801 -0.1939740 -0.2702292 -0.3550573 -0.4378332 -0.5240712 -0.6086451 -0.6911411 -0.7714453 -0.8495750 -0.9155592 -0.9863047 -1.054493 -1.120174 -1.171351 -1.228742 -1.283381 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -1.491770 -2.744501 -3.798517 -4.740869 -5.547055 -6.321981 -6.970215 -7.578551 -8.214234 -8.729507 -9.225703 -9.692220 -10.22627 -10.63989 -11.05039 -11.44264 -11.81882 -12.29904 -12.64718 -12.99540 0.000000 -1.423234 -2.602709 -3.554026 -4.387639 -5.085011 -5.707562 -6.315197 -6.821082 -7.291163 -7.727190 -8.202709 -8.573311 -8.932261 -9.270658 -9.590494 -9.897154 -10.19125 -10.57506 -10.84774 -11.11886 0.000000 -1.353977 -2.455137 -3.308691 -4.063559 -4.679343 -5.225314 -5.715738 -6.211512 -6.611584 -6.984450 -7.331986 -7.654800 -7.954638 -8.317479 -8.585922 -8.850686 -9.102505 -9.343682 -9.575749 -9.796268 0.000000 -1.283998 -2.301780 -3.071233 -3.719658 -4.306596 -4.792266 -5.219772 -5.615412 -6.032491 -6.356163 -6.657433 -6.938593 -7.209834 -7.465475 -7.704790 -7.930112 -8.144136 -8.348237 -8.543793 -8.730309 0.000000 -1.213286 -2.145379 -2.836733 -3.425251 -3.965220 -4.391632 -4.782917 -5.132566 -5.451947 -5.747894 -6.082533 -6.337336 -6.573980 -6.791455 -7.000829 -7.197463 -7.383354 -7.562630 -7.736949 -7.904475 0.000000 -1.141840 -1.987930 -2.609342 -3.138046 -3.595638 -4.037457 -4.379419 -4.692067 -4.987529 -5.261758 -5.506790 -5.726774 -5.987218 -6.175451 -6.358145 -6.533400 -6.709427 -6.878493 -7.039788 -7.195023 0.000000 -1.069646 -1.831326 -2.393789 -2.878644 -3.293138 -3.654057 -4.007748 -4.302080 -4.567437 -4.800621 -5.007229 -5.201929 -5.388479 -5.566926 -5.795084 -5.960619 -6.121274 -6.275594 -6.434090 -6.586261 0.000000 -0.9966895 -1.677485 -2.184295 -2.617968 -3.004357 -3.322949 -3.629935 -3.895232 -4.151964 -4.346400 -4.540965 -4.728333 -4.906641 -5.077641 -5.240732 -5.395483 -5.603851 -5.759999 -5.911335 -6.053132 0.000000 -0.9229497 -1.525140 -1.984206 -2.379497 -2.717451 -3.025990 -3.303152 -3.520319 -3.705763 -3.932670 -4.120790 -4.299393 -4.469616 -4.632370 -4.787232 -4.942977 -5.146380 -5.295584 -5.437491 -5.574507 0.000000 -0.8484011 -1.380888 -1.795502 -2.152356 -2.446836 -2.741331 -2.969000 -3.147037 -3.334183 -3.554826 -3.733327 -3.902658 -4.065470 -4.222104 -4.376430 -4.575749 -4.723683 -4.864622 -5.008921 -5.159113 0.000000 -0.7730046 -1.224017 -1.603380 -1.923050 -2.204412 -2.454318 -2.626367 -2.811260 -2.995228 -3.200867 -3.369888 -3.532774 -3.690263 -3.842725 -4.037718 -4.185389 -4.327845 -4.472413 -4.669333 -4.806360 0.000000 -0.6967036 -1.088687 -1.421635 -1.690376 -1.964850 -2.157271 -2.312321 -2.497122 -2.697014 -2.865206 -3.028454 -3.186365 -3.336223 -3.526237 -3.674187 -3.819764 -3.964029 -4.156264 -4.304758 -4.423588 0.000000 -0.6194127 -0.9498205 -1.239320 -1.489394 -1.721777 -1.853022 -2.027120 -2.199013 -2.386402 -2.549220 -2.706926 -2.854727 -3.038397 -3.187497 -3.334674 -3.479419 -3.664508 -3.801469 -3.933548 -4.102220 0.000000 -0.5410042 -0.8243256 -1.068282 -1.297779 -1.470881 -1.584222 -1.755599 -1.933540 -2.093837 -2.251859 -2.396626 -2.573724 -2.723186 -2.871815 -3.020719 -3.195735 -3.327157 -3.468536 -3.624832 -3.761840 0.000000 -0.4615365 -0.6967856 -0.8928217 -1.103623 -1.209754 -1.343748 -1.509598 -1.663925 -1.820307 -1.964128 -2.132775 -2.279112 -2.431576 -2.572979 -2.747319 -2.879887 -3.030530 -3.163763 -3.315841 -3.437869 0.000000 -0.3815435 -0.5702404 -0.7408956 -0.9043366 -0.9618368 -1.110747 -1.260972 -1.410656 -1.557635 -1.711765 -1.859894 -2.002871 -2.169563 -2.304454 -2.467146 -2.590476 -2.730843 -2.860396 -3.003951 -3.112944 0.000000 -0.3017327 -0.4533359 -0.5928174 -0.6966534 -0.7683670 -0.8960687 -1.027291 -1.181801 -1.313481 -1.454751 -1.608822 -1.747511 -1.904590 -2.031334 -2.177817 -2.291087 -2.421401 -2.546923 -2.647780 -2.757726 0.000000 -0.2236860 -0.3340032 -0.4426529 -0.4808684 -0.5814521 -0.6817078 -0.8094009 -0.9369724 -1.072194 -1.204630 -1.346433 -1.474959 -1.612484 -1.741671 -1.847611 -1.969398 -2.084503 -2.174588 -2.274371 -2.370295 0.000000 -0.1475801 -0.2192862 -0.2868252 -0.3230318 -0.3901152 -0.4759640 -0.5762651 -0.6857435 -0.8045064 -0.9143220 -1.031923 -1.147934 -1.246640 -1.353641 -1.454834 -1.552331 -1.646798 -1.716768 -1.800130 -1.880483 0.000000 -7.3024489E-02 -0.1102187 -0.1362045 -0.1649790 -0.2006218 -0.2531770 -0.3183944 -0.3892992 -0.4633735 -0.5330060 -0.6059115 -0.6774056 -0.7472112 -0.8152280 -0.8815190 -0.9461426 -1.009137 -1.059499 -1.116764 -1.172193 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -1.308572 -2.471915 -3.485864 -4.416794 -5.210608 -5.985771 -6.651650 -7.320396 -7.893635 -8.495350 -9.002067 -9.556671 -10.00902 -10.52937 -10.93755 -11.43431 -11.80746 -12.28839 -12.63276 -13.10411 0.000000 -1.247330 -2.355439 -3.302016 -4.151334 -4.845061 -5.533378 -6.104768 -6.696753 -7.179106 -7.711768 -8.132425 -8.622912 -8.991651 -9.454030 -9.780658 -10.11448 -10.51741 -10.80595 -11.20748 -11.46945 0.000000 -1.185637 -2.236410 -3.109448 -3.837479 -4.506187 -5.084593 -5.636922 -6.107345 -6.590652 -6.992956 -7.433074 -7.782065 -8.193515 -8.494338 -8.793610 -9.151181 -9.412934 -9.767593 -10.00086 -10.23863 0.000000 -1.123504 -2.114648 -2.912197 -3.572546 -4.183142 -4.701344 -5.199260 -5.622681 -6.060507 -6.415280 -6.753986 -7.124484 -7.415259 -7.766438 -8.022698 -8.272660 -8.585095 -8.806443 -9.121734 -9.324907 0.000000 -1.060922 -1.989933 -2.714450 -3.310611 -3.871382 -4.330403 -4.807560 -5.172026 -5.527415 -5.899651 -6.196870 -6.543099 -6.801906 -7.052079 -7.355993 -7.578934 -7.877759 -8.072817 -8.265064 -8.528444 0.000000 -0.9978958 -1.861993 -2.516849 -3.055869 -3.572789 -3.998352 -4.376312 -4.770155 -5.084955 -5.423824 -5.693859 -5.951839 -6.252929 -6.481466 -6.764799 -6.954380 -7.144545 -7.382502 -7.541828 -7.706629 0.000000 -0.9344325 -1.730891 -2.323347 -2.812908 -3.256113 -3.666857 -4.027392 -4.386026 -4.663752 -4.939688 -5.236909 -5.474012 -5.746971 -5.936007 -6.181601 -6.345825 -6.511940 -6.740844 -6.892473 -7.049081 0.000000 -0.8705226 -1.597611 -2.133605 -2.575497 -2.980980 -3.366277 -3.687851 -4.010025 -4.279247 -4.534820 -4.808798 -5.002184 -5.232427 -5.399728 -5.577290 -5.794810 -5.950274 -6.169665 -6.312610 -6.460158 0.000000 -0.8061777 -1.463000 -1.923495 -2.347595 -2.703344 -3.075490 -3.345897 -3.627659 -3.918372 -4.140042 -4.363460 -4.526942 -4.703742 -4.916763 -5.085641 -5.290400 -5.437769 -5.644764 -5.780478 -5.920954 0.000000 -0.7413871 -1.328091 -1.743770 -2.131394 -2.459210 -2.781034 -3.040463 -3.301615 -3.555653 -3.724264 -3.925777 -4.097116 -4.269558 -4.470725 -4.624050 -4.820778 -4.961145 -5.156810 -5.286139 -5.418153 0.000000 -0.6761631 -1.193428 -1.566679 -1.910999 -2.214178 -2.461530 -2.749063 -2.974426 -3.171214 -3.319837 -3.532467 -3.696383 -3.860332 -4.047853 -4.195060 -4.379453 -4.514422 -4.695745 -4.818157 -4.946627 0.000000 -0.6104959 -1.061504 -1.391187 -1.700529 -1.964182 -2.205585 -2.459076 -2.631034 -2.784914 -2.960759 -3.157958 -3.312826 -3.467183 -3.642162 -3.787027 -3.959379 -4.087780 -4.255001 -4.379323 -4.499119 0.000000 -0.5443923 -0.9342020 -1.227033 -1.503160 -1.710062 -1.953865 -2.158206 -2.273811 -2.454272 -2.615805 -2.795927 -2.944750 -3.087211 -3.256314 -3.394296 -3.550693 -3.679456 -3.800863 -3.958941 -4.115869 0.000000 -0.4778581 -0.8076771 -1.059684 -1.301168 -1.494953 -1.699294 -1.841385 -1.954963 -2.134550 -2.280835 -2.448042 -2.587685 -2.752447 -2.884609 -3.038150 -3.162593 -3.283228 -3.437360 -3.590993 -3.699753 0.000000 -0.4108839 -0.6872669 -0.8965511 -1.093120 -1.280843 -1.435685 -1.510831 -1.670030 -1.820973 -1.958275 -2.113023 -2.248525 -2.399261 -2.520575 -2.667224 -2.784958 -2.933318 -3.081316 -3.188585 -3.335343 0.000000 -0.3434820 -0.5655701 -0.7432984 -0.9005198 -1.063137 -1.168089 -1.252649 -1.398882 -1.519992 -1.664752 -1.791199 -1.936435 -2.052818 -2.190794 -2.306262 -2.446754 -2.585746 -2.691736 -2.829766 -2.959682 0.000000 -0.2756424 -0.4498642 -0.5874599 -0.7212037 -0.8385219 -0.8837394 -1.003710 -1.117718 -1.232115 -1.359710 -1.494916 -1.606866 -1.732298 -1.845502 -1.975280 -2.103811 -2.207999 -2.335510 -2.452343 -2.542339 0.000000 -0.2073767 -0.3326918 -0.4317269 -0.5393842 -0.6000260 -0.6643438 -0.7617951 -0.8484513 -0.9572890 -1.063166 -1.178249 -1.288709 -1.394733 -1.511231 -1.624890 -1.737935 -1.831801 -1.940198 -2.042722 -2.118698 0.000000 -0.1386767 -0.2208363 -0.2884335 -0.3516658 -0.3902565 -0.4467826 -0.5117278 -0.5878004 -0.6691699 -0.7612109 -0.8516851 -0.9482808 -1.034443 -1.129216 -1.221296 -1.311646 -1.400281 -1.471258 -1.552145 -1.632915 0.000000 -6.9548994E-02 -0.1090139 -0.1426151 -0.1687298 -0.1963779 -0.2279537 -0.2630903 -0.3091357 -0.3621845 -0.4181870 -0.4765468 -0.5356996 -0.5948713 -0.6538374 -0.7047061 -0.7606424 -0.8154128 -0.8691366 -0.9217440 -0.9731842 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.9771606 -1.888879 -2.716326 -3.473022 -4.181796 -4.855225 -5.444002 -6.032590 -6.598656 -7.148777 -7.597951 -8.091809 -8.579315 -8.971320 -9.418210 -9.864320 -10.20903 -10.62148 -11.03759 -11.34195 0.000000 -0.9304210 -1.802110 -2.589344 -3.300165 -3.955675 -4.568995 -5.083438 -5.606950 -6.110477 -6.534041 -6.978812 -7.418119 -7.772424 -8.171299 -8.569764 -8.876157 -9.240555 -9.610241 -9.872187 -10.21443 0.000000 -0.8834551 -1.714467 -2.459659 -3.120607 -3.719531 -4.238753 -4.740220 -5.217566 -5.684898 -6.046853 -6.456603 -6.857154 -7.157339 -7.522910 -7.811569 -8.142102 -8.475863 -8.717603 -9.027853 -9.344723 0.000000 -0.8362640 -1.625944 -2.327069 -2.934228 -3.482880 -3.953450 -4.411562 -4.850236 -5.221659 -5.598851 -5.974264 -6.271810 -6.603420 -6.935764 -7.181439 -7.492522 -7.726407 -8.011081 -8.301084 -8.494510 0.000000 -0.7888472 -1.536524 -2.191343 -2.744086 -3.247795 -3.670939 -4.088562 -4.503278 -4.822742 -5.185152 -5.477638 -5.785813 -6.101957 -6.344604 -6.629207 -6.915936 -7.113986 -7.378644 -7.566988 -7.812852 0.000000 -0.7412072 -1.446210 -2.052179 -2.552303 -3.017032 -3.395715 -3.788875 -4.117366 -4.463643 -4.788066 -5.054371 -5.351284 -5.643940 -5.849938 -6.110544 -6.309650 -6.554399 -6.805514 -6.974026 -7.208677 0.000000 -0.6933426 -1.354982 -1.909630 -2.360832 -2.757027 -3.132443 -3.485936 -3.800707 -4.106457 -4.422077 -4.663089 -4.935571 -5.139270 -5.386965 -5.636717 -5.817765 -6.049356 -6.218285 -6.430205 -6.640697 0.000000 -0.6452482 -1.262823 -1.764671 -2.171578 -2.525709 -2.874678 -3.214713 -3.482235 -3.778833 -4.027059 -4.280119 -4.526307 -4.724611 -4.960354 -5.145874 -5.359190 -5.568131 -5.702850 -5.876453 -6.057336 0.000000 -0.5969372 -1.169709 -1.618167 -1.983215 -2.311138 -2.626157 -2.909077 -3.183927 -3.462713 -3.674233 -3.904451 -4.150721 -4.335043 -4.556173 -4.716066 -4.894421 -5.058270 -5.172338 -5.341737 -5.520900 0.000000 -0.5484028 -1.075611 -1.471141 -1.803064 -2.095129 -2.389572 -2.632652 -2.899795 -3.142557 -3.328205 -3.562218 -3.752399 -3.956043 -4.143806 -4.259226 -4.405198 -4.573941 -4.696706 -4.862914 -4.980506 0.000000 -0.4996483 -0.9804816 -1.324144 -1.624473 -1.886102 -2.148257 -2.381292 -2.612613 -2.819059 -3.015635 -3.230380 -3.395781 -3.559463 -3.697186 -3.806326 -3.970054 -4.137755 -4.252364 -4.406010 -4.518768 0.000000 -0.4506704 -0.8842707 -1.179731 -1.453584 -1.685713 -1.916207 -2.127916 -2.315397 -2.508126 -2.708897 -2.894536 -3.018912 -3.134224 -3.279332 -3.408779 -3.562035 -3.714167 -3.823257 -3.969006 -4.074569 0.000000 -0.4014729 -0.7868851 -1.039850 -1.263885 -1.481386 -1.697122 -1.868203 -2.048970 -2.227400 -2.398874 -2.539925 -2.618531 -2.749552 -2.905679 -3.023521 -3.161715 -3.304398 -3.409747 -3.544883 -3.642038 0.000000 -0.3520545 -0.6881900 -0.9006037 -1.100609 -1.283820 -1.473240 -1.609624 -1.793177 -1.943413 -2.073395 -2.162386 -2.258133 -2.402177 -2.537661 -2.645093 -2.774800 -2.906142 -3.008028 -3.130414 -3.222197 0.000000 -0.3024163 -0.5882362 -0.7673797 -0.9348288 -1.096565 -1.242116 -1.381902 -1.535704 -1.665759 -1.728013 -1.814363 -1.952744 -2.057837 -2.176247 -2.301096 -2.398296 -2.517691 -2.609303 -2.727927 -2.839067 0.000000 -0.2525589 -0.4875525 -0.6326878 -0.7696497 -0.9053043 -1.025461 -1.153002 -1.271171 -1.349311 -1.393338 -1.512853 -1.626387 -1.718223 -1.826305 -1.938047 -2.027220 -2.137531 -2.245700 -2.326161 -2.426845 0.000000 -0.2024831 -0.3868455 -0.5038659 -0.6138774 -0.7085799 -0.8218439 -0.9199682 -0.9934890 -1.028246 -1.128018 -1.214053 -1.303766 -1.400088 -1.485572 -1.582279 -1.680674 -1.763389 -1.859418 -1.949283 -2.035911 0.000000 -0.1521887 -0.2877504 -0.3734153 -0.4551384 -0.5328550 -0.6157517 -0.6834221 -0.7036266 -0.7724951 -0.8488428 -0.9239688 -0.9899961 -1.071011 -1.154519 -1.228698 -1.315655 -1.399206 -1.479800 -1.559181 -1.618973 0.000000 -0.1016765 -0.1904439 -0.2481370 -0.3004628 -0.3552247 -0.4030849 -0.4306833 -0.4760731 -0.5187876 -0.5706643 -0.6227879 -0.6831983 -0.7464609 -0.8049696 -0.8732113 -0.9400419 -1.005908 -1.072678 -1.127207 -1.190053 0.000000 -5.0948594E-02 -9.4535269E-02 -0.1227323 -0.1510031 -0.1725030 -0.1945065 -0.2166041 -0.2394843 -0.2644982 -0.2927807 -0.3211682 -0.3558031 -0.3936206 -0.4333753 -0.4740322 -0.5149694 -0.5563828 -0.5976673 -0.6380821 -0.6786242 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.5355183 -1.051025 -1.548087 -2.026603 -2.480808 -2.912665 -3.326220 -3.724482 -4.109962 -4.484373 -4.849058 -5.205215 -5.554296 -5.897825 -6.160551 -6.472597 -6.778533 -7.079218 -7.375738 -7.668618 0.000000 -0.5093302 -1.000795 -1.475759 -1.933653 -2.367173 -2.777361 -3.167819 -3.541176 -3.899715 -4.244952 -4.578164 -4.901792 -5.218593 -5.458967 -5.742232 -6.019676 -6.291841 -6.558536 -6.825382 -7.088184 0.000000 -0.4830854 -0.9503117 -1.402895 -1.839769 -2.251892 -2.639235 -3.004818 -3.350830 -3.679535 -3.994828 -4.300765 -4.598842 -4.830643 -5.094625 -5.354467 -5.605332 -5.856841 -6.104568 -6.279251 -6.496483 0.000000 -0.4567717 -0.8995878 -1.329496 -1.744938 -2.134893 -2.498060 -2.836763 -3.153257 -3.453921 -3.744201 -4.028648 -4.254314 -4.502963 -4.745463 -4.984311 -5.214324 -5.446050 -5.614070 -5.818035 -6.015256 0.000000 -0.4303960 -0.8486179 -1.255567 -1.649140 -2.016094 -2.353582 -2.663362 -2.951695 -3.227527 -3.495229 -3.721084 -3.954606 -4.184809 -4.402152 -4.625726 -4.844144 -4.999661 -5.186424 -5.380649 -5.569656 0.000000 -0.4039637 -0.7974029 -1.181096 -1.552380 -1.895395 -2.205487 -2.486364 -2.748328 -3.000892 -3.250653 -3.448801 -3.662024 -3.871804 -4.082067 -4.281554 -4.434911 -4.620750 -4.800406 -4.973885 -5.142448 0.000000 -0.3774627 -0.7459425 -1.106089 -1.454625 -1.772663 -2.053802 -2.307204 -2.545114 -2.778112 -2.977628 -3.178015 -3.380982 -3.575760 -3.758814 -3.956992 -4.093812 -4.258362 -4.416156 -4.579639 -4.746763 0.000000 -0.3509056 -0.6942302 -1.030545 -1.355875 -1.647739 -1.899543 -2.127117 -2.343937 -2.558626 -2.731270 -2.924555 -3.105551 -3.282864 -3.467400 -3.601459 -3.751761 -3.903029 -4.061419 -4.217031 -4.320375 0.000000 -0.3242807 -0.6422809 -0.9544672 -1.256093 -1.520419 -1.743542 -1.946574 -2.143399 -2.342269 -2.501601 -2.671035 -2.839305 -3.010470 -3.173078 -3.277598 -3.429405 -3.576958 -3.720399 -3.820967 -3.939471 0.000000 -0.2975929 -0.5900876 -0.8778595 -1.155243 -1.390815 -1.586835 -1.767933 -1.951088 -2.110149 -2.270035 -2.426633 -2.585034 -2.733269 -2.844861 -2.986701 -3.122764 -3.253650 -3.377551 -3.451997 -3.564296 0.000000 -0.2708499 -0.5376502 -0.8007115 -1.053295 -1.259403 -1.429977 -1.594980 -1.760101 -1.901763 -2.045503 -2.191773 -2.326452 -2.463220 -2.572897 -2.697710 -2.814692 -2.922076 -3.029855 -3.111165 -3.220193 0.000000 -0.2440380 -0.4849700 -0.7230281 -0.9501743 -1.126886 -1.275564 -1.423344 -1.576780 -1.694387 -1.829641 -1.951796 -2.076749 -2.186741 -2.300562 -2.403606 -2.495478 -2.603589 -2.688334 -2.787590 -2.882812 0.000000 -0.2171720 -0.4320416 -0.6448112 -0.8458004 -0.9943070 -1.125585 -1.258183 -1.373969 -1.498527 -1.609864 -1.721627 -1.840289 -1.931026 -2.021792 -2.101566 -2.207254 -2.309065 -2.381558 -2.465387 -2.543683 0.000000 -0.1902375 -0.3788773 -0.5660616 -0.7400337 -0.8629694 -0.9761033 -1.093199 -1.197364 -1.298724 -1.396669 -1.501606 -1.599892 -1.667556 -1.744108 -1.839136 -1.928499 -2.015130 -2.073397 -2.139791 -2.197099 0.000000 -0.1632412 -0.3254720 -0.4867861 -0.6329127 -0.7334644 -0.8325397 -0.9309593 -1.018137 -1.102760 -1.193842 -1.278346 -1.351125 -1.413868 -1.498136 -1.576115 -1.649499 -1.717987 -1.761500 -1.802590 -1.825628 0.000000 -0.1361908 -0.2718255 -0.4069732 -0.5249791 -0.6068903 -0.6873535 -0.7719740 -0.8393672 -0.9165109 -0.9875271 -1.047027 -1.117175 -1.182087 -1.249562 -1.311088 -1.365440 -1.414082 -1.447501 -1.441830 -1.472641 0.000000 -0.1090724 -0.2179389 -0.3266309 -0.4169349 -0.4825911 -0.5478989 -0.6109190 -0.6700007 -0.7273542 -0.7751921 -0.8352687 -0.8968565 -0.9558886 -0.9982209 -1.039576 -1.072574 -1.090367 -1.107281 -1.138567 -1.171031 0.000000 -8.1898831E-02 -0.1638064 -0.2457592 -0.3104284 -0.3592645 -0.4066595 -0.4570820 -0.4976966 -0.5376315 -0.5833759 -0.6284960 -0.6732572 -0.7123108 -0.7441828 -0.7550001 -0.7660358 -0.8014492 -0.8280898 -0.8476549 -0.8679623 0.000000 -5.4658044E-02 -0.1094428 -0.1643616 -0.2056392 -0.2377627 -0.2704465 -0.3004847 -0.3291874 -0.3597400 -0.3896170 -0.4179499 -0.4424939 -0.4571214 -0.4732656 -0.4974097 -0.5166286 -0.5413213 -0.5541452 -0.5729695 -0.5858485 0.000000 -2.7356146E-02 -5.4839984E-02 -8.2446165E-02 -0.1021661 -0.1182912 -0.1339587 -0.1499424 -0.1656920 -0.1787190 -0.1901568 -0.2022611 -0.2148526 -0.2269580 -0.2392410 -0.2516834 -0.2644508 -0.2780104 -0.2863041 -0.2939225 -0.3055578 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 12.94686 14.19368 14.89234 15.43551 15.78473 16.09194 16.37912 16.54193 16.73581 16.84452 16.82991 16.98771 17.06384 17.01523 16.93302 16.96118 17.00299 16.98512 16.92096 16.82270 0.000000 12.73902 14.04925 14.75463 15.23653 15.55514 15.84452 16.11213 16.25977 16.42956 16.53674 16.51569 16.49947 16.56342 16.62866 16.63709 16.53921 16.54109 16.48754 16.49956 16.39902 0.000000 12.65950 13.78343 14.58506 15.08457 15.35809 15.58467 15.80740 15.99935 16.11479 16.21315 16.13977 16.25178 16.21983 16.20484 16.15240 16.18231 16.13463 16.14515 16.14395 16.08840 0.000000 12.62191 13.65471 14.27584 14.83387 15.00391 15.35439 15.44689 15.62256 15.71732 15.78998 15.82563 15.75364 15.77378 15.75305 15.78279 15.68797 15.62732 15.64563 15.60797 15.50484 0.000000 12.51905 13.56004 14.14475 14.52602 14.78611 15.03509 15.22376 15.34851 15.33300 15.37710 15.38231 15.46066 15.33096 15.32091 15.35424 15.35045 15.27374 15.27415 15.18028 15.04802 0.000000 12.30126 13.41463 13.97816 14.34068 14.57054 14.78399 14.87781 14.97684 14.94761 15.00003 15.00301 15.00902 14.94223 14.92575 14.97892 14.91466 14.86484 14.80205 14.65253 14.65174 0.000000 12.21522 13.14873 13.66434 14.04028 14.25202 14.43970 14.62628 14.58707 14.66652 14.58646 14.62513 14.64466 14.56655 14.61468 14.60591 14.49519 14.42072 14.28967 14.26926 14.24494 0.000000 12.12234 13.01429 13.53489 13.84468 14.05867 14.21580 14.28134 14.21639 14.31775 14.24510 14.28807 14.28636 14.25919 14.24315 14.13534 14.08599 13.98325 13.98887 13.91945 13.80935 0.000000 12.05515 12.90883 13.36652 13.55924 13.73778 13.86710 13.94649 13.88118 13.99105 13.92463 13.96211 13.88461 13.91735 13.80688 13.83551 13.69938 13.63161 13.63929 13.51356 13.51299 0.000000 11.94007 12.63077 13.06161 13.36788 13.54527 13.55828 13.62475 13.57723 13.54061 13.62138 13.62479 13.57132 13.54731 13.49634 13.39719 13.37642 13.36829 13.24215 13.11330 13.11857 0.000000 11.72114 12.49117 12.92305 13.09023 13.24779 13.25996 13.33361 13.27725 13.24655 13.30044 13.23944 13.24754 13.16274 13.08636 13.12606 13.09626 12.96063 12.83414 12.77900 12.70813 0.000000 11.61225 12.37276 12.62482 12.89251 12.96154 13.05975 13.04350 12.98810 12.96507 13.05172 12.94146 12.87670 12.86791 12.78524 12.78768 12.68077 12.55822 12.58233 12.53353 12.41552 0.000000 11.48746 12.08071 12.48215 12.62386 12.76935 12.77445 12.75932 12.70416 12.69231 12.77142 12.69518 12.61077 12.55772 12.42958 12.41549 12.34902 12.25839 12.22032 12.21191 12.13541 0.000000 11.34360 11.92220 12.17526 12.42498 12.47818 12.49635 12.48269 12.41165 12.41030 12.46853 12.29993 12.26892 12.19533 12.19993 12.11763 12.04458 11.98416 11.95807 11.86379 11.79342 0.000000 11.17562 11.73869 11.98315 12.14077 12.19776 12.21704 12.20943 12.20891 12.17705 12.11584 12.03216 12.05994 11.96307 11.93347 11.92412 11.78736 11.79261 11.71402 11.64397 11.58562 0.000000 10.97550 11.42380 11.68211 11.81274 11.87453 11.93569 11.94267 11.92426 11.82128 11.79251 11.81636 11.73160 11.80854 11.72812 11.59881 11.58710 11.48251 11.47733 11.41860 11.39326 0.000000 10.73048 11.20869 11.45429 11.59933 11.57688 11.62169 11.67029 11.68274 11.60693 11.58691 11.60233 11.60275 11.56209 11.42997 11.43093 11.36318 11.39630 11.33048 11.29091 11.32771 0.000000 10.41766 10.92086 11.06019 11.23898 11.35074 11.33465 11.40574 11.33867 11.40484 11.33434 11.38982 11.41707 11.32932 11.26501 11.27785 11.32057 11.26200 11.29185 11.30927 11.25616 0.000000 9.986932 10.51795 10.72029 10.90294 10.97494 10.99953 11.10443 11.09049 11.17574 11.15942 11.12933 11.19292 11.15462 11.11163 11.18457 11.22726 11.17850 11.11444 11.16733 11.08874 0.000000 9.227264 9.724473 9.926026 10.01659 10.05013 10.04839 10.02216 9.976958 10.02792 9.968237 9.913483 9.849267 9.894349 9.802653 9.836349 9.771955 9.712443 9.698032 9.638566 9.575015 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 11.92099 13.13241 13.80751 14.32372 14.77561 15.08451 15.26397 15.46886 15.60292 15.60508 15.72499 15.67926 15.80693 15.86650 15.87421 15.79587 15.80449 15.68014 15.66004 15.55573 0.000000 11.72123 12.99341 13.67106 14.12226 14.43474 14.70590 14.96583 15.10219 15.16051 15.27617 15.32108 15.40733 15.38035 15.35397 15.40026 15.39517 15.44044 15.39111 15.36002 15.26836 0.000000 11.64283 12.74055 13.51245 13.84809 14.22775 14.47091 14.61679 14.80566 14.90648 14.89810 14.89519 14.97777 14.99325 15.04350 15.04481 14.96060 14.96616 14.87493 14.86852 14.76889 0.000000 11.55843 12.61662 13.21614 13.74481 14.03029 14.23074 14.26225 14.41691 14.43740 14.52562 14.62979 14.59816 14.64314 14.59491 14.61396 14.54360 14.55754 14.53281 14.48090 14.38410 0.000000 11.50475 12.52454 13.08551 13.45183 13.70542 13.84422 13.98897 14.09082 14.20679 14.21579 14.26936 14.21004 14.25816 14.20994 14.24308 14.12551 14.15838 14.13585 14.07171 13.97117 0.000000 11.40008 12.37907 12.92062 13.26650 13.38998 13.65171 13.76804 13.86667 13.84113 13.85436 13.90118 13.86062 13.89480 13.84376 13.86443 13.71428 13.70642 13.70467 13.62078 13.51402 0.000000 11.20036 12.12218 12.62405 12.94555 13.18248 13.32711 13.52451 13.49113 13.57056 13.49280 13.53521 13.48687 13.53953 13.47869 13.47622 13.33358 13.33630 13.19624 13.20535 13.17875 0.000000 11.10847 11.99062 12.49791 12.78507 13.00246 13.14243 13.19898 13.12936 13.23939 13.16403 13.21375 13.19276 13.17484 13.13835 13.04192 12.99969 12.96087 12.85306 12.81571 12.69631 0.000000 11.00895 11.88592 12.31790 12.60460 12.68358 12.80502 12.86549 12.82457 12.92194 12.85137 12.90175 12.83753 12.72569 12.69874 12.73549 12.66444 12.57238 12.54154 12.42638 12.43469 0.000000 10.92688 11.73760 12.03606 12.32228 12.49588 12.49956 12.57872 12.52020 12.61689 12.55354 12.47780 12.49123 12.41793 12.38141 12.41202 12.31480 12.25317 12.23201 12.16481 12.07804 0.000000 10.69932 11.47308 11.89870 12.01611 12.20769 12.31042 12.28556 12.22726 12.32495 12.26154 12.17807 12.22064 12.10331 12.14066 11.98209 11.95599 11.90656 11.79696 11.74669 11.65707 0.000000 10.59187 11.32193 11.60592 11.85940 11.92862 12.02135 12.00280 11.94645 12.04022 11.95761 11.92457 11.81182 11.82025 11.78548 11.70668 11.60910 11.54140 11.44581 11.44106 11.42835 0.000000 10.46866 11.17997 11.46588 11.56084 11.72674 11.74488 11.72426 11.67581 11.74498 11.69882 11.55575 11.54571 11.49893 11.42476 11.42542 11.33176 11.25292 11.19982 11.10423 11.11832 0.000000 10.32619 10.90655 11.15961 11.40253 11.45515 11.46957 11.45291 11.40982 11.42565 11.34842 11.29752 11.24897 11.24283 11.22246 11.09438 11.04954 10.97781 10.93687 10.85297 10.78167 0.000000 10.15957 10.72501 10.96987 11.08962 11.17844 11.19001 11.18532 11.13317 11.14598 11.10964 11.09387 11.01240 10.95033 10.90535 10.87791 10.82668 10.80307 10.66187 10.56708 10.52411 0.000000 9.960967 10.52102 10.66742 10.79829 10.85919 10.88498 10.92100 10.90117 10.90164 10.86662 10.76976 10.75142 10.68065 10.65824 10.61637 10.57996 10.54635 10.46480 10.41519 10.39577 0.000000 9.717672 10.19155 10.44082 10.58828 10.56028 10.60253 10.64823 10.65199 10.55262 10.54774 10.55326 10.54347 10.51567 10.41506 10.36309 10.36744 10.37609 10.27031 10.23094 10.22747 0.000000 9.406602 9.904834 10.14569 10.22122 10.33108 10.30872 10.37369 10.30798 10.35732 10.28834 10.33280 10.34394 10.27605 10.30733 10.20290 10.24277 10.23101 10.16742 10.17039 10.21438 0.000000 8.976733 9.500653 9.699032 9.874537 9.939949 9.958715 10.04315 10.03149 10.02198 10.08830 10.05125 10.10562 10.06962 10.11731 10.06419 10.11739 10.06741 10.09286 10.02814 10.06466 0.000000 8.223505 8.718682 8.919918 9.010710 9.044855 9.043967 9.018546 8.974161 9.015354 8.971870 8.917861 8.947159 8.872667 8.811315 8.835533 8.782242 8.774092 8.710341 8.651610 8.637730 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 10.89004 12.06758 12.71353 13.20465 13.62603 13.88911 14.08123 14.15600 14.28684 14.32492 14.43256 14.53025 14.57397 14.50834 14.56378 14.47571 14.41425 14.43250 14.45284 14.38225 0.000000 10.70015 11.92920 12.57774 13.00474 13.31115 13.64114 13.83263 13.99380 13.98842 14.14575 14.21164 14.16105 14.22587 14.24353 14.15692 14.09576 14.10723 14.12446 14.04625 14.08336 0.000000 10.62302 11.69149 12.42470 12.83079 13.15378 13.30314 13.46608 13.64541 13.74801 13.78372 13.87297 13.86588 13.81224 13.77638 13.80806 13.79232 13.81450 13.71572 13.63470 13.65471 0.000000 10.54003 11.57027 12.14662 12.51880 12.90598 13.10366 13.13735 13.28538 13.33679 13.41781 13.42745 13.47478 13.52786 13.51379 13.42993 13.42548 13.33942 13.32875 13.29501 13.21629 0.000000 10.45159 11.44315 12.01861 12.36868 12.60846 12.74142 12.87398 13.01227 13.11923 13.12624 13.15607 13.12041 13.11304 13.08676 12.99672 12.98699 12.88231 12.93063 12.88902 12.87250 0.000000 10.38340 11.33786 11.86052 12.18853 12.31048 12.54687 12.67128 12.70599 12.78682 12.74450 12.79778 12.72227 12.72849 12.66609 12.61378 12.60098 12.55839 12.47324 12.47403 12.45246 0.000000 10.18437 11.09122 11.57928 11.88578 12.11330 12.23864 12.38981 12.36229 12.33033 12.40798 12.35743 12.37290 12.37507 12.30942 12.26801 12.27084 12.21747 12.10525 12.06130 11.97779 0.000000 10.09351 10.96277 11.45357 11.72835 11.91618 12.04110 12.10234 12.04205 12.02934 12.09148 12.03833 12.08629 12.03932 11.92528 11.96108 11.82366 11.76626 11.77039 11.75731 11.68313 0.000000 9.995104 10.82551 11.27769 11.54794 11.63416 11.74072 11.79469 11.74776 11.72287 11.78630 11.72257 11.66866 11.65405 11.63737 11.54642 11.50300 11.49846 11.44437 11.41222 11.34929 0.000000 9.888055 10.70375 11.00660 11.28098 11.43528 11.44831 11.51717 11.45350 11.43018 11.49270 11.45064 11.36958 11.37185 11.33524 11.21741 11.13640 11.15953 11.07867 11.05498 10.96363 0.000000 9.791063 10.45304 10.86897 11.09846 11.16626 11.26101 11.23329 11.16957 11.15252 11.19714 11.18181 11.08928 11.07358 10.97563 10.95695 10.89552 10.87458 10.80713 10.69006 10.61673 0.000000 9.570940 10.30442 10.69371 10.83570 10.89557 10.97931 10.95909 10.89683 10.88830 10.87891 10.82211 10.81181 10.69646 10.70515 10.70467 10.60431 10.54330 10.41918 10.39100 10.30367 0.000000 9.449402 10.16528 10.41236 10.54008 10.69459 10.71043 10.68827 10.63473 10.63210 10.62070 10.55308 10.50474 10.41378 10.42238 10.38828 10.28994 10.25545 10.14562 10.04672 10.05328 0.000000 9.308541 9.889749 10.25375 10.37076 10.42576 10.44350 10.42238 10.38128 10.37457 10.34557 10.32547 10.23379 10.17289 10.10281 10.06449 9.978683 9.967447 9.879417 9.814674 9.767596 0.000000 9.143364 9.710291 9.956565 10.07572 10.12755 10.17133 10.16037 10.12868 10.10046 10.10952 10.08084 9.943789 9.901877 9.884277 9.811803 9.744416 9.667590 9.593583 9.592631 9.557785 0.000000 8.946327 9.496851 9.753134 9.783929 9.847214 9.865978 9.897985 9.858006 9.874663 9.779521 9.789998 9.738763 9.662897 9.652217 9.559792 9.516930 9.446370 9.419132 9.420155 9.381218 0.000000 8.704808 9.174205 9.426590 9.552399 9.642644 9.586180 9.622432 9.624525 9.552718 9.518984 9.497063 9.463964 9.437490 9.429656 9.412586 9.272412 9.260128 9.252197 9.246398 9.135232 0.000000 8.395570 8.888866 9.127630 9.203559 9.294507 9.283414 9.323257 9.274313 9.329009 9.338500 9.265892 9.277920 9.209518 9.205978 9.230204 9.144259 9.164127 9.161581 9.072136 9.070001 0.000000 7.966810 8.483905 8.678502 8.847769 8.907019 8.920245 8.995515 8.978963 9.055458 9.020410 8.977935 9.024126 8.982584 9.018098 8.963812 9.000052 8.940327 8.971369 8.922412 8.935681 0.000000 7.220071 7.713210 7.914137 8.005239 8.040049 8.040119 8.015543 8.057436 8.018749 7.976099 7.922947 7.954777 7.881406 7.821158 7.846126 7.763300 7.777009 7.724072 7.715638 7.652641 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 9.851875 10.95580 11.63407 12.03464 12.36251 12.69145 12.88945 12.97323 13.03121 13.13427 13.15510 13.22937 13.24876 13.31307 13.30785 13.23375 13.24716 13.27125 13.20654 13.12061 0.000000 9.673233 10.85341 11.47189 11.87658 12.15345 12.34225 12.52118 12.68515 12.76290 12.86425 12.89377 12.96431 12.91042 12.93798 12.91147 12.92747 12.96555 12.96031 12.85907 12.88021 0.000000 9.597476 10.63107 11.21067 11.70674 12.00893 12.13900 12.38500 12.51272 12.61936 12.67138 12.67380 12.61630 12.57997 12.59648 12.55998 12.56592 12.49317 12.49098 12.43573 12.45533 0.000000 9.516097 10.51367 11.06432 11.41862 11.77658 11.97250 12.08139 12.19715 12.27958 12.32547 12.33953 12.35389 12.26859 12.29296 12.27622 12.20986 12.19489 12.16136 12.10217 12.01138 0.000000 9.429408 10.39046 10.94114 11.27031 11.48951 11.67164 11.84949 11.90295 11.94024 12.00930 11.97702 11.98783 11.90469 11.92136 11.90351 11.87366 11.77123 11.68607 11.66947 11.62887 0.000000 9.361670 10.28733 10.77819 11.09368 11.29776 11.43270 11.55700 11.58209 11.59869 11.67507 11.63997 11.60186 11.55946 11.55797 11.53597 11.52149 11.43992 11.31824 11.23015 11.22283 0.000000 9.259591 10.15303 10.52065 10.81101 11.02272 11.23162 11.31795 11.25506 11.28461 11.35367 11.32010 11.25528 11.20592 11.19337 11.19286 11.11144 11.00563 11.05203 10.94699 10.92999 0.000000 9.076132 9.926397 10.36665 10.65723 10.83236 10.94549 11.00145 10.94475 10.98215 11.04561 10.98890 10.90984 10.91351 10.90484 10.78044 10.77204 10.74667 10.72462 10.66684 10.57655 0.000000 8.978928 9.792991 10.22720 10.48245 10.56420 10.65704 10.70809 10.66104 10.68899 10.72595 10.69051 10.56005 10.55044 10.55256 10.44066 10.45586 10.42662 10.35567 10.24831 10.12383 0.000000 8.873162 9.672410 9.966864 10.22971 10.36993 10.38339 10.43845 10.37788 10.40578 10.33947 10.31453 10.27309 10.25931 10.20042 10.21153 10.13461 10.05968 10.00579 9.878340 9.847506 0.000000 8.757438 9.427791 9.833543 10.04907 10.10396 10.18966 10.16862 10.10307 10.13015 10.07540 10.05250 10.03799 10.00857 9.918331 9.856911 9.817653 9.687283 9.688209 9.561604 9.470076 0.000000 8.644692 9.281636 9.658073 9.794699 9.918079 9.925406 9.900466 9.837726 9.852183 9.821762 9.780473 9.699811 9.716599 9.680273 9.510363 9.485414 9.394655 9.396796 9.277697 9.202264 0.000000 8.429655 9.120705 9.386661 9.605664 9.655076 9.665522 9.635835 9.581387 9.609226 9.556889 9.481727 9.463919 9.461530 9.327317 9.250602 9.209792 9.177453 9.085325 9.033783 8.965252 0.000000 8.290573 8.960366 9.221416 9.342531 9.394138 9.401720 9.371925 9.333354 9.369143 9.293240 9.217495 9.237003 9.162489 9.042526 9.046414 8.959409 8.853187 8.856159 8.819153 8.769174 0.000000 8.127043 8.693171 8.937386 9.053106 9.100999 9.109832 9.088012 9.086541 9.041072 8.978365 9.007169 8.916984 8.847874 8.848163 8.744769 8.681471 8.612133 8.637471 8.597621 8.557305 0.000000 7.931648 8.482376 8.737698 8.858776 8.915456 8.840794 8.834454 8.824906 8.803775 8.745327 8.791660 8.657457 8.617494 8.565775 8.500673 8.494753 8.447438 8.422587 8.375858 8.309904 0.000000 7.691977 8.156525 8.410351 8.534774 8.614002 8.562744 8.569640 8.587789 8.554699 8.549314 8.517403 8.405617 8.404802 8.351310 8.343060 8.240011 8.272349 8.235159 8.155490 8.082588 0.000000 7.384696 7.873008 8.112567 8.184824 8.271969 8.256738 8.291202 8.242135 8.289414 8.278877 8.233204 8.222349 8.205787 8.134445 8.153769 8.128455 8.137198 8.042166 8.040550 8.051325 0.000000 6.957370 7.467784 7.658770 7.821744 7.875096 7.883246 7.948668 7.944406 7.997904 7.955317 7.996802 7.951115 7.980923 7.925680 7.956566 7.890392 7.912803 7.851520 7.874338 7.886563 0.000000 6.217453 6.708367 6.908969 7.000434 7.036032 7.037076 7.013471 7.052124 7.022301 6.980629 6.999276 6.942422 6.890629 6.902971 6.834792 6.776698 6.790331 6.713230 6.721947 6.670722 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 8.806581 9.868299 10.50893 10.88864 11.19435 11.47981 11.65646 11.74267 11.85420 11.95455 11.99626 11.98724 12.04398 12.05088 12.09723 12.09225 12.05396 12.07841 12.05908 11.99942 0.000000 8.639856 9.766412 10.35318 10.73508 10.99504 11.17244 11.33401 11.48878 11.55863 11.65470 11.73836 11.72484 11.75569 11.79344 11.75188 11.77324 11.74633 11.66519 11.65360 11.57151 0.000000 8.565459 9.559506 10.10962 10.57056 10.85499 10.97265 11.11890 11.28099 11.35401 11.41375 11.44724 11.40325 11.42350 11.47166 11.47023 11.46514 11.40649 11.36035 11.26242 11.25813 0.000000 8.485738 9.446054 9.968081 10.30121 10.63201 10.79064 10.88460 10.93351 11.02523 11.06674 11.08675 11.12697 11.06812 11.05330 11.00707 10.94245 10.93073 10.95106 10.93340 10.87096 0.000000 8.400889 9.326946 9.847865 10.15532 10.35926 10.49103 10.57531 10.70651 10.80830 10.85435 10.82774 10.80290 10.71390 10.70884 10.63502 10.58462 10.56529 10.58193 10.46986 10.48612 0.000000 8.310828 9.223313 9.689323 9.984259 10.17362 10.29600 10.40158 10.51333 10.51174 10.53515 10.45698 10.44873 10.35962 10.36067 10.28918 10.23294 10.22609 10.18299 10.16928 10.13817 0.000000 8.231350 9.092745 9.446069 9.717895 9.912930 10.10132 10.17822 10.21838 10.20786 10.20475 10.14130 10.12099 10.03739 10.02531 9.957557 9.978652 9.870722 9.807122 9.772565 9.726007 0.000000 8.054583 8.878311 9.297238 9.567025 9.720528 9.831157 9.866266 9.935864 9.907345 9.885373 9.820684 9.809784 9.731605 9.722912 9.678988 9.584065 9.502646 9.431397 9.396731 9.299849 0.000000 7.958728 8.748408 9.161548 9.395413 9.539370 9.547121 9.600888 9.634160 9.603108 9.621369 9.523871 9.504750 9.439391 9.446266 9.361156 9.238960 9.194480 9.181162 9.055257 8.973424 0.000000 7.854400 8.630580 8.912539 9.156236 9.283877 9.360498 9.326389 9.263220 9.325123 9.344094 9.249249 9.238363 9.171048 9.138636 9.019624 8.969810 8.924669 8.832387 8.789657 8.698628 0.000000 7.740222 8.479685 8.754523 8.982232 9.032674 9.098718 9.039163 8.998816 9.065598 9.063473 8.985219 8.898183 8.866316 8.840686 8.754354 8.650846 8.597926 8.582210 8.494351 8.401279 0.000000 7.614434 8.250748 8.602809 8.737946 8.846532 8.845431 8.781165 8.747149 8.809171 8.762196 8.719629 8.640650 8.555675 8.576720 8.490245 8.399071 8.320267 8.279395 8.223101 8.175344 0.000000 7.484718 8.093114 8.350320 8.550900 8.589827 8.591981 8.530272 8.506371 8.553967 8.495326 8.442794 8.364618 8.355787 8.285025 8.207040 8.190644 8.079731 7.955791 7.916799 7.835910 0.000000 7.272323 7.931451 8.187675 8.303615 8.320215 8.321485 8.285250 8.270000 8.291988 8.260844 8.186413 8.129536 8.115427 8.068700 7.977336 7.894402 7.807602 7.729146 7.638531 7.562487 0.000000 7.110684 7.671958 7.911130 8.021513 8.146198 8.066038 8.040299 8.036570 7.986855 7.974321 7.922494 7.881881 7.854561 7.798076 7.745462 7.602536 7.532219 7.504016 7.437365 7.372279 0.000000 6.917072 7.464289 7.696644 7.822956 7.872658 7.804733 7.794139 7.797329 7.760188 7.755175 7.707261 7.669496 7.569371 7.553845 7.501481 7.376538 7.378417 7.341135 7.267940 7.217628 0.000000 6.679400 7.211462 7.390649 7.511265 7.585756 7.531619 7.534803 7.535232 7.517394 7.452112 7.476195 7.426796 7.329807 7.296747 7.247235 7.212262 7.204669 7.181595 7.133156 7.088401 0.000000 6.374320 6.857373 7.095081 7.163536 7.245317 7.226162 7.255490 7.279171 7.218285 7.225628 7.227422 7.159848 7.140044 7.070620 7.059057 7.100589 7.031959 7.016268 6.944225 6.926672 0.000000 5.948986 6.452560 6.639990 6.795384 6.843005 6.846495 6.903604 6.893514 6.926662 6.890968 6.913733 6.874117 6.892560 6.837065 6.856457 6.863521 6.807131 6.802737 6.751549 6.749913 0.000000 5.216949 5.704925 5.905025 5.996833 6.033332 6.035336 6.012750 6.054690 6.025961 5.985506 6.005850 5.950615 5.900226 5.913479 5.847400 5.850936 5.804915 5.790508 5.738677 5.726340 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 7.754914 8.771070 9.373268 9.731774 10.01542 10.27771 10.44047 10.52038 10.62198 10.71791 10.72296 10.78063 10.75041 10.78126 10.81282 10.77310 10.79171 10.80515 10.74741 10.67591 0.000000 7.600913 8.670668 9.225359 9.584531 9.825968 9.999599 10.20387 10.30989 10.42953 10.47856 10.47594 10.52162 10.52691 10.55737 10.56982 10.50933 10.45860 10.47915 10.46740 10.41346 0.000000 7.527914 8.479612 9.000222 9.427705 9.657759 9.846529 9.931274 10.08216 10.08093 10.10426 10.14431 10.17543 10.17346 10.20025 10.21387 10.14775 10.13606 10.12744 10.04540 10.05046 0.000000 7.449860 8.370064 8.864309 9.176615 9.480147 9.626606 9.710968 9.757937 9.826858 9.900450 9.968829 9.992874 9.979417 9.975773 9.974190 9.876242 9.791370 9.720297 9.689951 9.598531 0.000000 7.366898 8.254908 8.721652 9.035081 9.223621 9.344898 9.515432 9.576557 9.608882 9.629650 9.630624 9.663741 9.632085 9.632947 9.590579 9.487908 9.396588 9.358192 9.287911 9.284484 0.000000 7.278859 8.153134 8.593147 8.866529 9.039710 9.153196 9.242843 9.331147 9.328313 9.313964 9.331544 9.345778 9.317009 9.293046 9.199184 9.102332 9.048941 9.034551 8.958434 8.864156 0.000000 7.199861 8.025858 8.364835 8.617514 8.773807 8.959333 9.032677 9.052897 9.039560 9.019664 9.030832 9.037954 8.989121 8.860939 8.854785 8.738725 8.727919 8.693938 8.633037 8.550040 0.000000 7.029142 7.823010 8.221152 8.469902 8.608076 8.699280 8.758682 8.784114 8.763359 8.735945 8.741154 8.722078 8.581539 8.562044 8.492643 8.420250 8.384950 8.375607 8.301233 8.210814 0.000000 6.934746 7.696572 8.086281 8.301948 8.371539 8.423036 8.478428 8.528639 8.494473 8.457821 8.440395 8.366693 8.284951 8.279124 8.175839 8.160648 8.103791 8.033838 7.942890 7.839078 0.000000 6.831966 7.561066 7.850759 8.054404 8.189363 8.255589 8.289773 8.271541 8.232112 8.175306 8.087057 8.094857 8.002523 7.934993 7.911401 7.816487 7.782958 7.714015 7.609228 7.588783 0.000000 6.719456 7.429301 7.697621 7.903377 7.950879 8.006269 8.043200 8.021296 7.963920 7.878733 7.831695 7.834726 7.740487 7.665052 7.662977 7.578955 7.494731 7.392496 7.350631 7.233797 0.000000 6.595484 7.214137 7.547368 7.650938 7.770247 7.765039 7.804392 7.776401 7.723171 7.624517 7.579865 7.566430 7.515374 7.415006 7.388567 7.340242 7.242782 7.133116 7.042809 6.962309 0.000000 6.457848 7.059737 7.306425 7.488407 7.524946 7.525323 7.568651 7.532118 7.485021 7.384260 7.382768 7.301120 7.233854 7.146756 7.131318 7.064793 6.985389 6.901665 6.803508 6.780396 0.000000 6.254020 6.901477 7.128497 7.231556 7.267504 7.341548 7.328506 7.277467 7.183764 7.169791 7.098532 7.039861 6.966068 6.959960 6.868948 6.765762 6.728186 6.675139 6.587988 6.502203 0.000000 6.094521 6.647471 6.879259 6.982687 7.091686 7.089772 7.082356 6.978915 6.945714 6.885094 6.885317 6.825948 6.762373 6.691054 6.610059 6.530016 6.499872 6.418700 6.336591 6.266215 0.000000 5.903080 6.443248 6.669094 6.787992 6.829010 6.838059 6.820566 6.750368 6.708840 6.660754 6.604883 6.595735 6.544372 6.461179 6.396752 6.356612 6.286048 6.217143 6.159710 6.102339 0.000000 5.667762 6.194052 6.368516 6.483895 6.535770 6.567671 6.497695 6.507335 6.470230 6.439591 6.398758 6.382561 6.311604 6.229544 6.188844 6.199508 6.093700 6.066949 6.013571 5.970015 0.000000 5.365442 5.842466 6.075909 6.140652 6.216300 6.261718 6.219481 6.230398 6.232817 6.171811 6.163773 6.138518 6.069320 6.065000 6.031087 6.020852 5.930387 5.912986 5.894339 5.869712 0.000000 4.943283 5.439133 5.622837 5.769400 5.811762 5.872073 5.868764 5.905313 5.869218 5.828073 5.845199 5.800820 5.806256 5.817808 5.758266 5.761658 5.703473 5.699450 5.643182 5.635048 0.000000 4.222070 4.704974 4.903969 4.995961 5.033277 5.036225 5.073087 5.059112 5.031755 4.992794 5.002362 4.961185 4.963962 4.911847 4.863026 4.866280 4.805138 4.803725 4.743423 4.741119 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 6.697876 7.665525 8.228120 8.565391 8.827188 9.066113 9.215769 9.285268 9.383924 9.470451 9.476338 9.517556 9.556459 9.528724 9.552487 9.534098 9.547241 9.554737 9.498712 9.431580 0.000000 6.557398 7.570634 8.091046 8.426860 8.651320 8.802795 8.999276 9.128764 9.137516 9.238841 9.245902 9.253098 9.297796 9.292242 9.323309 9.315002 9.242150 9.273339 9.248382 9.195537 0.000000 6.486177 7.393373 7.884875 8.278423 8.499755 8.637991 8.743993 8.868902 8.893300 8.996906 9.031146 9.055367 9.048123 9.070530 9.028331 8.991591 8.994584 8.965782 8.888266 8.889330 0.000000 6.410152 7.288692 7.756440 8.048205 8.259635 8.452799 8.534095 8.593551 8.691724 8.753690 8.770385 8.735399 8.723430 8.695566 8.637893 8.639981 8.609813 8.603045 8.511510 8.442071 0.000000 6.329414 7.178504 7.621835 7.893945 8.086776 8.198136 8.350953 8.370501 8.464371 8.419198 8.413966 8.392345 8.391440 8.362817 8.278823 8.259207 8.209764 8.208642 8.167805 8.095697 0.000000 6.243706 7.062789 7.494490 7.750099 7.910383 8.024017 8.077910 8.170760 8.182174 8.133138 8.116020 8.070816 8.049598 7.988739 7.953988 7.915549 7.872467 7.827137 7.813462 7.778946 0.000000 6.152730 6.952512 7.282030 7.518664 7.739614 7.826215 7.890030 7.887346 7.903907 7.850635 7.811841 7.768896 7.722059 7.678764 7.610089 7.592631 7.542439 7.527982 7.465158 7.386604 0.000000 6.065102 6.765376 7.143683 7.374620 7.503628 7.580495 7.630075 7.622119 7.636188 7.578676 7.531627 7.483878 7.444039 7.399183 7.328153 7.297881 7.245585 7.155536 7.093225 7.067114 0.000000 5.909070 6.642810 7.012310 7.210570 7.256875 7.319721 7.362516 7.359698 7.381087 7.309514 7.248188 7.223574 7.179762 7.116077 7.087436 7.003162 6.961539 6.881739 6.815691 6.714270 0.000000 5.807959 6.511624 6.789225 6.978962 7.094531 7.153396 7.175782 7.123497 7.127569 7.041388 7.035686 6.966111 6.903157 6.817152 6.815271 6.729484 6.681786 6.592940 6.509431 6.459693 0.000000 5.697252 6.382600 6.640436 6.821624 6.849696 6.913311 6.938311 6.883235 6.868524 6.810543 6.760550 6.689811 6.621251 6.595583 6.551953 6.473919 6.360421 6.281963 6.242774 6.205063 0.000000 5.575265 6.175730 6.493776 6.590710 6.691132 6.666824 6.712224 6.647241 6.632830 6.570321 6.493969 6.462671 6.387739 6.353016 6.287225 6.204798 6.108068 6.033582 5.992393 5.892839 0.000000 5.439842 6.024917 6.263127 6.433365 6.466063 6.502808 6.482509 6.412911 6.344911 6.281900 6.264162 6.170582 6.149271 6.089674 6.024818 5.946453 5.847468 5.825939 5.729795 5.648667 0.000000 5.293843 5.856603 6.088855 6.186995 6.215561 6.270514 6.253739 6.172051 6.130044 6.058196 5.995891 5.972871 5.892099 5.822200 5.762096 5.694041 5.632612 5.608713 5.519702 5.425473 0.000000 5.079709 5.622189 5.846867 6.003932 6.038010 6.036175 6.017889 5.973745 5.911560 5.849678 5.781047 5.767932 5.692187 5.594158 5.574136 5.519955 5.453022 5.382110 5.303491 5.231950 0.000000 4.891133 5.421684 5.641001 5.738055 5.789601 5.792091 5.767760 5.739249 5.684143 5.629587 5.575528 5.516912 5.460532 5.393526 5.379423 5.316892 5.261165 5.200654 5.132344 5.078913 0.000000 4.659045 5.176684 5.346527 5.456331 5.502662 5.527091 5.461030 5.488368 5.434042 5.382049 5.346209 5.300098 5.257985 5.220486 5.172552 5.111449 5.074296 5.016707 4.970608 4.933186 0.000000 4.360882 4.829743 5.057626 5.172225 5.188013 5.215041 5.184016 5.198407 5.175788 5.159739 5.104304 5.075164 5.041664 4.967882 4.963764 4.919931 4.907984 4.867501 4.831583 4.760383 0.000000 3.944745 4.430079 4.609303 4.746477 4.783907 4.829210 4.828037 4.852318 4.815794 4.829391 4.784204 4.784688 4.733077 4.727709 4.722210 4.669596 4.647749 4.599371 4.583894 4.567305 0.000000 3.242125 3.714121 3.910236 4.001738 4.039421 4.043183 4.081993 4.069392 4.043640 4.048932 4.017614 3.978493 3.973575 3.932786 3.927138 3.878695 3.832070 3.820667 3.774061 3.761411 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 5.644282 6.558284 7.081686 7.394393 7.634349 7.848779 7.974279 8.035583 8.107127 8.172184 8.188953 8.229187 8.229795 8.260108 8.252609 8.273968 8.257912 8.276733 8.267472 8.223502 0.000000 5.516151 6.465610 6.952675 7.264258 7.470895 7.608671 7.783813 7.895900 7.976762 7.994330 8.012244 8.053854 8.058404 8.027602 8.036545 8.020177 7.976404 7.974263 7.941292 7.882236 0.000000 5.446775 6.305894 6.766062 7.053844 7.317807 7.451477 7.549387 7.653673 7.702169 7.767868 7.752606 7.734945 7.743410 7.753185 7.782196 7.778680 7.726936 7.721662 7.663946 7.592108 0.000000 5.372669 6.205774 6.644323 6.915150 7.092441 7.280283 7.354544 7.462645 7.485203 7.487253 7.517941 7.511975 7.525280 7.499968 7.498616 7.441483 7.420701 7.377378 7.310447 7.299565 0.000000 5.294027 6.100301 6.516702 6.769865 6.946039 7.048137 7.178031 7.222153 7.218970 7.262703 7.233680 7.269587 7.267148 7.234897 7.165849 7.139818 7.067017 7.024898 6.986975 6.949972 0.000000 5.210587 5.989467 6.394154 6.631855 6.780171 6.870498 6.932583 6.960413 7.007305 6.998930 7.007681 6.983271 6.957695 6.924122 6.846915 6.801466 6.752490 6.657162 6.624070 6.545133 0.000000 5.122044 5.881863 6.198403 6.419689 6.550099 6.694083 6.735848 6.740678 6.730837 6.724209 6.729777 6.697731 6.650746 6.609736 6.521585 6.462618 6.388019 6.347636 6.271165 6.237906 0.000000 5.027966 5.707895 6.066227 6.283093 6.397400 6.455809 6.482992 6.486187 6.469772 6.464010 6.458014 6.422248 6.358304 6.267268 6.174204 6.153322 6.108179 6.021185 5.932536 5.898362 0.000000 4.885808 5.589547 5.925736 6.125582 6.229168 6.219651 6.249181 6.252443 6.220802 6.206495 6.193427 6.144661 6.082679 5.966733 5.902968 5.861953 5.782776 5.695953 5.639462 5.586603 0.000000 4.786712 5.462904 5.789400 5.905683 6.009611 6.055813 6.068911 6.014699 5.978044 5.950584 5.929070 5.828659 5.774097 5.717397 5.671992 5.568789 5.501001 5.405431 5.370955 5.307089 0.000000 4.678169 5.326638 5.585566 5.753734 5.780239 5.828390 5.836142 5.784344 5.742719 5.716713 5.635376 5.582359 5.535811 5.488144 5.385181 5.292358 5.223613 5.191298 5.141031 5.079198 0.000000 4.558569 5.139819 5.429886 5.534281 5.617331 5.651474 5.617145 5.557264 5.513301 5.434363 5.396389 5.374686 5.290326 5.209104 5.123213 5.089135 4.998847 4.962694 4.893339 4.808904 0.000000 4.425846 4.992899 5.221573 5.375113 5.389631 5.433784 5.391459 5.338799 5.281707 5.207852 5.202900 5.125211 5.047353 4.995428 4.902521 4.875556 4.780181 4.731188 4.635741 4.553530 0.000000 4.276752 4.828753 5.051898 5.143714 5.220379 5.208057 5.160657 5.124367 5.059428 4.999266 4.984879 4.918223 4.842891 4.759739 4.724237 4.639911 4.583412 4.505984 4.428055 4.390067 0.000000 4.069653 4.650537 4.869927 4.961405 4.989264 4.981271 4.961105 4.905455 4.851537 4.787416 4.749771 4.667171 4.594397 4.566289 4.497324 4.423580 4.384103 4.315524 4.243624 4.181291 0.000000 3.885383 4.404106 4.616383 4.708335 4.738763 4.734345 4.730741 4.675436 4.637076 4.584661 4.508410 4.453403 4.390812 4.363454 4.303545 4.246883 4.178128 4.112547 4.052273 4.006770 0.000000 3.658845 4.164515 4.379389 4.432464 4.474048 4.479973 4.473864 4.446672 4.404871 4.365688 4.291658 4.228700 4.184296 4.148390 4.085583 4.078088 3.992141 3.937167 3.893779 3.852512 0.000000 3.368448 3.823502 4.045093 4.146195 4.164524 4.186758 4.194746 4.144996 4.132172 4.110435 4.038007 4.017086 3.986132 3.948220 3.913166 3.883698 3.811535 3.773722 3.740834 3.716700 0.000000 2.965492 3.432489 3.642211 3.732561 3.764615 3.806866 3.796843 3.805607 3.772673 3.771484 3.730372 3.719078 3.710690 3.650978 3.640304 3.619712 3.571981 3.550291 3.530160 3.479830 0.000000 2.300833 2.747084 2.935481 3.024209 3.060993 3.101616 3.105335 3.093800 3.069513 3.076377 3.047016 3.042579 3.006740 2.968338 2.957647 2.918373 2.904305 2.864665 2.849514 2.809905 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 4.588469 5.460574 5.918959 6.230113 6.415908 6.563435 6.709542 6.782126 6.873165 6.910938 6.963737 6.976732 7.022784 7.041772 7.050451 7.024992 7.037340 7.029439 7.017353 6.976052 0.000000 4.480889 5.310571 5.812450 6.096600 6.283751 6.462080 6.565605 6.608758 6.700961 6.734605 6.783836 6.789598 6.816074 6.819354 6.770212 6.779245 6.761595 6.728281 6.723722 6.676246 0.000000 4.413683 5.220953 5.647298 5.910048 6.143033 6.260816 6.387784 6.468963 6.530101 6.550915 6.527057 6.566963 6.574865 6.561655 6.515381 6.500358 6.474022 6.464265 6.466143 6.399804 0.000000 4.341746 5.125803 5.533407 5.781833 5.942140 6.106155 6.172131 6.264321 6.281736 6.278388 6.308723 6.300067 6.302670 6.255482 6.242362 6.203990 6.212502 6.189898 6.107823 6.079465 0.000000 4.265409 5.025708 5.414110 5.646862 5.806110 5.896437 6.008358 6.033869 6.039568 6.072107 6.042644 6.053348 6.027464 6.017951 5.969401 5.926989 5.910032 5.829309 5.787613 5.732623 0.000000 4.184489 4.920648 5.298234 5.516978 5.651051 5.731855 5.773304 5.798826 5.847631 5.815928 5.773938 5.772725 5.723259 5.712407 5.657439 5.617660 5.591857 5.521889 5.455657 5.376972 0.000000 4.098719 4.817503 5.118948 5.324274 5.444715 5.565622 5.598513 5.600807 5.587541 5.570837 5.517664 5.499578 5.453950 5.435931 5.375161 5.321699 5.283854 5.180101 5.137219 5.054799 0.000000 4.007674 4.656289 4.993940 5.181935 5.296394 5.345669 5.363844 5.363922 5.343599 5.325706 5.262240 5.233616 5.190544 5.158236 5.081214 5.005214 4.962286 4.880341 4.795242 4.746646 0.000000 3.910575 4.542662 4.860769 5.038857 5.082704 5.125519 5.146758 5.143547 5.108561 5.081013 5.014146 4.984832 4.931290 4.841810 4.810295 4.744634 4.640632 4.577404 4.502656 4.442619 0.000000 3.774354 4.421148 4.726241 4.840663 4.920917 4.964417 4.967793 4.920909 4.876808 4.838435 4.773746 4.741453 4.655733 4.586137 4.541610 4.445564 4.393030 4.299371 4.248830 4.188391 0.000000 3.668924 4.290438 4.538142 4.694025 4.715871 4.742670 4.756942 4.698333 4.652782 4.618268 4.558731 4.478136 4.424503 4.370811 4.276937 4.208631 4.145124 4.060539 3.997835 3.896665 0.000000 3.552829 4.155075 4.388666 4.486010 4.557470 4.577418 4.542390 4.481425 4.437520 4.403874 4.297496 4.251681 4.213325 4.110477 4.037551 3.988596 3.918555 3.826915 3.736154 3.684177 0.000000 3.424156 3.969717 4.232819 4.320322 4.342403 4.367795 4.330400 4.270538 4.229355 4.154327 4.090541 4.055414 3.977062 3.895263 3.852517 3.793804 3.680366 3.617790 3.538092 3.492925 0.000000 3.279914 3.810992 4.025664 4.110472 4.172555 4.154852 4.119208 4.063880 4.023300 3.951913 3.899499 3.815547 3.745779 3.696256 3.652287 3.562876 3.475897 3.422825 3.351919 3.309722 0.000000 3.115710 3.631684 3.839828 3.923070 3.944675 3.929387 3.906087 3.857614 3.811586 3.746654 3.670996 3.618541 3.569198 3.490816 3.451869 3.373449 3.299819 3.258579 3.182077 3.121197 0.000000 2.898158 3.399117 3.603342 3.688353 3.711851 3.702161 3.685790 3.643020 3.582958 3.527001 3.475040 3.433561 3.376723 3.310387 3.247598 3.177716 3.145490 3.083432 3.033719 2.979490 0.000000 2.682748 3.168037 3.366494 3.456872 3.455464 3.455601 3.446490 3.407923 3.370390 3.325305 3.270881 3.227278 3.166377 3.112839 3.063255 3.009168 2.957767 2.907653 2.858052 2.809995 0.000000 2.409085 2.874879 3.049073 3.142890 3.187235 3.170531 3.167910 3.150366 3.091252 3.064402 3.033979 2.995435 2.925899 2.896553 2.851749 2.810553 2.771955 2.732894 2.689622 2.654217 0.000000 2.036238 2.465558 2.660576 2.741783 2.794940 2.800699 2.814017 2.786319 2.782791 2.743056 2.725325 2.680529 2.660982 2.638970 2.583553 2.563867 2.536305 2.510189 2.460268 2.434206 0.000000 1.451183 1.839890 2.009126 2.089243 2.121881 2.161725 2.164158 2.152415 2.156851 2.136339 2.108338 2.101789 2.070900 2.057801 2.025300 2.009221 1.976017 1.959013 1.925602 1.909048 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 3.544012 4.330766 4.760806 5.016726 5.194796 5.321071 5.436158 5.494325 5.567847 5.596553 5.642918 5.654296 5.639113 5.655540 5.646049 5.655097 5.638631 5.645497 5.631519 5.600278 0.000000 3.450023 4.210556 4.660194 4.917229 5.078980 5.230399 5.318044 5.354591 5.424576 5.486285 5.515206 5.532406 5.517694 5.525323 5.510262 5.510704 5.479063 5.452773 5.446177 5.401464 0.000000 3.386128 4.129179 4.517081 4.752175 4.954586 5.057773 5.165961 5.209683 5.274535 5.266716 5.299994 5.286301 5.266547 5.272391 5.289080 5.282321 5.242870 5.227850 5.170379 5.159149 0.000000 3.317777 4.041714 4.414518 4.638783 4.780170 4.918873 4.974870 5.045297 5.051415 5.045747 5.057403 5.092904 5.091544 5.064293 5.058467 4.995732 4.963468 4.934354 4.910375 4.851991 0.000000 3.245373 3.949274 4.306750 4.517802 4.648213 4.736476 4.827464 4.836534 4.834948 4.868426 4.871265 4.857560 4.854445 4.821219 4.776087 4.740375 4.718281 4.661738 4.585891 4.551795 0.000000 3.168609 3.852143 4.193289 4.395377 4.516934 4.585898 4.612877 4.627093 4.657812 4.646391 4.639591 4.605562 4.597725 4.571106 4.516847 4.473529 4.395948 4.356751 4.291224 4.215731 0.000000 3.087269 3.749983 4.040591 4.226534 4.332253 4.387409 4.453642 4.453508 4.440706 4.443176 4.410435 4.380241 4.342102 4.269426 4.225668 4.150721 4.106519 4.025578 3.969949 3.917814 0.000000 3.001047 3.609840 3.924284 4.094522 4.186246 4.232867 4.251896 4.245530 4.258520 4.219619 4.174886 4.131126 4.083291 4.008735 3.961746 3.886717 3.803905 3.719826 3.650052 3.597010 0.000000 2.909219 3.503203 3.799907 3.960393 4.041285 4.076260 4.081615 4.071755 4.040593 3.990942 3.937385 3.878860 3.825984 3.749114 3.667289 3.600266 3.524850 3.477242 3.389013 3.329611 0.000000 2.810915 3.388655 3.672645 3.779482 3.848278 3.879896 3.873610 3.859651 3.820096 3.763945 3.681782 3.638081 3.559919 3.490535 3.424216 3.373123 3.299077 3.224877 3.139587 3.053753 0.000000 2.681526 3.265238 3.499645 3.632530 3.696927 3.711868 3.673311 3.649219 3.599209 3.539041 3.461676 3.396270 3.311109 3.268838 3.196217 3.132136 3.054152 2.965084 2.895671 2.812663 0.000000 2.572169 3.131773 3.357609 3.482605 3.497384 3.516455 3.463043 3.442672 3.391734 3.296956 3.256215 3.156593 3.118246 3.060034 2.989278 2.894636 2.818361 2.762413 2.687374 2.624447 0.000000 2.451501 2.962709 3.203564 3.288802 3.336461 3.313955 3.261526 3.238101 3.158088 3.095164 3.028730 2.961603 2.918431 2.843755 2.777374 2.683116 2.622095 2.562432 2.498391 2.424740 0.000000 2.317099 2.812598 3.014398 3.122478 3.135957 3.107265 3.060880 3.029886 2.957709 2.894254 2.835432 2.787266 2.700678 2.647602 2.570749 2.497015 2.428037 2.367179 2.312634 2.250676 0.000000 2.165524 2.643614 2.837753 2.911932 2.923766 2.901861 2.858141 2.802885 2.768288 2.702885 2.655251 2.585083 2.503472 2.455255 2.388774 2.331772 2.258838 2.191540 2.138816 2.075926 0.000000 1.991608 2.450436 2.640716 2.687944 2.703766 2.685756 2.649638 2.601480 2.546982 2.508670 2.445148 2.380478 2.320880 2.257391 2.209464 2.145543 2.086805 2.040349 1.981750 1.924083 0.000000 1.789038 2.210059 2.390973 2.463574 2.486845 2.452571 2.425609 2.383124 2.338831 2.295220 2.243431 2.186594 2.126644 2.073656 2.017761 1.980251 1.928998 1.872519 1.820774 1.771839 0.000000 1.532297 1.942626 2.116015 2.175198 2.202284 2.184098 2.169716 2.145656 2.112509 2.073809 2.010595 1.968661 1.929132 1.881255 1.835564 1.794589 1.746929 1.703784 1.659629 1.621427 0.000000 1.222010 1.575852 1.743833 1.807460 1.845385 1.843151 1.841009 1.814957 1.797000 1.774834 1.731274 1.704570 1.674256 1.624552 1.595890 1.561608 1.529918 1.480930 1.452599 1.421789 0.000000 0.7791935 1.064648 1.194701 1.255215 1.296747 1.308713 1.305920 1.307090 1.292247 1.270399 1.259646 1.233813 1.217389 1.189511 1.170520 1.141863 1.122202 1.093379 1.074236 1.045745 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 2.504768 3.192220 3.561131 3.790087 3.939909 4.078787 4.153385 4.233721 4.262684 4.283947 4.310953 4.335333 4.339896 4.352638 4.328173 4.307580 4.306785 4.290150 4.287251 4.275095 0.000000 2.426697 3.090183 3.475878 3.695320 3.829001 3.929059 4.022125 4.059664 4.114922 4.147503 4.157990 4.178181 4.177556 4.184705 4.196182 4.180369 4.166164 4.129174 4.115030 4.117564 0.000000 2.368922 3.018536 3.357333 3.559328 3.724801 3.809069 3.894231 3.930707 3.972086 3.987386 3.990374 3.999203 3.985288 3.986902 3.968404 3.935284 3.918602 3.888318 3.882971 3.870186 0.000000 2.307124 2.941397 3.267985 3.462204 3.584165 3.697051 3.740599 3.792510 3.791766 3.814945 3.829893 3.823790 3.798662 3.785914 3.747018 3.707735 3.682386 3.642951 3.613629 3.579921 0.000000 2.242136 2.859982 3.175727 3.362146 3.474949 3.537841 3.606946 3.616604 3.645351 3.630075 3.617667 3.584231 3.566039 3.547035 3.490810 3.455515 3.405305 3.362612 3.328537 3.268234 0.000000 2.173811 2.775331 3.080290 3.255588 3.357762 3.409572 3.435110 3.462747 3.448352 3.446615 3.415023 3.365877 3.339832 3.299578 3.250057 3.206037 3.151990 3.105364 3.034600 2.984154 0.000000 2.101775 2.687013 2.982993 3.115299 3.202103 3.274362 3.284621 3.274168 3.282317 3.245708 3.197522 3.177430 3.114021 3.065972 3.004539 2.948470 2.885891 2.822993 2.738968 2.658931 0.000000 2.025969 2.596460 2.851744 2.998981 3.071684 3.106584 3.107256 3.116437 3.088643 3.033143 2.997180 2.957276 2.891235 2.826312 2.765685 2.670364 2.609948 2.527316 2.447359 2.370720 0.000000 1.945915 2.476142 2.742247 2.873310 2.938656 2.958116 2.949482 2.926335 2.886628 2.834000 2.787426 2.732793 2.656621 2.574152 2.501590 2.417203 2.346056 2.276993 2.204409 2.121125 0.000000 1.860762 2.376035 2.623519 2.718500 2.771112 2.780294 2.770078 2.734818 2.688477 2.632364 2.573896 2.495326 2.418842 2.339422 2.262000 2.199826 2.124325 2.039665 1.965103 1.902123 0.000000 1.769625 2.266686 2.475062 2.585021 2.628742 2.630070 2.582641 2.547681 2.495390 2.433134 2.347299 2.272002 2.197835 2.134386 2.061530 1.980912 1.909302 1.832597 1.756530 1.688057 0.000000 1.656840 2.147505 2.346375 2.446126 2.455045 2.452935 2.424163 2.363576 2.304651 2.235733 2.154743 2.081694 2.004323 1.931069 1.854519 1.778796 1.712405 1.644658 1.567924 1.499464 0.000000 1.553856 2.018474 2.207064 2.275360 2.303539 2.270152 2.241163 2.177876 2.116741 2.038831 1.968875 1.893641 1.804428 1.741205 1.672011 1.602494 1.532617 1.455304 1.396300 1.324235 0.000000 1.440401 1.864977 2.058764 2.118723 2.120718 2.088233 2.058049 1.993052 1.931729 1.856545 1.784375 1.705775 1.631293 1.559948 1.498715 1.429935 1.352762 1.293123 1.232612 1.172595 0.000000 1.314950 1.716762 1.880135 1.935673 1.935001 1.921433 1.871502 1.808253 1.746503 1.673987 1.598732 1.539224 1.466324 1.391012 1.331865 1.260988 1.199855 1.131516 1.079989 1.013436 0.000000 1.174812 1.550336 1.702419 1.753993 1.756648 1.726771 1.679630 1.618169 1.555835 1.487804 1.430289 1.361973 1.298050 1.228826 1.163688 1.109457 1.045834 0.9936553 0.9333789 0.8760266 0.000000 1.016535 1.361235 1.490466 1.540334 1.542057 1.516176 1.475642 1.426054 1.356669 1.297952 1.251636 1.190275 1.128348 1.069121 1.010367 0.9520617 0.9049506 0.8498940 0.7977749 0.7510417 0.000000 0.8345898 1.131631 1.259432 1.295798 1.303472 1.283991 1.242449 1.203897 1.157463 1.108730 1.058542 1.006758 0.9553422 0.9037906 0.8528503 0.8032423 0.7549284 0.7063337 0.6611831 0.6167121 0.000000 0.6150056 0.8643888 0.9675568 1.012532 1.016973 1.009998 0.9817012 0.9541351 0.9128140 0.8779736 0.8385233 0.8007068 0.7516329 0.7118181 0.6704636 0.6312687 0.5910929 0.5530992 0.5142394 0.4770987 0.000000 0.3507633 0.5116766 0.5851428 0.6228580 0.6335465 0.6298591 0.6225891 0.6055297 0.5829778 0.5638746 0.5371214 0.5137230 0.4851169 0.4599550 0.4308574 0.4012903 0.3724161 0.3452381 0.3173398 0.2912482 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 1.517557 2.068085 2.367100 2.551021 2.669257 2.772758 2.827202 2.882649 2.929448 2.961164 2.964343 2.986319 2.990217 2.987935 2.994029 2.987173 2.975126 2.948972 2.939108 2.940135 0.000000 1.454074 1.980858 2.286461 2.458523 2.567827 2.666151 2.716494 2.766049 2.805974 2.829594 2.830656 2.825184 2.826415 2.826401 2.831449 2.823844 2.820725 2.808065 2.802127 2.792769 0.000000 1.406408 1.916658 2.186706 2.368741 2.470188 2.552923 2.595010 2.643111 2.647074 2.673893 2.682135 2.667264 2.666727 2.662626 2.656992 2.632334 2.605613 2.571259 2.547934 2.530774 0.000000 1.356506 1.850645 2.109128 2.258975 2.372820 2.427924 2.477954 2.489174 2.508579 2.496341 2.489324 2.486535 2.477903 2.461560 2.432362 2.395734 2.356848 2.328875 2.289007 2.260698 0.000000 1.304807 1.782858 2.031300 2.174210 2.255365 2.320757 2.338460 2.360026 2.338005 2.333042 2.319945 2.276069 2.256994 2.223427 2.185015 2.139019 2.089194 2.043167 1.988143 1.944176 0.000000 1.251368 1.713816 1.953423 2.086370 2.154659 2.182155 2.205961 2.189628 2.186592 2.145121 2.100706 2.066256 2.034404 1.986972 1.938873 1.881836 1.816563 1.759510 1.702363 1.648995 0.000000 1.196155 1.643608 1.874039 1.994943 2.047215 2.060454 2.049214 2.041668 2.004369 1.955894 1.905010 1.859699 1.809194 1.759400 1.685931 1.628885 1.566053 1.502203 1.431931 1.362099 0.000000 1.139278 1.571955 1.776472 1.879778 1.915865 1.914621 1.911425 1.876889 1.830734 1.772767 1.713281 1.659556 1.601325 1.526579 1.462618 1.398470 1.315232 1.244018 1.163465 1.093679 0.000000 1.080525 1.484634 1.692607 1.776717 1.799006 1.787028 1.754136 1.710606 1.660758 1.594258 1.527200 1.466767 1.399604 1.319244 1.251952 1.169863 1.085834 1.011946 0.9375809 0.8601913 0.000000 1.019677 1.411229 1.598709 1.669616 1.663844 1.641415 1.603647 1.552027 1.494354 1.420415 1.348248 1.280730 1.200302 1.129596 1.046476 0.9632061 0.8799790 0.8045547 0.7296192 0.6521437 0.000000 0.9563733 1.332795 1.499332 1.543734 1.543426 1.514012 1.469710 1.398523 1.331164 1.253000 1.177915 1.096422 1.023974 0.9411442 0.8582506 0.7756357 0.6955543 0.6229646 0.5451645 0.4744155 0.000000 0.8816712 1.244882 1.381940 1.429404 1.407779 1.372199 1.322819 1.245444 1.173054 1.092980 1.016372 0.9327039 0.8505222 0.7687230 0.6878949 0.6096485 0.5328532 0.4579397 0.3882496 0.3162754 0.000000 0.8149379 1.146848 1.273995 1.299313 1.284166 1.232351 1.176555 1.095953 1.021424 0.9398027 0.8617117 0.7730581 0.6921261 0.6132946 0.5366233 0.4609628 0.3880273 0.3160940 0.2475955 0.1777792 0.000000 0.7391509 1.034308 1.158923 1.178188 1.147989 1.103029 1.032653 0.9510564 0.8766789 0.7971776 0.7108006 0.6319757 0.5536172 0.4771267 0.3991269 0.3279746 0.2570958 0.1880378 0.1194956 5.3090185E-02 0.000000 0.6563176 0.9269593 1.029157 1.041663 1.020022 0.9623526 0.8910567 0.8113990 0.7381526 0.6537075 0.5769702 0.4959455 0.4207358 0.3477466 0.2773994 0.2078047 0.1371148 6.8527453E-02 4.2646448E-03 -6.0979582E-02 0.000000 0.5675983 0.8105592 0.9006125 0.9096478 0.8776268 0.8207758 0.7520669 0.6764168 0.6043254 0.5247988 0.4478545 0.3744194 0.2998164 0.2310320 0.1635150 9.5095165E-02 2.6923314E-02 -3.6821343E-02 -9.8547019E-02 -0.1599909 0.000000 0.4725666 0.6832870 0.7541854 0.7608402 0.7305362 0.6773140 0.6141075 0.5447808 0.4730015 0.4042564 0.3311465 0.2598260 0.1925702 0.1266837 6.1067816E-02 -4.4879927E-03 -6.7654848E-02 -0.1272859 -0.1853713 -0.2420236 0.000000 0.3701453 0.5392318 0.6039771 0.6081190 0.5755316 0.5303146 0.4755288 0.4144126 0.3512187 0.2867880 0.2219434 0.1576762 9.6457437E-02 3.6558483E-02 -2.6126539E-02 -8.5662134E-02 -0.1426838 -0.1980070 -0.2508832 -0.3015026 0.000000 0.2569801 0.3850085 0.4296691 0.4339268 0.4087084 0.3746877 0.3319690 0.2843877 0.2315101 0.1792196 0.1259192 7.2533026E-02 1.9690916E-02 -3.2470711E-02 -8.6548232E-02 -0.1363361 -0.1852695 -0.2347522 -0.2799054 -0.3230278 0.000000 0.1357860 0.2061166 0.2351450 0.2366403 0.2235238 0.2039759 0.1780023 0.1480366 0.1177926 8.3258241E-02 4.8672140E-02 1.2980169E-02 -2.2642110E-02 -5.8480762E-02 -9.3185909E-02 -0.1280669 -0.1619960 -0.1952470 -0.2285956 -0.2587948 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.7121192 1.055130 1.253030 1.379172 1.462838 1.533108 1.572645 1.610267 1.640054 1.649196 1.664231 1.666916 1.673623 1.665870 1.663965 1.656646 1.653011 1.644008 1.639757 1.626174 0.000000 0.6729419 1.003973 1.187768 1.301609 1.377152 1.440330 1.474182 1.506948 1.531731 1.536647 1.546300 1.554242 1.562522 1.558290 1.552406 1.544447 1.527983 1.518392 1.503216 1.496236 0.000000 0.6400065 0.9417729 1.105567 1.214713 1.279925 1.320197 1.356215 1.383338 1.395142 1.404923 1.396953 1.397959 1.389894 1.383611 1.368590 1.351301 1.327878 1.308056 1.282466 1.262329 0.000000 0.6063535 0.8876268 1.033080 1.126725 1.178360 1.208688 1.233338 1.247054 1.239720 1.229217 1.223400 1.205453 1.186149 1.162730 1.137698 1.105322 1.074455 1.038207 1.003176 0.9698241 0.000000 0.5722623 0.8316788 0.9590133 1.028897 1.076692 1.091084 1.102013 1.087198 1.074101 1.054738 1.030442 1.002064 0.9657205 0.9219831 0.8819575 0.8350031 0.7893615 0.7387928 0.6839433 0.6320866 0.000000 0.5377240 0.7743646 0.8853438 0.9409797 0.9614710 0.9684664 0.9511548 0.9329928 0.9024860 0.8672215 0.8259943 0.7790636 0.7214984 0.6688678 0.6115303 0.5505620 0.4908097 0.4277063 0.3664967 0.3003577 0.000000 0.5027589 0.7166930 0.8120759 0.8502260 0.8530042 0.8338715 0.8080510 0.7637425 0.7195778 0.6702976 0.6130953 0.5519568 0.4846792 0.4182287 0.3495051 0.2814982 0.2088400 0.1340311 5.8309529E-02 -2.0578077E-02 0.000000 0.4674590 0.6594368 0.7385607 0.7578194 0.7423182 0.7068347 0.6575243 0.6055663 0.5473843 0.4768998 0.4077266 0.3361112 0.2608213 0.1835997 0.1045141 2.4391962E-02 -5.9254751E-02 -0.1441524 -0.2318042 -0.3187568 0.000000 0.4317973 0.6029118 0.6586611 0.6593696 0.6325616 0.5806254 0.5173029 0.4515080 0.3746484 0.2976508 0.2175135 0.1337879 4.9992986E-02 -3.5670526E-02 -0.1231658 -0.2126565 -0.3014637 -0.3899796 -0.4791768 -0.5662228 0.000000 0.3958180 0.5421532 0.5870554 0.5697597 0.5204716 0.4547262 0.3830123 0.3008958 0.2165174 0.1288307 4.0622495E-02 -5.0141744E-02 -0.1404133 -0.2326175 -0.3233314 -0.4131450 -0.5060933 -0.5959014 -0.6837862 -0.7691442 0.000000 0.3596695 0.4883119 0.5156642 0.4819980 0.4190673 0.3413869 0.2547495 0.1631947 7.1341239E-02 -2.2248009E-02 -0.1174509 -0.2127500 -0.3048810 -0.3998209 -0.4904391 -0.5797271 -0.6731511 -0.7619734 -0.8477761 -0.9357578 0.000000 0.3234635 0.4346572 0.4454404 0.3943283 0.3209447 0.2338916 0.1402925 4.1817017E-02 -5.6715585E-02 -0.1557992 -0.2546062 -0.3486020 -0.4447871 -0.5361331 -0.6311390 -0.7173690 -0.8099174 -0.8912739 -0.9816090 -1.066199 0.000000 0.2851149 0.3816163 0.3740031 0.3175896 0.2352865 0.1402591 3.8560651E-02 -6.4431302E-02 -0.1665356 -0.2679550 -0.3662587 -0.4636852 -0.5566680 -0.6507320 -0.7387850 -0.8288715 -0.9154076 -0.9969280 -1.079129 -1.150256 0.000000 0.2501372 0.3289409 0.3108351 0.2463446 0.1582888 5.7576343E-02 -4.7148362E-02 -0.1526627 -0.2561643 -0.3581170 -0.4549535 -0.5528842 -0.6493927 -0.7351567 -0.8265055 -0.9101460 -0.9870936 -1.068896 -1.142264 -1.216891 0.000000 0.2148956 0.2741873 0.2512724 0.1810309 9.1277003E-02 -9.9163502E-03 -0.1159604 -0.2211872 -0.3246212 -0.4208974 -0.5214179 -0.6181744 -0.7108134 -0.8001718 -0.8773105 -0.9616416 -1.041476 -1.118610 -1.183888 -1.254919 0.000000 0.1792157 0.2245079 0.1939120 0.1261138 3.7664361E-02 -6.1669350E-02 -0.1642569 -0.2663230 -0.3693422 -0.4616024 -0.5622829 -0.6556895 -0.7433604 -0.8284443 -0.9101015 -0.9831076 -1.059788 -1.131668 -1.202435 -1.269845 0.000000 0.1435107 0.1761156 0.1444644 7.8838505E-02 -3.1610178E-03 -9.5324159E-02 -0.1923424 -0.2879924 -0.3830345 -0.4745423 -0.5707982 -0.6581708 -0.7414135 -0.8204370 -0.9000264 -0.9750427 -1.046509 -1.116762 -1.182202 -1.243660 0.000000 0.1077967 0.1288546 9.9740587E-02 4.2927783E-02 -2.8368013E-02 -0.1083493 -0.1930175 -0.2780605 -0.3623640 -0.4490943 -0.5366088 -0.6158473 -0.6929954 -0.7671055 -0.8474044 -0.9156843 -0.9819443 -1.044700 -1.106104 -1.175156 0.000000 7.1288243E-02 8.3627187E-02 5.9979539E-02 1.6526021E-02 -3.7940092E-02 -9.9313952E-02 -0.1650801 -0.2337868 -0.3010227 -0.3720220 -0.4433811 -0.5100726 -0.5807016 -0.6436030 -0.7108628 -0.7703758 -0.8274206 -0.8895501 -0.9437451 -1.004829 0.000000 3.5777885E-02 4.0687688E-02 2.6706584E-02 2.2577071E-03 -2.8561324E-02 -6.3651390E-02 -0.1018296 -0.1423738 -0.1829129 -0.2256224 -0.2692784 -0.3136892 -0.3587353 -0.3993891 -0.4433972 -0.4875382 -0.5264262 -0.5686533 -0.6106930 -0.6523308 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.3854044 0.5851423 0.6996253 0.7727035 0.8209359 0.8611182 0.8820602 0.9014930 0.9069582 0.9159059 0.9131090 0.9087562 0.9088118 0.9037351 0.8920085 0.8856848 0.8729984 0.8589595 0.8518864 0.8404601 0.000000 0.3660325 0.5547039 0.6619411 0.7307700 0.7762628 0.8126000 0.8305129 0.8467260 0.8508369 0.8571237 0.8614928 0.8568257 0.8517922 0.8503270 0.8447892 0.8381969 0.8292655 0.8180496 0.8034655 0.7883642 0.000000 0.3457239 0.5205726 0.6171001 0.6762044 0.7113440 0.7379980 0.7489592 0.7583627 0.7651729 0.7663186 0.7596803 0.7505864 0.7441632 0.7317063 0.7169018 0.7037393 0.6864008 0.6664636 0.6492817 0.6303216 0.000000 0.3245676 0.4843134 0.5675021 0.6121308 0.6349205 0.6520774 0.6606938 0.6586930 0.6563063 0.6481238 0.6352054 0.6184306 0.5981417 0.5755517 0.5456617 0.5171283 0.4884819 0.4546950 0.4200015 0.3861429 0.000000 0.3030717 0.4469972 0.5141776 0.5432789 0.5553626 0.5630761 0.5557858 0.5479459 0.5313745 0.5078153 0.4789308 0.4464261 0.4107913 0.3721610 0.3306051 0.2867852 0.2410328 0.1906054 0.1381101 8.3133347E-02 0.000000 0.2814111 0.4088766 0.4585490 0.4738419 0.4751220 0.4650874 0.4482316 0.4227227 0.3881726 0.3478876 0.3029530 0.2548130 0.2023648 0.1472315 8.8239908E-02 2.5438676E-02 -4.2225935E-02 -0.1139933 -0.1879562 -0.2658577 0.000000 0.2596924 0.3700132 0.4025477 0.4050760 0.3926143 0.3662421 0.3305903 0.2860899 0.2345101 0.1780701 0.1166540 5.1810149E-02 -1.7000308E-02 -9.2755958E-02 -0.1716137 -0.2542221 -0.3389868 -0.4241402 -0.5144210 -0.6021965 0.000000 0.2381669 0.3308726 0.3477909 0.3365725 0.3072829 0.2618961 0.2069380 0.1445759 7.6973692E-02 4.1474393E-03 -7.3947564E-02 -0.1547682 -0.2427082 -0.3342434 -0.4237209 -0.5140178 -0.6091440 -0.7049596 -0.7924513 -0.8832067 0.000000 0.2168156 0.2894659 0.2923610 0.2661172 0.2201797 0.1556167 8.3004259E-02 4.7807670E-03 -7.8806832E-02 -0.1680222 -0.2579018 -0.3545404 -0.4538964 -0.5521675 -0.6441516 -0.7426038 -0.8400472 -0.9289310 -1.020990 -1.113267 0.000000 0.1957466 0.2529864 0.2421178 0.1997219 0.1337425 5.1856071E-02 -3.6729798E-02 -0.1297276 -0.2276715 -0.3255377 -0.4291269 -0.5344712 -0.6346154 -0.7362292 -0.8353119 -0.9358793 -1.023649 -1.118603 -1.213064 -1.306548 0.000000 0.1750321 0.2176611 0.1936366 0.1348269 5.1304955E-02 -4.5960270E-02 -0.1485903 -0.2531982 -0.3603889 -0.4681797 -0.5780773 -0.6869890 -0.7861717 -0.8900090 -0.9893482 -1.078559 -1.173999 -1.269658 -1.364874 -1.456370 0.000000 0.1531283 0.1836069 0.1478185 7.3884986E-02 -2.4317322E-02 -0.1334537 -0.2464593 -0.3593301 -0.4740576 -0.5878012 -0.6990623 -0.8076914 -0.9053981 -1.007154 -1.104471 -1.201408 -1.296586 -1.391789 -1.484614 -1.574113 0.000000 0.1337040 0.1516974 0.1053000 1.9250600E-02 -8.9329623E-02 -0.2057512 -0.3268128 -0.4481262 -0.5668002 -0.6830605 -0.7933517 -0.9014003 -0.9963105 -1.097024 -1.192804 -1.286372 -1.379308 -1.471058 -1.563172 -1.641774 0.000000 0.1148125 0.1220780 6.7056686E-02 -2.7527990E-02 -0.1415940 -0.2627218 -0.3909490 -0.5145861 -0.6345893 -0.7446907 -0.8543334 -0.9605585 -1.061695 -1.158530 -1.252307 -1.343679 -1.434796 -1.520620 -1.603941 -1.677777 0.000000 9.6418686E-02 9.4514452E-02 3.3895705E-02 -6.3809611E-02 -0.1791201 -0.3009212 -0.4284115 -0.5505507 -0.6695542 -0.7790551 -0.8888104 -0.9919543 -1.088180 -1.181888 -1.273807 -1.362515 -1.449176 -1.530825 -1.608202 -1.698280 0.000000 7.8381181E-02 6.9492616E-02 7.5191092E-03 -8.7470993E-02 -0.1994236 -0.3168671 -0.4396299 -0.5582018 -0.6701698 -0.7794186 -0.8822526 -0.9810057 -1.082129 -1.174298 -1.265329 -1.359332 -1.438664 -1.515373 -1.592796 -1.665904 0.000000 6.1022632E-02 4.8659794E-02 -1.1209427E-02 -9.9245816E-02 -0.2019778 -0.3094035 -0.4221697 -0.5305976 -0.6417259 -0.7440073 -0.8417320 -0.9365195 -1.036226 -1.122912 -1.215829 -1.292230 -1.372476 -1.444022 -1.522335 -1.589678 0.000000 4.4581175E-02 3.0467330E-02 -2.1671511E-02 -9.6324630E-02 -0.1836658 -0.2754333 -0.3725170 -0.4713388 -0.5654593 -0.6620593 -0.7514695 -0.8371470 -0.9265902 -1.006588 -1.093866 -1.165170 -1.237116 -1.316164 -1.378456 -1.450357 0.000000 2.8566573E-02 1.6169807E-02 -2.3781363E-02 -7.9767808E-02 -0.1451019 -0.2142629 -0.2878762 -0.3638223 -0.4415052 -0.5144442 -0.5917156 -0.6628669 -0.7378283 -0.8117124 -0.8767667 -0.9490158 -1.010448 -1.078197 -1.131638 -1.196538 0.000000 1.3880832E-02 5.8795698E-03 -1.6545011E-02 -4.7333002E-02 -8.3288491E-02 -0.1228471 -0.1634668 -0.2068469 -0.2516447 -0.2975612 -0.3443728 -0.3919362 -0.4350463 -0.4817246 -0.5284219 -0.5751049 -0.6217558 -0.6603491 -0.7042776 -0.7477097 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.2827537 0.4210026 0.4885662 0.5291336 0.5528212 0.5649551 0.5695693 0.5688357 0.5642703 0.5568675 0.5530452 0.5439837 0.5326154 0.5197224 0.5058503 0.4963353 0.4828409 0.4711288 0.4571234 0.4429127 0.000000 0.2693309 0.4050605 0.4712392 0.5096016 0.5328869 0.5453849 0.5504600 0.5501614 0.5458936 0.5441209 0.5360612 0.5307789 0.5237970 0.5134641 0.5039889 0.4918248 0.4779676 0.4676022 0.4562834 0.4435388 0.000000 0.2552819 0.3835993 0.4414342 0.4727780 0.4900899 0.4973800 0.4967385 0.4908901 0.4868452 0.4810144 0.4695237 0.4598041 0.4493878 0.4328991 0.4188679 0.4011660 0.3853427 0.3675722 0.3470629 0.3284183 0.000000 0.2403734 0.3569893 0.4044404 0.4262205 0.4343695 0.4323101 0.4240635 0.4166289 0.4059032 0.3890661 0.3738465 0.3547455 0.3336257 0.3094216 0.2834102 0.2544107 0.2246086 0.1948061 0.1615112 0.1251800 0.000000 0.2238578 0.3281519 0.3637622 0.3740831 0.3693990 0.3582076 0.3429555 0.3275788 0.3062934 0.2783985 0.2477810 0.2161306 0.1794474 0.1406993 9.8920710E-02 5.3332847E-02 5.3823623E-03 -4.6701390E-02 -0.1031352 -0.1626470 0.000000 0.2070936 0.2982549 0.3185177 0.3147351 0.3005492 0.2807378 0.2581027 0.2277335 0.1883893 0.1457705 0.1001275 5.0179925E-02 -3.9246753E-03 -6.3147239E-02 -0.1259107 -0.1923789 -0.2623050 -0.3364742 -0.4125250 -0.4895189 0.000000 0.1905564 0.2651242 0.2754567 0.2562813 0.2312987 0.1996909 0.1603196 0.1113273 5.6046281E-02 -3.1170680E-03 -6.7863710E-02 -0.1370522 -0.2109309 -0.2864026 -0.3662210 -0.4489306 -0.5381989 -0.6255916 -0.7091091 -0.7976779 0.000000 0.1738117 0.2349586 0.2306134 0.1981848 0.1617937 0.1128868 5.3596839E-02 -1.3487529E-02 -8.6307324E-02 -0.1623224 -0.2447568 -0.3300769 -0.4179099 -0.5077747 -0.6008050 -0.6958356 -0.7916642 -0.8803774 -0.9772152 -1.071787 0.000000 0.1572990 0.2051501 0.1858278 0.1425601 9.0316758E-02 2.1994298E-02 -5.6891534E-02 -0.1412202 -0.2287880 -0.3216580 -0.4188992 -0.5159910 -0.6117217 -0.7116719 -0.8139203 -0.9169038 -1.009608 -1.109187 -1.209850 -1.300631 0.000000 0.1409887 0.1760667 0.1429745 8.8982351E-02 1.7609185E-02 -7.0472792E-02 -0.1646677 -0.2632990 -0.3654677 -0.4722459 -0.5766286 -0.6781383 -0.7821248 -0.8887925 -0.9954541 -1.098156 -1.196732 -1.295900 -1.383030 -1.472595 0.000000 0.1238793 0.1476868 0.1032306 3.6486220E-02 -5.3513054E-02 -0.1574797 -0.2659141 -0.3776290 -0.4896848 -0.6036559 -0.7126518 -0.8201293 -0.9317417 -1.040880 -1.145363 -1.241113 -1.333499 -1.424426 -1.516533 -1.606208 0.000000 0.1085656 0.1199949 6.7078128E-02 -1.3527587E-02 -0.1191139 -0.2352605 -0.3572153 -0.4795978 -0.5939927 -0.7140879 -0.8256624 -0.9422562 -1.053082 -1.159420 -1.255676 -1.347068 -1.439130 -1.528711 -1.618466 -1.705539 0.000000 9.3622379E-02 9.4345197E-02 3.4407325E-02 -5.8674626E-02 -0.1754107 -0.3001262 -0.4301109 -0.5585473 -0.6764540 -0.7941732 -0.9123464 -1.034516 -1.141773 -1.238228 -1.329453 -1.421351 -1.513681 -1.605134 -1.690875 -1.790192 0.000000 7.9356916E-02 7.1350738E-02 5.4268660E-03 -9.6785910E-02 -0.2193305 -0.3484418 -0.4830915 -0.6137004 -0.7335736 -0.8519046 -0.9738026 -1.092119 -1.184563 -1.283048 -1.377979 -1.467854 -1.556720 -1.644536 -1.745051 -1.823924 0.000000 6.5766647E-02 5.0797276E-02 -1.9078400E-02 -0.1238361 -0.2484386 -0.3775226 -0.5124593 -0.6411455 -0.7619508 -0.8816947 -1.000726 -1.109178 -1.196690 -1.300698 -1.395759 -1.480805 -1.569692 -1.665355 -1.742860 -1.820143 0.000000 5.2706927E-02 3.3029091E-02 -3.7367407E-02 -0.1395139 -0.2598353 -0.3837576 -0.5139893 -0.6369449 -0.7549209 -0.8749993 -0.9835646 -1.084363 -1.178215 -1.283995 -1.372985 -1.457586 -1.552405 -1.626355 -1.705445 -1.793593 0.000000 4.0313050E-02 1.9249713E-02 -4.7862496E-02 -0.1423879 -0.2500001 -0.3653311 -0.4846673 -0.5974222 -0.7134979 -0.8185651 -0.9197207 -1.016500 -1.117702 -1.206054 -1.301227 -1.394143 -1.471642 -1.542070 -1.631087 -1.698962 0.000000 2.8912200E-02 8.1974734E-03 -4.9801204E-02 -0.1301780 -0.2206091 -0.3189490 -0.4212225 -0.5188251 -0.6202453 -0.7148836 -0.8117004 -0.8991168 -0.9935746 -1.073344 -1.160626 -1.247736 -1.317923 -1.398162 -1.466837 -1.526343 0.000000 1.8134581E-02 1.2448006E-03 -4.2740583E-02 -0.1020054 -0.1701819 -0.2437566 -0.3209634 -0.3962059 -0.4746130 -0.5541109 -0.6276882 -0.7055941 -0.7836830 -0.8513380 -0.9243564 -0.9975893 -1.059354 -1.129643 -1.184491 -1.248376 0.000000 8.5864514E-03 -1.7354083E-03 -2.6182348E-02 -5.8639608E-02 -9.5967561E-02 -0.1366213 -0.1797772 -0.2249345 -0.2683221 -0.3147908 -0.3619940 -0.4097894 -0.4580635 -0.5014396 -0.5482621 -0.5949110 -0.6413699 -0.6876652 -0.7257285 -0.7688505 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.1787247 0.2909274 0.3514497 0.3689876 0.3725168 0.3677300 0.3582277 0.3451149 0.3297752 0.3158678 0.2974772 0.2794810 0.2617632 0.2434268 0.2245382 0.2074821 0.1895769 0.1711129 0.1542995 0.1368954 0.000000 0.1808487 0.3002575 0.3516518 0.3712077 0.3778771 0.3762390 0.3700082 0.3603637 0.3480308 0.3372417 0.3214439 0.3059517 0.2922741 0.2773784 0.2616165 0.2477117 0.2333534 0.2182852 0.2025765 0.1871573 0.000000 0.1837385 0.3015804 0.3412474 0.3569414 0.3592396 0.3547683 0.3454411 0.3320125 0.3191991 0.3024366 0.2871968 0.2701765 0.2522808 0.2332051 0.2152936 0.1973743 0.1772132 0.1581696 0.1366095 0.1151806 0.000000 0.1874115 0.2856517 0.3213463 0.3280330 0.3234273 0.3122092 0.2956811 0.2790460 0.2590893 0.2385910 0.2157068 0.1923404 0.1665102 0.1406428 0.1115167 8.0875449E-02 4.8330259E-02 1.4451844E-02 -2.1636302E-02 -6.0921263E-02 0.000000 0.1808192 0.2686239 0.2932646 0.2903334 0.2761202 0.2554220 0.2318701 0.2088207 0.1827753 0.1520553 0.1176257 8.0604918E-02 4.0308263E-02 -2.8883892E-03 -4.8893653E-02 -9.8543853E-02 -0.1499324 -0.2044792 -0.2624461 -0.3218150 0.000000 0.1684334 0.2471482 0.2607229 0.2467135 0.2210727 0.1918087 0.1621194 0.1273528 8.5813873E-02 3.9609157E-02 -1.1038617E-02 -6.6208385E-02 -0.1255978 -0.1874588 -0.2493567 -0.3183247 -0.3884560 -0.4626797 -0.5397807 -0.6187631 0.000000 0.1557734 0.2237436 0.2256461 0.1991079 0.1629962 0.1250864 8.1374168E-02 2.8770639E-02 -3.0314932E-02 -9.3922570E-02 -0.1629492 -0.2349715 -0.3094211 -0.3862167 -0.4662138 -0.5496664 -0.6417291 -0.7307639 -0.8218669 -0.9091035 0.000000 0.1419078 0.1991540 0.1888219 0.1499253 0.1034270 5.0481290E-02 -1.1452531E-02 -8.2313813E-02 -0.1582996 -0.2363359 -0.3227980 -0.4065102 -0.4943238 -0.5901508 -0.6856084 -0.7816956 -0.8801867 -0.9770145 -1.076082 -1.179001 0.000000 0.1285359 0.1740775 0.1513197 0.1012676 4.1625615E-02 -2.9870141E-02 -0.1111678 -0.1978074 -0.2875690 -0.3812197 -0.4790976 -0.5745775 -0.6804284 -0.7810106 -0.8852040 -0.9883452 -1.093402 -1.195730 -1.300734 -1.401521 0.000000 0.1152462 0.1495287 0.1144870 5.3460430E-02 -2.3082025E-02 -0.1126786 -0.2095684 -0.3103950 -0.4149441 -0.5221722 -0.6248084 -0.7344546 -0.8457621 -0.9539823 -1.060520 -1.168820 -1.272289 -1.375381 -1.478647 -1.573311 0.000000 0.1026532 0.1254667 7.9197653E-02 6.1598825E-03 -8.6808115E-02 -0.1923372 -0.3028581 -0.4147046 -0.5318136 -0.6486860 -0.7570434 -0.8785424 -0.9912709 -1.099099 -1.205171 -1.312894 -1.412500 -1.512164 -1.596406 -1.684441 0.000000 8.9768745E-02 0.1018876 4.6635978E-02 -3.9441552E-02 -0.1465713 -0.2651680 -0.3859694 -0.5074078 -0.6322646 -0.7541106 -0.8720053 -0.9965139 -1.106869 -1.218284 -1.313189 -1.412209 -1.510421 -1.605306 -1.695856 -1.782353 0.000000 7.7356510E-02 7.9373837E-02 1.7085884E-02 -7.9645708E-02 -0.1988294 -0.3266149 -0.4548168 -0.5830112 -0.7119346 -0.8350984 -0.9622387 -1.075565 -1.186672 -1.293588 -1.391742 -1.489351 -1.586602 -1.676046 -1.761283 -1.847613 0.000000 6.5393284E-02 5.8888983E-02 -9.2344023E-03 -0.1136265 -0.2379685 -0.3724132 -0.5047158 -0.6363441 -0.7658455 -0.8958483 -1.014933 -1.126051 -1.243568 -1.343498 -1.440178 -1.534453 -1.620613 -1.708624 -1.796094 -1.874957 0.000000 5.3930786E-02 4.0164378E-02 -3.0995144E-02 -0.1387977 -0.2647160 -0.3998962 -0.5317113 -0.6625646 -0.7968844 -0.9157874 -1.031088 -1.148510 -1.253574 -1.348660 -1.452376 -1.544112 -1.615529 -1.711794 -1.787561 -1.863269 0.000000 4.2977937E-02 2.4786908E-02 -4.7142006E-02 -0.1512429 -0.2736309 -0.4002597 -0.5314450 -0.6568935 -0.7849811 -0.9011993 -1.008835 -1.123782 -1.220680 -1.322666 -1.413802 -1.497782 -1.578857 -1.674124 -1.745098 -1.818622 0.000000 3.2583315E-02 1.2806411E-02 -5.5321135E-02 -0.1520114 -0.2641012 -0.3791473 -0.4997865 -0.6149123 -0.7329977 -0.8404347 -0.9507439 -1.049206 -1.150621 -1.239601 -1.326766 -1.419729 -1.493465 -1.583686 -1.652588 -1.737744 0.000000 2.3121191E-02 3.5750601E-03 -5.5287674E-02 -0.1375946 -0.2300962 -0.3300201 -0.4334894 -0.5329342 -0.6357217 -0.7375582 -0.8305290 -0.9261581 -1.011121 -1.104183 -1.181970 -1.265597 -1.336141 -1.418412 -1.497236 -1.561132 0.000000 1.4361088E-02 -1.8326243E-03 -4.6574511E-02 -0.1072858 -0.1767433 -0.2514152 -0.3294707 -0.4059069 -0.4851328 -0.5650221 -0.6455953 -0.7177998 -0.7956420 -0.8737071 -0.9388031 -1.010592 -1.072406 -1.142291 -1.211898 -1.265431 0.000000 6.6835638E-03 -3.2489866E-03 -2.8153494E-02 -6.1352070E-02 -9.9355355E-02 -0.1405847 -0.1841922 -0.2296930 -0.2737617 -0.3205210 -0.3679367 -0.4158670 -0.4642001 -0.5129018 -0.5552230 -0.6018670 -0.6482503 -0.6944035 -0.7403944 -0.7762924 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 9.9425085E-02 0.1693096 0.1972480 0.2025749 0.1963667 0.1825899 0.1616374 0.1369265 0.1119216 8.5209541E-02 5.8496803E-02 3.1928495E-02 5.8360728E-03 -2.0397048E-02 -4.6618696E-02 -7.3513620E-02 -0.1005342 -0.1265154 -0.1519184 -0.1790441 0.000000 9.8236665E-02 0.1728538 0.2098066 0.2259009 0.2256641 0.2168364 0.2015870 0.1830280 0.1626580 0.1412579 0.1205360 9.9128313E-02 7.8435719E-02 5.8216080E-02 3.8243763E-02 1.8560253E-02 -6.5111183E-04 -2.0327717E-02 -4.0268153E-02 -6.0652234E-02 0.000000 9.6769936E-02 0.1782297 0.2269027 0.2381985 0.2349171 0.2244191 0.2079123 0.1881192 0.1664015 0.1435915 0.1218953 0.1002439 7.7908732E-02 5.5884380E-02 3.3284891E-02 1.0369333E-02 -1.3702854E-02 -3.9015520E-02 -6.5573454E-02 -9.3194395E-02 0.000000 9.6934780E-02 0.1866681 0.2333007 0.2336877 0.2235892 0.2078307 0.1860715 0.1612753 0.1348929 0.1087638 8.1801109E-02 5.3617902E-02 2.3910901E-02 -7.7628903E-03 -4.2090587E-02 -7.8170575E-02 -0.1154922 -0.1550620 -0.1960728 -0.2408691 0.000000 9.7619101E-02 0.1986990 0.2244479 0.2157145 0.1973428 0.1728930 0.1440073 0.1126406 7.9979733E-02 4.5053910E-02 6.9135274E-03 -3.4936380E-02 -7.9919539E-02 -0.1280203 -0.1770368 -0.2288880 -0.2828934 -0.3402750 -0.4012378 -0.4625733 0.000000 9.9802323E-02 0.2015505 0.2073300 0.1886859 0.1590917 0.1255539 8.8439219E-02 4.8267521E-02 3.0277364E-03 -4.7354683E-02 -0.1023778 -0.1599279 -0.2202270 -0.2840640 -0.3478737 -0.4203480 -0.4903417 -0.5677046 -0.6425723 -0.7253922 0.000000 0.1033746 0.1877195 0.1845911 0.1545015 0.1133169 7.0260085E-02 2.1687889E-02 -3.4152761E-02 -9.6210159E-02 -0.1629679 -0.2328148 -0.3067945 -0.3795955 -0.4598244 -0.5429463 -0.6299797 -0.7228044 -0.8088166 -0.9002988 -0.9886186 0.000000 0.1072854 0.1712088 0.1581414 0.1151101 6.3824743E-02 7.8966282E-03 -5.7375900E-02 -0.1297704 -0.2079433 -0.2902544 -0.3757595 -0.4593592 -0.5503659 -0.6460645 -0.7441400 -0.8452434 -0.9465721 -1.035736 -1.135745 -1.242307 0.000000 0.1069015 0.1525874 0.1292150 7.3565461E-02 1.1291935E-02 -6.1552014E-02 -0.1441067 -0.2332271 -0.3265079 -0.4230720 -0.5180511 -0.6202368 -0.7242354 -0.8309398 -0.9372272 -1.042197 -1.136557 -1.240451 -1.346763 -1.455591 0.000000 9.6123382E-02 0.1329915 9.8582424E-02 3.2417044E-02 -4.4216160E-02 -0.1340704 -0.2329212 -0.3367192 -0.4425406 -0.5513610 -0.6620892 -0.7732775 -0.8857368 -0.9981302 -1.097823 -1.204400 -1.310758 -1.416658 -1.521646 -1.625937 0.000000 8.5498147E-02 0.1131895 6.7487247E-02 -7.9962434E-03 -0.1001217 -0.2063384 -0.3199545 -0.4355558 -0.5526981 -0.6708544 -0.7875615 -0.9036599 -1.018596 -1.130562 -1.239639 -1.345573 -1.450319 -1.552797 -1.651320 -1.747772 0.000000 7.4819654E-02 9.3418807E-02 3.8349044E-02 -4.7337294E-02 -0.1522789 -0.2720166 -0.3999225 -0.5245165 -0.6504305 -0.7734880 -0.8934991 -1.013782 -1.127563 -1.238440 -1.343188 -1.447204 -1.548036 -1.642290 -1.732503 -1.822342 0.000000 6.4678624E-02 7.4138425E-02 1.2042699E-02 -8.3279863E-02 -0.2000214 -0.3304476 -0.4626128 -0.5982161 -0.7286798 -0.8536527 -0.9770814 -1.092872 -1.213978 -1.318817 -1.424798 -1.527664 -1.620847 -1.709273 -1.797479 -1.884672 0.000000 5.4430176E-02 5.5476703E-02 -1.1532820E-02 -0.1130303 -0.2391714 -0.3748529 -0.5111207 -0.6506307 -0.7820166 -0.9082372 -1.027053 -1.148623 -1.254304 -1.359225 -1.459903 -1.566038 -1.654133 -1.743379 -1.831190 -1.912389 0.000000 4.4821575E-02 3.8775146E-02 -3.0761212E-02 -0.1360782 -0.2633700 -0.4015289 -0.5370109 -0.6762664 -0.8048244 -0.9270465 -1.051479 -1.158807 -1.264558 -1.375402 -1.470909 -1.558474 -1.646782 -1.728422 -1.826020 -1.900341 0.000000 3.6054056E-02 2.4136398E-02 -4.5418784E-02 -0.1495720 -0.2724303 -0.4063871 -0.5358315 -0.6701140 -0.7923868 -0.9176651 -1.027429 -1.133315 -1.243086 -1.338827 -1.425764 -1.513887 -1.610522 -1.685005 -1.776002 -1.849409 0.000000 2.7413296E-02 1.2793479E-02 -5.3232096E-02 -0.1494588 -0.2633089 -0.3811930 -0.5035068 -0.6270066 -0.7393706 -0.8555889 -0.9586796 -1.067965 -1.162600 -1.249962 -1.349356 -1.429289 -1.518721 -1.593059 -1.677939 -1.746402 0.000000 1.9422505E-02 4.0812902E-03 -5.3180367E-02 -0.1358977 -0.2302309 -0.3319802 -0.4366426 -0.5430807 -0.6408464 -0.7431238 -0.8370200 -0.9329937 -1.018591 -1.111630 -1.201125 -1.273728 -1.359298 -1.426588 -1.504938 -1.570899 0.000000 1.2044068E-02 -1.3209266E-03 -4.5568489E-02 -0.1064665 -0.1770812 -0.2528552 -0.3316821 -0.4127346 -0.4887642 -0.5689881 -0.6497886 -0.7227575 -0.8007357 -0.8787968 -0.9446223 -1.016440 -1.088858 -1.148489 -1.217766 -1.284046 0.000000 5.5270772E-03 -2.8927638E-03 -2.7476948E-02 -6.1083592E-02 -9.9678263E-02 -0.1414324 -0.1854314 -0.2312203 -0.2757210 -0.3227140 -0.3703169 -0.4183904 -0.4668157 -0.5155672 -0.5583440 -0.6050299 -0.6514176 -0.6975404 -0.7434566 -0.7798831 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 5.2066579E-02 7.1735933E-02 6.6121913E-02 4.1641764E-02 8.4642973E-03 -2.8638164E-02 -6.8736300E-02 -0.1092311 -0.1489947 -0.1880838 -0.2291072 -0.2687327 -0.3081098 -0.3470437 -0.3854071 -0.4234582 -0.4612192 -0.4987938 -0.5358981 -0.5761211 0.000000 5.1211726E-02 7.7325173E-02 7.9657391E-02 6.5860175E-02 4.5632504E-02 2.1485059E-02 -6.5798867E-03 -3.6120936E-02 -6.6010520E-02 -9.5216356E-02 -0.1244365 -0.1536256 -0.1824355 -0.2107383 -0.2388864 -0.2669189 -0.2947768 -0.3225440 -0.3498842 -0.3799003 0.000000 4.9371917E-02 7.9223670E-02 9.1823556E-02 8.9499474E-02 7.8060508E-02 5.6365509E-02 3.1831782E-02 5.6182328E-03 -2.1552308E-02 -4.9013309E-02 -7.7293977E-02 -0.1056612 -0.1342086 -0.1629322 -0.1917107 -0.2208963 -0.2508336 -0.2813387 -0.3117289 -0.3448700 0.000000 4.6642493E-02 8.2516052E-02 0.1074739 0.1129494 9.5582142E-02 7.2303884E-02 4.4850506E-02 1.4799997E-02 -1.6251039E-02 -4.8390519E-02 -8.1013896E-02 -0.1150763 -0.1514304 -0.1877076 -0.2251978 -0.2637676 -0.3055439 -0.3465187 -0.3885835 -0.4343652 0.000000 4.4032477E-02 8.8131338E-02 0.1267450 0.1204907 9.6751772E-02 6.6279940E-02 3.0842863E-02 -6.0207685E-03 -4.4347908E-02 -8.4824964E-02 -0.1269890 -0.1728707 -0.2193185 -0.2675066 -0.3199950 -0.3713338 -0.4250289 -0.4853013 -0.5439387 -0.6068673 0.000000 4.2888395E-02 9.6884362E-02 0.1377094 0.1158983 8.1646517E-02 4.0454973E-02 -3.0784616E-03 -4.8841827E-02 -9.7615138E-02 -0.1500862 -0.2051430 -0.2649685 -0.3250124 -0.3900245 -0.4543166 -0.5270010 -0.5982161 -0.6763159 -0.7512971 -0.8373623 0.000000 4.2092577E-02 0.1089367 0.1325353 9.9878840E-02 5.3264499E-02 2.2021576E-03 -5.1612433E-02 -0.1089275 -0.1706882 -0.2378925 -0.3103205 -0.3822512 -0.4601431 -0.5381160 -0.6242412 -0.7144800 -0.7977788 -0.8925105 -0.9802024 -1.076900 0.000000 4.2384248E-02 0.1232456 0.1201879 7.4765779E-02 1.6903646E-02 -4.4800758E-02 -0.1115808 -0.1820521 -0.2594899 -0.3422290 -0.4298097 -0.5165993 -0.6105505 -0.7079366 -0.8079027 -0.9011588 -1.004290 -1.109134 -1.199704 -1.303017 0.000000 4.3677706E-02 0.1257237 0.1013689 4.4881523E-02 -2.3946747E-02 -9.8742954E-02 -0.1784064 -0.2657034 -0.3590056 -0.4565898 -0.5582606 -0.6630205 -0.7708369 -0.8722252 -0.9809347 -1.089976 -1.198222 -1.292097 -1.396191 -1.504313 0.000000 4.5767121E-02 0.1128640 8.0753714E-02 1.2244910E-02 -6.7749374E-02 -0.1558220 -0.2518785 -0.3555117 -0.4631412 -0.5740209 -0.6868469 -0.8006741 -0.9168530 -1.032208 -1.144144 -1.255466 -1.353048 -1.459101 -1.564250 -1.669481 0.000000 5.0039224E-02 9.8553911E-02 5.7452124E-02 -2.1457436E-02 -0.1130989 -0.2155982 -0.3276749 -0.4455280 -0.5651889 -0.6860904 -0.8063176 -0.9290924 -1.049693 -1.162596 -1.273265 -1.383555 -1.490488 -1.593076 -1.692910 -1.792145 0.000000 5.6229781E-02 8.3210729E-02 3.3660360E-02 -5.4024108E-02 -0.1580822 -0.2744868 -0.4005993 -0.5288704 -0.6577268 -0.7843750 -0.9118317 -1.044434 -1.159666 -1.271058 -1.382563 -1.489080 -1.588669 -1.684909 -1.779362 -1.872330 0.000000 5.1804561E-02 6.6718578E-02 1.1142777E-02 -8.4367983E-02 -0.1975820 -0.3257423 -0.4645585 -0.5989841 -0.7331348 -0.8643805 -0.9995606 -1.117366 -1.229349 -1.343104 -1.450795 -1.547972 -1.641448 -1.733677 -1.823059 -1.909174 0.000000 4.3440599E-02 5.1790107E-02 -9.6347798E-03 -0.1111486 -0.2320576 -0.3681753 -0.5073659 -0.6501906 -0.7853433 -0.9238827 -1.046347 -1.160022 -1.273805 -1.393357 -1.488915 -1.582591 -1.676011 -1.766107 -1.850245 -1.930884 0.000000 3.5544217E-02 3.7674289E-02 -2.7381826E-02 -0.1304232 -0.2575521 -0.3944533 -0.5333881 -0.6758121 -0.8079327 -0.9418691 -1.059342 -1.172833 -1.291441 -1.387306 -1.483517 -1.575339 -1.676452 -1.760393 -1.840433 -1.915338 0.000000 2.8102910E-02 2.4468668E-02 -4.0738121E-02 -0.1425676 -0.2647805 -0.4004755 -0.5332996 -0.6702316 -0.7954983 -0.9226546 -1.034801 -1.154612 -1.252383 -1.348398 -1.451839 -1.539369 -1.621646 -1.713232 -1.787724 -1.861311 0.000000 2.1040749E-02 1.3691135E-02 -4.8493594E-02 -0.1429802 -0.2571613 -0.3772439 -0.5020251 -0.6276535 -0.7423060 -0.8600383 -0.9671113 -1.075380 -1.169651 -1.270540 -1.357251 -1.451834 -1.527657 -1.602392 -1.687134 -1.756161 0.000000 1.4667137E-02 5.3948662E-03 -4.8805576E-02 -0.1308981 -0.2263667 -0.3297755 -0.4362144 -0.5440813 -0.6435371 -0.7468204 -0.8496798 -0.9376735 -1.033786 -1.117234 -1.207018 -1.280458 -1.365855 -1.433769 -1.512123 -1.578473 0.000000 9.0184938E-03 -1.7554924E-04 -4.2293195E-02 -0.1033019 -0.1748573 -0.2517687 -0.3316694 -0.4135515 -0.4911239 -0.5714000 -0.6523075 -0.7259116 -0.8041139 -0.8823243 -0.9488196 -1.020811 -1.093307 -1.153429 -1.222712 -1.289093 0.000000 4.0926859E-03 -2.1563871E-03 -2.5787698E-02 -5.9649836E-02 -9.8829225E-02 -0.1411643 -0.1856540 -0.2318195 -0.2793920 -0.3239583 -0.3717524 -0.4199819 -0.4685371 -0.5173910 -0.5605100 -0.6072970 -0.6537615 -0.6999386 -0.7459013 -0.7826718 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -1.1295435E-02 -3.3151042E-02 -8.1806816E-02 -0.1477088 -0.2150549 -0.2822870 -0.3515316 -0.4160994 -0.4785756 -0.5389087 -0.6029365 -0.6609365 -0.7173598 -0.7723471 -0.8258498 -0.8781650 -0.9295107 -0.9800746 -1.029960 -1.083316 0.000000 -2.0714568E-03 -1.7396124E-02 -5.8888510E-02 -0.1066338 -0.1591526 -0.2119008 -0.2635723 -0.3157808 -0.3629584 -0.4083870 -0.4520570 -0.4939668 -0.5343255 -0.5733126 -0.6117482 -0.6557766 -0.6948065 -0.7331175 -0.7708271 -0.8117042 0.000000 6.0268808E-03 -1.1458754E-02 -3.9904881E-02 -7.8030407E-02 -0.1206408 -0.1603346 -0.1998602 -0.2387817 -0.2788150 -0.3165032 -0.3536810 -0.3902619 -0.4264876 -0.4624435 -0.4977733 -0.5329436 -0.5738795 -0.6108112 -0.6478792 -0.6882350 0.000000 7.5580929E-03 -5.7507423E-03 -2.5587168E-02 -5.3763375E-02 -8.1095405E-02 -0.1133305 -0.1489204 -0.1861919 -0.2268339 -0.2665081 -0.3062191 -0.3468136 -0.3907785 -0.4316191 -0.4731636 -0.5150416 -0.5571247 -0.6063736 -0.6516954 -0.7007275 0.000000 6.7003183E-03 -1.4388617E-03 -1.1768845E-02 -2.3371371E-02 -4.7861379E-02 -8.3269596E-02 -0.1237752 -0.1692941 -0.2147287 -0.2608093 -0.3110100 -0.3590257 -0.4077407 -0.4615011 -0.5131883 -0.5658482 -0.6263158 -0.6835902 -0.7421589 -0.8058645 0.000000 5.5077206E-03 2.0412060E-03 7.4528726E-03 4.2889691E-03 -3.1876888E-02 -7.6247610E-02 -0.1275151 -0.1801417 -0.2338819 -0.2913514 -0.3488216 -0.4100224 -0.4701183 -0.5369149 -0.6020146 -0.6759169 -0.7479145 -0.8222328 -0.9044062 -0.9858543 0.000000 4.3629562E-03 6.7043058E-03 3.2451428E-02 1.4448657E-02 -3.2688498E-02 -8.9023970E-02 -0.1502998 -0.2122854 -0.2778924 -0.3476121 -0.4158655 -0.4909947 -0.5659995 -0.6488366 -0.7304724 -0.8217372 -0.9169498 -1.002868 -1.101468 -1.195677 0.000000 3.5199006E-03 1.4557088E-02 5.5793606E-02 1.2503009E-02 -4.7143690E-02 -0.1166132 -0.1872265 -0.2613378 -0.3397226 -0.4194695 -0.5044401 -0.5952279 -0.6924248 -0.7867536 -0.8891702 -0.9933013 -1.088073 -1.194334 -1.303411 -1.399340 0.000000 3.2950570E-03 2.6182253E-02 5.3867511E-02 1.2915926E-03 -7.2168797E-02 -0.1520166 -0.2352944 -0.3221193 -0.4158280 -0.5082348 -0.6091048 -0.7161084 -0.8276163 -0.9410464 -1.043931 -1.152696 -1.264526 -1.376636 -1.471892 -1.579069 0.000000 2.9133554E-03 4.1035976E-02 4.8015468E-02 -1.6956527E-02 -0.1034116 -0.1947787 -0.2902708 -0.3925903 -0.4962628 -0.6070624 -0.7241383 -0.8447471 -0.9639955 -1.079738 -1.191550 -1.305471 -1.420313 -1.518202 -1.625293 -1.733747 0.000000 3.2658763E-03 5.8987930E-02 3.6865067E-02 -4.0310312E-02 -0.1364515 -0.2386127 -0.3467488 -0.4636270 -0.5844942 -0.7088706 -0.8431450 -0.9686242 -1.091291 -1.197806 -1.311866 -1.426211 -1.536113 -1.643431 -1.749239 -1.852628 0.000000 4.6636225E-03 6.2806688E-02 2.2279121E-02 -6.6126890E-02 -0.1711024 -0.2840253 -0.4075017 -0.5375738 -0.6684128 -0.8077448 -0.9383398 -1.064410 -1.184285 -1.300046 -1.415746 -1.525596 -1.631743 -1.737182 -1.836121 -1.931275 0.000000 7.3098796E-03 5.2028261E-02 6.5298090E-03 -8.9958906E-02 -0.2026873 -0.3282708 -0.4642039 -0.6019947 -0.7388334 -0.8814377 -1.011932 -1.134658 -1.251169 -1.368690 -1.479857 -1.579687 -1.694883 -1.790411 -1.880634 -1.968211 0.000000 1.1379802E-02 4.1452207E-02 -9.5291110E-03 -0.1112387 -0.2297750 -0.3626847 -0.5092458 -0.6498887 -0.7886907 -0.9306325 -1.057485 -1.175554 -1.293077 -1.415091 -1.513535 -1.612877 -1.709569 -1.797125 -1.881963 -1.965048 0.000000 1.7335840E-02 3.0890437E-02 -2.5011096E-02 -0.1272487 -0.2501710 -0.3872598 -0.5291854 -0.6749266 -0.8108210 -0.9482203 -1.069640 -1.186588 -1.307582 -1.406045 -1.504124 -1.612739 -1.699674 -1.784909 -1.868425 -1.945040 0.000000 1.7467130E-02 2.0699145E-02 -3.6658991E-02 -0.1371760 -0.2563193 -0.3936331 -0.5298210 -0.6697969 -0.7986272 -0.9287168 -1.043956 -1.165894 -1.265930 -1.363771 -1.467619 -1.556935 -1.640942 -1.736357 -1.812431 -1.881764 0.000000 1.2807391E-02 1.1867972E-02 -4.4131421E-02 -0.1366354 -0.2495801 -0.3720810 -0.4996812 -0.6279539 -0.7454577 -0.8653972 -0.9746612 -1.084471 -1.180286 -1.281875 -1.369625 -1.466792 -1.542866 -1.632541 -1.701099 -1.773305 0.000000 8.4837321E-03 4.7565293E-03 -4.4290356E-02 -0.1251101 -0.2212253 -0.3265374 -0.4351676 -0.5449454 -0.6463221 -0.7510612 -0.8550751 -0.9443668 -1.041133 -1.125052 -1.218316 -1.292644 -1.375421 -1.443823 -1.522193 -1.604268 0.000000 4.9650776E-03 -2.5995413E-04 -3.8642582E-02 -9.9170431E-02 -0.1716662 -0.2499925 -0.3312639 -0.4142956 -0.4929601 -0.5741404 -0.6557326 -0.7301164 -0.8087208 -0.8871863 -0.9638873 -1.026569 -1.099075 -1.159607 -1.228891 -1.295307 0.000000 2.0328346E-03 -1.9697906E-03 -2.3721399E-02 -5.7683233E-02 -9.7539783E-02 -0.1406240 -0.1857564 -0.2324370 -0.2804196 -0.3254322 -0.3735260 -0.4219907 -0.4707310 -0.5197255 -0.5631452 -0.6100453 -0.6565872 -0.7028099 -0.7488187 -0.7859192 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.1223415 -0.2283573 -0.3364531 -0.4464394 -0.5496790 -0.6498308 -0.7539614 -0.8492277 -0.9488249 -1.037334 -1.122053 -1.202851 -1.292691 -1.371921 -1.448345 -1.522694 -1.595293 -1.666343 -1.735761 -1.823627 0.000000 -0.1055523 -0.1977870 -0.2826948 -0.3622585 -0.4501608 -0.5343822 -0.6223905 -0.7007070 -0.7739343 -0.8501586 -0.9160799 -0.9781005 -1.036923 -1.093246 -1.159244 -1.215507 -1.269568 -1.322276 -1.373773 -1.428295 0.000000 -9.4216049E-02 -0.1710964 -0.2322570 -0.3070022 -0.3863079 -0.4588699 -0.5317304 -0.5932945 -0.6496915 -0.7025610 -0.7590133 -0.8090009 -0.8577576 -0.9048347 -0.9506658 -0.9965463 -1.051803 -1.099188 -1.145085 -1.193671 0.000000 -8.6148039E-02 -0.1444231 -0.1986108 -0.2690626 -0.3358948 -0.3909711 -0.4453824 -0.4954150 -0.5441836 -0.5921338 -0.6460896 -0.6956950 -0.7442287 -0.7924739 -0.8479107 -0.8968963 -0.9458150 -0.9942225 -1.042166 -1.104019 0.000000 -7.7918991E-02 -0.1193475 -0.1763797 -0.2343772 -0.2813034 -0.3218838 -0.3732418 -0.4231800 -0.4751246 -0.5337521 -0.5884883 -0.6416743 -0.7015302 -0.7555092 -0.8104301 -0.8741397 -0.9321343 -0.9905080 -1.050071 -1.124749 0.000000 -6.8876214E-02 -9.9827364E-02 -0.1562234 -0.1943394 -0.2253386 -0.2719491 -0.3276811 -0.3861500 -0.4508966 -0.5125131 -0.5726351 -0.6380689 -0.7010407 -0.7714055 -0.8377125 -0.9144157 -0.9859777 -1.059166 -1.144319 -1.224591 0.000000 -5.9977144E-02 -9.2867300E-02 -0.1335318 -0.1500291 -0.1884471 -0.2438976 -0.3108249 -0.3795223 -0.4521458 -0.5199861 -0.5930440 -0.6715596 -0.7469547 -0.8311942 -0.9129625 -1.005506 -1.091331 -1.187875 -1.274956 -1.377256 0.000000 -5.0988663E-02 -8.6236827E-02 -0.1064586 -0.1104960 -0.1677717 -0.2388140 -0.3155708 -0.3964216 -0.4726231 -0.5540831 -0.6418208 -0.7356674 -0.8250655 -0.9243270 -1.029895 -1.126137 -1.232912 -1.328911 -1.438452 -1.556797 0.000000 -4.1530430E-02 -7.8162044E-02 -7.5811386E-02 -9.4656825E-02 -0.1620216 -0.2476135 -0.3373248 -0.4227023 -0.5128827 -0.6099816 -0.7134606 -0.8223035 -0.9264794 -1.037833 -1.149840 -1.265722 -1.370122 -1.486764 -1.607477 -1.729853 0.000000 -3.1701237E-02 -6.8875074E-02 -4.3290213E-02 -8.6460009E-02 -0.1708021 -0.2661684 -0.3644779 -0.4629351 -0.5692401 -0.6817309 -0.7991638 -0.9199148 -1.042196 -1.153065 -1.271772 -1.391899 -1.512785 -1.633468 -1.749672 -1.860807 0.000000 -3.0433457E-02 -5.6691777E-02 -1.7488910E-02 -8.7389939E-02 -0.1853428 -0.2926605 -0.4001329 -0.5137574 -0.6355793 -0.7604889 -0.8889311 -1.016348 -1.142362 -1.265652 -1.388066 -1.509570 -1.628810 -1.744757 -1.836627 -1.939400 0.000000 -2.8815219E-02 -4.2494103E-02 -1.8163383E-02 -9.5113792E-02 -0.2032986 -0.3188717 -0.4361224 -0.5648207 -0.6971793 -0.8380128 -0.9714798 -1.101398 -1.226779 -1.348537 -1.469915 -1.588560 -1.701900 -1.807651 -1.909017 -2.009759 0.000000 -2.6756993E-02 -2.5144910E-02 -2.0203909E-02 -0.1078980 -0.2239442 -0.3460916 -0.4773315 -0.6170723 -0.7573361 -0.9025762 -1.037374 -1.165689 -1.288476 -1.411296 -1.527662 -1.648658 -1.751126 -1.850486 -1.949766 -2.046850 0.000000 -2.4005044E-02 -4.0559820E-03 -2.4725877E-02 -0.1193603 -0.2401198 -0.3675945 -0.5137104 -0.6578870 -0.8008772 -0.9465916 -1.078873 -1.202841 -1.325637 -1.451813 -1.555288 -1.658683 -1.757812 -1.851550 -1.958251 -2.043424 0.000000 -2.0514186E-02 1.0645532E-02 -3.1316798E-02 -0.1283700 -0.2518016 -0.3850288 -0.5298110 -0.6791623 -0.8197486 -0.9616449 -1.088330 -1.210314 -1.335137 -1.438073 -1.539738 -1.650247 -1.743838 -1.832849 -1.913531 -2.014452 0.000000 -1.6176624E-02 4.6457718E-03 -3.7488695E-02 -0.1342832 -0.2521189 -0.3889705 -0.5286293 -0.6727523 -0.8060240 -0.9404087 -1.060116 -1.185416 -1.289179 -1.390133 -1.495896 -1.587183 -1.690298 -1.770015 -1.850584 -1.945381 0.000000 -1.0437309E-02 2.2458597E-04 -4.1588593E-02 -0.1316682 -0.2424516 -0.3675686 -0.4986770 -0.6305302 -0.7519047 -0.8751662 -0.9875909 -1.100063 -1.198465 -1.301841 -1.391156 -1.490168 -1.568008 -1.662156 -1.735521 -1.821968 0.000000 -3.0739165E-03 -2.5544271E-03 -4.0901095E-02 -0.1196214 -0.2175853 -0.3232162 -0.4348641 -0.5473887 -0.6515056 -0.7584863 -0.8643466 -0.9557644 -1.053818 -1.139101 -1.233358 -1.310558 -1.393124 -1.479882 -1.545069 -1.623497 0.000000 -2.2740683E-03 -4.2998949E-03 -3.5159759E-02 -9.4295554E-02 -0.1677568 -0.2480001 -0.3312909 -0.4160956 -0.4963632 -0.5788852 -0.6615573 -0.7371175 -0.8165258 -0.8954299 -0.9745686 -1.038110 -1.109709 -1.182604 -1.240510 -1.307166 0.000000 -1.4882513E-03 -3.5974865E-03 -2.1624105E-02 -5.5181440E-02 -9.5910862E-02 -0.1400824 -0.1861742 -0.2336267 -0.2822250 -0.3278538 -0.3764054 -0.4252637 -0.4743405 -0.5236249 -0.5731156 -0.6146554 -0.6614336 -0.7078629 -0.7540154 -0.7915010 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.3839728 -0.5861157 -0.7721537 -0.9496328 -1.114049 -1.280148 -1.426447 -1.575361 -1.706284 -1.847191 -1.967920 -2.082692 -2.211894 -2.322072 -2.427444 -2.553530 -2.658727 -2.760409 -2.858104 -2.982980 0.000000 -0.3506145 -0.5193288 -0.6745947 -0.8184069 -0.9592882 -1.099790 -1.219733 -1.330000 -1.445262 -1.545693 -1.656196 -1.748567 -1.835561 -1.917818 -2.014587 -2.093827 -2.169372 -2.242177 -2.312432 -2.405022 0.000000 -0.3182087 -0.4629423 -0.5961763 -0.7158319 -0.8387364 -0.9464777 -1.056351 -1.153446 -1.254556 -1.338739 -1.414991 -1.497693 -1.566416 -1.630959 -1.691782 -1.767998 -1.830877 -1.890552 -1.947379 -2.025242 0.000000 -0.2884961 -0.4085660 -0.5244399 -0.6320642 -0.7340888 -0.8329098 -0.9322978 -1.013698 -1.094116 -1.158781 -1.219513 -1.290586 -1.351079 -1.408834 -1.481006 -1.540622 -1.596622 -1.650319 -1.704457 -1.777398 0.000000 -0.2608841 -0.3675074 -0.4670860 -0.5549807 -0.6524583 -0.7409375 -0.8192896 -0.8808527 -0.9470188 -1.007537 -1.078984 -1.142025 -1.203188 -1.276337 -1.336615 -1.394272 -1.452693 -1.525381 -1.589315 -1.672199 0.000000 -0.2333661 -0.3266304 -0.4139330 -0.4915863 -0.5825100 -0.6491674 -0.7092235 -0.7678972 -0.8384059 -0.9053234 -0.9824007 -1.049412 -1.125775 -1.189553 -1.255118 -1.332797 -1.403633 -1.489747 -1.566215 -1.660009 0.000000 -0.2115335 -0.2860683 -0.3631758 -0.4406653 -0.5101065 -0.5629132 -0.6221553 -0.6967502 -0.7706897 -0.8534083 -0.9263241 -1.007947 -1.078616 -1.163349 -1.243573 -1.336555 -1.423088 -1.522438 -1.611746 -1.719448 0.000000 -0.1897279 -0.2562260 -0.3167071 -0.3898841 -0.4343956 -0.4920105 -0.5651055 -0.6510813 -0.7398104 -0.8198854 -0.9080716 -0.9890028 -1.083252 -1.185559 -1.281183 -1.387945 -1.497926 -1.598294 -1.715179 -1.839242 0.000000 -0.1672682 -0.2292902 -0.2870552 -0.3375801 -0.3677494 -0.4457060 -0.5376627 -0.6273708 -0.7216356 -0.8161526 -0.9083678 -1.013890 -1.124596 -1.239519 -1.357688 -1.463906 -1.585439 -1.709501 -1.832811 -1.940640 0.000000 -0.1485831 -0.2012410 -0.2561038 -0.2782803 -0.3264703 -0.4185476 -0.5212636 -0.6244843 -0.7200232 -0.8282783 -0.9438982 -1.063508 -1.185406 -1.308232 -1.433049 -1.561821 -1.692323 -1.802403 -1.924031 -2.046357 0.000000 -0.1319296 -0.1722609 -0.2225906 -0.2212074 -0.3020715 -0.4090940 -0.5167614 -0.6256673 -0.7418547 -0.8667434 -0.9945620 -1.123404 -1.251758 -1.380214 -1.511715 -1.642669 -1.768133 -1.889230 -2.006875 -2.121995 0.000000 -0.1144750 -0.1420936 -0.1861100 -0.1890102 -0.2858328 -0.4030243 -0.5227895 -0.6431345 -0.7763148 -0.9121332 -1.048350 -1.182518 -1.314783 -1.450503 -1.583435 -1.707024 -1.824845 -1.938498 -2.047326 -2.152814 0.000000 -9.6239947E-02 -0.1291198 -0.1461301 -0.1706188 -0.2773678 -0.4026688 -0.5270527 -0.6691213 -0.8123552 -0.9545217 -1.094872 -1.230568 -1.367840 -1.511780 -1.632190 -1.749957 -1.863304 -1.970690 -2.071142 -2.168850 0.000000 -8.2699560E-02 -0.1159224 -0.1025410 -0.1574604 -0.2751424 -0.4051436 -0.5372120 -0.6846862 -0.8330451 -0.9840073 -1.123889 -1.260905 -1.403392 -1.522185 -1.640372 -1.751034 -1.865836 -1.962588 -2.059365 -2.152177 0.000000 -6.9947407E-02 -9.9018261E-02 -6.7039996E-02 -0.1493922 -0.2688081 -0.3988086 -0.5445858 -0.6940687 -0.8420572 -0.9904942 -1.126110 -1.269153 -1.388301 -1.504036 -1.625827 -1.719908 -1.817263 -1.911466 -2.014229 -2.096667 0.000000 -5.6406029E-02 -8.0015197E-02 -6.3765913E-02 -0.1412250 -0.2615349 -0.3887078 -0.5316602 -0.6817932 -0.8225823 -0.9640512 -1.094177 -1.224174 -1.336739 -1.455208 -1.548759 -1.643089 -1.750755 -1.833504 -1.914843 -2.009917 0.000000 -4.1641280E-02 -5.7586417E-02 -5.6745525E-02 -0.1317268 -0.2413539 -0.3660952 -0.4989382 -0.6372384 -0.7652273 -0.8944207 -1.022087 -1.129880 -1.245655 -1.339474 -1.431114 -1.535622 -1.616979 -1.708652 -1.783656 -1.871125 0.000000 -3.1242331E-02 -3.0453278E-02 -4.7838055E-02 -0.1148981 -0.2116180 -0.3185900 -0.4350505 -0.5527260 -0.6617779 -0.7729588 -0.8822154 -0.9793015 -1.078580 -1.165464 -1.261082 -1.352898 -1.424584 -1.512143 -1.579106 -1.658383 0.000000 -2.0978998E-02 -1.9782305E-02 -3.6975771E-02 -8.9728557E-02 -0.1620892 -0.2449736 -0.3319534 -0.4201155 -0.5033355 -0.5883082 -0.6729192 -0.7574304 -0.8312366 -0.9112477 -0.9913059 -1.056446 -1.128958 -1.202556 -1.261253 -1.330487 0.000000 -9.7986246E-03 -1.1273902E-02 -2.1614127E-02 -5.1730581E-02 -9.3260348E-02 -0.1392377 -0.1871482 -0.2360931 -0.2858598 -0.3325843 -0.3819503 -0.4314916 -0.4811532 -0.5309387 -0.5808581 -0.6231547 -0.6703420 -0.7171305 -0.7635831 -0.8098255 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.9389783 -1.667367 -2.259194 -2.778911 -3.246494 -3.676211 -4.075975 -4.450170 -4.803465 -5.140110 -5.462955 -5.774977 -6.079022 -6.376920 -6.671365 -6.963747 -7.254849 -7.545743 -7.759203 -8.012605 0.000000 -0.8916581 -1.552991 -2.073404 -2.530456 -2.939862 -3.314101 -3.659527 -3.980804 -4.281747 -4.566941 -4.839299 -5.101409 -5.356208 -5.605581 -5.852111 -6.031817 -6.245796 -6.464843 -6.688015 -6.910141 0.000000 -0.8439577 -1.436983 -1.897817 -2.300238 -2.658757 -2.985279 -3.284116 -3.560909 -3.818496 -4.061406 -4.293314 -4.516684 -4.733666 -4.892970 -5.075878 -5.260578 -5.446179 -5.574080 -5.735173 -5.901419 0.000000 -0.7958493 -1.322761 -1.731440 -2.086469 -2.402450 -2.687031 -2.948023 -3.186927 -3.409914 -3.620330 -3.820852 -4.012252 -4.148339 -4.303964 -4.459219 -4.615259 -4.719136 -4.853149 -4.994986 -5.140655 0.000000 -0.7473021 -1.211550 -1.574118 -1.890085 -2.167197 -2.418242 -2.644842 -2.855946 -3.052019 -3.233220 -3.401313 -3.523544 -3.659422 -3.794216 -3.929561 -4.025023 -4.143613 -4.269430 -4.356682 -4.473259 0.000000 -0.6982808 -1.105106 -1.425968 -1.705267 -1.953597 -2.171507 -2.376016 -2.561340 -2.726701 -2.876104 -3.017663 -3.122741 -3.243296 -3.365845 -3.490854 -3.581082 -3.697324 -3.814104 -3.935510 -4.059436 0.000000 -0.6487329 -1.003550 -1.289968 -1.539016 -1.753042 -1.952684 -2.131090 -2.284688 -2.421742 -2.554516 -2.684950 -2.784980 -2.900278 -3.018426 -3.140383 -3.261468 -3.346861 -3.459695 -3.575099 -3.694477 0.000000 -0.5985910 -0.9047273 -1.161624 -1.382483 -1.573143 -1.749768 -1.896009 -2.024779 -2.153642 -2.281667 -2.408826 -2.510446 -2.628777 -2.746956 -2.860078 -2.977742 -3.099613 -3.191853 -3.311227 -3.438249 0.000000 -0.5477720 -0.8156850 -1.035561 -1.232241 -1.408820 -1.553248 -1.671945 -1.799536 -1.927735 -2.055570 -2.183080 -2.307734 -2.428699 -2.524554 -2.644334 -2.768047 -2.895741 -3.025889 -3.158414 -3.291468 0.000000 -0.4964116 -0.7277895 -0.9286705 -1.095635 -1.250541 -1.359978 -1.479315 -1.609166 -1.739594 -1.870600 -1.997463 -2.119253 -2.242967 -2.373094 -2.503237 -2.637725 -2.773659 -2.908880 -3.041586 -3.171196 0.000000 -0.4448685 -0.6455936 -0.8229960 -0.9753428 -1.092677 -1.186024 -1.314622 -1.448533 -1.583876 -1.717100 -1.842298 -1.970569 -2.106476 -2.241967 -2.398242 -2.537799 -2.674807 -2.808311 -2.936513 -3.065033 0.000000 -0.3936118 -0.5691190 -0.7178544 -0.8570099 -0.9347668 -1.041618 -1.174634 -1.313034 -1.464542 -1.593901 -1.727936 -1.868780 -2.010370 -2.147593 -2.309126 -2.446776 -2.580822 -2.708210 -2.835151 -2.991332 0.000000 -0.3432309 -0.4920229 -0.6144048 -0.7385290 -0.7879934 -0.9159029 -1.062337 -1.203308 -1.338820 -1.474759 -1.621276 -1.781429 -1.920102 -2.061008 -2.218483 -2.351587 -2.477191 -2.599928 -2.743068 -2.849330 0.000000 -0.2943315 -0.4203963 -0.5346122 -0.6177853 -0.6794959 -0.8111265 -0.9498404 -1.090629 -1.226974 -1.385353 -1.530428 -1.675578 -1.829725 -1.964261 -2.114208 -2.238144 -2.356248 -2.489444 -2.589507 -2.686992 0.000000 -0.2470987 -0.3551359 -0.4546222 -0.4941352 -0.5837812 -0.7074040 -0.8465093 -0.9904272 -1.130732 -1.278993 -1.433350 -1.573508 -1.719956 -1.845790 -1.984681 -2.096550 -2.222789 -2.320325 -2.415743 -2.528971 0.000000 -0.2020880 -0.2889345 -0.3729065 -0.3856353 -0.4885464 -0.6092615 -0.7486669 -0.8775758 -1.029069 -1.167088 -1.315009 -1.444007 -1.578877 -1.696405 -1.820257 -1.920937 -2.032606 -2.123784 -2.226823 -2.304625 0.000000 -0.1589757 -0.2213521 -0.2885493 -0.3136987 -0.3990800 -0.5169684 -0.6343124 -0.7656907 -0.8943874 -1.028773 -1.161264 -1.275503 -1.394648 -1.513972 -1.607392 -1.714174 -1.800074 -1.897207 -1.972626 -2.068635 0.000000 -0.1169711 -0.1659020 -0.1990868 -0.2378900 -0.3107361 -0.4100620 -0.5152086 -0.6235464 -0.7372533 -0.8499997 -0.9611663 -1.056228 -1.157633 -1.257419 -1.341136 -1.431089 -1.520408 -1.591931 -1.678499 -1.760970 0.000000 -7.6514311E-02 -0.1099228 -0.1272806 -0.1615193 -0.2189146 -0.2936342 -0.3708639 -0.4542905 -0.5382708 -0.6215487 -0.7041321 -0.7769403 -0.8537353 -0.9298280 -1.005888 -1.068733 -1.140082 -1.211340 -1.280360 -1.331344 0.000000 -3.7703454E-02 -5.2048367E-02 -6.4697638E-02 -8.3943136E-02 -0.1160127 -0.1571358 -0.2015239 -0.2470293 -0.2927828 -0.3385261 -0.3843104 -0.4302414 -0.4706241 -0.5149201 -0.5590746 -0.6031302 -0.6471155 -0.6910819 -0.7270961 -0.7684706 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.9815204 -1.832369 -2.536212 -3.166807 -3.769293 -4.297335 -4.795874 -5.264890 -5.758277 -6.175231 -6.580060 -6.965590 -7.333576 -7.686164 -8.103198 -8.430975 -8.759659 -9.078003 -9.387266 -9.685115 0.000000 -0.9330003 -1.723931 -2.357735 -2.921996 -3.464326 -3.934074 -4.376419 -4.790338 -5.178415 -5.593847 -5.938177 -6.270320 -6.586977 -6.888405 -7.176753 -7.454470 -7.722069 -7.980626 -8.231276 -8.472756 0.000000 -0.8843683 -1.614042 -2.182022 -2.689464 -3.179194 -3.597335 -3.988168 -4.352872 -4.693606 -5.013364 -5.363270 -5.645449 -5.916737 -6.176706 -6.425186 -6.661587 -6.888901 -7.107637 -7.318479 -7.520392 0.000000 -0.8356212 -1.502797 -2.012973 -2.468583 -2.881196 -3.285329 -3.628195 -3.952949 -4.252440 -4.531761 -4.793550 -5.090738 -5.324025 -5.547393 -5.758346 -5.962027 -6.155005 -6.339376 -6.516348 -6.685962 0.000000 -0.7867541 -1.391737 -1.849149 -2.260547 -2.630823 -2.992406 -3.300738 -3.583755 -3.848852 -4.097113 -4.329259 -4.545603 -4.747536 -4.983297 -5.159628 -5.328428 -5.494200 -5.655420 -5.811810 -5.961173 0.000000 -0.7377644 -1.282067 -1.692385 -2.060904 -2.392552 -2.696550 -2.994032 -3.245914 -3.484555 -3.704209 -3.905629 -4.088768 -4.259268 -4.418144 -4.618829 -4.774158 -4.926482 -5.072478 -5.212715 -5.345055 0.000000 -0.6886441 -1.174905 -1.544182 -1.877010 -2.174110 -2.441152 -2.709889 -2.937995 -3.147752 -3.333910 -3.504333 -3.664315 -3.816322 -4.007484 -4.157283 -4.302670 -4.440462 -4.572074 -4.702781 -4.838833 0.000000 -0.6393847 -1.071203 -1.401342 -1.697032 -1.966984 -2.200782 -2.449052 -2.647264 -2.822344 -2.982429 -3.138252 -3.288234 -3.472283 -3.619073 -3.758445 -3.890449 -4.020879 -4.156198 -4.329870 -4.454195 0.000000 -0.5899742 -0.9698955 -1.265965 -1.532155 -1.766031 -1.983669 -2.199232 -2.361836 -2.514658 -2.668426 -2.818335 -2.996835 -3.140074 -3.277622 -3.407933 -3.544069 -3.708811 -3.831974 -3.958630 -4.084048 0.000000 -0.5403975 -0.8740158 -1.138470 -1.375765 -1.579036 -1.776854 -1.951753 -2.089046 -2.242481 -2.393028 -2.566126 -2.708866 -2.845794 -2.977000 -3.141768 -3.267327 -3.393807 -3.530202 -3.663497 -3.827568 0.000000 -0.4906321 -0.7720553 -1.011418 -1.221186 -1.410707 -1.572501 -1.707012 -1.851532 -2.000460 -2.170861 -2.314576 -2.453056 -2.585593 -2.742790 -2.870026 -3.003202 -3.171804 -3.302081 -3.435322 -3.559421 0.000000 -0.4406458 -0.6837784 -0.8925326 -1.068481 -1.246448 -1.379666 -1.491264 -1.637278 -1.804038 -1.948048 -2.089313 -2.224130 -2.374982 -2.505767 -2.646912 -2.804669 -2.939862 -3.097237 -3.215448 -3.337055 0.000000 -0.3903898 -0.5948082 -0.7820625 -0.9371577 -1.081933 -1.171896 -1.303127 -1.445247 -1.604233 -1.746273 -1.883875 -2.030105 -2.162781 -2.325699 -2.458694 -2.617537 -2.740677 -2.863005 -3.005435 -3.122147 0.000000 -0.3397923 -0.5141630 -0.6712034 -0.8122529 -0.9152588 -0.9975847 -1.129802 -1.280555 -1.419767 -1.559686 -1.700541 -1.834032 -1.990496 -2.127315 -2.274315 -2.401164 -2.539084 -2.653810 -2.789510 -2.900825 0.000000 -0.2889115 -0.4332783 -0.5594881 -0.6871731 -0.7535475 -0.8467852 -0.9701024 -1.111217 -1.247236 -1.385546 -1.513276 -1.662492 -1.814460 -1.936312 -2.080079 -2.191906 -2.323211 -2.432720 -2.556056 -2.676808 0.000000 -0.2381022 -0.3539122 -0.4586127 -0.5600315 -0.5971996 -0.7024276 -0.8248956 -0.9479640 -1.082535 -1.200549 -1.338495 -1.479263 -1.598104 -1.729913 -1.842555 -1.960869 -2.079458 -2.198142 -2.285810 -2.391351 0.000000 -0.1877791 -0.2804649 -0.3656952 -0.4297482 -0.4775082 -0.5657980 -0.6738976 -0.7930360 -0.8998743 -1.020351 -1.146135 -1.255812 -1.374144 -1.490226 -1.588250 -1.692181 -1.795484 -1.898687 -1.975310 -2.067291 0.000000 -0.1388363 -0.2063331 -0.2720422 -0.2986119 -0.3591743 -0.4348690 -0.5217171 -0.6183578 -0.7157915 -0.8197812 -0.9128261 -1.012364 -1.110212 -1.206387 -1.286979 -1.374171 -1.460532 -1.545941 -1.614277 -1.692652 0.000000 -9.1352686E-02 -0.1366411 -0.1762309 -0.2020111 -0.2419141 -0.2968938 -0.3641554 -0.4353660 -0.5045503 -0.5782813 -0.6518270 -0.7245289 -0.7962247 -0.8671234 -0.9280545 -0.9938905 -1.058730 -1.123533 -1.187841 -1.239136 0.000000 -4.5084000E-02 -6.7596897E-02 -8.4350318E-02 -0.1018921 -0.1239976 -0.1550633 -0.1901378 -0.2288011 -0.2684375 -0.3082634 -0.3479768 -0.3874301 -0.4266581 -0.4657333 -0.5047374 -0.5383118 -0.5757414 -0.6129377 -0.6499396 -0.6867718 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.8514053 -1.659656 -2.359080 -2.975003 -3.573551 -4.103745 -4.646172 -5.115077 -5.620473 -6.043664 -6.523926 -6.910835 -7.298681 -7.728657 -8.076955 -8.500415 -8.821663 -9.240376 -9.541256 -9.848492 0.000000 -0.8091964 -1.571290 -2.216091 -2.772850 -3.315954 -3.792537 -4.285222 -4.704661 -5.162917 -5.538550 -5.910201 -6.311910 -6.643311 -7.032915 -7.334007 -7.635806 -7.990352 -8.260100 -8.616261 -8.866929 0.000000 -0.7669467 -1.482368 -2.071450 -2.573711 -3.069953 -3.499569 -3.948538 -4.322290 -4.686688 -5.068818 -5.390967 -5.756354 -6.046487 -6.335373 -6.661652 -6.915919 -7.239192 -7.469927 -7.704432 -8.003658 0.000000 -0.7246613 -1.392820 -1.927006 -2.381412 -2.834519 -3.220997 -3.588353 -3.962483 -4.283626 -4.632319 -4.918348 -5.249988 -5.504181 -5.754213 -6.048915 -6.269609 -6.493530 -6.764167 -6.959296 -7.156346 0.000000 -0.6823351 -1.302561 -1.784843 -2.194595 -2.581660 -2.953855 -3.287318 -3.624325 -3.913847 -4.230394 -4.481723 -4.731543 -5.006045 -5.222504 -5.491862 -5.686210 -5.876778 -6.119079 -6.284539 -6.446695 0.000000 -0.6399710 -1.211486 -1.645448 -2.015048 -2.364237 -2.706135 -3.000475 -3.311551 -3.567345 -3.851870 -4.077682 -4.295977 -4.547339 -4.739013 -4.926954 -5.143954 -5.303182 -5.462824 -5.661620 -5.809045 0.000000 -0.5975711 -1.119706 -1.510835 -1.844162 -2.159493 -2.464915 -2.735847 -3.012859 -3.239403 -3.464947 -3.703311 -3.896634 -4.117553 -4.279442 -4.441133 -4.632173 -4.776379 -4.974517 -5.109874 -5.248310 0.000000 -0.5551309 -1.027901 -1.364572 -1.678663 -1.963457 -2.242768 -2.480999 -2.727009 -2.936991 -3.138577 -3.348196 -3.512363 -3.700757 -3.845473 -3.996066 -4.175363 -4.317629 -4.498249 -4.624762 -4.753811 0.000000 -0.5126552 -0.9366424 -1.236526 -1.520887 -1.770541 -2.029312 -2.232046 -2.464818 -2.650382 -2.823306 -2.996677 -3.142457 -3.317389 -3.460018 -3.639433 -3.772112 -3.907604 -4.073829 -4.194473 -4.317461 0.000000 -0.4701394 -0.8465406 -1.115384 -1.371222 -1.597787 -1.818893 -2.009014 -2.213800 -2.370026 -2.532527 -2.664851 -2.810261 -2.977537 -3.117519 -3.283337 -3.411902 -3.540146 -3.694864 -3.813781 -3.964580 0.000000 -0.4275881 -0.7578053 -0.9972193 -1.222108 -1.427623 -1.615554 -1.795766 -1.966802 -2.087299 -2.232940 -2.371055 -2.537977 -2.671127 -2.807560 -2.959849 -3.086634 -3.236742 -3.352130 -3.494604 -3.601722 0.000000 -0.3849967 -0.6716583 -0.8818305 -1.081364 -1.258191 -1.436120 -1.586887 -1.716604 -1.815407 -1.971664 -2.106017 -2.261704 -2.393451 -2.544211 -2.666392 -2.814243 -2.923268 -3.063566 -3.169886 -3.318602 0.000000 -0.3423677 -0.5888867 -0.7738599 -0.9493695 -1.090409 -1.260348 -1.376400 -1.466453 -1.587985 -1.731920 -1.862008 -2.008662 -2.133984 -2.275601 -2.394246 -2.524628 -2.634458 -2.769584 -2.911952 -3.017280 0.000000 -0.2997037 -0.5073618 -0.6656007 -0.8169637 -0.9478006 -1.084677 -1.161708 -1.252417 -1.376097 -1.508836 -1.649189 -1.768987 -1.905671 -2.022309 -2.146469 -2.256208 -2.387626 -2.522373 -2.626126 -2.753377 0.000000 -0.2569996 -0.4300284 -0.5612339 -0.6837536 -0.8067623 -0.9068190 -0.9461153 -1.065271 -1.184667 -1.298668 -1.426688 -1.556732 -1.666585 -1.785971 -1.891849 -2.016968 -2.143383 -2.244198 -2.363519 -2.484760 0.000000 -0.2142606 -0.3527636 -0.4632418 -0.5615959 -0.6649629 -0.7248567 -0.7895214 -0.8846511 -0.9901058 -1.107311 -1.209906 -1.327476 -1.439773 -1.536891 -1.653291 -1.769034 -1.864417 -1.974625 -2.084502 -2.193471 0.000000 -0.1714819 -0.2795507 -0.3649115 -0.4476049 -0.5260630 -0.5485052 -0.6304704 -0.7167988 -0.8023396 -0.9011245 -1.004774 -1.094529 -1.191794 -1.294241 -1.396987 -1.483564 -1.581014 -1.677701 -1.772748 -1.866316 0.000000 -0.1286684 -0.2062243 -0.2678758 -0.3331181 -0.3749258 -0.4126938 -0.4737686 -0.5416091 -0.6204307 -0.6954259 -0.7774654 -0.8578587 -0.9428573 -1.028054 -1.099971 -1.180998 -1.260996 -1.339797 -1.417193 -1.493725 0.000000 -8.5815109E-02 -0.1364365 -0.1781640 -0.2167585 -0.2419501 -0.2791022 -0.3183711 -0.3675588 -0.4232497 -0.4827258 -0.5420849 -0.6036742 -0.6580391 -0.7177167 -0.7770576 -0.8357548 -0.8936916 -0.9508671 -1.007545 -1.063786 0.000000 -4.2924732E-02 -6.7225844E-02 -8.8533700E-02 -0.1045148 -0.1216078 -0.1402078 -0.1625981 -0.1900145 -0.2208343 -0.2502563 -0.2823920 -0.3146753 -0.3468947 -0.3789690 -0.4108354 -0.4424653 -0.4738756 -0.5051116 -0.5361983 -0.5671760 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.6257874 -1.254144 -1.835158 -2.363497 -2.870092 -3.314713 -3.767939 -4.217296 -4.600528 -5.013536 -5.426865 -5.764002 -6.148813 -6.537607 -6.837989 -7.203791 -7.500337 -7.844960 -8.195953 -8.456113 0.000000 -0.5946255 -1.191633 -1.737725 -2.227115 -2.693153 -3.094459 -3.507205 -3.918323 -4.262356 -4.639312 -5.017372 -5.317741 -5.667802 -5.959565 -6.287123 -6.619654 -6.874996 -7.188007 -7.508206 -7.733120 0.000000 -0.5634501 -1.129049 -1.639766 -2.089437 -2.515258 -2.877354 -3.255275 -3.595243 -3.942608 -4.286144 -4.580330 -4.898482 -5.218646 -5.474452 -5.773351 -6.077331 -6.300558 -6.585548 -6.801284 -7.069339 0.000000 -0.5322613 -1.066389 -1.541211 -1.950558 -2.314762 -2.667222 -3.012969 -3.319407 -3.637162 -3.951553 -4.214408 -4.505762 -4.798301 -5.023202 -5.297089 -5.513265 -5.768458 -6.028762 -6.213048 -6.457798 0.000000 -0.5010589 -1.003646 -1.441981 -1.812018 -2.141622 -2.462698 -2.778296 -3.057460 -3.344472 -3.636385 -3.869945 -4.134457 -4.359018 -4.604402 -4.853020 -5.041633 -5.273190 -5.455310 -5.672654 -5.896134 0.000000 -0.4698432 -0.9408201 -1.341965 -1.675017 -1.973660 -2.265631 -2.557245 -2.804502 -3.071507 -3.333817 -3.544709 -3.788094 -3.985076 -4.207262 -4.433263 -4.601582 -4.813569 -4.976142 -5.174043 -5.377377 0.000000 -0.4386140 -0.8779024 -1.241278 -1.540675 -1.810840 -2.077384 -2.339478 -2.568284 -2.805487 -3.016891 -3.237902 -3.456589 -3.628665 -3.833869 -4.041220 -4.192479 -4.385133 -4.529342 -4.704745 -4.882040 0.000000 -0.4073687 -0.8148838 -1.140592 -1.409940 -1.651188 -1.894637 -2.138677 -2.336514 -2.558183 -2.745770 -2.941454 -3.137741 -3.297889 -3.484231 -3.672080 -3.805382 -3.973490 -4.094275 -4.242648 -4.399026 0.000000 -0.3761128 -0.7517526 -1.040486 -1.281742 -1.501585 -1.719719 -1.919445 -2.119451 -2.319784 -2.481521 -2.658079 -2.841616 -2.985379 -3.150688 -3.313067 -3.422784 -3.562007 -3.672096 -3.812953 -3.960823 0.000000 -0.3448434 -0.6884927 -0.9415678 -1.159119 -1.353733 -1.553087 -1.726432 -1.912147 -2.084976 -2.229034 -2.395990 -2.558620 -2.682360 -2.820242 -2.950880 -3.046371 -3.184257 -3.294266 -3.427202 -3.565250 0.000000 -0.3135608 -0.6250790 -0.8440463 -1.039012 -1.211982 -1.387102 -1.548919 -1.707531 -1.855693 -1.998042 -2.143329 -2.279665 -2.378227 -2.485229 -2.608829 -2.715406 -2.845386 -2.977991 -3.076191 -3.204864 0.000000 -0.2822648 -0.5614839 -0.7491403 -0.9242260 -1.076558 -1.229434 -1.373138 -1.503237 -1.650928 -1.773515 -1.892765 -1.997086 -2.070236 -2.183300 -2.309174 -2.411552 -2.531574 -2.655948 -2.753755 -2.872618 0.000000 -0.2509555 -0.4976562 -0.6576427 -0.8086122 -0.9411828 -1.080617 -1.197488 -1.320719 -1.450454 -1.550410 -1.637949 -1.711335 -1.817685 -1.916419 -2.030418 -2.147526 -2.241902 -2.356018 -2.472744 -2.560241 0.000000 -0.2196328 -0.4335239 -0.5674213 -0.6939907 -0.8117665 -0.9316518 -1.027159 -1.146057 -1.251235 -1.334714 -1.379333 -1.463930 -1.573710 -1.664409 -1.767673 -1.877104 -1.987334 -2.072168 -2.176976 -2.284499 0.000000 -0.1882969 -0.3691449 -0.4814238 -0.5868976 -0.6893227 -0.7817402 -0.8844676 -0.9726753 -1.049623 -1.098939 -1.150958 -1.246310 -1.340293 -1.436192 -1.520307 -1.618113 -1.716496 -1.815727 -1.895760 -1.989997 0.000000 -0.1569477 -0.3048746 -0.3955187 -0.4815529 -0.5663288 -0.6428260 -0.7314356 -0.7979981 -0.8425981 -0.8808033 -0.9640037 -1.035237 -1.115512 -1.201591 -1.290660 -1.366228 -1.452083 -1.541000 -1.628282 -1.695062 0.000000 -0.1255852 -0.2411230 -0.3136981 -0.3823212 -0.4423779 -0.5122361 -0.5781578 -0.6191311 -0.6412695 -0.7031225 -0.7694501 -0.8365631 -0.8991756 -0.9721258 -1.046645 -1.122943 -1.201166 -1.264572 -1.335544 -1.403897 0.000000 -9.4209395E-02 -0.1787905 -0.2317927 -0.2850669 -0.3309948 -0.3814943 -0.4224547 -0.4426539 -0.4813702 -0.5285172 -0.5778721 -0.6309663 -0.6890389 -0.7490550 -0.8022200 -0.8638396 -0.9243610 -0.9830909 -1.041093 -1.099761 0.000000 -6.2820457E-02 -0.1179529 -0.1534545 -0.1872820 -0.2195521 -0.2489125 -0.2676120 -0.2949044 -0.3244992 -0.3576335 -0.3882625 -0.4264089 -0.4668011 -0.5091411 -0.5529527 -0.5968083 -0.6400934 -0.6836240 -0.7272545 -0.7619951 0.000000 -3.1418171E-02 -5.8366213E-02 -7.5719245E-02 -9.2854001E-02 -0.1077138 -0.1204966 -0.1342168 -0.1480435 -0.1628619 -0.1794775 -0.1981386 -0.2187897 -0.2409912 -0.2640656 -0.2875504 -0.3077149 -0.3307757 -0.3537486 -0.3765163 -0.3992042 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.3365902 -0.6742858 -1.013077 -1.350246 -1.672723 -1.977995 -2.269738 -2.552238 -2.829386 -3.103934 -3.338665 -3.589616 -3.836978 -4.081995 -4.325556 -4.568941 -4.758304 -4.981852 -5.203670 -5.424524 0.000000 -0.3197860 -0.6406774 -0.9626594 -1.282841 -1.587278 -1.873225 -2.144621 -2.406081 -2.661809 -2.914782 -3.125857 -3.354552 -3.580113 -3.803823 -4.026635 -4.249873 -4.417416 -4.620728 -4.823110 -5.024529 0.000000 -0.3029819 -0.6070549 -0.9122159 -1.215376 -1.501612 -1.767955 -2.018634 -2.258667 -2.492706 -2.724735 -2.913962 -3.122638 -3.329464 -3.534365 -3.739393 -3.904006 -4.091872 -4.277563 -4.461547 -4.645007 0.000000 -0.2861720 -0.5734242 -0.8617476 -1.147843 -1.415701 -1.662109 -1.891661 -2.110087 -2.323918 -2.511793 -2.706689 -2.897620 -3.086295 -3.274404 -3.462875 -3.607946 -3.778888 -3.948715 -4.116755 -4.283864 0.000000 -0.2693593 -0.5397824 -0.8112572 -1.080237 -1.329511 -1.555605 -1.763683 -1.961885 -2.157524 -2.326467 -2.504621 -2.678172 -2.851660 -3.022202 -3.196562 -3.325342 -3.479552 -3.632499 -3.787661 -3.941735 0.000000 -0.2525468 -0.5061296 -0.7607390 -1.012558 -1.243002 -1.448339 -1.635706 -1.815258 -1.994014 -2.146273 -2.308118 -2.466164 -2.624230 -2.783419 -2.909696 -3.051946 -3.195135 -3.335782 -3.474837 -3.613282 0.000000 -0.2357285 -0.4724655 -0.7101957 -0.9447929 -1.156120 -1.340420 -1.508613 -1.671324 -1.835401 -1.971182 -2.116219 -2.262917 -2.407071 -2.548543 -2.664525 -2.794983 -2.922328 -3.047355 -3.174719 -3.268292 0.000000 -0.2189105 -0.4387874 -0.6596277 -0.8769389 -1.068798 -1.232527 -1.383161 -1.531032 -1.681105 -1.799287 -1.934845 -2.065471 -2.196113 -2.330406 -2.429137 -2.543941 -2.659546 -2.777117 -2.892863 -2.972202 0.000000 -0.2020868 -0.4051013 -0.6090345 -0.8089814 -0.9809499 -1.125230 -1.259558 -1.393316 -1.513142 -1.637404 -1.756483 -1.876112 -1.997168 -2.115183 -2.197706 -2.307390 -2.413887 -2.517910 -2.619705 -2.685182 0.000000 -0.1852602 -0.3714038 -0.5584196 -0.7409011 -0.8927077 -1.019140 -1.138848 -1.261209 -1.368006 -1.477377 -1.585950 -1.695138 -1.799997 -1.885442 -1.985748 -2.081923 -2.174979 -2.263932 -2.349244 -2.409470 0.000000 -0.1684340 -0.3376956 -0.5077772 -0.6726816 -0.8044300 -0.9144699 -1.022528 -1.131652 -1.225999 -1.323681 -1.422359 -1.515421 -1.610723 -1.691445 -1.778461 -1.860705 -1.937943 -2.015546 -2.099468 -2.155325 0.000000 -0.1516018 -0.3039763 -0.4571097 -0.6042844 -0.7165819 -0.8124344 -0.9081755 -1.007452 -1.086966 -1.176468 -1.259197 -1.344142 -1.432552 -1.500707 -1.573165 -1.639724 -1.714790 -1.790292 -1.863237 -1.910275 0.000000 -0.1347698 -0.2702428 -0.4064177 -0.5356663 -0.6297503 -0.7138255 -0.7986345 -0.8824545 -0.9556292 -1.029562 -1.104251 -1.181917 -1.255893 -1.310529 -1.369009 -1.440374 -1.507906 -1.572274 -1.632245 -1.669050 0.000000 -0.1179322 -0.2365014 -0.3557008 -0.4667523 -0.5445382 -0.6165141 -0.6904594 -0.7656595 -0.8241234 -0.8887325 -0.9566230 -1.020206 -1.078267 -1.125860 -1.189731 -1.249210 -1.305507 -1.356932 -1.402719 -1.440314 0.000000 -0.1010918 -0.2027489 -0.3049623 -0.3975976 -0.4611349 -0.5234442 -0.5851863 -0.6416104 -0.6967137 -0.7550372 -0.8093215 -0.8573889 -0.9099447 -0.9690570 -1.012590 -1.060789 -1.104132 -1.141857 -1.168992 -1.184497 0.000000 -8.4251516E-02 -0.1689853 -0.2541962 -0.3285637 -0.3801137 -0.4304910 -0.4828395 -0.5269665 -0.5758638 -0.6212003 -0.6604355 -0.7059025 -0.7548808 -0.8012527 -0.8363189 -0.8715454 -0.9011957 -0.9204527 -0.9280642 -0.9443228 0.000000 -6.7405619E-02 -0.1352109 -0.2034055 -0.2600569 -0.3011131 -0.3416361 -0.3806867 -0.4185379 -0.4548950 -0.4863051 -0.5244734 -0.5630662 -0.6000692 -0.6342213 -0.6638700 -0.6796064 -0.6914207 -0.7037745 -0.7264433 -0.7486273 0.000000 -5.0559763E-02 -0.1014224 -0.1525902 -0.1929785 -0.2233645 -0.2527184 -0.2835023 -0.3125090 -0.3353024 -0.3639266 -0.3921905 -0.4198064 -0.4445117 -0.4647618 -0.4788041 -0.4894948 -0.5078798 -0.5273705 -0.5449209 -0.5620765 0.000000 -3.3708278E-02 -6.7625843E-02 -0.1017503 -0.1274041 -0.1473112 -0.1673843 -0.1858959 -0.2055455 -0.2230677 -0.2416079 -0.2591910 -0.2746358 -0.2852906 -0.2963839 -0.3113925 -0.3268537 -0.3429137 -0.3561671 -0.3665193 -0.3809618 0.000000 -1.6854079E-02 -3.3818379E-02 -5.0888889E-02 -6.3085921E-02 -7.3032551E-02 -8.2674585E-02 -9.2419155E-02 -0.1019711 -0.1110392 -0.1189152 -0.1254874 -0.1334681 -0.1412270 -0.1489354 -0.1566394 -0.1644464 -0.1725572 -0.1795724 -0.1876528 -0.1966069 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.1411556 0.3199686 0.5199913 0.7234879 0.9160817 1.092242 1.240384 1.380996 1.508217 1.623418 1.711055 1.800653 1.882587 1.957612 2.026123 2.088565 2.145312 2.196689 2.243036 2.281162 0.000000 0.1228191 0.2690870 0.4317148 0.5991107 0.7589021 0.8962070 1.026012 1.142856 1.247688 1.341673 1.412131 1.483407 1.547669 1.605582 1.657501 1.703827 1.744905 1.781035 1.812586 1.836147 0.000000 0.1062187 0.2215544 0.3482075 0.4797452 0.6064143 0.7165108 0.8201095 0.9127471 0.9950272 1.067437 1.119901 1.172227 1.218383 1.258584 1.293274 1.322848 1.347661 1.368006 1.384320 1.393610 0.000000 9.1018967E-02 0.1776852 0.2700340 0.3671618 0.4623633 0.5453222 0.6231357 0.6915004 0.7505230 0.7929292 0.8331815 0.8668222 0.8945560 0.9169099 0.9343592 0.9472381 0.9559072 0.9606991 0.9621236 0.9576999 0.000000 7.7744670E-02 0.1365388 0.1979235 0.2625553 0.3240077 0.3830213 0.4346751 0.4781643 0.5136296 0.5365121 0.5566106 0.5712152 0.5808754 0.5858223 0.5863350 0.5828342 0.5758294 0.5655178 0.5523995 0.5345182 0.000000 6.4745344E-02 9.9831395E-02 0.1319275 0.1660076 0.1987251 0.2298604 0.2554726 0.2747999 0.2877949 0.2918583 0.2929723 0.2896276 0.2816818 0.2693932 0.2534686 0.2345117 0.2123687 0.1874191 0.1599129 0.1288205 0.000000 5.2939791E-02 6.7018129E-02 7.1646288E-02 7.7757023E-02 8.3457835E-02 8.7100387E-02 8.8095203E-02 8.4594838E-02 7.6267652E-02 6.3037366E-02 4.6090722E-02 2.4878340E-02 -1.8040206E-04 -2.8443800E-02 -5.8943342E-02 -9.2769824E-02 -0.1282747 -0.1673216 -0.2071271 -0.2505448 0.000000 4.2388417E-02 3.8022466E-02 1.9373572E-02 -2.1001741E-03 -2.2766203E-02 -4.3284822E-02 -6.5725029E-02 -9.0114512E-02 -0.1191272 -0.1491618 -0.1829996 -0.2215605 -0.2595713 -0.3011408 -0.3426038 -0.3892313 -0.4343334 -0.4855008 -0.5316476 -0.5824889 0.000000 3.2993954E-02 1.2767429E-02 -2.6907953E-02 -7.2357893E-02 -0.1164516 -0.1601675 -0.2024477 -0.2471853 -0.2929914 -0.3369626 -0.3861738 -0.4371872 -0.4839123 -0.5352145 -0.5907108 -0.6427342 -0.6990324 -0.7547714 -0.8029974 -0.8610860 0.000000 2.4664460E-02 -8.7257102E-03 -6.6206232E-02 -0.1321514 -0.1962651 -0.2597668 -0.3220354 -0.3838205 -0.4405757 -0.5010190 -0.5607434 -0.6206414 -0.6756164 -0.7370304 -0.7995385 -0.8632543 -0.9147716 -0.9703600 -1.030512 -1.095295 0.000000 1.7290536E-02 -2.6555607E-02 -9.7551122E-02 -0.1806109 -0.2616777 -0.3418089 -0.4193029 -0.4942421 -0.5670407 -0.6385428 -0.7017403 -0.7703208 -0.8387086 -0.9060249 -0.9728696 -1.037188 -1.087607 -1.148904 -1.212974 -1.278710 0.000000 1.0849270E-02 -4.0814228E-02 -0.1219400 -0.2161106 -0.3119074 -0.4057264 -0.4956434 -0.5815080 -0.6634439 -0.7432430 -0.8206965 -0.8965027 -0.9692670 -1.040199 -1.109693 -1.165736 -1.230717 -1.296354 -1.361282 -1.425485 0.000000 5.5903513E-03 -5.0662939E-02 -0.1392406 -0.2404646 -0.3459248 -0.4503049 -0.5501239 -0.6449046 -0.7352869 -0.8226646 -0.9071376 -0.9867024 -1.062153 -1.135904 -1.206078 -1.275510 -1.343912 -1.410290 -1.474104 -1.536582 0.000000 1.4509510E-03 -5.7260249E-02 -0.1474726 -0.2539924 -0.3619556 -0.4747515 -0.5816584 -0.6834165 -0.7824830 -0.8750669 -0.9694784 -1.050728 -1.131163 -1.206444 -1.280591 -1.353385 -1.422349 -1.488699 -1.551695 -1.619323 0.000000 -1.7058796E-03 -6.0445841E-02 -0.1495315 -0.2533749 -0.3665449 -0.4762101 -0.5888407 -0.6960690 -0.8045247 -0.8991317 -0.9876491 -1.076027 -1.158920 -1.234802 -1.320344 -1.393264 -1.463335 -1.529208 -1.598339 -1.683561 0.000000 -4.0156809E-03 -5.9540413E-02 -0.1444084 -0.2437570 -0.3494163 -0.4569536 -0.5669388 -0.6810057 -0.7835894 -0.8801478 -0.9729227 -1.071480 -1.152253 -1.232189 -1.307283 -1.391235 -1.460455 -1.528691 -1.611607 -1.675919 0.000000 -5.2522044E-03 -5.4465503E-02 -0.1309747 -0.2219143 -0.3198345 -0.4200033 -0.5206775 -0.6200607 -0.7234337 -0.8203613 -0.9201199 -1.007076 -1.090191 -1.178449 -1.253191 -1.326113 -1.407344 -1.473671 -1.551276 -1.611421 0.000000 -5.3271060E-03 -4.6679914E-02 -0.1091403 -0.1860507 -0.2701394 -0.3580631 -0.4472764 -0.5362523 -0.6248032 -0.7099773 -0.8007758 -0.8891551 -0.9722291 -1.047393 -1.131718 -1.200663 -1.279422 -1.342110 -1.413506 -1.470702 0.000000 -4.5901844E-03 -3.4615036E-02 -8.0897585E-02 -0.1372694 -0.1999085 -0.2662823 -0.3389594 -0.4102521 -0.4817814 -0.5528815 -0.6233036 -0.6913136 -0.7643062 -0.8310400 -0.9082951 -0.9690803 -1.041225 -1.095348 -1.160201 -1.210763 0.000000 -2.7893134E-03 -1.9184416E-02 -4.4101138E-02 -7.5413376E-02 -0.1104681 -0.1484616 -0.1886032 -0.2302173 -0.2727619 -0.3190909 -0.3635730 -0.4082403 -0.4520501 -0.4958689 -0.5389099 -0.5870291 -0.6295551 -0.6688052 -0.7139897 -0.7524910 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.1449917 0.3282149 0.5301307 0.7318878 0.9203112 1.080311 1.231159 1.366851 1.489075 1.583256 1.678097 1.764301 1.842920 1.914487 1.979607 2.038750 2.092327 2.140675 2.184147 2.219536 0.000000 0.1262826 0.2775543 0.4437178 0.6115758 0.7695757 0.9043211 1.030665 1.143608 1.244483 1.321327 1.398031 1.466928 1.528854 1.584274 1.633724 1.677640 1.716406 1.750335 1.779812 1.801436 0.000000 0.1093912 0.2298436 0.3609290 0.4944569 0.6212466 0.7304198 0.8321900 0.9224751 1.002274 1.062058 1.120371 1.171385 1.215825 1.254163 1.286989 1.314744 1.337797 1.356460 1.371195 1.378998 0.000000 9.4729133E-02 0.1855629 0.2829357 0.3831867 0.4800189 0.5633944 0.6407204 0.7082183 0.7661841 0.8070281 0.8457742 0.8781270 0.9045349 0.9254985 0.9415095 0.9529427 0.9602120 0.9636903 0.9638776 0.9581910 0.000000 8.0255799E-02 0.1447966 0.2104317 0.2791802 0.3432063 0.4037710 0.4562833 0.5002719 0.5304339 0.5568480 0.5767546 0.5907556 0.5994385 0.6032669 0.6025898 0.5979672 0.5899078 0.5784837 0.5639545 0.5444350 0.000000 6.6971332E-02 0.1067663 0.1438559 0.1824709 0.2184637 0.2521746 0.2798085 0.3001427 0.3102955 0.3169269 0.3178799 0.3138673 0.3052076 0.2920595 0.2753582 0.2556647 0.2323464 0.2054206 0.1757798 0.1430846 0.000000 5.4891512E-02 7.3788010E-02 8.3400719E-02 9.3333945E-02 0.1023103 0.1100443 0.1130694 0.1106690 0.1027617 8.9075834E-02 7.1982525E-02 5.1047914E-02 2.5392333E-02 -2.8906916E-03 -3.3605672E-02 -6.9039933E-02 -0.1076842 -0.1489396 -0.1892963 -0.2327131 0.000000 4.4078220E-02 4.3506138E-02 2.9306132E-02 1.2609627E-02 -3.6926018E-03 -2.1504892E-02 -4.1626833E-02 -6.5536834E-02 -9.3379043E-02 -0.1232479 -0.1578151 -0.1947992 -0.2346793 -0.2741290 -0.3197107 -0.3690005 -0.4154000 -0.4649745 -0.5100530 -0.5631689 0.000000 3.4436222E-02 1.7469464E-02 -1.8291105E-02 -5.8409799E-02 -9.9498168E-02 -0.1411102 -0.1817589 -0.2246412 -0.2697644 -0.3146748 -0.3636444 -0.4138593 -0.4605273 -0.5143659 -0.5718150 -0.6236983 -0.6782383 -0.7274513 -0.7842550 -0.8464845 0.000000 2.5873890E-02 -4.7550090E-03 -5.9082016E-02 -0.1196764 -0.1822090 -0.2440074 -0.3050879 -0.3621170 -0.4221864 -0.4816198 -0.5409360 -0.5963443 -0.6574944 -0.7201439 -0.7840738 -0.8374933 -0.8936853 -0.9539525 -1.017552 -1.084528 0.000000 1.8281760E-02 -2.3308778E-02 -9.1755554E-02 -0.1704420 -0.2507504 -0.3295200 -0.4060197 -0.4805270 -0.5533511 -0.6179727 -0.6866254 -0.7555381 -0.8242335 -0.8925998 -0.9582855 -1.011201 -1.073326 -1.137914 -1.203520 -1.270230 0.000000 1.1647033E-02 -3.7824951E-02 -0.1163069 -0.2093934 -0.3040349 -0.3966816 -0.4858720 -0.5714437 -0.6531870 -0.7315055 -0.8088039 -0.8842373 -0.9582024 -1.030037 -1.088732 -1.154808 -1.221677 -1.288370 -1.353914 -1.418393 0.000000 6.2184301E-03 -4.8705302E-02 -0.1343467 -0.2365024 -0.3405303 -0.4442471 -0.5435033 -0.6379102 -0.7269661 -0.8125027 -0.8962520 -0.9770797 -1.054121 -1.127164 -1.197877 -1.268185 -1.337555 -1.404373 -1.467997 -1.530206 0.000000 1.9300404E-03 -5.5771206E-02 -0.1449423 -0.2500759 -0.3594423 -0.4707523 -0.5774960 -0.6785079 -0.7739482 -0.8682244 -0.9555417 -1.045999 -1.123908 -1.199803 -1.274943 -1.348750 -1.418237 -1.483816 -1.546130 -1.613551 0.000000 -1.3557416E-03 -5.9366643E-02 -0.1477023 -0.2511773 -0.3631650 -0.4747184 -0.5861576 -0.6917517 -0.7931914 -0.8968158 -0.9847961 -1.069672 -1.152861 -1.230554 -1.317086 -1.391185 -1.459935 -1.524524 -1.593660 -1.679511 0.000000 -3.7801112E-03 -5.8256079E-02 -0.1431711 -0.2422233 -0.3478921 -0.4588891 -0.5665926 -0.6738554 -0.7830091 -0.8788486 -0.9712051 -1.059245 -1.150519 -1.229317 -1.307109 -1.389665 -1.456494 -1.525004 -1.608892 -1.673448 0.000000 -5.1012640E-03 -5.4047961E-02 -0.1302126 -0.2209421 -0.3188105 -0.4190385 -0.5232710 -0.6210450 -0.7238702 -0.8193240 -0.9197543 -1.006726 -1.087900 -1.179247 -1.254101 -1.322223 -1.404347 -1.471844 -1.549901 -1.610087 0.000000 -5.2422453E-03 -4.6445739E-02 -0.1087900 -0.1837820 -0.2695523 -0.3574680 -0.4467375 -0.5357974 -0.6277842 -0.7106630 -0.8007423 -0.8898451 -0.9690764 -1.056562 -1.127786 -1.197259 -1.278719 -1.341472 -1.413057 -1.470210 0.000000 -4.5521120E-03 -3.4511913E-02 -8.0740444E-02 -0.1370824 -0.1997184 -0.2661148 -0.3386758 -0.4099725 -0.4815190 -0.5526291 -0.6231199 -0.6915399 -0.7649016 -0.8314419 -0.8995102 -0.9692602 -1.041443 -1.095366 -1.160347 -1.210743 0.000000 -2.7802556E-03 -1.9165462E-02 -4.4079624E-02 -7.5363465E-02 -0.1104115 -0.1484009 -0.1885357 -0.2301482 -0.2726981 -0.3189992 -0.3634766 -0.4081020 -0.4522094 -0.4958346 -0.5388629 -0.5869805 -0.6294353 -0.6687921 -0.7139365 -0.7524650 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.1491336 0.3355812 0.5370966 0.7351314 0.9179838 1.072256 1.216764 1.346196 1.462331 1.551522 1.641164 1.722469 1.796475 1.863710 1.924765 1.980095 2.030093 2.075078 2.115401 2.147822 0.000000 0.1304285 0.2870062 0.4555257 0.6223332 0.7772090 0.9082637 1.029914 1.137978 1.234174 1.307348 1.380004 1.445038 1.503355 1.555421 1.601753 1.642768 1.678831 1.710240 1.737379 1.756851 0.000000 0.1134438 0.2402751 0.3756154 0.5100567 0.6357568 0.7423226 0.8413327 0.9287965 1.005558 1.062024 1.117287 1.165699 1.207626 1.243576 1.274120 1.299711 1.320730 1.337491 1.350464 1.356650 0.000000 9.8586552E-02 0.1960593 0.2987634 0.4017863 0.4948069 0.5821791 0.6586555 0.7245423 0.7731335 0.8183351 0.8558469 0.8865138 0.9111018 0.9302736 0.9445561 0.9543388 0.9600489 0.9620337 0.9607565 0.9536561 0.000000 8.3760560E-02 0.1549423 0.2267020 0.2996308 0.3660637 0.4276105 0.4802896 0.5238600 0.5534174 0.5788378 0.5975068 0.6102703 0.6177422 0.6203040 0.6183329 0.6124104 0.6029562 0.5899898 0.5738260 0.5527307 0.000000 7.0127167E-02 0.1171209 0.1598903 0.2035145 0.2428153 0.2787716 0.3077920 0.3288445 0.3392737 0.3454306 0.3460976 0.3415712 0.3320078 0.3178037 0.2999414 0.2787093 0.2535460 0.2247245 0.1934319 0.1593378 0.000000 5.7687853E-02 8.1948884E-02 9.8669164E-02 0.1138392 0.1269016 0.1378489 0.1433913 0.1424721 0.1341618 0.1221548 0.1052690 8.3240807E-02 5.6641411E-02 2.7406689E-02 -4.9801003E-03 -4.2771764E-02 -8.3359264E-02 -0.1258821 -0.1671499 -0.2116666 0.000000 4.6519071E-02 5.1557437E-02 4.3281589E-02 3.1985376E-02 2.0098573E-02 6.6553927E-03 -1.0887682E-02 -3.3034943E-02 -5.8577582E-02 -8.8620350E-02 -0.1226222 -0.1609887 -0.2020349 -0.2440687 -0.2921720 -0.3430954 -0.3897634 -0.4395574 -0.4859101 -0.5411536 0.000000 3.6525752E-02 2.4436913E-02 -5.9042284E-03 -4.0955376E-02 -7.7264100E-02 -0.1137657 -0.1524555 -0.1939754 -0.2356453 -0.2821742 -0.3323050 -0.3802531 -0.4321084 -0.4879754 -0.5464270 -0.5969771 -0.6510538 -0.7024249 -0.7624666 -0.8275248 0.000000 2.7622541E-02 1.1275195E-03 -4.8152160E-02 -0.1044349 -0.1625015 -0.2212390 -0.2772891 -0.3347307 -0.3930661 -0.4533390 -0.5148775 -0.5712300 -0.6336183 -0.6961159 -0.7569999 -0.8087245 -0.8696986 -0.9341096 -1.000355 -1.068801 0.000000 1.9718625E-02 -1.8447340E-02 -8.3099768E-02 -0.1576309 -0.2342996 -0.3108383 -0.3857946 -0.4549106 -0.5260423 -0.5961142 -0.6656851 -0.7352082 -0.8022023 -0.8672101 -0.9248680 -0.9900072 -1.056244 -1.122828 -1.188910 -1.255632 0.000000 1.2801739E-02 -3.4014910E-02 -0.1103260 -0.1992636 -0.2913562 -0.3822995 -0.4703291 -0.5551835 -0.6366161 -0.7153335 -0.7925416 -0.8679661 -0.9315248 -1.001825 -1.071840 -1.140664 -1.208931 -1.275307 -1.339981 -1.405141 0.000000 7.1260631E-03 -4.5679189E-02 -0.1292013 -0.2280882 -0.3319230 -0.4340223 -0.5322007 -0.6258896 -0.7147548 -0.8006513 -0.8828508 -0.9618782 -1.038634 -1.114230 -1.186488 -1.258009 -1.326492 -1.391302 -1.455887 -1.520149 0.000000 2.6252810E-03 -5.3457048E-02 -0.1409535 -0.2421311 -0.3544528 -0.4644597 -0.5697312 -0.6701182 -0.7655491 -0.8592396 -0.9456205 -1.026980 -1.114154 -1.191144 -1.267238 -1.340244 -1.406219 -1.472257 -1.537797 -1.600274 0.000000 -8.4384735E-04 -5.7677168E-02 -0.1447856 -0.2474339 -0.3563747 -0.4715132 -0.5816702 -0.6863910 -0.7881516 -0.8824084 -0.9795659 -1.061822 -1.146031 -1.225422 -1.311009 -1.379847 -1.448405 -1.518387 -1.582131 -1.647651 0.000000 -3.4294967E-03 -5.7190757E-02 -0.1411859 -0.2396576 -0.3451186 -0.4513077 -0.5637000 -0.6716443 -0.7731500 -0.8762454 -0.9654011 -1.053491 -1.147614 -1.225907 -1.300115 -1.370166 -1.452917 -1.520470 -1.586830 -1.667426 0.000000 -4.8751677E-03 -5.3360607E-02 -0.1278058 -0.2193428 -0.3170364 -0.4173609 -0.5180820 -0.6214516 -0.7235138 -0.8183984 -0.9092785 -1.005196 -1.087175 -1.173705 -1.248632 -1.320054 -1.402021 -1.466347 -1.545163 -1.607021 0.000000 -5.1137595E-03 -4.6059184E-02 -0.1081925 -0.1830868 -0.2685687 -0.3564526 -0.4457310 -0.5348670 -0.6271390 -0.7110040 -0.8002830 -0.8898675 -0.9685519 -1.044934 -1.127069 -1.196957 -1.273807 -1.336492 -1.411578 -1.469134 0.000000 -4.4933581E-03 -3.4340780E-02 -8.0476262E-02 -0.1367624 -0.1993787 -0.2657941 -0.3381940 -0.4094940 -0.4810511 -0.5522196 -0.6227211 -0.6914753 -0.7573563 -0.8317026 -0.8994555 -0.9692244 -1.031010 -1.095189 -1.160358 -1.210582 0.000000 -2.7650606E-03 -1.9128969E-02 -4.4032786E-02 -7.5281106E-02 -0.1103187 -0.1482968 -0.1884264 -0.2300407 -0.2725915 -0.3188553 -0.3633351 -0.4079333 -0.4520655 -0.4957097 -0.5387871 -0.5867614 -0.6292880 -0.6686961 -0.7138643 -0.7547229 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.1502899 0.3370337 0.5362209 0.7292655 0.9056535 1.053600 1.191346 1.314231 1.424151 1.508196 1.592549 1.668893 1.738242 1.801116 1.858086 1.909589 1.955998 1.997615 2.034782 2.063831 0.000000 0.1324277 0.2896631 0.4575045 0.6212708 0.7715713 0.8973715 1.013725 1.116880 1.208309 1.277185 1.345638 1.406953 1.461783 1.510579 1.553820 1.591916 1.625227 1.654040 1.678743 1.695964 0.000000 0.1149465 0.2439363 0.3804075 0.5139447 0.6310884 0.7404657 0.8369372 0.9212884 0.9852493 1.046366 1.099317 1.145038 1.184150 1.217303 1.245142 1.268147 1.286717 1.301172 1.311980 1.316166 0.000000 0.1001422 0.2006350 0.3062433 0.4109747 0.5048617 0.5917404 0.6669113 0.7307196 0.7764929 0.8187646 0.8535360 0.8814893 0.9034700 0.9201458 0.9320405 0.9395838 0.9431866 0.9431414 0.9399247 0.9310554 0.000000 8.5328355E-02 0.1602987 0.2369779 0.3144998 0.3838672 0.4467434 0.4989890 0.5358105 0.5674599 0.5910824 0.6078455 0.6186614 0.6241549 0.6247048 0.6208459 0.6130799 0.6016955 0.5868899 0.5691197 0.5465208 0.000000 7.1701571E-02 0.1232259 0.1729296 0.2212693 0.2668749 0.3047798 0.3339082 0.3510320 0.3629156 0.3683499 0.3679690 0.3620809 0.3508705 0.3351887 0.3157642 0.2925737 0.2658603 0.2359209 0.2030236 0.1667520 0.000000 5.9266515E-02 8.9447290E-02 0.1139682 0.1357842 0.1545992 0.1680769 0.1747625 0.1726715 0.1661904 0.1542028 0.1365519 0.1131610 8.5699096E-02 5.5000506E-02 2.0455956E-02 -1.7708015E-02 -5.8797732E-02 -0.1033139 -0.1485698 -0.1961273 0.000000 4.8093695E-02 5.8489528E-02 5.9806980E-02 5.5567298E-02 4.9189001E-02 3.9341062E-02 2.4224456E-02 4.3681161E-03 -2.0147907E-02 -5.0131898E-02 -8.5769996E-02 -0.1247573 -0.1649484 -0.2105464 -0.2596028 -0.3084937 -0.3612758 -0.4145588 -0.4638231 -0.5219482 0.000000 3.8084354E-02 3.2019597E-02 1.0440463E-02 -1.7430769E-02 -4.7293488E-02 -7.9796955E-02 -0.1155021 -0.1530216 -0.1954836 -0.2423621 -0.2923567 -0.3406069 -0.3948035 -0.4523577 -0.5081032 -0.5658041 -0.6230171 -0.6770092 -0.7397514 -0.8057758 0.000000 2.9142369E-02 8.6230123E-03 -3.2961890E-02 -8.2594149E-02 -0.1334181 -0.1864237 -0.2400265 -0.2956928 -0.3538982 -0.4145851 -0.4716378 -0.5333071 -0.5966219 -0.6617146 -0.7259115 -0.7798223 -0.8431616 -0.9098446 -0.9777997 -1.037196 0.000000 2.1161245E-02 -1.1638002E-02 -6.9770947E-02 -0.1369206 -0.2075182 -0.2781713 -0.3481272 -0.4188482 -0.4896600 -0.5599528 -0.6294392 -0.6985649 -0.7684649 -0.8377880 -0.8967113 -0.9638727 -1.032193 -1.099857 -1.166990 -1.235169 0.000000 1.4119789E-02 -2.8286928E-02 -9.9256046E-02 -0.1811106 -0.2678481 -0.3532856 -0.4388417 -0.5226038 -0.6030714 -0.6810780 -0.7565806 -0.8315928 -0.9052825 -0.9757007 -1.047168 -1.118275 -1.186697 -1.253706 -1.320053 -1.386848 0.000000 8.2440590E-03 -4.0981188E-02 -0.1200828 -0.2137137 -0.3131043 -0.4099758 -0.5062463 -0.6044358 -0.6929657 -0.7776061 -0.8595127 -0.9402698 -1.015662 -1.091265 -1.167222 -1.237489 -1.306059 -1.373114 -1.439217 -1.504419 0.000000 3.5069319E-03 -4.9744707E-02 -0.1338548 -0.2352896 -0.3396039 -0.4466335 -0.5549811 -0.6541820 -0.7488958 -0.8389332 -0.9282063 -1.010810 -1.087836 -1.175886 -1.249082 -1.321250 -1.390903 -1.458051 -1.524085 -1.586866 0.000000 -1.8237963E-04 -5.4879259E-02 -0.1394299 -0.2399614 -0.3509127 -0.4631599 -0.5716547 -0.6753698 -0.7746254 -0.8704588 -0.9683210 -1.050413 -1.134439 -1.213752 -1.286738 -1.368587 -1.437243 -1.507351 -1.571141 -1.636672 0.000000 -2.9643527E-03 -5.5306472E-02 -0.1374087 -0.2344758 -0.3387930 -0.4476132 -0.5578750 -0.6647137 -0.7665961 -0.8690876 -0.9580166 -1.045584 -1.139962 -1.217965 -1.292026 -1.361930 -1.444946 -1.512365 -1.578592 -1.659441 0.000000 -4.5673978E-03 -5.2118968E-02 -0.1255823 -0.2160051 -0.3130876 -0.4132738 -0.5160449 -0.6194969 -0.7206234 -0.8148285 -0.9048086 -1.000771 -1.082403 -1.169069 -1.243663 -1.314812 -1.396925 -1.460891 -1.539989 -1.601948 0.000000 -4.9327933E-03 -4.5343094E-02 -0.1069085 -0.1814271 -0.2663735 -0.3541141 -0.4432773 -0.5325119 -0.6211176 -0.7099611 -0.7982898 -0.8883089 -0.9663162 -1.042470 -1.124543 -1.194234 -1.271050 -1.333383 -1.409218 -1.466526 0.000000 -4.3661501E-03 -3.4013335E-02 -7.9896010E-02 -0.1360092 -0.1985316 -0.2649176 -0.3371196 -0.4083973 -0.4799289 -0.5511096 -0.6216109 -0.6906580 -0.7567708 -0.8310922 -0.8985935 -0.9684074 -1.029878 -1.094142 -1.159446 -1.209459 0.000000 -2.7393540E-03 -1.9048803E-02 -4.3904379E-02 -7.4364521E-02 -0.1100984 -0.1480554 -0.1881718 -0.2297792 -0.2723267 -0.3153821 -0.3630219 -0.4075856 -0.4517351 -0.4953380 -0.5385183 -0.5863824 -0.6289333 -0.6683648 -0.7064823 -0.7527553 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.1490821 0.3333586 0.5273487 0.7135599 0.8825506 1.023705 1.154626 1.271087 1.375011 1.454100 1.533414 1.605042 1.669965 1.728688 1.781761 1.829603 1.872570 1.910945 1.945068 1.971273 0.000000 0.1317655 0.2861908 0.4494055 0.6072935 0.7512540 0.8712234 0.9818997 1.079792 1.166306 1.231123 1.295514 1.353037 1.404323 1.449801 1.489932 1.525106 1.555669 1.581894 1.604164 1.619119 0.000000 0.1148014 0.2408815 0.3734350 0.5020567 0.6141895 0.7185190 0.8102805 0.8901394 0.9502259 1.007493 1.056830 1.099135 1.135005 1.165077 1.189991 1.210223 1.226166 1.238130 1.246587 1.248562 0.000000 9.9576660E-02 0.1983107 0.3008143 0.4016719 0.4916010 0.5743856 0.6454321 0.7051477 0.7472345 0.7857939 0.8169909 0.8415028 0.8601795 0.8737106 0.8826397 0.8873712 0.8883069 0.8857436 0.8801144 0.8688886 0.000000 8.5210569E-02 0.1586969 0.2332055 0.3081493 0.3745608 0.4337939 0.4820591 0.5149707 0.5427145 0.5625213 0.5755869 0.5828460 0.5850045 0.5824673 0.5756325 0.5650287 0.5509806 0.5334790 0.5129142 0.4875186 0.000000 7.1534283E-02 0.1223377 0.1710332 0.2179508 0.2610652 0.2953858 0.3205463 0.3337235 0.3416879 0.3432729 0.3392003 0.3299570 0.3156987 0.2969323 0.2744609 0.2485198 0.2186549 0.1852182 0.1491402 0.1100836 0.000000 5.9294306E-02 8.9310192E-02 0.1139533 0.1350121 0.1514455 0.1614012 0.1642522 0.1583500 0.1480375 0.1323955 0.1116145 8.5353814E-02 5.4630700E-02 2.0932112E-02 -1.6372766E-02 -5.8677141E-02 -0.1038375 -0.1508759 -0.1988905 -0.2468556 0.000000 4.8733167E-02 5.9693687E-02 6.1351910E-02 5.6545064E-02 4.7948238E-02 3.4805644E-02 1.6210815E-02 -7.2052940E-03 -3.5348695E-02 -6.7876391E-02 -0.1060099 -0.1477983 -0.1928720 -0.2397767 -0.2924122 -0.3478486 -0.3994308 -0.4540128 -0.5053484 -0.5650048 0.000000 3.8747545E-02 3.3513490E-02 1.2948927E-02 -1.5275152E-02 -4.7170617E-02 -8.2480453E-02 -0.1211471 -0.1616214 -0.2065637 -0.2555141 -0.3081365 -0.3596060 -0.4167508 -0.4767965 -0.5397529 -0.5954387 -0.6543795 -0.7105193 -0.7747141 -0.8433542 0.000000 2.9836467E-02 1.0477443E-02 -3.0026577E-02 -7.9817049E-02 -0.1322741 -0.1874920 -0.2434737 -0.3013311 -0.3608972 -0.4238138 -0.4842282 -0.5488934 -0.6145194 -0.6815827 -0.7478653 -0.8042018 -0.8694690 -0.9376650 -1.006816 -1.077804 0.000000 2.1869741E-02 -9.7087193E-03 -6.6936061E-02 -0.1338954 -0.2055802 -0.2778986 -0.3496977 -0.4212321 -0.4930595 -0.5669747 -0.6395801 -0.7108094 -0.7824683 -0.8537074 -0.9148516 -0.9838575 -1.053505 -1.122096 -1.190103 -1.259386 0.000000 1.4803011E-02 -2.6347069E-02 -9.5764890E-02 -0.1783084 -0.2654266 -0.3520084 -0.4387718 -0.5210426 -0.6052915 -0.6869263 -0.7642802 -0.8407855 -0.9161950 -0.9886025 -1.061702 -1.133846 -1.202808 -1.270453 -1.337999 -1.406261 0.000000 8.8451281E-03 -3.9430100E-02 -0.1179698 -0.2113904 -0.3099704 -0.4079257 -0.5040095 -0.5994844 -0.6958982 -0.7820428 -0.8650762 -0.9471973 -1.024374 -1.101346 -1.178023 -1.248332 -1.317218 -1.385616 -1.453390 -1.519996 0.000000 3.9439816E-03 -4.8416335E-02 -0.1317918 -0.2323752 -0.3381275 -0.4441904 -0.5494136 -0.6553208 -0.7511355 -0.8419867 -0.9321403 -1.016244 -1.094302 -1.182921 -1.255787 -1.327701 -1.398917 -1.467974 -1.535261 -1.598858 0.000000 1.7083358E-04 -5.3388618E-02 -0.1365034 -0.2385284 -0.3481466 -0.4590399 -0.5665749 -0.6763206 -0.7764149 -0.8724411 -0.9715647 -1.054778 -1.138464 -1.217434 -1.288944 -1.372840 -1.443858 -1.515060 -1.579365 -1.645272 0.000000 -2.6939358E-03 -5.4561798E-02 -0.1349009 -0.2330921 -0.3365288 -0.4495842 -0.5593761 -0.6665307 -0.7676569 -0.8708113 -0.9606272 -1.048260 -1.141348 -1.217269 -1.292475 -1.365985 -1.450091 -1.517791 -1.584176 -1.665342 0.000000 -4.3668854E-03 -5.1570870E-02 -0.1248316 -0.2149496 -0.3121790 -0.4127696 -0.5123441 -0.6227772 -0.7210460 -0.8160299 -0.9069586 -1.000616 -1.082413 -1.159992 -1.246689 -1.317956 -1.400486 -1.464340 -1.543662 -1.605693 0.000000 -4.7958824E-03 -4.4984061E-02 -0.1063879 -0.1809254 -0.2657267 -0.3536192 -0.4431606 -0.5327235 -0.6239687 -0.7124338 -0.7998855 -0.8818790 -0.9672312 -1.044469 -1.126639 -1.196372 -1.273277 -1.335372 -1.411573 -1.468946 0.000000 -4.2908140E-03 -3.3818230E-02 -7.9610258E-02 -0.1357009 -0.1982756 -0.2647781 -0.3368647 -0.4082416 -0.4799022 -0.5512071 -0.6219069 -0.6937372 -0.7583543 -0.8329174 -0.8998002 -0.9698838 -1.030917 -1.095513 -1.161276 -1.210966 0.000000 -2.7048734E-03 -1.8983938E-02 -4.3827631E-02 -7.4304059E-02 -0.1099826 -0.1479471 -0.1880806 -0.2297140 -0.2722995 -0.3154069 -0.3629498 -0.4075010 -0.4517174 -0.4953449 -0.5385823 -0.5863971 -0.6292088 -0.6685264 -0.7070318 -0.7530357 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.1527355 0.3332380 0.5214677 0.7004009 0.8618537 0.9959946 1.119919 1.229802 1.327504 1.401383 1.475386 1.542048 1.602295 1.656621 1.705554 1.749495 1.788783 1.823687 1.854545 1.877705 0.000000 0.1337048 0.2867391 0.4451102 0.5967921 0.7344255 0.8485703 0.9535460 1.046051 1.127548 1.188046 1.248163 1.301731 1.349338 1.391392 1.428337 1.460545 1.488340 1.511982 1.531846 1.544563 0.000000 0.1168413 0.2416459 0.3696954 0.4924589 0.5988085 0.6973696 0.7837313 0.8586359 0.9143410 0.9676579 1.013423 1.052400 1.085180 1.112388 1.134624 1.152337 1.165906 1.175625 1.181950 1.181884 0.000000 0.1011575 0.1988411 0.2967043 0.3914297 0.4750654 0.5521957 0.6180701 0.6732373 0.7121228 0.7471759 0.7749432 0.7963283 0.8120866 0.8228296 0.8290768 0.8312517 0.8297255 0.8247575 0.8167709 0.8032677 0.000000 8.7411895E-02 0.1587719 0.2281313 0.2962372 0.3563712 0.4098672 0.4533527 0.4872291 0.5070511 0.5231528 0.5328643 0.5369058 0.5359066 0.5303288 0.5206731 0.5072954 0.4904637 0.4702608 0.4472726 0.4199757 0.000000 7.3250473E-02 0.1218038 0.1645958 0.2062821 0.2411151 0.2701163 0.2908655 0.3000526 0.3045649 0.3022691 0.2944961 0.2816615 0.2640393 0.2423401 0.2167689 0.1875764 0.1549415 0.1193102 8.2763389E-02 4.2511471E-02 0.000000 6.0639650E-02 8.8067435E-02 0.1061588 0.1211185 0.1305314 0.1354806 0.1338028 0.1251202 0.1090351 8.9193389E-02 6.4408652E-02 3.4993045E-02 1.5497260E-03 -3.6334086E-02 -7.7709407E-02 -0.1215954 -0.1689273 -0.2163258 -0.2678263 -0.3229301 0.000000 4.9723547E-02 5.7760943E-02 5.2674733E-02 4.1765526E-02 2.7228303E-02 8.7229498E-03 -1.4785733E-02 -4.3553106E-02 -7.5915977E-02 -0.1127313 -0.1549804 -0.1988672 -0.2466793 -0.2991010 -0.3513767 -0.4081078 -0.4617882 -0.5202951 -0.5804260 -0.6368778 0.000000 3.9527267E-02 3.1031277E-02 4.2047510E-03 -3.0257335E-02 -6.7868240E-02 -0.1083712 -0.1520620 -0.1989667 -0.2466041 -0.2993373 -0.3552213 -0.4095343 -0.4691702 -0.5313250 -0.5955642 -0.6539891 -0.7158900 -0.7805684 -0.8392382 -0.9069884 0.000000 3.0420186E-02 7.7112587E-03 -3.8422085E-02 -9.4091736E-02 -0.1519959 -0.2123596 -0.2734579 -0.3357605 -0.3994783 -0.4657848 -0.5289484 -0.5959973 -0.6635853 -0.7320598 -0.8016909 -0.8622324 -0.9270750 -0.9949169 -1.064227 -1.135657 0.000000 2.2293020E-02 -1.2360732E-02 -7.3863685E-02 -0.1469370 -0.2236862 -0.3010822 -0.3775196 -0.4533530 -0.5286741 -0.6053907 -0.6802475 -0.7534526 -0.8264035 -0.8993825 -0.9727066 -1.034866 -1.103927 -1.172745 -1.241308 -1.311279 0.000000 1.5116995E-02 -2.9124368E-02 -0.1024854 -0.1898232 -0.2814696 -0.3729021 -0.4626354 -0.5494828 -0.6367141 -0.7204861 -0.7996634 -0.8778471 -0.9546685 -1.030725 -1.105394 -1.177067 -1.246309 -1.314637 -1.382988 -1.452057 0.000000 9.1288378E-03 -4.1133493E-02 -0.1239949 -0.2211260 -0.3236430 -0.4259799 -0.5275632 -0.6234099 -0.7224042 -0.8098143 -0.8946356 -0.9784414 -1.060003 -1.139120 -1.213833 -1.284500 -1.354222 -1.423522 -1.492157 -1.559531 0.000000 4.2940555E-03 -4.9508642E-02 -0.1369709 -0.2403465 -0.3494212 -0.4588891 -0.5649426 -0.6752078 -0.7715665 -0.8639488 -0.9560595 -1.041848 -1.132424 -1.210896 -1.284670 -1.357564 -1.429718 -1.499693 -1.567684 -1.631861 0.000000 4.8399952E-04 -5.4459188E-02 -0.1402182 -0.2445083 -0.3574302 -0.4702787 -0.5799701 -0.6909487 -0.7909563 -0.8893716 -0.9903292 -1.074777 -1.159559 -1.239375 -1.311860 -1.396714 -1.468591 -1.540465 -1.605240 -1.671476 0.000000 -2.3969272E-03 -5.5193171E-02 -0.1373328 -0.2351934 -0.3453633 -0.4589915 -0.5694011 -0.6751185 -0.7780994 -0.8834278 -0.9742907 -1.062978 -1.157074 -1.233561 -1.309746 -1.384038 -1.468880 -1.536826 -1.603536 -1.684515 0.000000 -4.0940926E-03 -5.1853344E-02 -0.1262047 -0.2154182 -0.3156644 -0.4171035 -0.5202678 -0.6229181 -0.7294500 -0.8248931 -0.9159619 -1.011047 -1.092820 -1.171353 -1.258983 -1.330640 -1.413535 -1.477214 -1.556374 -1.616136 0.000000 -4.5638415E-03 -4.5022540E-02 -0.1069835 -0.1821777 -0.2650194 -0.3558031 -0.4460510 -0.5354781 -0.6236594 -0.7178225 -0.8055379 -0.8885013 -0.9746329 -1.051970 -1.134347 -1.204492 -1.280596 -1.342775 -1.415208 -1.471053 0.000000 -4.1232295E-03 -3.3430785E-02 -7.9728156E-02 -0.1360518 -0.1988852 -0.2656858 -0.3347240 -0.4093721 -0.4813587 -0.5527318 -0.6239391 -0.6898085 -0.7625639 -0.8376701 -0.9035958 -0.9742900 -1.033247 -1.098531 -1.154225 -1.214699 0.000000 -2.6091752E-03 -1.8885188E-02 -4.3778408E-02 -7.4328877E-02 -0.1099811 -0.1479884 -0.1881756 -0.2298775 -0.2725408 -0.3158789 -0.3631887 -0.4077416 -0.4520788 -0.4958710 -0.5391089 -0.5814211 -0.6280627 -0.6688773 -0.7084259 -0.7503119 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.1656937 0.3548337 0.5423995 0.7149498 0.8592497 0.9907801 1.105809 1.207017 1.283915 1.359513 1.426945 1.487397 1.541571 1.590114 1.633549 1.672293 1.706680 1.736965 1.763492 1.782625 0.000000 0.1474824 0.3090424 0.4698834 0.6188826 0.7444677 0.8583304 0.9572594 1.043336 1.107949 1.170727 1.226000 1.274825 1.317816 1.355511 1.388367 1.416757 1.440998 1.461331 1.478136 1.488055 0.000000 0.1298756 0.2643288 0.3973715 0.5204334 0.6247122 0.7190242 0.8004330 0.8701456 0.9209729 0.9695721 1.011301 1.046579 1.075932 1.099909 1.119101 1.133954 1.144829 1.152018 1.156003 1.153799 0.000000 0.1133571 0.2215257 0.3262094 0.4233212 0.5060151 0.5808181 0.6437131 0.6890135 0.7300516 0.7628856 0.7882511 0.8070319 0.8201402 0.8282531 0.8319488 0.8316351 0.8277422 0.8205878 0.8105534 0.7950928 0.000000 9.7947128E-02 0.1810104 0.2583798 0.3271333 0.3909098 0.4440043 0.4863571 0.5139730 0.5361717 0.5504169 0.5579070 0.5595792 0.5561256 0.5481395 0.5360913 0.5204446 0.5015602 0.4792179 0.4538547 0.4239768 0.000000 8.3553419E-02 0.1432005 0.1947227 0.2392094 0.2781788 0.3084041 0.3292695 0.3378076 0.3405250 0.3366294 0.3268697 0.3117415 0.2919545 0.2680165 0.2404920 0.2094630 0.1741878 0.1354354 9.4789006E-02 5.1579122E-02 0.000000 7.0237361E-02 0.1083481 0.1354076 0.1548116 0.1689650 0.1760936 0.1750394 0.1643738 0.1487661 0.1274157 0.1005661 6.9093794E-02 3.3536550E-02 -5.2239341E-03 -4.8145089E-02 -9.6182607E-02 -0.1473639 -0.1978944 -0.2517472 -0.3090001 0.000000 5.7721086E-02 7.6707073E-02 8.0412805E-02 7.5073868E-02 6.5322764E-02 4.9511395E-02 2.6836727E-02 -1.5729567E-03 -3.5057545E-02 -7.4025705E-02 -0.1163790 -0.1625148 -0.2128405 -0.2653826 -0.3234779 -0.3839604 -0.4400841 -0.5001225 -0.5622851 -0.6214110 0.000000 4.7133040E-02 4.8454605E-02 3.0017965E-02 2.0446251E-03 -3.0953655E-02 -6.9122620E-02 -0.1121866 -0.1576507 -0.2078023 -0.2609803 -0.3174410 -0.3744201 -0.4374433 -0.5028970 -0.5703427 -0.6300524 -0.6926640 -0.7597743 -0.8215643 -0.8922679 0.000000 3.7505064E-02 2.3444915E-02 -1.4880366E-02 -6.3563764E-02 -0.1179637 -0.1763328 -0.2369101 -0.2992128 -0.3636665 -0.4261516 -0.4942539 -0.5648497 -0.6357063 -0.7064845 -0.7761818 -0.8360515 -0.9048367 -0.9763373 -1.048357 -1.121770 0.000000 2.8458515E-02 1.5121164E-03 -5.3118892E-02 -0.1205016 -0.1935424 -0.2693364 -0.3450052 -0.4204540 -0.4959061 -0.5724969 -0.6506957 -0.7271418 -0.8015529 -0.8756789 -0.9404190 -1.012641 -1.085208 -1.156291 -1.226151 -1.297351 0.000000 2.0539157E-02 -1.6993832E-02 -8.4621452E-02 -0.1672487 -0.2559503 -0.3458464 -0.4341522 -0.5205517 -0.6058628 -0.6925979 -0.7757915 -0.8540401 -0.9314277 -1.007987 -1.084103 -1.158650 -1.229883 -1.298791 -1.368091 -1.439040 0.000000 1.3800992E-02 -3.1189257E-02 -0.1081414 -0.2007552 -0.3029553 -0.4035949 -0.5021179 -0.5975316 -0.6927269 -0.7894658 -0.8737858 -0.9560005 -1.037904 -1.118351 -1.196024 -1.268986 -1.338399 -1.408241 -1.479471 -1.549122 0.000000 8.2300231E-03 -4.1458074E-02 -0.1241558 -0.2235391 -0.3332526 -0.4408651 -0.5464614 -0.6500220 -0.7549146 -0.8465521 -0.9345774 -1.023215 -1.106544 -1.195082 -1.269882 -1.341964 -1.413973 -1.488031 -1.557949 -1.623106 0.000000 3.7431037E-03 -4.7924783E-02 -0.1302231 -0.2328359 -0.3451911 -0.4561870 -0.5652506 -0.6778960 -0.7779712 -0.8725346 -0.9668080 -1.063435 -1.144850 -1.224975 -1.301109 -1.373373 -1.459402 -1.531730 -1.596727 -1.658200 0.000000 1.7310239E-04 -5.0088890E-02 -0.1304718 -0.2282699 -0.3356892 -0.4467190 -0.5555770 -0.6662075 -0.7668248 -0.8651887 -0.9662265 -1.053840 -1.137081 -1.225721 -1.302040 -1.376384 -1.461638 -1.530114 -1.591303 -1.653596 0.000000 -2.1270432E-03 -4.8069648E-02 -0.1211483 -0.2097984 -0.3067838 -0.4102229 -0.5157624 -0.6180286 -0.7165030 -0.8200328 -0.9098300 -1.004666 -1.087237 -1.165724 -1.253658 -1.325014 -1.408195 -1.471704 -1.535734 -1.610526 0.000000 -3.1615836E-03 -4.2423081E-02 -0.1035524 -0.1782996 -0.2610262 -0.3479834 -0.4371697 -0.5323752 -0.6210816 -0.7167399 -0.8006541 -0.8848200 -0.9717901 -1.048673 -1.131065 -1.200858 -1.277058 -1.339151 -1.411124 -1.466399 0.000000 -3.2437393E-03 -3.1914148E-02 -7.7695727E-02 -0.1337407 -0.1964270 -0.2631802 -0.3322521 -0.4065615 -0.4785534 -0.5502069 -0.6196404 -0.6898978 -0.7613568 -0.8366905 -0.9018327 -0.9726740 -1.031242 -1.096893 -1.150805 -1.211831 0.000000 -2.1917494E-03 -1.8189231E-02 -4.2917255E-02 -7.3376760E-02 -0.1089021 -0.1468569 -0.1870092 -0.2286915 -0.2713541 -0.3146355 -0.3620402 -0.4063970 -0.4507484 -0.4945375 -0.5378717 -0.5801054 -0.6268964 -0.6676604 -0.7104829 -0.7482984 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.1849017 0.3791794 0.5627127 0.7260759 0.8598667 0.9795852 1.082915 1.172849 1.240240 1.306154 1.364577 1.416640 1.463025 1.504333 1.541048 1.573542 1.602112 1.626976 1.648460 1.662937 0.000000 0.1669188 0.3364359 0.4974615 0.6419543 0.7604039 0.8653774 0.9552484 1.022664 1.086767 1.142461 1.191167 1.233712 1.270808 1.302948 1.330586 1.354099 1.373814 1.389948 1.402868 1.409225 0.000000 0.1493649 0.2951114 0.4335409 0.5502001 0.6538399 0.7420415 0.8167294 0.8710757 0.9219857 0.9652798 1.001632 1.031641 1.055940 1.075044 1.089710 1.100507 1.107558 1.111111 1.111676 1.106175 0.000000 0.1329173 0.2559695 0.3688644 0.4624297 0.5461417 0.6167942 0.6679575 0.7132298 0.7493457 0.7772972 0.7978729 0.8119984 0.8207365 0.8247754 0.8247477 0.8201087 0.8120863 0.8011236 0.7876687 0.7695823 0.000000 0.1175256 0.2177442 0.3042116 0.3756330 0.4386702 0.4890819 0.5226532 0.5498739 0.5681310 0.5784417 0.5819083 0.5796413 0.5724072 0.5608078 0.5394281 0.5190395 0.4961537 0.4704848 0.4467111 0.4158105 0.000000 0.1029740 0.1801410 0.2416267 0.2906155 0.3305446 0.3590790 0.3739740 0.3819997 0.3817609 0.3745652 0.3612218 0.3425223 0.3192182 0.2889533 0.2576187 0.2231670 0.1868036 0.1456600 0.1021922 5.5957962E-02 0.000000 8.9185186E-02 0.1442013 0.1804951 0.2073468 0.2232848 0.2297898 0.2252781 0.2141474 0.1960202 0.1716233 0.1414455 0.1066044 6.7675777E-02 2.5282638E-02 -2.0863105E-02 -7.2325237E-02 -0.1266077 -0.1805776 -0.2377989 -0.2982787 0.000000 7.6154739E-02 0.1108074 0.1249118 0.1268318 0.1195606 0.1041853 8.0378562E-02 5.0725993E-02 1.5122153E-02 -2.6608557E-02 -7.2314270E-02 -0.1215207 -0.1755076 -0.2314964 -0.2928385 -0.3567263 -0.4167408 -0.4804049 -0.5455837 -0.6075777 0.000000 6.3871481E-02 8.0358326E-02 7.2661653E-02 5.1385690E-02 2.1646252E-02 -1.4937841E-02 -5.7446949E-02 -0.1053350 -0.1581847 -0.2146678 -0.2714010 -0.3334321 -0.3993313 -0.4682710 -0.5395665 -0.6031927 -0.6692977 -0.7389221 -0.8030602 -0.8761435 0.000000 5.2084107E-02 5.2851718E-02 2.4840707E-02 -1.7383119E-02 -6.8313047E-02 -0.1247999 -0.1854647 -0.2496969 -0.3169499 -0.3822666 -0.4519581 -0.5244519 -0.5990908 -0.6740716 -0.7474388 -0.8102145 -0.8808071 -0.9541509 -1.028616 -1.104673 0.000000 4.1941307E-02 2.8210307E-02 -1.6990773E-02 -7.8372158E-02 -0.1478753 -0.2215798 -0.2978985 -0.3753908 -0.4531533 -0.5307622 -0.6094507 -0.6898915 -0.7688216 -0.8462956 -0.9131043 -0.9861411 -1.060240 -1.134074 -1.206743 -1.280244 0.000000 3.2764021E-02 6.8574720E-03 -5.2144740E-02 -0.1298739 -0.2151796 -0.3032356 -0.3925790 -0.4807211 -0.5665153 -0.6512664 -0.7383545 -0.8221037 -0.9019055 -0.9804084 -1.055974 -1.131592 -1.206278 -1.278034 -1.349227 -1.421557 0.000000 2.4669366E-02 -1.0528163E-02 -8.0525771E-02 -0.1685802 -0.2650984 -0.3671936 -0.4665388 -0.5625912 -0.6550502 -0.7481554 -0.8442153 -0.9279063 -1.010936 -1.089484 -1.167385 -1.245314 -1.317349 -1.388669 -1.460832 -1.531416 0.000000 1.7691482E-02 -2.3822607E-02 -0.1010159 -0.1967811 -0.3007335 -0.4109399 -0.5168218 -0.6183197 -0.7179943 -0.8197771 -0.9087552 -0.9979833 -1.081592 -1.158922 -1.247762 -1.321543 -1.394649 -1.469343 -1.540006 -1.605719 0.000000 1.1622406E-02 -3.3341136E-02 -0.1130433 -0.2115370 -0.3185654 -0.4324642 -0.5412191 -0.6457745 -0.7547139 -0.8503438 -0.9441224 -1.041581 -1.121898 -1.203996 -1.282047 -1.355029 -1.441858 -1.514388 -1.580170 -1.640657 0.000000 6.6484902E-03 -3.8392819E-02 -0.1149038 -0.2116768 -0.3166122 -0.4286844 -0.5374218 -0.6422640 -0.7490439 -0.8467841 -0.9472643 -1.033009 -1.117512 -1.209664 -1.286119 -1.360537 -1.446279 -1.514601 -1.575550 -1.638157 0.000000 2.9562234E-03 -3.9043535E-02 -0.1096711 -0.1971989 -0.2927737 -0.3970427 -0.4991389 -0.6060725 -0.7035547 -0.8052726 -0.8950536 -0.9816256 -1.074733 -1.152759 -1.241094 -1.312033 -1.395434 -1.458263 -1.521932 -1.597544 0.000000 5.7798100E-04 -3.5920434E-02 -9.5334306E-02 -0.1691568 -0.2515055 -0.3385088 -0.4280502 -0.5220478 -0.6133315 -0.7028157 -0.7928500 -0.8763002 -0.9635290 -1.039613 -1.122136 -1.191155 -1.266989 -1.328147 -1.401037 -1.457044 0.000000 -8.2321645E-04 -2.7827078E-02 -7.2503045E-02 -0.1279156 -0.1902234 -0.2567758 -0.3257892 -0.3960999 -0.4670312 -0.5386939 -0.6133926 -0.6873807 -0.7566119 -0.8323466 -0.8962906 -0.9667346 -1.023654 -1.089148 -1.144411 -1.207735 0.000000 -9.9748326E-04 -1.6220307E-02 -4.0497731E-02 -7.0692018E-02 -0.1059515 -0.1437574 -0.1837993 -0.2254021 -0.2680197 -0.3111747 -0.3583471 -0.4026442 -0.4470375 -0.4908115 -0.5343455 -0.5758049 -0.6224636 -0.6613776 -0.7020356 -0.7460133 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.2246916 0.4261552 0.5966848 0.7335429 0.8534715 0.9546488 1.041129 1.105701 1.167985 1.222634 1.270963 1.313725 1.351601 1.385101 1.414652 1.440576 1.463101 1.482385 1.498727 1.508480 0.000000 0.2066649 0.3864444 0.5379873 0.6602578 0.7669989 0.8563243 0.9318503 0.9871293 1.040013 1.085991 1.126085 1.161095 1.191310 1.216492 1.237545 1.255007 1.269189 1.280290 1.288654 1.290816 0.000000 0.1879641 0.3446279 0.4754878 0.5799319 0.6703770 0.7466751 0.8034968 0.8555384 0.8991217 0.9355679 0.9656442 0.9886523 0.9964278 1.007190 1.014883 1.019517 1.021152 1.019900 1.016044 1.006381 0.000000 0.1694514 0.3032699 0.4119475 0.4982634 0.5750250 0.6389623 0.6837184 0.7225983 0.7528596 0.7751023 0.7814831 0.7883720 0.7911757 0.7901565 0.7856084 0.7777930 0.7669409 0.7531471 0.7367029 0.7149419 0.000000 0.1516280 0.2630648 0.3471583 0.4210279 0.4826525 0.5250900 0.5583010 0.5809343 0.5941831 0.5933185 0.5909545 0.5838600 0.5725948 0.5574796 0.5387780 0.5166816 0.4912592 0.4626113 0.4315118 0.3959613 0.000000 0.1346554 0.2245255 0.2901204 0.3466115 0.3886058 0.4117267 0.4262005 0.4302181 0.4254302 0.4102219 0.3928481 0.3709714 0.3447484 0.3143304 0.2801355 0.2420378 0.2002869 0.1574411 0.1114348 6.2517554E-02 0.000000 0.1186289 0.1883837 0.2362681 0.2723767 0.2889608 0.2947708 0.2894259 0.2749627 0.2535962 0.2243539 0.1918629 0.1542109 0.1118977 6.6035308E-02 1.5528049E-02 -3.9188735E-02 -9.5574297E-02 -0.1531576 -0.2136942 -0.2777034 0.000000 0.1036700 0.1550176 0.1844544 0.1977784 0.1924788 0.1770052 0.1524775 0.1209683 8.3496191E-02 4.0146448E-02 -8.6165490E-03 -6.2702604E-02 -0.1206026 -0.1823500 -0.2471371 -0.3130347 -0.3761699 -0.4443015 -0.5143676 -0.5810842 0.000000 8.9724101E-02 0.1233506 0.1343395 0.1245655 9.7663522E-02 6.2112112E-02 1.9786786E-02 -2.8287113E-02 -8.2091026E-02 -0.1413360 -0.2050716 -0.2721240 -0.3420295 -0.4152011 -0.4834796 -0.5532373 -0.6257132 -0.7010964 -0.7698718 -0.8467364 0.000000 7.6702617E-02 9.5498286E-02 8.6499169E-02 5.4726571E-02 8.2298536E-03 -4.6268035E-02 -0.1057490 -0.1700516 -0.2390013 -0.3114713 -0.3860474 -0.4624453 -0.5408724 -0.6187588 -0.6876210 -0.7623201 -0.8387226 -0.9157849 -0.9934676 -1.072767 0.000000 6.4562716E-02 6.9451094E-02 4.2059824E-02 -9.5058633E-03 -7.4070714E-02 -0.1449319 -0.2212007 -0.3002265 -0.3814955 -0.4631673 -0.5455810 -0.6289462 -0.7124314 -0.7855939 -0.8632349 -0.9409896 -1.017752 -1.094370 -1.170516 -1.246726 0.000000 5.2896757E-02 4.5640659E-02 2.4261440E-03 -6.5703779E-02 -0.1458339 -0.2307666 -0.3208682 -0.4112518 -0.5006227 -0.5879924 -0.6765038 -0.7647229 -0.8488047 -0.9290479 -1.009015 -1.086168 -1.162731 -1.238696 -1.311992 -1.385035 0.000000 4.2939648E-02 2.5056407E-02 -3.1680744E-02 -0.1121923 -0.2043836 -0.3008225 -0.4023330 -0.5007702 -0.5956022 -0.6899995 -0.7829046 -0.8770269 -0.9592043 -1.041593 -1.120578 -1.198175 -1.276265 -1.348842 -1.420061 -1.491752 0.000000 3.3918612E-02 7.7325497E-03 -5.8027957E-02 -0.1480880 -0.2481323 -0.3523988 -0.4616077 -0.5649827 -0.6638731 -0.7696673 -0.8612867 -0.9468465 -1.033287 -1.116246 -1.192276 -1.280203 -1.353745 -1.425314 -1.497795 -1.566905 0.000000 2.5903050E-02 -6.4563854E-03 -7.6586492E-02 -0.1693624 -0.2749775 -0.3829052 -0.4954880 -0.6008399 -0.7037683 -0.8084239 -0.8990583 -0.9884038 -1.082830 -1.162279 -1.240687 -1.317871 -1.388270 -1.471236 -1.541055 -1.605266 0.000000 1.8608598E-02 -1.6413182E-02 -8.7172732E-02 -0.1782698 -0.2824053 -0.3888311 -0.5002580 -0.6047432 -0.7137048 -0.8101985 -0.9025382 -0.9981921 -1.082993 -1.163231 -1.252525 -1.326301 -1.394462 -1.475967 -1.541739 -1.600693 0.000000 1.2524865E-02 -2.1632448E-02 -8.7177426E-02 -0.1729777 -0.2690498 -0.3688197 -0.4733630 -0.5733167 -0.6772716 -0.7703139 -0.8664713 -0.9528020 -1.044483 -1.123708 -1.210350 -1.281847 -1.349425 -1.427944 -1.488345 -1.547760 0.000000 7.7197449E-03 -2.3345107E-02 -7.9329021E-02 -0.1513252 -0.2328780 -0.3173736 -0.4098422 -0.5020254 -0.5970001 -0.6819665 -0.7669972 -0.8547993 -0.9345737 -1.017381 -1.090243 -1.167722 -1.233238 -1.304826 -1.363112 -1.435356 0.000000 3.8955188E-03 -1.9754702E-02 -6.1719000E-02 -0.1165276 -0.1781721 -0.2443661 -0.3132325 -0.3835676 -0.4546844 -0.5283459 -0.5986311 -0.6715964 -0.7460502 -0.8127654 -0.8837225 -0.9455006 -1.011637 -1.066012 -1.128695 -1.192664 0.000000 1.3347947E-03 -1.2294109E-02 -3.5669040E-02 -6.5374300E-02 -9.9232905E-02 -0.1377883 -0.1776517 -0.2191194 -0.2616364 -0.3047632 -0.3481398 -0.3958993 -0.4401083 -0.4838796 -0.5270051 -0.5696439 -0.6164052 -0.6575595 -0.6978674 -0.7413032 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.2562560 0.4482469 0.5953274 0.7092382 0.8075973 0.8897439 0.9597633 1.011018 1.060990 1.104678 1.143234 1.177263 1.207221 1.233528 1.256537 1.276422 1.293379 1.307528 1.319141 1.324567 0.000000 0.2398799 0.4175939 0.5529907 0.6569299 0.7457082 0.8188517 0.8719227 0.9215150 0.9636117 0.9997465 1.030906 1.057608 1.079711 1.098145 1.113344 1.125607 1.135131 1.142012 1.146560 1.145300 0.000000 0.2218094 0.3836183 0.4996147 0.5940766 0.6701991 0.7321528 0.7751594 0.8143910 0.8469317 0.8740875 0.8949062 0.9019240 0.9117272 0.9186124 0.9226014 0.9236056 0.9218179 0.9174016 0.9106778 0.8984830 0.000000 0.2039192 0.3480743 0.4481388 0.5274529 0.5903472 0.6339514 0.6707346 0.6995740 0.7219694 0.7293808 0.7370473 0.7402307 0.7392841 0.7346367 0.7265602 0.7155071 0.7017526 0.6853513 0.6666250 0.6428800 0.000000 0.1864591 0.3124334 0.3959245 0.4597159 0.5075498 0.5374939 0.5625286 0.5797721 0.5820783 0.5820658 0.5763132 0.5656613 0.5509562 0.5325661 0.5110129 0.4863692 0.4586418 0.4279362 0.3949083 0.3576139 0.000000 0.1693846 0.2773187 0.3436649 0.3907817 0.4184443 0.4395838 0.4515848 0.4486489 0.4400916 0.4248559 0.4042367 0.3792854 0.3502078 0.3174202 0.2808615 0.2405099 0.1972509 0.1513660 0.1043796 5.3862870E-02 0.000000 0.1528406 0.2405876 0.2917968 0.3210889 0.3343728 0.3409950 0.3355710 0.3156908 0.2910432 0.2606958 0.2257119 0.1857911 0.1415860 9.2597179E-02 4.0171906E-02 -1.5073310E-02 -7.2465554E-02 -0.1332694 -0.1955910 -0.2610667 0.000000 0.1369821 0.2073560 0.2404740 0.2499802 0.2516761 0.2397485 0.2127688 0.1792012 0.1392529 9.4415195E-02 4.3922078E-02 -1.1374872E-02 -7.1922012E-02 -0.1356914 -0.2015599 -0.2670451 -0.3367577 -0.4082220 -0.4767506 -0.5521744 0.000000 0.1216919 0.1753710 0.1905693 0.1852262 0.1689392 0.1366059 9.3425155E-02 4.3025255E-02 -1.1358925E-02 -7.2048731E-02 -0.1377147 -0.2074411 -0.2803015 -0.3514304 -0.4249041 -0.5006270 -0.5787430 -0.6527484 -0.7323691 -0.8149278 0.000000 0.1069085 0.1449375 0.1432940 0.1231704 8.6759806E-02 3.4975089E-02 -2.5001766E-02 -8.9499898E-02 -0.1589027 -0.2332343 -0.3104970 -0.3896353 -0.4705762 -0.5466015 -0.6263055 -0.7072969 -0.7894160 -0.8717586 -0.9536027 -1.036027 0.000000 9.2691489E-02 0.1161518 9.9684209E-02 6.3485146E-02 7.6894229E-03 -6.1416555E-02 -0.1363797 -0.2141073 -0.2966262 -0.3809864 -0.4655169 -0.5507133 -0.6360179 -0.7193891 -0.8027811 -0.8863977 -0.9686713 -1.048961 -1.127142 -1.205774 0.000000 7.8405909E-02 8.9263454E-02 6.0231160E-02 7.9188105E-03 -6.5418623E-02 -0.1487085 -0.2353142 -0.3288471 -0.4207377 -0.5119287 -0.6021472 -0.6925660 -0.7795426 -0.8654540 -0.9512471 -1.033635 -1.113476 -1.189949 -1.265694 -1.342860 0.000000 6.5898314E-02 6.5212294E-02 2.5103781E-02 -4.1823890E-02 -0.1288608 -0.2233949 -0.3204895 -0.4234224 -0.5213823 -0.6165563 -0.7127678 -0.8041660 -0.8897814 -0.9832109 -1.066084 -1.146123 -1.222765 -1.298329 -1.375474 -1.450706 0.000000 5.4288641E-02 4.4208903E-02 -4.9822223E-03 -8.3462872E-02 -0.1801310 -0.2823077 -0.3868652 -0.4959494 -0.5974440 -0.6972730 -0.8004615 -0.8885100 -0.9750541 -1.061182 -1.143592 -1.220883 -1.294032 -1.380488 -1.455336 -1.526225 0.000000 4.3579929E-02 2.6047498E-02 -2.9499030E-02 -0.1142565 -0.2143613 -0.3226198 -0.4303259 -0.5420267 -0.6450863 -0.7525083 -0.8454405 -0.9355687 -1.023954 -1.116294 -1.196315 -1.271877 -1.343557 -1.429432 -1.500346 -1.565743 0.000000 3.3635367E-02 1.1598166E-02 -4.7414608E-02 -0.1327627 -0.2320144 -0.3399555 -0.4464599 -0.5570777 -0.6604424 -0.7637551 -0.8547578 -0.9542614 -1.041762 -1.123219 -1.209869 -1.283640 -1.355293 -1.437775 -1.504204 -1.564594 0.000000 2.4809046E-02 1.2650600E-03 -5.6557503E-02 -0.1377476 -0.2307141 -0.3319845 -0.4323047 -0.5367616 -0.6397297 -0.7337513 -0.8230733 -0.9188911 -1.011135 -1.090355 -1.165075 -1.248687 -1.315548 -1.394718 -1.456425 -1.517050 0.000000 1.7012788E-02 -5.7995748E-03 -5.6284517E-02 -0.1253751 -0.2071539 -0.2947613 -0.3843387 -0.4778033 -0.5658665 -0.6508132 -0.7421021 -0.8303531 -0.9095266 -0.9924531 -1.064444 -1.141062 -1.205890 -1.279243 -1.339034 -1.408858 0.000000 1.0155118E-02 -8.2192589E-03 -4.7154699E-02 -9.9137411E-02 -0.1610782 -0.2270836 -0.2959853 -0.3665011 -0.4378878 -0.5086089 -0.5869647 -0.6565518 -0.7320189 -0.7967109 -0.8669424 -0.9262472 -0.9930065 -1.050143 -1.113268 -1.162789 0.000000 4.4890610E-03 -6.5807137E-03 -2.8577723E-02 -5.7655927E-02 -9.1277733E-02 -0.1294999 -0.1692487 -0.2106379 -0.2531070 -0.2962039 -0.3395788 -0.3869437 -0.4311429 -0.4750236 -0.5171527 -0.5621685 -0.6039120 -0.6457154 -0.6906706 -0.7271304 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.2649635 0.4268792 0.5515295 0.6450362 0.7244547 0.7899748 0.8453531 0.8847280 0.9236727 0.9575243 0.9871791 1.013124 1.035725 1.055290 1.072093 1.086269 1.097941 1.107170 1.114214 1.115417 0.000000 0.2636163 0.4166653 0.5287168 0.6184821 0.6891493 0.7455698 0.7841359 0.8207861 0.8520129 0.8786954 0.9015623 0.9208450 0.9368451 0.9498538 0.9600587 0.9676964 0.9729137 0.9757669 0.9765624 0.9719937 0.000000 0.2487612 0.4048119 0.5065302 0.5791112 0.6362886 0.6761358 0.7123052 0.7416049 0.7651936 0.7839605 0.7970261 0.8058575 0.8112524 0.8136778 0.8134320 0.8106230 0.8054315 0.7980476 0.7888096 0.7751479 0.000000 0.2309980 0.3810485 0.4667624 0.5291114 0.5778372 0.6101772 0.6371316 0.6562005 0.6688545 0.6680276 0.6677383 0.6639677 0.6570107 0.6471834 0.6346079 0.6194776 0.6020623 0.5823554 0.5662902 0.5432497 0.000000 0.2136431 0.3478364 0.4262074 0.4791769 0.5137359 0.5386477 0.5529981 0.5593697 0.5527237 0.5449730 0.5329791 0.5171028 0.4979112 0.4756217 0.4503901 0.4223647 0.3915313 0.3579149 0.3257222 0.2878121 0.000000 0.1972955 0.3185606 0.3856009 0.4281785 0.4487844 0.4592721 0.4603938 0.4485480 0.4338311 0.4136851 0.3886828 0.3597473 0.3271054 0.2907781 0.2508085 0.2073278 0.1610543 0.1136634 6.3199259E-02 1.0024895E-02 0.000000 0.1805033 0.2888264 0.3449750 0.3700149 0.3782078 0.3752053 0.3588803 0.3376158 0.3094407 0.2755596 0.2368339 0.1934465 0.1456255 9.3243323E-02 3.7147179E-02 -2.1038802E-02 -8.1396297E-02 -0.1445602 -0.2106981 -0.2803174 0.000000 0.1641779 0.2596290 0.3030343 0.3116979 0.3055665 0.2857222 0.2584314 0.2227795 0.1802909 0.1322416 7.8385435E-02 1.9046733E-02 -4.4951547E-02 -0.1121422 -0.1811692 -0.2502204 -0.3230578 -0.3986352 -0.4760434 -0.5511571 0.000000 0.1486303 0.2305251 0.2588483 0.2521234 0.2325049 0.1981048 0.1556882 0.1051920 4.8202600E-02 -1.5006142E-02 -8.5156567E-02 -0.1590180 -0.2356985 -0.3103958 -0.3876299 -0.4672605 -0.5489984 -0.6333600 -0.7119877 -0.7974503 0.000000 0.1329763 0.2015585 0.2118875 0.1937883 0.1578535 0.1101472 5.2346285E-02 -1.3278829E-02 -8.4699303E-02 -0.1636586 -0.2455058 -0.3289190 -0.4133137 -0.4937373 -0.5781937 -0.6635029 -0.7501219 -0.8372971 -0.9235871 -1.009855 0.000000 0.1166629 0.1724932 0.1684664 0.1372649 8.6783208E-02 2.3740655E-02 -4.9841337E-02 -0.1294491 -0.2151015 -0.3043123 -0.3935620 -0.4822364 -0.5713068 -0.6604759 -0.7483435 -0.8366038 -0.9244741 -1.009460 -1.091531 -1.173704 0.000000 0.1019973 0.1437121 0.1275180 8.3234727E-02 1.9073069E-02 -5.9387743E-02 -0.1465792 -0.2385997 -0.3371266 -0.4327783 -0.5267724 -0.6199319 -0.7131235 -0.8032837 -0.8931825 -0.9823430 -1.066701 -1.146896 -1.226119 -1.306585 0.000000 8.7746426E-02 0.1162604 8.9574330E-02 3.3193033E-02 -4.3730903E-02 -0.1354108 -0.2334320 -0.3376176 -0.4395540 -0.5385899 -0.6354328 -0.7329772 -0.8261859 -0.9143400 -1.010713 -1.094215 -1.174346 -1.253247 -1.333345 -1.410871 0.000000 7.3992550E-02 8.9953788E-02 5.5386756E-02 -1.1409367E-02 -9.8760359E-02 -0.2001882 -0.3053716 -0.4157762 -0.5209437 -0.6218933 -0.7224574 -0.8246341 -0.9141973 -1.003493 -1.088638 -1.169367 -1.245740 -1.334665 -1.411317 -1.483772 0.000000 6.0877584E-02 6.6885464E-02 2.5626874E-02 -4.8297655E-02 -0.1424190 -0.2493904 -0.3579253 -0.4707067 -0.5763804 -0.6792968 -0.7839797 -0.8756003 -0.9667018 -1.061090 -1.143963 -1.222844 -1.296326 -1.383761 -1.455943 -1.522498 0.000000 4.8344951E-02 4.6972357E-02 6.7966484E-04 -7.5044721E-02 -0.1709813 -0.2782122 -0.3854324 -0.4966484 -0.6004929 -0.7076198 -0.8021173 -0.8952761 -0.9894550 -1.071976 -1.163239 -1.237860 -1.310503 -1.394066 -1.461269 -1.521981 0.000000 3.6737267E-02 3.0329755E-02 -1.6732404E-02 -9.0888664E-02 -0.1821394 -0.2832161 -0.3835782 -0.4883340 -0.5876971 -0.6878427 -0.7802160 -0.8767989 -0.9586142 -1.048489 -1.124067 -1.207636 -1.275429 -1.354756 -1.416646 -1.476420 0.000000 2.6128678E-02 1.6332543E-02 -2.6344147E-02 -9.1865875E-02 -0.1714014 -0.2590693 -0.3472066 -0.4397016 -0.5324530 -0.6197894 -0.7092499 -0.7915035 -0.8752098 -0.9600893 -1.029671 -1.107967 -1.171418 -1.245553 -1.303295 -1.373359 0.000000 1.6164567E-02 6.7639374E-03 -2.7419491E-02 -7.7629820E-02 -0.1373521 -0.2026023 -0.2712303 -0.3443742 -0.4159234 -0.4924242 -0.5632564 -0.6380747 -0.7046012 -0.7766602 -0.8374639 -0.9042041 -0.9633358 -1.027007 -1.080392 -1.142249 0.000000 7.6144962E-03 9.5708697E-04 -1.8807799E-02 -4.7064725E-02 -8.0518685E-02 -0.1185355 -0.1583389 -0.1998297 -0.2423301 -0.2855280 -0.3290558 -0.3726695 -0.4205896 -0.4649594 -0.5084195 -0.5503407 -0.5908788 -0.6380715 -0.6748140 -0.7184879 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.1888374 0.3420659 0.4500641 0.5279028 0.5917091 0.6432847 0.6867033 0.7237678 0.7484549 0.7738172 0.7957283 0.8147219 0.8309571 0.8446814 0.8560945 0.8652621 0.8722690 0.8771402 0.8801111 0.8775515 0.000000 0.1761080 0.3182076 0.4190596 0.4891201 0.5447581 0.5883265 0.6242304 0.6475686 0.6707546 0.6904257 0.7069429 0.7205480 0.7314198 0.7396898 0.7454150 0.7487639 0.7498329 0.7486675 0.7531655 0.7497407 0.000000 0.1639479 0.2944515 0.3836594 0.4484030 0.4958111 0.5328717 0.5566944 0.5787143 0.5958856 0.6086122 0.6167731 0.6207213 0.6210295 0.6182059 0.6126371 0.6044499 0.5940546 0.5816729 0.5734169 0.5585277 0.000000 0.1519871 0.2724600 0.3545078 0.4122716 0.4550891 0.4817317 0.5027590 0.5152697 0.5206635 0.5185839 0.5115182 0.5005249 0.4864299 0.4697452 0.4507414 0.4301227 0.4077193 0.3832653 0.3606706 0.3324486 0.000000 0.1407663 0.2521713 0.3290598 0.3843901 0.4182894 0.4385200 0.4450960 0.4417233 0.4255095 0.4079531 0.3866223 0.3622052 0.3352050 0.3059077 0.2772032 0.2443966 0.2084081 0.1694606 0.1296553 8.5593998E-02 0.000000 0.1303943 0.2319468 0.3096310 0.3626270 0.3846798 0.3862322 0.3754598 0.3519938 0.3259558 0.2957051 0.2621414 0.2258954 0.1868650 0.1446904 0.1001476 5.0648689E-02 -1.5480054E-03 -5.7577599E-02 -0.1169579 -0.1803811 0.000000 0.1207828 0.2172695 0.2956669 0.3375380 0.3406026 0.3243671 0.2951385 0.2616273 0.2233003 0.1815808 0.1367913 8.7907784E-02 3.4967463E-02 -2.2964193E-02 -8.6164325E-02 -0.1524089 -0.2196001 -0.2910312 -0.3640229 -0.4363362 0.000000 0.1122981 0.2058765 0.2843598 0.3059784 0.2894186 0.2553343 0.2154730 0.1698861 0.1207877 6.8178438E-02 1.0207000E-02 -5.4445051E-02 -0.1238387 -0.1972731 -0.2740553 -0.3507729 -0.4302899 -0.5106918 -0.5885278 -0.6750169 0.000000 0.1048601 0.1978334 0.2701422 0.2654474 0.2325730 0.1872561 0.1351411 7.9150178E-02 1.9496297E-02 -4.6933644E-02 -0.1206936 -0.1998224 -0.2816882 -0.3657500 -0.4519649 -0.5392741 -0.6201086 -0.7083528 -0.8000712 -0.8949695 0.000000 9.8580465E-02 0.1926137 0.2422912 0.2230999 0.1768684 0.1190439 5.6204755E-02 -9.6785100E-03 -8.2932137E-02 -0.1647186 -0.2521177 -0.3416758 -0.4317908 -0.5230339 -0.6157389 -0.7020019 -0.7947463 -0.8889421 -0.9822339 -1.075084 0.000000 9.3570620E-02 0.1895010 0.2094907 0.1776532 0.1207598 5.2368306E-02 -1.9997576E-02 -9.8009765E-02 -0.1861601 -0.2808624 -0.3770272 -0.4720511 -0.5671560 -0.6635574 -0.7591622 -0.8552205 -0.9511193 -1.043649 -1.132347 -1.220625 0.000000 8.9273281E-02 0.1753015 0.1766549 0.1342347 6.6502571E-02 -1.1430396E-02 -9.3367770E-02 -0.1852157 -0.2884969 -0.3913746 -0.4923688 -0.5917458 -0.6926127 -0.7914460 -0.8894318 -0.9870088 -1.078993 -1.165422 -1.250487 -1.337166 0.000000 8.7752387E-02 0.1476364 0.1440715 9.1513142E-02 1.5426604E-02 -7.0082203E-02 -0.1635988 -0.2684851 -0.3793386 -0.4858863 -0.5888121 -0.6936792 -0.7961749 -0.8923827 -0.9964296 -1.087526 -1.173016 -1.257332 -1.343778 -1.427588 0.000000 7.7711113E-02 0.1234159 0.1112619 5.1726066E-02 -3.1239893E-02 -0.1224342 -0.2279469 -0.3432914 -0.4550645 -0.5623304 -0.6688666 -0.7800186 -0.8774860 -0.9737673 -1.066469 -1.151152 -1.232208 -1.327671 -1.410371 -1.487829 0.000000 6.4536154E-02 0.1000669 8.1355184E-02 1.6905792E-02 -7.0355602E-02 -0.1682313 -0.2802916 -0.3983414 -0.5101966 -0.6170319 -0.7296926 -0.8291355 -0.9255670 -1.026728 -1.112211 -1.193897 -1.275086 -1.368386 -1.444966 -1.515631 0.000000 5.1827170E-02 7.8214824E-02 5.3387940E-02 -1.2788442E-02 -9.9672861E-02 -0.2015682 -0.3135736 -0.4302637 -0.5386341 -0.6444585 -0.7512440 -0.8478810 -0.9470672 -1.035327 -1.116747 -1.206392 -1.284402 -1.372232 -1.442580 -1.506236 0.000000 3.9907459E-02 5.7975788E-02 3.0012624E-02 -3.4950297E-02 -0.1188790 -0.2168698 -0.3228797 -0.4319640 -0.5335038 -0.6383458 -0.7331929 -0.8312761 -0.9184726 -1.009925 -1.086003 -1.175560 -1.247344 -1.329135 -1.393118 -1.452185 0.000000 2.8839333E-02 3.8716380E-02 1.1951269E-02 -4.6046957E-02 -0.1208346 -0.2079611 -0.3009452 -0.3965455 -0.4867585 -0.5798631 -0.6662247 -0.7541065 -0.8417084 -0.9163449 -0.9963972 -1.079700 -1.144198 -1.219652 -1.278718 -1.337033 0.000000 1.8218987E-02 2.2860486E-02 -6.4848718E-06 -4.5784596E-02 -0.1050094 -0.1720510 -0.2434280 -0.3176073 -0.3893674 -0.4642639 -0.5344600 -0.6080057 -0.6812136 -0.7447906 -0.8133669 -0.8837000 -0.9406873 -1.006006 -1.061030 -1.121928 0.000000 8.7307701E-03 9.4552636E-03 -4.4349483E-03 -3.0613126E-02 -6.3848898E-02 -0.1011258 -0.1423264 -0.1843419 -0.2274033 -0.2710962 -0.3151007 -0.3591983 -0.4032523 -0.4482312 -0.4945443 -0.5360704 -0.5778833 -0.6214790 -0.6653224 -0.7018283 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.1165726 0.1983732 0.2655802 0.3261526 0.3763885 0.4216797 0.4605431 0.4945489 0.5240628 0.5495161 0.5712979 0.5898454 0.6055832 0.6187695 0.6296297 0.6383054 0.6448968 0.6494365 0.6522457 0.6500087 0.000000 0.1047167 0.1710384 0.2218653 0.2668775 0.3052738 0.3409641 0.3720923 0.3991667 0.4221642 0.4412963 0.4568111 0.4691101 0.4786339 0.4856324 0.4903089 0.4929101 0.4935098 0.4974427 0.4975298 0.4927215 0.000000 9.2470899E-02 0.1419966 0.1741140 0.2011221 0.2264715 0.2517955 0.2724611 0.2883783 0.2997412 0.3069459 0.3103793 0.3105745 0.3077879 0.3022006 0.2973681 0.2886652 0.2774515 0.2639564 0.2516143 0.2341781 0.000000 8.1633680E-02 0.1132630 0.1251022 0.1360550 0.1510621 0.1608325 0.1656750 0.1652922 0.1603427 0.1512838 0.1397461 0.1233315 0.1035163 8.0762096E-02 5.5872250E-02 2.8484356E-02 -1.7864970E-03 -3.4513608E-02 -6.9341190E-02 -0.1071521 0.000000 7.0510529E-02 8.4952176E-02 7.8075320E-02 7.5662687E-02 7.3269367E-02 6.4353667E-02 4.9341246E-02 2.9806891E-02 5.6361561E-03 -2.2613557E-02 -5.6076448E-02 -9.2738926E-02 -0.1320813 -0.1764712 -0.2225459 -0.2712180 -0.3245004 -0.3776928 -0.4323800 -0.4952522 0.000000 6.0006585E-02 5.7373852E-02 3.4858864E-02 1.6490206E-02 -8.4839324E-03 -3.9476644E-02 -7.5704820E-02 -0.1157280 -0.1611060 -0.2098072 -0.2639180 -0.3182133 -0.3801387 -0.4420326 -0.5098906 -0.5762683 -0.6438830 -0.7179237 -0.7883666 -0.8710612 0.000000 5.0078921E-02 3.1422805E-02 -3.7795065E-03 -4.2617109E-02 -9.1648579E-02 -0.1449488 -0.2021511 -0.2643140 -0.3284176 -0.3976184 -0.4654464 -0.5411009 -0.6218256 -0.6967546 -0.7817612 -0.8604830 -0.9454091 -1.025589 -1.115668 -1.209852 0.000000 4.0799487E-02 8.8611674E-03 -3.9802525E-02 -0.1016242 -0.1738698 -0.2474269 -0.3251401 -0.4067121 -0.4910613 -0.5709326 -0.6586864 -0.7517935 -0.8374233 -0.9307902 -1.025795 -1.107852 -1.201728 -1.300614 -1.382595 -1.472719 0.000000 3.2132559E-02 -1.0487857E-02 -7.4099600E-02 -0.1580268 -0.2489062 -0.3434449 -0.4396540 -0.5370796 -0.6347399 -0.7300385 -0.8315439 -0.9318397 -1.030918 -1.131914 -1.219369 -1.317176 -1.415874 -1.511779 -1.587299 -1.679015 0.000000 2.4078410E-02 -2.6956251E-02 -0.1050419 -0.2069381 -0.3172733 -0.4289064 -0.5407817 -0.6447524 -0.7616333 -0.8735874 -0.9837982 -1.081217 -1.184688 -1.285968 -1.386446 -1.484152 -1.578291 -1.656584 -1.749031 -1.844026 0.000000 1.6809143E-02 -4.1283529E-02 -0.1329485 -0.2505690 -0.3754974 -0.5009964 -0.6191377 -0.7393438 -0.8653987 -0.9824618 -1.095698 -1.204877 -1.308963 -1.410809 -1.512682 -1.594861 -1.688473 -1.782591 -1.874149 -1.964632 0.000000 1.0450578E-02 -5.2536659E-02 -0.1540427 -0.2813610 -0.4158131 -0.5504355 -0.6829861 -0.8109143 -0.9424967 -1.062235 -1.176424 -1.283673 -1.386547 -1.489795 -1.588613 -1.684870 -1.780276 -1.869596 -1.956498 -2.041706 0.000000 5.2714627E-03 -6.0637418E-02 -0.1691406 -0.3041843 -0.4448647 -0.5861042 -0.7240309 -0.8565886 -0.9908333 -1.111929 -1.225172 -1.331402 -1.439628 -1.541836 -1.634649 -1.741283 -1.828705 -1.913724 -1.997336 -2.080266 0.000000 1.2033657E-03 -6.5926038E-02 -0.1777928 -0.3116597 -0.4534586 -0.6013294 -0.7404122 -0.8737363 -1.009040 -1.130224 -1.241802 -1.352492 -1.468776 -1.562073 -1.654775 -1.744764 -1.830355 -1.913879 -1.993927 -2.093075 0.000000 -1.9003391E-03 -6.8982460E-02 -0.1767554 -0.3093302 -0.4476442 -0.5879890 -0.7307171 -0.8608399 -0.9956709 -1.114652 -1.227451 -1.345903 -1.441946 -1.539327 -1.630586 -1.726557 -1.812009 -1.895541 -1.970236 -2.065373 0.000000 -4.2240787E-03 -6.7524187E-02 -0.1696223 -0.2900143 -0.4234802 -0.5553203 -0.6922413 -0.8163005 -0.9473596 -1.061734 -1.182506 -1.283357 -1.381036 -1.487736 -1.569152 -1.653883 -1.754312 -1.829046 -1.902790 -1.993146 0.000000 -5.4730014E-03 -6.1971191E-02 -0.1515972 -0.2607822 -0.3761623 -0.4985925 -0.6166335 -0.7377489 -0.8595454 -0.9661435 -1.079063 -1.175212 -1.281999 -1.366689 -1.450619 -1.549431 -1.623918 -1.711090 -1.780422 -1.864173 0.000000 -5.5668498E-03 -5.3083438E-02 -0.1257197 -0.2141611 -0.3119105 -0.4155652 -0.5153851 -0.6206518 -0.7271276 -0.8213648 -0.9219704 -1.012095 -1.105671 -1.187022 -1.278307 -1.365980 -1.433132 -1.517650 -1.580502 -1.657205 0.000000 -4.8425077E-03 -3.9155357E-02 -9.2378877E-02 -0.1570748 -0.2291902 -0.3023285 -0.3805596 -0.4609631 -0.5431348 -0.6176979 -0.6977880 -0.7784186 -0.8488399 -0.9259704 -1.003331 -1.065605 -1.135897 -1.207438 -1.264252 -1.329763 0.000000 -2.9900130E-03 -2.1838045E-02 -5.0575476E-02 -8.4565878E-02 -0.1229751 -0.1642805 -0.2078600 -0.2532589 -0.3001719 -0.3447384 -0.3921523 -0.4400240 -0.4882331 -0.5367393 -0.5855207 -0.6267143 -0.6729364 -0.7188470 -0.7645119 -0.8017554 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.1553632 0.2406308 0.2960143 0.3380233 0.3749451 0.4046670 0.4284098 0.4472619 0.4619160 0.4732053 0.4814298 0.4875566 0.4918318 0.4944219 0.4954460 0.4949643 0.4930018 0.4895593 0.4902221 0.4848109 0.000000 0.1441902 0.2194420 0.2662198 0.3027492 0.3353593 0.3608313 0.3800758 0.3944673 0.4053431 0.4132978 0.4188465 0.4227747 0.4251224 0.4259333 0.4251877 0.4229369 0.4192168 0.4183717 0.4147190 0.4067693 0.000000 0.1326610 0.1959108 0.2294486 0.2570213 0.2771802 0.2915268 0.3017865 0.3091784 0.3141284 0.3164626 0.3158857 0.3130076 0.3077602 0.3003174 0.2908858 0.2795942 0.2695014 0.2562098 0.2412276 0.2247511 0.000000 0.1208396 0.1713615 0.1918562 0.2030525 0.2091365 0.2138131 0.2165040 0.2158680 0.2113054 0.2022586 0.1887093 0.1718757 0.1522683 0.1315255 0.1076431 8.1295863E-02 5.3279821E-02 2.2908058E-02 -9.4853118E-03 -4.5011058E-02 0.000000 0.1091058 0.1466355 0.1514722 0.1459872 0.1407948 0.1358123 0.1268101 0.1119966 9.0895504E-02 6.4135909E-02 3.3253357E-02 -9.3528954E-04 -3.7747614E-02 -7.8124054E-02 -0.1209624 -0.1674551 -0.2153943 -0.2683159 -0.3222392 -0.3798601 0.000000 9.7537383E-02 0.1219317 0.1099805 9.0568721E-02 7.3715262E-02 5.4140396E-02 2.7563203E-02 -7.1950941E-03 -4.8249751E-02 -9.4112955E-02 -0.1429088 -0.1961230 -0.2512087 -0.3113602 -0.3720301 -0.4382583 -0.5038742 -0.5784981 -0.6500521 -0.7231277 0.000000 8.6232528E-02 9.7288579E-02 6.9613323E-02 3.7825704E-02 5.4082465E-03 -3.3672798E-02 -8.2362816E-02 -0.1374628 -0.1968442 -0.2608773 -0.3266743 -0.3986290 -0.4695408 -0.5474766 -0.6221933 -0.7059372 -0.7886468 -0.8770707 -0.9565471 -1.045913 0.000000 7.5440362E-02 7.2495475E-02 3.1985156E-02 -1.3602102E-02 -6.4841442E-02 -0.1266083 -0.1968432 -0.2686997 -0.3438621 -0.4244795 -0.5103308 -0.5932048 -0.6831838 -0.7684786 -0.8616304 -0.9585900 -1.055344 -1.137015 -1.230152 -1.329904 0.000000 6.5121442E-02 5.0172307E-02 -2.5243822E-03 -6.3557371E-02 -0.1362500 -0.2196786 -0.3085594 -0.3941415 -0.4855641 -0.5806808 -0.6789122 -0.7800484 -0.8746352 -0.9757347 -1.076776 -1.175646 -1.260086 -1.355264 -1.453363 -1.553845 0.000000 5.5361655E-02 3.0121790E-02 -3.4204803E-02 -0.1119025 -0.2054692 -0.3080247 -0.4080660 -0.5110792 -0.6165714 -0.7225610 -0.8306730 -0.9397705 -1.046875 -1.150642 -1.252568 -1.341391 -1.439410 -1.536589 -1.632329 -1.728845 0.000000 4.6227679E-02 1.1750809E-02 -6.2726453E-02 -0.1560143 -0.2661951 -0.3826896 -0.4985468 -0.6146426 -0.7303928 -0.8457721 -0.9619014 -1.073751 -1.179572 -1.281881 -1.384330 -1.484822 -1.580444 -1.672867 -1.764684 -1.856738 0.000000 3.7659865E-02 -4.4953967E-03 -8.7609425E-02 -0.1950841 -0.3189957 -0.4468938 -0.5734436 -0.6996240 -0.8213367 -0.9501458 -1.067728 -1.178544 -1.283390 -1.388846 -1.491259 -1.585556 -1.675361 -1.765026 -1.853323 -1.939621 0.000000 2.9857431E-02 -1.7788766E-02 -0.1071410 -0.2241930 -0.3596163 -0.4949294 -0.6291795 -0.7605594 -0.8854904 -1.015825 -1.132163 -1.240110 -1.349600 -1.455902 -1.550027 -1.637901 -1.727115 -1.814389 -1.896664 -1.977510 0.000000 2.2745844E-02 -2.7911464E-02 -0.1222354 -0.2448068 -0.3803651 -0.5189541 -0.6616282 -0.7934627 -0.9201297 -1.049590 -1.163393 -1.273755 -1.394678 -1.489848 -1.578758 -1.670392 -1.760928 -1.842417 -1.922614 -2.001420 0.000000 1.6773243E-02 -3.5646804E-02 -0.1292934 -0.2511834 -0.3879798 -0.5252861 -0.6674610 -0.7967325 -0.9222149 -1.048788 -1.160286 -1.282771 -1.381877 -1.472946 -1.564698 -1.668478 -1.750266 -1.831653 -1.912346 -1.984789 0.000000 1.1466783E-02 -3.9249286E-02 -0.1295516 -0.2459200 -0.3728645 -0.5068058 -0.6361805 -0.7675422 -0.8881668 -1.010144 -1.121460 -1.235553 -1.329496 -1.422955 -1.522132 -1.607614 -1.688584 -1.782014 -1.854680 -1.920341 0.000000 7.0932964E-03 -3.9027512E-02 -0.1217510 -0.2254681 -0.3411631 -0.4631406 -0.5803831 -0.7019007 -0.8137820 -0.9282790 -1.043272 -1.139231 -1.233485 -1.330903 -1.415504 -1.510659 -1.585289 -1.672616 -1.738322 -1.808759 0.000000 3.8519911E-03 -3.5923969E-02 -0.1042717 -0.1908804 -0.2880174 -0.3871288 -0.4908961 -0.5961902 -0.6944278 -0.7960225 -0.8973085 -0.9870380 -1.080805 -1.162040 -1.253747 -1.328165 -1.409142 -1.475418 -1.552468 -1.633652 0.000000 1.4855206E-03 -2.7963854E-02 -7.8890972E-02 -0.1427690 -0.2123337 -0.2875146 -0.3657434 -0.4461914 -0.5232257 -0.6027234 -0.6828723 -0.7636177 -0.8338302 -0.9111042 -0.9886371 -1.050730 -1.121167 -1.181116 -1.249685 -1.315391 0.000000 1.8578187E-04 -1.6388088E-02 -4.3756086E-02 -7.7888988E-02 -0.1162331 -0.1575644 -0.2011956 -0.2466599 -0.2936509 -0.3381359 -0.3855988 -0.4335250 -0.4817964 -0.5303733 -0.5792354 -0.6202947 -0.6665679 -0.7125418 -0.7582712 -0.7953994 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.1767804 0.2616694 0.2976798 0.3235076 0.3411561 0.3522459 0.3590537 0.3625436 0.3633707 0.3619872 0.3589021 0.3544270 0.3485506 0.3415169 0.3334671 0.3244899 0.3182136 0.3095792 0.3001245 0.2899608 0.000000 0.1668113 0.2495931 0.2839249 0.3070497 0.3235468 0.3343036 0.3409137 0.3442244 0.3448585 0.3432040 0.3398848 0.3353926 0.3299418 0.3236184 0.3162645 0.3079614 0.3019936 0.2937896 0.2847372 0.2748711 0.000000 0.1565015 0.2303788 0.2587411 0.2741910 0.2839242 0.2886757 0.2887441 0.2856989 0.2807401 0.2745982 0.2672310 0.2585493 0.2484806 0.2369727 0.2240149 0.2117118 0.1969532 0.1805713 0.1649646 0.1455522 0.000000 0.1457295 0.2092440 0.2272121 0.2327692 0.2327217 0.2272656 0.2186249 0.2086809 0.1976050 0.1844933 0.1684176 0.1495624 0.1282903 0.1047089 7.9905108E-02 5.2348919E-02 2.3374915E-02 -7.5452854E-03 -4.0346898E-02 -7.6521419E-02 0.000000 0.1336194 0.1864172 0.1929111 0.1870065 0.1733879 0.1573249 0.1408387 0.1225806 0.1002566 7.3019460E-02 4.1796975E-02 7.7732634E-03 -2.9549018E-02 -6.9993667E-02 -0.1136285 -0.1589218 -0.2060127 -0.2577941 -0.3108417 -0.3721492 0.000000 0.1214593 0.1630402 0.1576769 0.1369038 0.1100803 8.4926009E-02 5.7652764E-02 2.4038883E-02 -1.6005607E-02 -6.0952947E-02 -0.1086771 -0.1614990 -0.2160691 -0.2750780 -0.3346109 -0.3994365 -0.4652855 -0.5397384 -0.6117866 -0.6927902 0.000000 0.1097181 0.1393860 0.1212392 8.4580161E-02 4.7411945E-02 9.9553503E-03 -3.5508208E-02 -8.8207237E-02 -0.1465782 -0.2076482 -0.2740408 -0.3445880 -0.4141892 -0.4902880 -0.5643399 -0.6474308 -0.7376944 -0.8204951 -0.9088563 -0.9933204 0.000000 9.7944528E-02 0.1158120 8.3589882E-02 3.3700027E-02 -1.4356997E-02 -7.0687436E-02 -0.1368531 -0.2067228 -0.2817778 -0.3607615 -0.4442687 -0.5258313 -0.6139957 -0.6990823 -0.7928282 -0.8908001 -0.9887592 -1.072105 -1.166771 -1.268517 0.000000 8.6564422E-02 9.3101412E-02 4.6743829E-02 -1.3479106E-02 -7.7742130E-02 -0.1552105 -0.2381878 -0.3257264 -0.4157481 -0.5089888 -0.6050766 -0.7045646 -0.7997150 -0.9024530 -1.005610 -1.106290 -1.192409 -1.289432 -1.390120 -1.493169 0.000000 7.5525910E-02 7.1590170E-02 1.2682351E-02 -5.8038682E-02 -0.1421553 -0.2369884 -0.3376457 -0.4394074 -0.5428516 -0.6476840 -0.7537107 -0.8633047 -0.9733030 -1.080126 -1.183823 -1.273476 -1.373322 -1.473823 -1.572453 -1.670958 0.000000 6.4412862E-02 5.1212855E-02 -1.7442215E-02 -0.1000629 -0.2019104 -0.3142801 -0.4286292 -0.5427664 -0.6570651 -0.7703844 -0.8870676 -1.002993 -1.112126 -1.215778 -1.317546 -1.419872 -1.519685 -1.615213 -1.708281 -1.801357 0.000000 5.4473955E-02 3.1905677E-02 -4.3661177E-02 -0.1398075 -0.2569262 -0.3817422 -0.5066340 -0.6309031 -0.7526202 -0.8738449 -1.002155 -1.115400 -1.221900 -1.324672 -1.428516 -1.528290 -1.620977 -1.710723 -1.799642 -1.887923 0.000000 4.5064926E-02 1.5042921E-02 -6.5172650E-02 -0.1722149 -0.2994364 -0.4356652 -0.5679520 -0.6978850 -0.8244802 -0.9566010 -1.074597 -1.184397 -1.288349 -1.395216 -1.496719 -1.587622 -1.675230 -1.762595 -1.848004 -1.931008 0.000000 3.6473852E-02 1.2467633E-03 -8.2592092E-02 -0.1980602 -0.3300840 -0.4668441 -0.6082886 -0.7396734 -0.8681405 -0.9989983 -1.114355 -1.221181 -1.328810 -1.443089 -1.533287 -1.622024 -1.711850 -1.798546 -1.880383 -1.959863 0.000000 2.8695034E-02 -9.8330816E-03 -9.5415525E-02 -0.2112396 -0.3456286 -0.4814285 -0.6165949 -0.7530314 -0.8793173 -1.006919 -1.118905 -1.227393 -1.341402 -1.433184 -1.525543 -1.614100 -1.712937 -1.794800 -1.875689 -1.948473 0.000000 2.1580810E-02 -1.7679768E-02 -0.1012240 -0.2132956 -0.3387755 -0.4719221 -0.6011839 -0.7331680 -0.8541639 -0.9767430 -1.085163 -1.201393 -1.296355 -1.389734 -1.490057 -1.576073 -1.657397 -1.751124 -1.823977 -1.889886 0.000000 1.5246911E-02 -2.1573182E-02 -9.9428348E-02 -0.2003634 -0.3152394 -0.4370295 -0.5542225 -0.6761804 -0.7881263 -0.9029012 -1.007843 -1.113914 -1.206642 -1.305350 -1.390470 -1.486007 -1.560606 -1.648175 -1.713954 -1.784488 0.000000 9.9974396E-03 -2.2538181E-02 -8.7890886E-02 -0.1730745 -0.2699705 -0.3689505 -0.4729078 -0.5784160 -0.6765373 -0.7782040 -0.8795800 -0.9669331 -1.061805 -1.144004 -1.235873 -1.310134 -1.391216 -1.457509 -1.534640 -1.616023 0.000000 5.6227478E-03 -1.9330164E-02 -6.8428621E-02 -0.1316920 -0.2010992 -0.2763742 -0.3547284 -0.4352891 -0.5122326 -0.5917281 -0.6718935 -0.7451784 -0.8227321 -0.9000547 -0.9776447 -1.039539 -1.110021 -1.169861 -1.238494 -1.304284 0.000000 2.2330568E-03 -1.1979319E-02 -3.8733356E-02 -7.2680853E-02 -0.1110582 -0.1524839 -0.1962022 -0.2417402 -0.2887957 -0.3332204 -0.3807034 -0.4286486 -0.4769389 -0.5255373 -0.5744255 -0.6153536 -0.6616276 -0.7076069 -0.7533460 -0.7903706 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.1226583 0.2097523 0.2560109 0.2702702 0.2715363 0.2668264 0.2588007 0.2480146 0.2355039 0.2214551 0.2063547 0.1907421 0.1762297 0.1605771 0.1445145 0.1294976 0.1136819 9.8585591E-02 8.3250687E-02 6.6802919E-02 0.000000 0.1284315 0.2207180 0.2620964 0.2749829 0.2787139 0.2764265 0.2710879 0.2633333 0.2534352 0.2420380 0.2293797 0.2161531 0.2025780 0.1887289 0.1765708 0.1632054 0.1508258 0.1374207 0.1237807 0.1092938 0.000000 0.1338259 0.2256054 0.2541278 0.2623132 0.2608391 0.2551338 0.2460867 0.2339239 0.2198397 0.2049662 0.1896187 0.1737029 0.1571306 0.1412652 0.1240000 0.1054143 8.6804785E-02 6.6661537E-02 4.6630654E-02 2.5046557E-02 0.000000 0.1400853 0.2149547 0.2362515 0.2347915 0.2259579 0.2129213 0.1961062 0.1776684 0.1585992 0.1385762 0.1168104 9.2868984E-02 6.7694433E-02 4.0292401E-02 1.1069519E-02 -1.9920796E-02 -5.2901734E-02 -8.6709678E-02 -0.1215381 -0.1613273 0.000000 0.1357641 0.2002442 0.2103763 0.1989928 0.1800970 0.1570932 0.1330462 0.1083121 8.0780976E-02 4.9550507E-02 1.4319276E-02 -2.3811540E-02 -6.4509347E-02 -0.1081130 -0.1528980 -0.2014912 -0.2499011 -0.3004574 -0.3566781 -0.4151244 0.000000 0.1255395 0.1813625 0.1804783 0.1577984 0.1270814 9.5375866E-02 6.3106135E-02 2.6289130E-02 -1.6452817E-02 -6.4217515E-02 -0.1163711 -0.1700172 -0.2281460 -0.2860109 -0.3497993 -0.4127990 -0.4787792 -0.5523840 -0.6240960 -0.7042411 0.000000 0.1140485 0.1608736 0.1484875 0.1131489 7.1874954E-02 2.9993843E-02 -1.6772868E-02 -7.0794351E-02 -0.1308554 -0.1960644 -0.2622904 -0.3335117 -0.4039069 -0.4813388 -0.5577088 -0.6402432 -0.7294015 -0.8124495 -0.9009165 -0.9860349 0.000000 0.1042867 0.1394579 0.1151614 6.7507073E-02 1.5852928E-02 -4.1485049E-02 -0.1067213 -0.1774158 -0.2538830 -0.3338760 -0.4179152 -0.5002304 -0.5890882 -0.6820348 -0.7709947 -0.8686620 -0.9673049 -1.052687 -1.148748 -1.251922 0.000000 9.3304448E-02 0.1178223 8.1565164E-02 2.3008155E-02 -4.2710539E-02 -0.1184470 -0.2000183 -0.2880378 -0.3787411 -0.4723770 -0.5690885 -0.6694648 -0.7662008 -0.8702766 -0.9747335 -1.077055 -1.165961 -1.265177 -1.367982 -1.473109 0.000000 8.2518183E-02 9.6981779E-02 4.9077477E-02 -2.0148383E-02 -0.1023567 -0.1953830 -0.2943113 -0.3963232 -0.4998811 -0.6054741 -0.7128412 -0.8239372 -0.9356147 -1.044309 -1.150231 -1.242862 -1.345283 -1.448024 -1.548725 -1.648778 0.000000 7.2527461E-02 7.6875046E-02 1.8532563E-02 -6.2530287E-02 -0.1609934 -0.2702154 -0.3832439 -0.4971324 -0.6118609 -0.7266040 -0.8450710 -0.9630133 -1.074376 -1.180552 -1.284958 -1.389690 -1.491718 -1.589233 -1.683940 -1.778233 0.000000 6.2340524E-02 5.7473447E-02 -8.9030657E-03 -0.1029632 -0.2155564 -0.3379405 -0.4614273 -0.5854463 -0.7083551 -0.8314766 -0.9618032 -1.077396 -1.186414 -1.291825 -1.397893 -1.499665 -1.594222 -1.685454 -1.775664 -1.865090 0.000000 5.2718971E-02 3.9337281E-02 -3.3172857E-02 -0.1369242 -0.2600484 -0.3944706 -0.5250674 -0.6552863 -0.7835907 -0.9177827 -1.038024 -1.150088 -1.256457 -1.365254 -1.468411 -1.561032 -1.650104 -1.738554 -1.825057 -1.908993 0.000000 4.3620944E-02 2.3433337E-02 -5.3683091E-02 -0.1651736 -0.2942992 -0.4297923 -0.5696961 -0.7021275 -0.8323965 -0.9651718 -1.082402 -1.191218 -1.300528 -1.416149 -1.507775 -1.597687 -1.688394 -1.775860 -1.858196 -1.938171 0.000000 3.5095572E-02 9.8650940E-03 -6.9753602E-02 -0.1822067 -0.3147140 -0.4493666 -0.5836822 -0.7216204 -0.8493727 -0.9785078 -1.091895 -1.201753 -1.316865 -1.409732 -1.502946 -1.592224 -1.691672 -1.773785 -1.854897 -1.928418 0.000000 2.7152624E-02 -8.0732780E-04 -7.9212554E-02 -0.1889956 -0.3133966 -0.4460361 -0.5749446 -0.7082274 -0.8301779 -0.9538043 -1.063162 -1.180198 -1.275849 -1.369800 -1.470725 -1.557194 -1.638402 -1.732220 -1.805875 -1.872634 0.000000 1.9833513E-02 -7.9068318E-03 -8.1667483E-02 -0.1812572 -0.2955412 -0.4131258 -0.5345987 -0.6573603 -0.7698576 -0.8852686 -0.9906554 -1.097196 -1.190264 -1.289330 -1.374919 -1.470156 -1.544330 -1.632696 -1.699324 -1.770034 0.000000 1.3496283E-02 -1.2032096E-02 -7.4569046E-02 -0.1592284 -0.2560441 -0.3550883 -0.4593488 -0.5653393 -0.6636928 -0.7656773 -0.8673389 -0.9547996 -1.049865 -1.132282 -1.224129 -1.297004 -1.378907 -1.446089 -1.523510 -1.604875 0.000000 8.0296183E-03 -1.2314836E-02 -5.9769440E-02 -0.1228588 -0.1922832 -0.2677656 -0.3463610 -0.4271912 -0.5042383 -0.5838742 -0.6641694 -0.7374761 -0.8151376 -0.8927792 -0.9686327 -1.030606 -1.102553 -1.162461 -1.231193 -1.296966 0.000000 3.4477920E-03 -8.4578730E-03 -3.4509327E-02 -6.8432383E-02 -0.1069386 -0.1485344 -0.1924063 -0.2380829 -0.2852540 -0.3296970 -0.3772430 -0.4252404 -0.4735752 -0.5222135 -0.5653878 -0.6120024 -0.6582896 -0.7042819 -0.7500516 -0.7869434 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 7.0348427E-02 0.1249578 0.1486835 0.1512824 0.1443399 0.1307514 0.1105591 8.7026753E-02 6.2078375E-02 3.6810968E-02 1.0587991E-02 -1.5147395E-02 -4.0422704E-02 -6.6056982E-02 -9.1387652E-02 -0.1166946 -0.1419072 -0.1671092 -0.1918716 -0.2188585 0.000000 7.0938557E-02 0.1300827 0.1625870 0.1761624 0.1749347 0.1660791 0.1514119 0.1337827 0.1145152 9.4374634E-02 7.4418277E-02 5.4153621E-02 3.4309611E-02 1.4604725E-02 -5.2641300E-03 -2.4575397E-02 -4.4105094E-02 -6.3679524E-02 -8.2895815E-02 -0.1039100 0.000000 7.0260718E-02 0.1374671 0.1818891 0.1899589 0.1850393 0.1740620 0.1573133 0.1377793 0.1169290 9.5416866E-02 7.3741578E-02 5.2566845E-02 3.0598763E-02 8.2814405E-03 -1.4272450E-02 -3.7936982E-02 -6.2215194E-02 -8.7171338E-02 -0.1135879 -0.1420416 0.000000 7.1653180E-02 0.1495697 0.1899296 0.1863786 0.1742032 0.1556978 0.1335127 0.1101204 8.5040584E-02 5.8937430E-02 3.2037478E-02 3.0577565E-03 -2.7013395E-02 -5.9134603E-02 -9.2744477E-02 -0.1274335 -0.1632230 -0.2022491 -0.2407849 -0.2828109 0.000000 7.3667504E-02 0.1635030 0.1823005 0.1693098 0.1471192 0.1213850 9.2321031E-02 6.2325273E-02 2.9308846E-02 -6.6331625E-03 -4.5376062E-02 -8.6957574E-02 -0.1300739 -0.1771499 -0.2243982 -0.2733741 -0.3270984 -0.3807989 -0.4361163 -0.5004119 0.000000 7.7207766E-02 0.1680658 0.1664770 0.1434176 0.1100776 7.5481251E-02 3.8790312E-02 -2.8980826E-03 -4.9067322E-02 -9.8861076E-02 -0.1526650 -0.2079386 -0.2678466 -0.3279935 -0.3930739 -0.4586672 -0.5299011 -0.6001201 -0.6783379 -0.7562338 0.000000 8.2166240E-02 0.1556232 0.1452301 0.1095673 6.6079602E-02 2.2368690E-02 -2.7855653E-02 -8.4225275E-02 -0.1456871 -0.2118591 -0.2793911 -0.3513539 -0.4268689 -0.5022867 -0.5854903 -0.6649440 -0.7532554 -0.8382422 -0.9296109 -1.026972 0.000000 8.7751955E-02 0.1406465 0.1205094 7.2292596E-02 1.9055037E-02 -3.8932994E-02 -0.1054234 -0.1773653 -0.2542504 -0.3351568 -0.4199216 -0.5029154 -0.5939030 -0.6891978 -0.7789671 -0.8766761 -0.9786038 -1.070291 -1.166895 -1.269811 0.000000 8.8686146E-02 0.1237196 9.3531869E-02 3.3453263E-02 -3.1637423E-02 -0.1063318 -0.1900894 -0.2768804 -0.3685758 -0.4632003 -0.5606094 -0.6614397 -0.7670761 -0.8659133 -0.9713554 -1.077443 -1.182865 -1.273390 -1.375122 -1.481126 0.000000 7.9156838E-02 0.1059645 6.4400643E-02 -5.4316181E-03 -8.5197918E-02 -0.1753972 -0.2748799 -0.3780653 -0.4828772 -0.5894026 -0.6975560 -0.8092866 -0.9222701 -1.032841 -1.141185 -1.249411 -1.343790 -1.447242 -1.549934 -1.652409 0.000000 6.9840379E-02 8.8141941E-02 3.6300879E-02 -4.3255311E-02 -0.1373401 -0.2448650 -0.3594727 -0.4749696 -0.5909250 -0.7065692 -0.8257588 -0.9447027 -1.058085 -1.166929 -1.274349 -1.381649 -1.485877 -1.585781 -1.682939 -1.779425 0.000000 6.0537361E-02 7.0481390E-02 9.7214309E-03 -8.0196835E-02 -0.1880551 -0.3102006 -0.4362037 -0.5617656 -0.6856931 -0.8096911 -0.9409009 -1.058185 -1.169722 -1.278093 -1.386638 -1.490462 -1.587386 -1.681069 -1.773072 -1.863704 0.000000 5.1832411E-02 5.3425111E-02 -1.3931816E-02 -0.1123189 -0.2314289 -0.3669167 -0.5002964 -0.6317943 -0.7609773 -0.8961698 -1.017995 -1.131986 -1.241003 -1.352012 -1.457081 -1.551853 -1.643159 -1.733180 -1.820351 -1.905036 0.000000 4.3066740E-02 3.7223097E-02 -3.4429599E-02 -0.1399602 -0.2668450 -0.4043846 -0.5466973 -0.6802192 -0.8114536 -0.9454808 -1.064288 -1.175065 -1.286313 -1.403425 -1.496935 -1.588651 -1.680502 -1.768349 -1.851311 -1.932348 0.000000 3.4981597E-02 2.2899354E-02 -5.0960310E-02 -0.1584635 -0.2901847 -0.4270524 -0.5635155 -0.7022632 -0.8310903 -0.9614384 -1.076223 -1.187574 -1.303976 -1.398303 -1.492842 -1.583193 -1.682704 -1.765048 -1.847125 -1.921924 0.000000 2.7776212E-02 1.0748712E-02 -6.2056672E-02 -0.1682035 -0.2929759 -0.4276619 -0.5581628 -0.6921898 -0.8150727 -0.9396902 -1.050160 -1.168121 -1.264789 -1.359632 -1.461620 -1.548091 -1.628825 -1.723692 -1.798609 -1.866263 0.000000 2.0736851E-02 2.0121876E-03 -6.7136303E-02 -0.1645696 -0.2795183 -0.3987330 -0.5213814 -0.6448447 -0.7580519 -0.8741849 -0.9802493 -1.087434 -1.181095 -1.280890 -1.366920 -1.460501 -1.535694 -1.625723 -1.692964 -1.764106 0.000000 1.4377697E-02 -4.0754015E-03 -6.3216008E-02 -0.1471146 -0.2447429 -0.3448925 -0.4499295 -0.5564508 -0.6552315 -0.7576630 -0.8597582 -0.9475569 -1.043018 -1.126130 -1.215237 -1.288403 -1.373058 -1.440663 -1.518303 -1.599910 0.000000 8.6715138E-03 -6.8282816E-03 -5.2203853E-02 -0.1139477 -0.1851162 -0.2612825 -0.3403662 -0.4215450 -0.4988398 -0.5787343 -0.6592821 -0.7328023 -0.8106820 -0.8885219 -0.9549565 -1.026632 -1.098728 -1.158752 -1.227582 -1.293548 0.000000 3.8279262E-03 -5.6238333E-03 -3.0794196E-02 -6.4761862E-02 -0.1036023 -0.1455330 -0.1896582 -0.2355296 -0.2828664 -0.3274122 -0.3750771 -0.4231803 -0.4716030 -0.5203191 -0.5635264 -0.6101949 -0.6565315 -0.7025702 -0.7483720 -0.7853004 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 3.7604779E-02 5.0468683E-02 4.1083258E-02 1.4879364E-02 -1.8491033E-02 -5.5954430E-02 -9.4802178E-02 -0.1346440 -0.1751110 -0.2139900 -0.2526278 -0.2912136 -0.3296310 -0.3677045 -0.4052781 -0.4426063 -0.4796995 -0.5166538 -0.5531750 -0.5928558 0.000000 3.7282377E-02 5.5907708E-02 5.5050652E-02 4.0103868E-02 1.9256635E-02 -5.2397195E-03 -3.2785010E-02 -6.1488107E-02 -9.0336800E-02 -0.1188014 -0.1472839 -0.1757010 -0.2037351 -0.2313285 -0.2591106 -0.2867373 -0.3141888 -0.3415910 -0.3685556 -0.3982334 0.000000 3.5880018E-02 5.9140012E-02 6.8589471E-02 6.4922713E-02 5.3011309E-02 3.1220360E-02 6.1129979E-03 -2.0073187E-02 -4.6525571E-02 -7.3602468E-02 -0.1006434 -0.1283042 -0.1563384 -0.1861232 -0.2149454 -0.2446156 -0.2746515 -0.3048704 -0.3351127 -0.3685607 0.000000 3.3749543E-02 6.3202903E-02 8.5162602E-02 8.9268520E-02 7.1030684E-02 4.7372755E-02 1.9632157E-02 -1.0833985E-02 -4.1400079E-02 -7.2506130E-02 -0.1053001 -0.1392528 -0.1738802 -0.2092669 -0.2485003 -0.2868091 -0.3255881 -0.3658232 -0.4067884 -0.4517672 0.000000 3.1901378E-02 6.9685787E-02 0.1054871 9.7422764E-02 7.2517581E-02 4.1398108E-02 5.4941885E-03 -3.1238640E-02 -6.9296524E-02 -0.1088532 -0.1519518 -0.1958064 -0.2411680 -0.2912075 -0.3402791 -0.3902947 -0.4472072 -0.5028931 -0.5601889 -0.6281254 0.000000 3.0890111E-02 7.9391986E-02 0.1173826 9.3368717E-02 5.7333034E-02 1.5902612E-02 -2.8134655E-02 -7.3489316E-02 -0.1228127 -0.1741480 -0.2299474 -0.2863496 -0.3485643 -0.4099877 -0.4731579 -0.5444037 -0.6146178 -0.6916385 -0.7658463 -0.8509881 0.000000 3.1130223E-02 9.2462040E-02 0.1129662 7.7439338E-02 3.0233443E-02 -2.1873076E-02 -7.5260274E-02 -0.1332635 -0.1965637 -0.2608935 -0.3314256 -0.4030684 -0.4804412 -0.5570539 -0.6414828 -0.7305279 -0.8131649 -0.9067966 -0.9936191 -1.089339 0.000000 3.2114025E-02 0.1078435 0.1004867 5.4125629E-02 -5.5280398E-03 -6.7610562E-02 -0.1341437 -0.2069547 -0.2828690 -0.3636032 -0.4498373 -0.5406344 -0.6292170 -0.7252641 -0.8242615 -0.9168047 -1.018571 -1.122113 -1.211872 -1.314245 0.000000 3.4119695E-02 0.1112837 8.3788134E-02 2.5103236E-02 -4.5367308E-02 -0.1203198 -0.2019258 -0.2907737 -0.3803097 -0.4768431 -0.5773296 -0.6811181 -0.7886389 -0.8895503 -0.9965202 -1.104045 -1.211001 -1.304121 -1.407176 -1.514399 0.000000 3.6997546E-02 9.9282101E-02 6.4134292E-02 -6.6901240E-03 -8.8434435E-02 -0.1778625 -0.2754975 -0.3762549 -0.4833069 -0.5932304 -0.7051176 -0.8198772 -0.9350671 -1.047767 -1.158061 -1.268178 -1.365060 -1.470016 -1.574368 -1.679291 0.000000 4.1996874E-02 8.5912280E-02 4.1909501E-02 -3.9049875E-02 -0.1317749 -0.2347694 -0.3474230 -0.4650660 -0.5844152 -0.7041864 -0.8270392 -0.9490731 -1.065237 -1.176503 -1.286284 -1.395658 -1.501448 -1.603392 -1.703436 -1.802677 0.000000 4.8929930E-02 7.1592219E-02 1.9311929E-02 -7.0697069E-02 -0.1751330 -0.2921411 -0.4188726 -0.5475317 -0.6755301 -0.8035774 -0.9382277 -1.059088 -1.173434 -1.284098 -1.394865 -1.500244 -1.599296 -1.696470 -1.790934 -1.882666 0.000000 4.5231704E-02 5.6282263E-02 -1.8449152E-03 -9.9050671E-02 -0.2132777 -0.3452199 -0.4809818 -0.6161186 -0.7493703 -0.8883318 -1.013976 -1.131262 -1.242724 -1.355604 -1.462604 -1.558927 -1.654462 -1.746992 -1.833842 -1.918844 0.000000 3.7611537E-02 4.2478029E-02 -2.1261552E-02 -0.1240995 -0.2459983 -0.3829724 -0.5276489 -0.6650540 -0.8001264 -0.9377424 -1.059868 -1.173271 -1.286407 -1.404832 -1.500176 -1.596832 -1.691330 -1.776741 -1.860266 -1.942125 0.000000 3.0486323E-02 2.9558357E-02 -3.7756566E-02 -0.1417697 -0.2695926 -0.4073912 -0.5467303 -0.6888722 -0.8211278 -0.9544103 -1.071812 -1.185030 -1.302684 -1.398569 -1.494228 -1.601143 -1.686363 -1.770354 -1.852982 -1.928216 0.000000 2.3842081E-02 1.7607916E-02 -4.9228124E-02 -0.1520360 -0.2752387 -0.4112777 -0.5445441 -0.6813290 -0.8069044 -0.9336576 -1.045940 -1.165017 -1.262931 -1.358872 -1.461104 -1.549223 -1.632113 -1.726918 -1.801808 -1.869906 0.000000 1.7600240E-02 8.1375185E-03 -5.5782653E-02 -0.1506724 -0.2653819 -0.3861576 -0.5110331 -0.6366301 -0.7516896 -0.8692260 -0.9764643 -1.084438 -1.178957 -1.279197 -1.366020 -1.462390 -1.537683 -1.626770 -1.694426 -1.766073 0.000000 1.2065230E-02 1.1931078E-03 -5.3950693E-02 -0.1366229 -0.2348439 -0.3363113 -0.4429203 -0.5508230 -0.6506742 -0.7539150 -0.8566131 -0.9450262 -1.040887 -1.124127 -1.216786 -1.290488 -1.372915 -1.440815 -1.518800 -1.600725 0.000000 7.2764913E-03 -2.9932400E-03 -4.5703031E-02 -0.1071261 -0.1789456 -0.2560399 -0.3360570 -0.4179928 -0.4958346 -0.5761735 -0.6570733 -0.7309474 -0.8090978 -0.8871957 -0.9634982 -1.025908 -1.098241 -1.158555 -1.227613 -1.293836 0.000000 3.2142813E-03 -3.5696756E-03 -2.7495274E-02 -6.1532937E-02 -0.1008284 -0.1432452 -0.1877924 -0.2339945 -0.2815847 -0.3263211 -0.3741439 -0.4223863 -0.4709385 -0.5197733 -0.5631043 -0.6098814 -0.6563189 -0.7024528 -0.7483569 -0.7853751 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -1.7773578E-02 -4.2787880E-02 -9.2771396E-02 -0.1590144 -0.2264502 -0.2940265 -0.3630035 -0.4273473 -0.4894962 -0.5494866 -0.6129414 -0.6705576 -0.7266210 -0.7812759 -0.8344699 -0.8864992 -0.9375792 -0.9878947 -1.037547 -1.090686 0.000000 -8.3374111E-03 -2.6686605E-02 -6.9817089E-02 -0.1181670 -0.1706736 -0.2233335 -0.2747791 -0.3264485 -0.3733646 -0.4185090 -0.4618341 -0.5033808 -0.5433276 -0.5820161 -0.6262131 -0.6657792 -0.7043883 -0.7422462 -0.7795333 -0.8200367 0.000000 -5.7623318E-05 -2.0557936E-02 -5.0673481E-02 -8.9432441E-02 -0.1320522 -0.1716567 -0.2109832 -0.2518694 -0.2898787 -0.3270390 -0.3636378 -0.3998190 -0.4362146 -0.4719425 -0.5118159 -0.5483698 -0.5846636 -0.6204059 -0.6566011 -0.6963300 0.000000 1.7682525E-03 -1.4637590E-02 -3.6115747E-02 -6.4891517E-02 -9.2222102E-02 -0.1244550 -0.1599376 -0.1987784 -0.2375303 -0.2766324 -0.3163061 -0.3602765 -0.4009590 -0.4409765 -0.4818510 -0.5231662 -0.5648606 -0.6137754 -0.6589217 -0.7077858 0.000000 1.1179522E-03 -1.0079582E-02 -2.1940580E-02 -3.4181647E-02 -5.8706935E-02 -9.4245665E-02 -0.1347626 -0.1799929 -0.2251902 -0.2720845 -0.3215315 -0.3687904 -0.4169115 -0.4700962 -0.5213844 -0.5739504 -0.6344544 -0.6916348 -0.7499336 -0.8212801 0.000000 1.0291044E-04 -6.2669814E-03 -2.3272652E-03 -6.0828710E-03 -4.2491302E-02 -8.7095045E-02 -0.1384315 -0.1909256 -0.2476197 -0.3021455 -0.3585378 -0.4193205 -0.4793067 -0.5459422 -0.6116978 -0.6858892 -0.7570663 -0.8306295 -0.9121947 -0.9932153 0.000000 -7.4890925E-04 -1.2854047E-03 2.3070326E-02 4.3487884E-03 -4.3071605E-02 -0.1007182 -0.1609564 -0.2253369 -0.2885514 -0.3570884 -0.4261667 -0.5009657 -0.5761703 -0.6587465 -0.7464422 -0.8309689 -0.9254203 -1.011189 -1.109015 -1.202509 0.000000 -1.2881234E-03 7.0646051E-03 4.7191832E-02 2.8381736E-03 -5.7227794E-02 -0.1269402 -0.1994792 -0.2717768 -0.3495411 -0.4328124 -0.5157375 -0.6065778 -0.7032508 -0.7959220 -0.8980172 -1.003378 -1.097478 -1.202128 -1.309993 -1.405326 0.000000 -1.1934770E-03 1.8992407E-02 4.5752116E-02 -7.8630801E-03 -8.2534373E-02 -0.1620506 -0.2455502 -0.3319533 -0.4251268 -0.5231700 -0.6226417 -0.7286882 -0.8367847 -0.9480737 -1.061774 -1.162537 -1.272141 -1.382988 -1.477785 -1.584554 0.000000 -1.2495808E-03 3.4561507E-02 4.0321011E-02 -2.5622707E-02 -0.1125508 -0.2043105 -0.2999760 -0.4017852 -0.5054681 -0.6235650 -0.7419525 -0.8534514 -0.9711930 -1.088590 -1.201866 -1.313022 -1.426450 -1.524051 -1.630745 -1.738742 0.000000 -5.6064833E-04 5.3059530E-02 2.9646162E-02 -4.8463043E-02 -0.1465200 -0.2501819 -0.3558716 -0.4726016 -0.5931728 -0.7241088 -0.8506292 -0.9756485 -1.097902 -1.216052 -1.319176 -1.432272 -1.541947 -1.648847 -1.754137 -1.857076 0.000000 1.1600278E-03 5.7431623E-02 1.5590386E-02 -7.3627815E-02 -0.1790484 -0.2923717 -0.4159531 -0.5458873 -0.6765360 -0.8152322 -0.9454433 -1.071160 -1.190722 -1.306127 -1.421591 -1.531378 -1.637118 -1.742054 -1.840579 -1.935509 0.000000 4.1839643E-03 4.7113266E-02 4.5142145E-04 -9.6824132E-02 -0.2119009 -0.3357248 -0.4719029 -0.6096392 -0.7463604 -0.8884246 -1.018644 -1.141139 -1.257383 -1.374482 -1.485388 -1.585209 -1.699808 -1.794954 -1.885047 -1.972612 0.000000 8.6111948E-03 3.7042379E-02 -1.4989797E-02 -0.1173217 -0.2362917 -0.3696013 -0.5160940 -0.6568025 -0.7955564 -0.9370764 -1.063772 -1.181704 -1.298893 -1.420464 -1.518950 -1.618012 -1.714250 -1.801736 -1.886622 -1.969562 0.000000 1.4930163E-02 2.7030900E-02 -2.9759875E-02 -0.1325835 -0.2558218 -0.3933582 -0.5354120 -0.6810071 -0.8169517 -0.9540473 -1.075431 -1.192214 -1.312812 -1.411429 -1.509360 -1.617342 -1.704219 -1.789570 -1.872868 -1.949191 0.000000 1.5433083E-02 1.7425295E-02 -4.0685736E-02 -0.1416505 -0.2612734 -0.3987418 -0.5350722 -0.6749690 -0.8039293 -0.9338274 -1.049117 -1.170696 -1.270957 -1.368819 -1.472171 -1.561350 -1.645601 -1.740625 -1.816411 -1.885623 0.000000 1.1159739E-02 9.2081018E-03 -4.7371559E-02 -0.1402770 -0.2534538 -0.3763021 -0.5038933 -0.6321424 -0.7498223 -0.8696651 -0.9789878 -1.088716 -1.184794 -1.286024 -1.373680 -1.470788 -1.546981 -1.636183 -1.704729 -1.776851 0.000000 7.2357282E-03 2.7368329E-03 -4.6748087E-02 -0.1278297 -0.2263492 -0.3296103 -0.4383089 -0.5480947 -0.6496449 -0.7543586 -0.8582938 -0.9479212 -1.044494 -1.128429 -1.221513 -1.295959 -1.378603 -1.447081 -1.525291 -1.607150 0.000000 4.1255071E-03 -1.6185350E-03 -4.0277023E-02 -0.1009911 -0.1736015 -0.2520043 -0.3333222 -0.4163726 -0.4951559 -0.5763610 -0.6579463 -0.7324511 -0.8110302 -0.8894435 -0.9661055 -1.028928 -1.101361 -1.161981 -1.231163 -1.297507 0.000000 1.6103778E-03 -2.6531927E-03 -2.4541970E-02 -5.8581799E-02 -9.8487861E-02 -0.1416056 -0.1867612 -0.2334559 -0.2814442 -0.3265329 -0.3746383 -0.4231077 -0.4718457 -0.5208307 -0.5643470 -0.6112424 -0.6577719 -0.7039750 -0.7499570 -0.7871709 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.1245564 -0.2317018 -0.3403140 -0.4504022 -0.5536735 -0.6602917 -0.7599383 -0.8549736 -0.9538642 -1.042100 -1.126547 -1.207124 -1.296675 -1.375724 -1.451990 -1.526201 -1.598678 -1.669618 -1.738934 -1.826674 0.000000 -0.1077383 -0.2011959 -0.2865966 -0.3663790 -0.4542769 -0.5384849 -0.6263422 -0.7045618 -0.7776803 -0.8537216 -0.9195198 -0.9814188 -1.040125 -1.096343 -1.162206 -1.218377 -1.272662 -1.325493 -1.376964 -1.431434 0.000000 -9.6355364E-02 -0.1744715 -0.2361336 -0.3111539 -0.3904842 -0.4630508 -0.5357548 -0.5972109 -0.6534900 -0.7062260 -0.7624803 -0.8123416 -0.8610048 -0.9080074 -0.9537664 -1.009547 -1.057456 -1.103893 -1.149117 -1.197269 0.000000 -8.8226102E-02 -0.1477386 -0.2024632 -0.2732078 -0.3400699 -0.3951346 -0.4493740 -0.4993090 -0.5479475 -0.5957679 -0.6496224 -0.6992062 -0.7476875 -0.7958231 -0.8510846 -0.8999448 -0.9487371 -0.9970194 -1.044847 -1.106572 0.000000 -7.9138868E-02 -0.1225778 -0.1801747 -0.2384620 -0.2853945 -0.3259583 -0.3771891 -0.4270652 -0.4788502 -0.5376510 -0.5923839 -0.6454075 -0.7049749 -0.7587780 -0.8135381 -0.8770460 -0.9348847 -0.9931318 -1.052597 -1.127152 0.000000 -7.0816725E-02 -0.1029567 -0.1599258 -0.1982992 -0.2292981 -0.2759538 -0.3316058 -0.3900345 -0.4554571 -0.5166978 -0.5764234 -0.6415563 -0.7043557 -0.7744979 -0.8406341 -0.9171380 -0.9885809 -1.061679 -1.146665 -1.226742 0.000000 -6.1833858E-02 -9.5891185E-02 -0.1371022 -0.1538175 -0.1923007 -0.2478425 -0.3147078 -0.3870901 -0.4561978 -0.5237195 -0.5965960 -0.6748938 -0.7501029 -0.8341106 -0.9157265 -1.008130 -1.093847 -1.190136 -1.276927 -1.379018 0.000000 -5.2752666E-02 -8.9131780E-02 -0.1098588 -0.1141010 -0.1715217 -0.2425992 -0.3193895 -0.4001000 -0.4763502 -0.5577361 -0.6452627 -0.7388297 -0.8280406 -0.9271138 -1.032540 -1.128656 -1.235069 -1.330726 -1.440271 -1.558878 0.000000 -4.3195620E-02 -8.0908716E-02 -7.9012245E-02 -9.8065630E-02 -0.1656602 -0.2513051 -0.3409380 -0.4264046 -0.5165950 -0.6135156 -0.7167016 -0.8252939 -0.9293382 -1.040547 -1.152402 -1.267815 -1.371860 -1.488904 -1.610260 -1.732888 0.000000 -3.3262983E-02 -7.1427912E-02 -4.6270724E-02 -8.9720801E-02 -0.1742310 -0.2697136 -0.3680271 -0.4666519 -0.5728087 -0.6850265 -0.8022355 -0.9227948 -1.044891 -1.155745 -1.273909 -1.393627 -1.515522 -1.637205 -1.753220 -1.863728 0.000000 -3.1877790E-02 -5.9066527E-02 -2.0248875E-02 -9.0479448E-02 -0.1886176 -0.2959551 -0.4036516 -0.5173574 -0.6388479 -0.7635934 -0.8918588 -1.019104 -1.144977 -1.268213 -1.389913 -1.513124 -1.633890 -1.748565 -1.839362 -1.941373 0.000000 -3.0136148E-02 -4.4672750E-02 -2.0738903E-02 -9.8004274E-02 -0.2063780 -0.3220641 -0.4398938 -0.5681429 -0.7003219 -0.8409265 -0.9742492 -1.104043 -1.229316 -1.350857 -1.475297 -1.596058 -1.705738 -1.810034 -1.910766 -2.011420 0.000000 -2.7948935E-02 -2.7112626E-02 -2.2569356E-02 -0.1105232 -0.2267371 -0.3489671 -0.4806392 -0.6200238 -0.7602465 -0.9052904 -1.039984 -1.168230 -1.290843 -1.413399 -1.545134 -1.651150 -1.753355 -1.852148 -1.951627 -2.049319 0.000000 -2.5063420E-02 -5.8479370E-03 -2.6843714E-02 -0.1217390 -0.2426626 -0.3739291 -0.5163360 -0.6605585 -0.8035325 -0.9490882 -1.081319 -1.205212 -1.327719 -1.453941 -1.557990 -1.661169 -1.759450 -1.853610 -1.961270 -2.046629 0.000000 -2.1435179E-02 9.1270441E-03 -3.3182982E-02 -0.1304667 -0.2540067 -0.3873353 -0.5322061 -0.6815177 -0.8221189 -0.9638976 -1.090585 -1.212356 -1.337098 -1.440838 -1.542607 -1.651862 -1.745775 -1.836573 -1.917139 -2.016767 0.000000 -1.6956387E-02 3.3475782E-03 -3.9080191E-02 -0.1360488 -0.2540110 -0.3909148 -0.5306642 -0.6747582 -0.8080730 -0.9423817 -1.062098 -1.187053 -1.291795 -1.393243 -1.497926 -1.588750 -1.694563 -1.774227 -1.852798 -1.946771 0.000000 -1.1073481E-02 -8.3540572E-04 -4.2878818E-02 -0.1331090 -0.2439739 -0.3691774 -0.5003162 -0.6321558 -0.7535912 -0.8768125 -0.9891886 -1.101882 -1.201923 -1.304051 -1.392278 -1.495279 -1.573814 -1.663943 -1.736908 -1.823213 0.000000 -3.5635824E-03 -3.3672936E-03 -4.1885264E-02 -0.1207027 -0.2187179 -0.3244200 -0.4360889 -0.5486121 -0.6527899 -0.7597578 -0.8655853 -0.9593423 -1.056271 -1.140454 -1.234581 -1.324920 -1.394336 -1.481020 -1.546229 -1.624598 0.000000 -2.6051505E-03 -4.8490744E-03 -3.5817664E-02 -9.5021792E-02 -0.1685222 -0.2487899 -0.3320946 -0.4169033 -0.4972128 -0.5797418 -0.6624092 -0.7453602 -0.8174106 -0.8962955 -0.9754052 -1.039000 -1.110581 -1.183441 -1.241376 -1.308005 0.000000 -1.6554708E-03 -3.8753427E-03 -2.1955669E-02 -5.5541079E-02 -9.6286766E-02 -0.1404688 -0.1865673 -0.2340236 -0.2826226 -0.3282791 -0.3768339 -0.4256932 -0.4747685 -0.5240487 -0.5735328 -0.6151130 -0.6618861 -0.7083077 -0.7544500 -0.7919781 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.3842777 -0.5868357 -0.7731062 -0.9506943 -1.115198 -1.281310 -1.427632 -1.576526 -1.707446 -1.848322 -1.969039 -2.083799 -2.212971 -2.323134 -2.428492 -2.554552 -2.659734 -2.761403 -2.859085 -2.983941 0.000000 -0.3509283 -0.5200698 -0.6755765 -0.8195499 -0.9604924 -1.101008 -1.220980 -1.331262 -1.446501 -1.546926 -1.657397 -1.749754 -1.836734 -1.918977 -2.015716 -2.094938 -2.170466 -2.243255 -2.313494 -2.406059 0.000000 -0.3185300 -0.4636962 -0.5971752 -0.7169946 -0.8399639 -0.9477595 -1.057631 -1.154739 -1.255820 -1.339991 -1.416227 -1.498889 -1.567588 -1.632108 -1.692909 -1.769088 -1.831942 -1.891593 -1.948399 -2.026232 0.000000 -0.2888215 -0.4093246 -0.5254422 -0.6332318 -0.7353162 -0.8341948 -0.9335794 -1.014985 -1.095361 -1.160004 -1.220716 -1.291742 -1.352208 -1.409940 -1.482068 -1.541657 -1.597634 -1.651309 -1.705424 -1.778332 0.000000 -0.2612117 -0.3682615 -0.4680834 -0.5561339 -0.6536753 -0.7422068 -0.8205436 -0.8820954 -0.9482204 -1.008720 -1.080122 -1.143138 -1.204279 -1.277380 -1.337632 -1.395266 -1.453662 -1.526311 -1.590217 -1.673066 0.000000 -0.2336932 -0.3273734 -0.4149121 -0.4927161 -0.5837011 -0.6503932 -0.7104186 -0.7690938 -0.8395658 -0.9064713 -0.9835010 -1.050491 -1.126806 -1.190560 -1.256099 -1.333736 -1.404542 -1.490613 -1.567051 -1.660796 0.000000 -0.2118538 -0.2867939 -0.3641258 -0.4417629 -0.5112491 -0.5640436 -0.6233051 -0.6978787 -0.7718136 -0.8544892 -0.9273915 -1.008966 -1.079617 -1.164304 -1.244497 -1.337433 -1.423933 -1.523241 -1.612520 -1.719925 0.000000 -0.1900401 -0.2569270 -0.3176210 -0.3909355 -0.4354733 -0.4930941 -0.5662169 -0.6521701 -0.7408684 -0.8209361 -0.9090780 -0.9899966 -1.084200 -1.186455 -1.282045 -1.388762 -1.498700 -1.599040 -1.715882 -1.839905 0.000000 -0.1675714 -0.2299606 -0.2879310 -0.3385417 -0.3687635 -0.4467435 -0.5386976 -0.6284221 -0.7226585 -0.8171409 -0.9093464 -1.014825 -1.125483 -1.240358 -1.358480 -1.464671 -1.586161 -1.710179 -1.833450 -1.960655 0.000000 -0.1488731 -0.2018758 -0.2569314 -0.2791760 -0.3274291 -0.4195358 -0.5222535 -0.6254617 -0.7210081 -0.8292299 -0.9448122 -1.064382 -1.186238 -1.309021 -1.433797 -1.562523 -1.692979 -1.803034 -1.924626 -2.046919 0.000000 -0.1322024 -0.1728541 -0.2233613 -0.2220309 -0.3029474 -0.4099973 -0.5177017 -0.6265999 -0.7427626 -0.8676242 -0.9954144 -1.124221 -1.252538 -1.380957 -1.512413 -1.643321 -1.768746 -1.889809 -2.007420 -2.122511 0.000000 -0.1147301 -0.1426413 -0.1868152 -0.1897703 -0.2866499 -0.4038708 -0.5236438 -0.6439829 -0.7771466 -0.9129493 -1.049141 -1.183278 -1.315513 -1.451187 -1.584072 -1.707627 -1.825416 -1.939037 -2.047836 -2.153300 0.000000 -9.6476667E-02 -0.1296194 -0.1467630 -0.1713133 -0.2781176 -0.4034480 -0.5278445 -0.6698811 -0.8131122 -0.9552705 -1.095596 -1.231271 -1.368506 -1.512382 -1.632768 -1.750506 -1.863822 -1.971182 -2.071613 -2.169299 0.000000 -8.2913041E-02 -0.1163605 -0.1030959 -0.1580827 -0.2757979 -0.4058264 -0.5379101 -0.6853939 -0.8337534 -0.9846784 -1.124546 -1.261539 -1.403971 -1.522748 -1.640907 -1.751544 -1.866311 -1.963046 -2.059800 -2.152591 0.000000 -7.0134856E-02 -9.9402763E-02 -6.7517795E-02 -0.1499273 -0.2693855 -0.3994115 -0.5451843 -0.6946826 -0.8426750 -0.9910838 -1.126695 -1.269691 -1.388830 -1.504548 -1.626298 -1.720376 -1.817713 -1.911897 -2.014629 -2.097055 0.000000 -5.6566995E-02 -8.0342166E-02 -6.4169414E-02 -0.1416798 -0.2620104 -0.3892081 -0.5321795 -0.6823054 -0.8231041 -0.9645540 -1.094676 -1.224645 -1.337207 -1.455645 -1.549199 -1.643521 -1.751151 -1.833894 -1.915223 -2.010271 0.000000 -4.1775353E-02 -5.7852685E-02 -5.7075072E-02 -0.1320874 -0.2417413 -0.3664886 -0.4993500 -0.6376449 -0.7656471 -0.8948296 -1.022476 -1.130279 -1.246032 -1.339859 -1.431502 -1.535979 -1.617338 -1.708991 -1.783992 -1.871441 0.000000 -3.1344831E-02 -3.0656746E-02 -4.8088577E-02 -0.1151719 -0.2119024 -0.3188896 -0.4353525 -0.5530257 -0.6620907 -0.7732673 -0.8825154 -0.9796109 -1.078881 -1.165775 -1.261377 -1.353180 -1.424877 -1.512418 -1.579387 -1.658650 0.000000 -2.1048492E-02 -1.9919891E-02 -3.7142508E-02 -8.9907505E-02 -0.1622790 -0.2451672 -0.3321482 -0.4203096 -0.5035384 -0.5885117 -0.6731210 -0.7576282 -0.8314453 -0.9114518 -0.9915030 -1.056655 -1.129163 -1.202753 -1.261458 -1.330682 0.000000 -9.8343575E-03 -1.1342765E-02 -2.1697599E-02 -5.1820043E-02 -9.3352377E-02 -0.1393309 -0.1872420 -0.2361871 -0.2859533 -0.3326837 -0.3820501 -0.4315912 -0.4812524 -0.5310367 -0.5809544 -0.6232600 -0.6704463 -0.7172328 -0.7636830 -0.8099226 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.9389783 -1.667367 -2.259194 -2.778911 -3.246494 -3.676211 -4.075976 -4.450171 -4.803466 -5.140110 -5.462955 -5.774977 -6.079022 -6.376921 -6.671366 -6.963748 -7.254850 -7.545743 -7.759203 -8.012605 0.000000 -0.8916581 -1.552991 -2.073404 -2.530456 -2.939862 -3.314101 -3.659527 -3.980804 -4.281747 -4.566941 -4.839299 -5.101409 -5.356208 -5.605582 -5.852112 -6.031818 -6.245796 -6.464843 -6.688015 -6.910141 0.000000 -0.8439577 -1.436984 -1.897817 -2.300238 -2.658757 -2.985279 -3.284116 -3.560909 -3.818496 -4.061406 -4.293314 -4.516684 -4.733666 -4.892970 -5.075878 -5.260578 -5.446179 -5.574080 -5.735174 -5.901419 0.000000 -0.7958493 -1.322761 -1.731440 -2.086469 -2.402450 -2.687031 -2.948023 -3.186927 -3.409914 -3.620330 -3.820852 -4.012252 -4.148339 -4.303964 -4.459219 -4.615259 -4.719136 -4.853149 -4.994987 -5.140656 0.000000 -0.7473021 -1.211550 -1.574118 -1.890085 -2.167197 -2.418242 -2.644842 -2.855946 -3.052019 -3.233220 -3.401313 -3.523544 -3.659422 -3.794216 -3.929561 -4.025023 -4.143613 -4.269430 -4.356682 -4.473259 0.000000 -0.6982808 -1.105106 -1.425969 -1.705267 -1.953597 -2.171507 -2.376016 -2.561340 -2.726701 -2.876104 -3.017663 -3.122741 -3.243296 -3.365845 -3.490854 -3.581082 -3.697324 -3.814104 -3.935511 -4.059436 0.000000 -0.6487329 -1.003550 -1.289968 -1.539016 -1.753042 -1.952684 -2.131090 -2.284688 -2.421742 -2.554516 -2.684950 -2.784981 -2.900278 -3.018426 -3.140383 -3.261468 -3.346861 -3.459695 -3.575099 -3.694477 0.000000 -0.5985910 -0.9047274 -1.161624 -1.382483 -1.573143 -1.749768 -1.896009 -2.024779 -2.153643 -2.281667 -2.408827 -2.510447 -2.628777 -2.746956 -2.860078 -2.977742 -3.099614 -3.191853 -3.311227 -3.438249 0.000000 -0.5477720 -0.8156851 -1.035561 -1.232241 -1.408820 -1.553248 -1.671945 -1.799536 -1.927735 -2.055571 -2.183081 -2.307734 -2.428699 -2.524554 -2.644334 -2.768047 -2.895741 -3.025889 -3.158414 -3.291468 0.000000 -0.4964116 -0.7277895 -0.9286706 -1.095635 -1.250541 -1.359978 -1.479316 -1.609166 -1.739594 -1.870600 -1.997464 -2.119253 -2.242967 -2.373094 -2.503238 -2.637725 -2.773659 -2.908880 -3.041586 -3.171196 0.000000 -0.4448685 -0.6455936 -0.8229963 -0.9753429 -1.092677 -1.186024 -1.314622 -1.448533 -1.583876 -1.717100 -1.842298 -1.970569 -2.106476 -2.241967 -2.398242 -2.537799 -2.674807 -2.808312 -2.936513 -3.065033 0.000000 -0.3936118 -0.5691190 -0.7178544 -0.8570101 -0.9347669 -1.041618 -1.174634 -1.313034 -1.464542 -1.593901 -1.727936 -1.868780 -2.010370 -2.147593 -2.309126 -2.446776 -2.580822 -2.708210 -2.835151 -2.991332 0.000000 -0.3432309 -0.4920229 -0.6144048 -0.7385290 -0.7879935 -0.9159029 -1.062337 -1.203308 -1.338820 -1.474759 -1.621276 -1.781429 -1.920102 -2.061008 -2.218483 -2.351587 -2.477191 -2.599928 -2.743068 -2.849330 0.000000 -0.2943315 -0.4203964 -0.5346122 -0.6177854 -0.6794960 -0.8111266 -0.9498404 -1.090629 -1.226974 -1.385353 -1.530429 -1.675578 -1.829725 -1.964261 -2.114208 -2.238144 -2.356248 -2.489444 -2.589507 -2.686992 0.000000 -0.2470987 -0.3551359 -0.4546222 -0.4941353 -0.5837812 -0.7074041 -0.8465095 -0.9904273 -1.130732 -1.278993 -1.433350 -1.573508 -1.719957 -1.845790 -1.984681 -2.096550 -2.222789 -2.320325 -2.415743 -2.528971 0.000000 -0.2020880 -0.2889346 -0.3729066 -0.3856353 -0.4885465 -0.6092616 -0.7486669 -0.8775760 -1.029069 -1.167088 -1.315009 -1.444008 -1.578877 -1.696405 -1.820257 -1.920937 -2.032606 -2.123784 -2.226823 -2.304625 0.000000 -0.1589757 -0.2213521 -0.2885494 -0.3136987 -0.3990801 -0.5169685 -0.6343124 -0.7656908 -0.8943875 -1.028774 -1.161264 -1.275503 -1.394649 -1.513972 -1.607392 -1.714174 -1.800074 -1.897207 -1.972626 -2.068635 0.000000 -0.1169711 -0.1659020 -0.1990868 -0.2378900 -0.3107361 -0.4100621 -0.5152086 -0.6235464 -0.7372534 -0.8499997 -0.9611663 -1.056228 -1.157633 -1.257419 -1.341136 -1.431089 -1.520408 -1.591931 -1.678499 -1.760970 0.000000 -7.6514311E-02 -0.1099228 -0.1272806 -0.1615194 -0.2189146 -0.2936342 -0.3708639 -0.4542905 -0.5382708 -0.6215487 -0.7041321 -0.7769403 -0.8537353 -0.9298280 -1.005889 -1.068733 -1.140082 -1.211340 -1.280360 -1.331344 0.000000 -3.7703454E-02 -5.2048367E-02 -6.4697705E-02 -8.3943136E-02 -0.1160127 -0.1571358 -0.2015239 -0.2470293 -0.2927828 -0.3385261 -0.3843104 -0.4302414 -0.4706241 -0.5149201 -0.5590746 -0.6031302 -0.6471156 -0.6910819 -0.7270961 -0.7684706 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.9815204 -1.832369 -2.536212 -3.166807 -3.769293 -4.297335 -4.795874 -5.264890 -5.758277 -6.175231 -6.580060 -6.965590 -7.333576 -7.686164 -8.103198 -8.430975 -8.759659 -9.078003 -9.387266 -9.685115 0.000000 -0.9330003 -1.723931 -2.357735 -2.921996 -3.464326 -3.934074 -4.376419 -4.790338 -5.178415 -5.593847 -5.938177 -6.270320 -6.586977 -6.888405 -7.176753 -7.454470 -7.722069 -7.980626 -8.231276 -8.472756 0.000000 -0.8843683 -1.614042 -2.182022 -2.689464 -3.179194 -3.597335 -3.988168 -4.352872 -4.693606 -5.013364 -5.363270 -5.645449 -5.916737 -6.176706 -6.425186 -6.661587 -6.888901 -7.107637 -7.318479 -7.520392 0.000000 -0.8356212 -1.502797 -2.012973 -2.468583 -2.881196 -3.285329 -3.628195 -3.952949 -4.252440 -4.531761 -4.793550 -5.090738 -5.324025 -5.547393 -5.758346 -5.962027 -6.155005 -6.339376 -6.516348 -6.685962 0.000000 -0.7867541 -1.391737 -1.849149 -2.260547 -2.630823 -2.992406 -3.300738 -3.583755 -3.848852 -4.097113 -4.329259 -4.545603 -4.747536 -4.983297 -5.159628 -5.328428 -5.494200 -5.655420 -5.811810 -5.961173 0.000000 -0.7377644 -1.282067 -1.692385 -2.060904 -2.392552 -2.696550 -2.994032 -3.245914 -3.484555 -3.704209 -3.905629 -4.088768 -4.259268 -4.418144 -4.618829 -4.774158 -4.926482 -5.072478 -5.212715 -5.345055 0.000000 -0.6886441 -1.174905 -1.544182 -1.877010 -2.174110 -2.441152 -2.709889 -2.937995 -3.147752 -3.333910 -3.504333 -3.664315 -3.816322 -4.007484 -4.157283 -4.302670 -4.440462 -4.572074 -4.702781 -4.838833 0.000000 -0.6393847 -1.071203 -1.401342 -1.697032 -1.966984 -2.200782 -2.449052 -2.647264 -2.822344 -2.982429 -3.138252 -3.288234 -3.472283 -3.619073 -3.758445 -3.890449 -4.020879 -4.156198 -4.329870 -4.454195 0.000000 -0.5899742 -0.9698955 -1.265965 -1.532155 -1.766031 -1.983669 -2.199232 -2.361836 -2.514658 -2.668426 -2.818335 -2.996835 -3.140074 -3.277622 -3.407933 -3.544069 -3.708811 -3.831974 -3.958630 -4.084048 0.000000 -0.5403975 -0.8740158 -1.138470 -1.375765 -1.579036 -1.776854 -1.951753 -2.089046 -2.242481 -2.393028 -2.566126 -2.708866 -2.845794 -2.977000 -3.141768 -3.267327 -3.393807 -3.530202 -3.663497 -3.827568 0.000000 -0.4906321 -0.7720553 -1.011418 -1.221186 -1.410707 -1.572501 -1.707012 -1.851532 -2.000460 -2.170861 -2.314576 -2.453056 -2.585593 -2.742790 -2.870026 -3.003202 -3.171804 -3.302081 -3.435322 -3.559421 0.000000 -0.4406458 -0.6837784 -0.8925326 -1.068481 -1.246448 -1.379666 -1.491264 -1.637278 -1.804038 -1.948048 -2.089313 -2.224130 -2.374982 -2.505767 -2.646912 -2.804669 -2.939862 -3.097237 -3.215448 -3.337055 0.000000 -0.3903898 -0.5948082 -0.7820625 -0.9371577 -1.081933 -1.171896 -1.303127 -1.445247 -1.604233 -1.746273 -1.883875 -2.030105 -2.162781 -2.325699 -2.458694 -2.617537 -2.740677 -2.863005 -3.005435 -3.122147 0.000000 -0.3397923 -0.5141630 -0.6712034 -0.8122529 -0.9152588 -0.9975847 -1.129802 -1.280555 -1.419767 -1.559686 -1.700541 -1.834032 -1.990496 -2.127315 -2.274315 -2.401164 -2.539084 -2.653810 -2.789510 -2.900825 0.000000 -0.2889115 -0.4332783 -0.5594881 -0.6871731 -0.7535475 -0.8467852 -0.9701024 -1.111217 -1.247236 -1.385546 -1.513276 -1.662492 -1.814460 -1.936312 -2.080079 -2.191906 -2.323211 -2.432720 -2.556056 -2.676808 0.000000 -0.2381022 -0.3539122 -0.4586127 -0.5600315 -0.5971996 -0.7024276 -0.8248956 -0.9479640 -1.082535 -1.200549 -1.338495 -1.479263 -1.598104 -1.729913 -1.842555 -1.960869 -2.079458 -2.198142 -2.285810 -2.391351 0.000000 -0.1877791 -0.2804649 -0.3656952 -0.4297482 -0.4775082 -0.5657980 -0.6738976 -0.7930360 -0.8998743 -1.020351 -1.146135 -1.255812 -1.374144 -1.490226 -1.588250 -1.692181 -1.795484 -1.898687 -1.975310 -2.067291 0.000000 -0.1388363 -0.2063331 -0.2720422 -0.2986119 -0.3591743 -0.4348690 -0.5217171 -0.6183578 -0.7157915 -0.8197812 -0.9128261 -1.012364 -1.110212 -1.206387 -1.286979 -1.374171 -1.460532 -1.545941 -1.614277 -1.692652 0.000000 -9.1352686E-02 -0.1366411 -0.1762309 -0.2020111 -0.2419141 -0.2968938 -0.3641554 -0.4353660 -0.5045503 -0.5782813 -0.6518270 -0.7245289 -0.7962247 -0.8671234 -0.9280545 -0.9938905 -1.058730 -1.123533 -1.187841 -1.239136 0.000000 -4.5084000E-02 -6.7596897E-02 -8.4350318E-02 -0.1018921 -0.1239976 -0.1550633 -0.1901378 -0.2288011 -0.2684375 -0.3082634 -0.3479768 -0.3874301 -0.4266581 -0.4657333 -0.5047374 -0.5383118 -0.5757414 -0.6129377 -0.6499396 -0.6867718 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.8514053 -1.659656 -2.359080 -2.975003 -3.573551 -4.103745 -4.646172 -5.115077 -5.620473 -6.043664 -6.523926 -6.910835 -7.298681 -7.728657 -8.076955 -8.500415 -8.821663 -9.240376 -9.541256 -9.848492 0.000000 -0.8091964 -1.571290 -2.216091 -2.772850 -3.315954 -3.792537 -4.285222 -4.704661 -5.162917 -5.538550 -5.910201 -6.311910 -6.643311 -7.032915 -7.334007 -7.635806 -7.990352 -8.260100 -8.616261 -8.866929 0.000000 -0.7669467 -1.482368 -2.071450 -2.573711 -3.069953 -3.499569 -3.948538 -4.322290 -4.686688 -5.068818 -5.390967 -5.756354 -6.046487 -6.335373 -6.661652 -6.915919 -7.239192 -7.469927 -7.704432 -8.003658 0.000000 -0.7246613 -1.392820 -1.927006 -2.381412 -2.834519 -3.220997 -3.588353 -3.962483 -4.283626 -4.632319 -4.918348 -5.249988 -5.504181 -5.754213 -6.048915 -6.269609 -6.493530 -6.764167 -6.959296 -7.156346 0.000000 -0.6823351 -1.302561 -1.784843 -2.194595 -2.581660 -2.953855 -3.287318 -3.624325 -3.913847 -4.230394 -4.481723 -4.731543 -5.006045 -5.222504 -5.491862 -5.686210 -5.876778 -6.119079 -6.284539 -6.446695 0.000000 -0.6399710 -1.211486 -1.645448 -2.015048 -2.364237 -2.706135 -3.000475 -3.311551 -3.567345 -3.851870 -4.077682 -4.295977 -4.547339 -4.739013 -4.926954 -5.143954 -5.303182 -5.462824 -5.661620 -5.809045 0.000000 -0.5975711 -1.119706 -1.510835 -1.844162 -2.159493 -2.464915 -2.735847 -3.012859 -3.239403 -3.464947 -3.703311 -3.896634 -4.117553 -4.279442 -4.441133 -4.632173 -4.776379 -4.974517 -5.109874 -5.248310 0.000000 -0.5551309 -1.027901 -1.364572 -1.678663 -1.963457 -2.242768 -2.480999 -2.727009 -2.936991 -3.138577 -3.348196 -3.512363 -3.700757 -3.845473 -3.996066 -4.175363 -4.317629 -4.498249 -4.624762 -4.753811 0.000000 -0.5126552 -0.9366424 -1.236526 -1.520887 -1.770541 -2.029312 -2.232046 -2.464818 -2.650382 -2.823306 -2.996677 -3.142457 -3.317389 -3.460018 -3.639433 -3.772112 -3.907604 -4.073829 -4.194473 -4.317461 0.000000 -0.4701394 -0.8465406 -1.115384 -1.371222 -1.597787 -1.818893 -2.009014 -2.213800 -2.370026 -2.532527 -2.664851 -2.810261 -2.977537 -3.117519 -3.283337 -3.411902 -3.540146 -3.694864 -3.813781 -3.964580 0.000000 -0.4275881 -0.7578053 -0.9972193 -1.222108 -1.427623 -1.615554 -1.795766 -1.966802 -2.087299 -2.232940 -2.371055 -2.537977 -2.671127 -2.807560 -2.959849 -3.086634 -3.236742 -3.352130 -3.494604 -3.601722 0.000000 -0.3849967 -0.6716583 -0.8818305 -1.081364 -1.258191 -1.436120 -1.586887 -1.716604 -1.815407 -1.971664 -2.106017 -2.261704 -2.393451 -2.544211 -2.666392 -2.814243 -2.923268 -3.063566 -3.169886 -3.318602 0.000000 -0.3423677 -0.5888867 -0.7738599 -0.9493695 -1.090409 -1.260348 -1.376400 -1.466453 -1.587985 -1.731920 -1.862008 -2.008662 -2.133984 -2.275601 -2.394246 -2.524628 -2.634458 -2.769584 -2.911952 -3.017280 0.000000 -0.2997037 -0.5073618 -0.6656007 -0.8169637 -0.9478006 -1.084677 -1.161708 -1.252417 -1.376097 -1.508836 -1.649189 -1.768987 -1.905671 -2.022309 -2.146469 -2.256208 -2.387626 -2.522373 -2.626126 -2.753377 0.000000 -0.2569996 -0.4300284 -0.5612339 -0.6837536 -0.8067623 -0.9068190 -0.9461153 -1.065271 -1.184667 -1.298668 -1.426688 -1.556732 -1.666585 -1.785971 -1.891849 -2.016968 -2.143383 -2.244198 -2.363519 -2.484760 0.000000 -0.2142606 -0.3527636 -0.4632418 -0.5615959 -0.6649629 -0.7248567 -0.7895214 -0.8846511 -0.9901058 -1.107311 -1.209906 -1.327476 -1.439773 -1.536891 -1.653291 -1.769034 -1.864417 -1.974625 -2.084502 -2.193471 0.000000 -0.1714819 -0.2795507 -0.3649115 -0.4476049 -0.5260630 -0.5485052 -0.6304704 -0.7167988 -0.8023396 -0.9011245 -1.004774 -1.094529 -1.191794 -1.294241 -1.396987 -1.483564 -1.581014 -1.677701 -1.772748 -1.866316 0.000000 -0.1286684 -0.2062243 -0.2678758 -0.3331181 -0.3749258 -0.4126938 -0.4737686 -0.5416091 -0.6204307 -0.6954259 -0.7774654 -0.8578587 -0.9428573 -1.028054 -1.099971 -1.180998 -1.260996 -1.339797 -1.417193 -1.493725 0.000000 -8.5815109E-02 -0.1364365 -0.1781640 -0.2167585 -0.2419501 -0.2791022 -0.3183711 -0.3675588 -0.4232497 -0.4827258 -0.5420849 -0.6036742 -0.6580391 -0.7177167 -0.7770576 -0.8357548 -0.8936916 -0.9508671 -1.007545 -1.063786 0.000000 -4.2924732E-02 -6.7225844E-02 -8.8533700E-02 -0.1045148 -0.1216078 -0.1402078 -0.1625981 -0.1900145 -0.2208343 -0.2502563 -0.2823920 -0.3146753 -0.3468947 -0.3789690 -0.4108354 -0.4424653 -0.4738756 -0.5051116 -0.5361983 -0.5671760 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.6257874 -1.254144 -1.835158 -2.363497 -2.870092 -3.314713 -3.767939 -4.217296 -4.600528 -5.013536 -5.426865 -5.764002 -6.148813 -6.537607 -6.837989 -7.203791 -7.500337 -7.844960 -8.195953 -8.456113 0.000000 -0.5946255 -1.191633 -1.737725 -2.227115 -2.693153 -3.094459 -3.507205 -3.918323 -4.262356 -4.639312 -5.017372 -5.317741 -5.667802 -5.959565 -6.287123 -6.619654 -6.874996 -7.188007 -7.508206 -7.733120 0.000000 -0.5634501 -1.129049 -1.639766 -2.089437 -2.515258 -2.877354 -3.255275 -3.595243 -3.942608 -4.286144 -4.580330 -4.898482 -5.218646 -5.474452 -5.773351 -6.077331 -6.300558 -6.585548 -6.801284 -7.069339 0.000000 -0.5322613 -1.066389 -1.541211 -1.950558 -2.314762 -2.667222 -3.012969 -3.319407 -3.637162 -3.951553 -4.214408 -4.505762 -4.798301 -5.023202 -5.297089 -5.513265 -5.768458 -6.028762 -6.213048 -6.457798 0.000000 -0.5010589 -1.003646 -1.441981 -1.812018 -2.141622 -2.462698 -2.778296 -3.057460 -3.344472 -3.636385 -3.869945 -4.134457 -4.359018 -4.604402 -4.853020 -5.041633 -5.273190 -5.455310 -5.672654 -5.896134 0.000000 -0.4698432 -0.9408201 -1.341965 -1.675017 -1.973660 -2.265631 -2.557245 -2.804502 -3.071507 -3.333817 -3.544709 -3.788094 -3.985076 -4.207262 -4.433263 -4.601582 -4.813569 -4.976142 -5.174043 -5.377377 0.000000 -0.4386140 -0.8779024 -1.241278 -1.540675 -1.810840 -2.077384 -2.339478 -2.568284 -2.805487 -3.016891 -3.237902 -3.456589 -3.628665 -3.833869 -4.041220 -4.192479 -4.385133 -4.529342 -4.704745 -4.882040 0.000000 -0.4073687 -0.8148838 -1.140592 -1.409940 -1.651188 -1.894637 -2.138677 -2.336514 -2.558183 -2.745770 -2.941454 -3.137741 -3.297889 -3.484231 -3.672080 -3.805382 -3.973490 -4.094275 -4.242648 -4.399026 0.000000 -0.3761128 -0.7517526 -1.040486 -1.281742 -1.501585 -1.719719 -1.919445 -2.119451 -2.319784 -2.481521 -2.658079 -2.841616 -2.985379 -3.150688 -3.313067 -3.422784 -3.562007 -3.672096 -3.812953 -3.960823 0.000000 -0.3448434 -0.6884927 -0.9415678 -1.159119 -1.353733 -1.553087 -1.726432 -1.912147 -2.084976 -2.229034 -2.395990 -2.558620 -2.682360 -2.820242 -2.950880 -3.046371 -3.184257 -3.294266 -3.427202 -3.565250 0.000000 -0.3135608 -0.6250790 -0.8440463 -1.039012 -1.211982 -1.387102 -1.548919 -1.707531 -1.855693 -1.998042 -2.143329 -2.279665 -2.378227 -2.485229 -2.608829 -2.715406 -2.845386 -2.977991 -3.076191 -3.204864 0.000000 -0.2822648 -0.5614839 -0.7491403 -0.9242260 -1.076558 -1.229434 -1.373138 -1.503237 -1.650928 -1.773515 -1.892765 -1.997086 -2.070236 -2.183300 -2.309174 -2.411552 -2.531574 -2.655948 -2.753755 -2.872618 0.000000 -0.2509555 -0.4976562 -0.6576427 -0.8086122 -0.9411828 -1.080617 -1.197488 -1.320719 -1.450454 -1.550410 -1.637949 -1.711335 -1.817685 -1.916419 -2.030418 -2.147526 -2.241902 -2.356018 -2.472744 -2.560241 0.000000 -0.2196328 -0.4335239 -0.5674213 -0.6939907 -0.8117665 -0.9316518 -1.027159 -1.146057 -1.251235 -1.334714 -1.379333 -1.463930 -1.573710 -1.664409 -1.767673 -1.877104 -1.987334 -2.072168 -2.176976 -2.284499 0.000000 -0.1882969 -0.3691449 -0.4814238 -0.5868976 -0.6893227 -0.7817402 -0.8844676 -0.9726753 -1.049623 -1.098939 -1.150958 -1.246310 -1.340293 -1.436192 -1.520307 -1.618113 -1.716496 -1.815727 -1.895760 -1.989997 0.000000 -0.1569477 -0.3048746 -0.3955187 -0.4815529 -0.5663288 -0.6428260 -0.7314356 -0.7979981 -0.8425981 -0.8808033 -0.9640037 -1.035237 -1.115512 -1.201591 -1.290660 -1.366228 -1.452083 -1.541000 -1.628282 -1.695062 0.000000 -0.1255852 -0.2411230 -0.3136981 -0.3823212 -0.4423779 -0.5122361 -0.5781578 -0.6191311 -0.6412695 -0.7031225 -0.7694501 -0.8365631 -0.8991756 -0.9721258 -1.046645 -1.122943 -1.201166 -1.264572 -1.335544 -1.403897 0.000000 -9.4209395E-02 -0.1787905 -0.2317927 -0.2850669 -0.3309948 -0.3814943 -0.4224547 -0.4426539 -0.4813702 -0.5285172 -0.5778721 -0.6309663 -0.6890389 -0.7490550 -0.8022200 -0.8638396 -0.9243610 -0.9830909 -1.041093 -1.099761 0.000000 -6.2820457E-02 -0.1179529 -0.1534545 -0.1872820 -0.2195521 -0.2489125 -0.2676120 -0.2949044 -0.3244992 -0.3576335 -0.3882625 -0.4264089 -0.4668011 -0.5091411 -0.5529527 -0.5968083 -0.6400934 -0.6836240 -0.7272545 -0.7619951 0.000000 -3.1418171E-02 -5.8366213E-02 -7.5719245E-02 -9.2854001E-02 -0.1077138 -0.1204966 -0.1342168 -0.1480435 -0.1628619 -0.1794775 -0.1981386 -0.2187897 -0.2409912 -0.2640656 -0.2875504 -0.3077149 -0.3307757 -0.3537486 -0.3765163 -0.3992042 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.3365902 -0.6742858 -1.013077 -1.350246 -1.672723 -1.977995 -2.269738 -2.552238 -2.829386 -3.103934 -3.338665 -3.589616 -3.836978 -4.081995 -4.325556 -4.568941 -4.758304 -4.981852 -5.203670 -5.424524 0.000000 -0.3197860 -0.6406774 -0.9626594 -1.282841 -1.587278 -1.873225 -2.144621 -2.406081 -2.661809 -2.914782 -3.125857 -3.354552 -3.580113 -3.803823 -4.026635 -4.249873 -4.417416 -4.620728 -4.823110 -5.024529 0.000000 -0.3029819 -0.6070549 -0.9122159 -1.215376 -1.501612 -1.767955 -2.018634 -2.258667 -2.492706 -2.724735 -2.913962 -3.122638 -3.329464 -3.534365 -3.739393 -3.904006 -4.091872 -4.277563 -4.461547 -4.645007 0.000000 -0.2861720 -0.5734242 -0.8617476 -1.147843 -1.415701 -1.662109 -1.891661 -2.110087 -2.323918 -2.511793 -2.706689 -2.897620 -3.086295 -3.274404 -3.462875 -3.607946 -3.778888 -3.948715 -4.116755 -4.283864 0.000000 -0.2693593 -0.5397824 -0.8112572 -1.080237 -1.329511 -1.555605 -1.763683 -1.961885 -2.157524 -2.326467 -2.504621 -2.678172 -2.851660 -3.022202 -3.196562 -3.325342 -3.479552 -3.632499 -3.787661 -3.941735 0.000000 -0.2525468 -0.5061296 -0.7607390 -1.012558 -1.243002 -1.448339 -1.635706 -1.815258 -1.994014 -2.146273 -2.308118 -2.466164 -2.624230 -2.783419 -2.909696 -3.051946 -3.195135 -3.335782 -3.474837 -3.613282 0.000000 -0.2357285 -0.4724655 -0.7101957 -0.9447929 -1.156120 -1.340420 -1.508613 -1.671324 -1.835401 -1.971182 -2.116219 -2.262917 -2.407071 -2.548543 -2.664525 -2.794983 -2.922328 -3.047355 -3.174719 -3.268292 0.000000 -0.2189105 -0.4387874 -0.6596277 -0.8769389 -1.068798 -1.232527 -1.383161 -1.531032 -1.681105 -1.799287 -1.934845 -2.065471 -2.196113 -2.330406 -2.429137 -2.543941 -2.659546 -2.777117 -2.892863 -2.972202 0.000000 -0.2020868 -0.4051013 -0.6090345 -0.8089814 -0.9809499 -1.125230 -1.259558 -1.393316 -1.513142 -1.637404 -1.756483 -1.876112 -1.997168 -2.115183 -2.197706 -2.307390 -2.413887 -2.517910 -2.619705 -2.685182 0.000000 -0.1852602 -0.3714038 -0.5584196 -0.7409011 -0.8927077 -1.019140 -1.138848 -1.261209 -1.368006 -1.477377 -1.585950 -1.695138 -1.799997 -1.885442 -1.985748 -2.081923 -2.174979 -2.263932 -2.349244 -2.409470 0.000000 -0.1684340 -0.3376956 -0.5077772 -0.6726816 -0.8044300 -0.9144699 -1.022528 -1.131652 -1.225999 -1.323681 -1.422359 -1.515421 -1.610723 -1.691445 -1.778461 -1.860705 -1.937943 -2.015546 -2.099468 -2.155325 0.000000 -0.1516018 -0.3039763 -0.4571097 -0.6042844 -0.7165819 -0.8124344 -0.9081755 -1.007452 -1.086966 -1.176468 -1.259197 -1.344142 -1.432552 -1.500707 -1.573165 -1.639724 -1.714790 -1.790292 -1.863237 -1.910275 0.000000 -0.1347698 -0.2702428 -0.4064177 -0.5356663 -0.6297503 -0.7138255 -0.7986345 -0.8824545 -0.9556292 -1.029562 -1.104251 -1.181917 -1.255893 -1.310529 -1.369009 -1.440374 -1.507906 -1.572274 -1.632245 -1.669050 0.000000 -0.1179322 -0.2365014 -0.3557008 -0.4667523 -0.5445382 -0.6165141 -0.6904594 -0.7656595 -0.8241234 -0.8887325 -0.9566230 -1.020206 -1.078267 -1.125860 -1.189731 -1.249210 -1.305507 -1.356932 -1.402719 -1.440314 0.000000 -0.1010918 -0.2027489 -0.3049623 -0.3975976 -0.4611349 -0.5234442 -0.5851863 -0.6416104 -0.6967137 -0.7550372 -0.8093215 -0.8573889 -0.9099447 -0.9690570 -1.012590 -1.060789 -1.104132 -1.141857 -1.168992 -1.184497 0.000000 -8.4251516E-02 -0.1689853 -0.2541962 -0.3285637 -0.3801137 -0.4304910 -0.4828395 -0.5269665 -0.5758638 -0.6212003 -0.6604355 -0.7059025 -0.7548808 -0.8012527 -0.8363189 -0.8715454 -0.9011957 -0.9204527 -0.9280642 -0.9443228 0.000000 -6.7405619E-02 -0.1352109 -0.2034055 -0.2600569 -0.3011131 -0.3416361 -0.3806867 -0.4185379 -0.4548950 -0.4863051 -0.5244734 -0.5630662 -0.6000692 -0.6342213 -0.6638700 -0.6796064 -0.6914207 -0.7037745 -0.7264433 -0.7486273 0.000000 -5.0559763E-02 -0.1014224 -0.1525902 -0.1929785 -0.2233645 -0.2527184 -0.2835023 -0.3125090 -0.3353024 -0.3639266 -0.3921905 -0.4198064 -0.4445117 -0.4647618 -0.4788041 -0.4894948 -0.5078798 -0.5273705 -0.5449209 -0.5620765 0.000000 -3.3708278E-02 -6.7625843E-02 -0.1017503 -0.1274041 -0.1473112 -0.1673843 -0.1858959 -0.2055455 -0.2230677 -0.2416079 -0.2591910 -0.2746358 -0.2852906 -0.2963839 -0.3113925 -0.3268537 -0.3429137 -0.3561671 -0.3665193 -0.3809618 0.000000 -1.6854079E-02 -3.3818379E-02 -5.0888889E-02 -6.3085921E-02 -7.3032551E-02 -8.2674585E-02 -9.2419155E-02 -0.1019711 -0.1110392 -0.1189152 -0.1254874 -0.1334681 -0.1412270 -0.1489354 -0.1566394 -0.1644464 -0.1725572 -0.1795724 -0.1876528 -0.1966069 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 diff --git a/modules/epos/epos.inirj.lhc b/modules/epos/epos.inirj.lhc new file mode 100644 index 0000000000000000000000000000000000000000..8e22ad74ab99a21d9ddb95efe39f174bf36dc8e1 --- /dev/null +++ b/modules/epos/epos.inirj.lhc @@ -0,0 +1,12477 @@ + 0.7750000 0.7000000 1.000000 0.7000000 1.000000 1.075000 0.1800000 0.4425756 1.000000 0.3782009 2.1177933E-02 1.000000 0.8500000 0.7000000 0.000000 1.000000 1.000000 1.000000 1.000000 3.9999999E-02 4.000000 0.2500000 0.2500000 0.1000000 3 2.000000 0.000000 7.9999998E-02 + 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -80.00000 -5.437748 -4.257186 -3.772734 -3.555046 -3.490223 -3.487799 -3.551739 -3.667205 -3.801362 -3.950526 -80.00000 -5.230782 -4.028383 -3.519294 -3.278365 -3.189385 -3.165905 -3.206128 -3.294643 -3.403497 -3.529932 -80.00000 -5.108983 -3.891734 -3.365267 -3.107259 -3.000074 -2.959657 -2.981147 -3.049015 -3.138250 -3.246495 -80.00000 -5.022232 -3.793468 -3.253238 -2.981372 -2.859170 -2.804278 -2.809831 -2.860344 -2.932915 -3.025428 -80.00000 -4.954748 -3.716476 -3.164714 -2.881032 -2.745875 -2.678196 -2.669689 -2.704983 -2.762815 -2.841231 -80.00000 -4.899482 -3.653060 -3.091299 -2.797239 -2.650596 -2.571384 -2.550195 -2.571813 -2.616301 -2.681830 -80.00000 -4.852666 -3.599079 -3.028449 -2.725088 -2.568072 -2.478308 -2.445510 -2.454636 -2.486861 -2.540455 -80.00000 -4.812045 -3.552047 -2.973421 -2.661601 -2.495093 -2.395567 -2.352028 -2.349612 -2.370447 -2.412887 -80.00000 -4.776162 -3.510349 -2.924424 -2.604826 -2.429543 -2.320916 -2.267356 -2.254183 -2.264356 -2.296297 -80.00000 -4.744022 -3.472879 -2.880228 -2.553415 -2.369955 -2.252784 -2.189815 -2.166550 -2.166680 -2.188688 -80.00000 -4.602033 -3.429005 -2.951084 -2.738470 -2.678036 -2.678874 -2.745995 -2.864690 -3.001492 -3.152715 -80.00000 -4.379677 -3.185763 -2.683967 -2.448988 -2.365262 -2.346122 -2.390429 -2.482863 -2.595068 -2.724326 -80.00000 -4.248732 -3.040181 -2.521047 -2.269108 -2.167291 -2.131481 -2.157257 -2.229170 -2.321956 -2.433305 -80.00000 -4.155424 -2.935342 -2.402261 -2.136318 -2.019319 -1.968966 -1.978698 -2.033113 -2.109171 -2.204800 -80.00000 -4.082816 -2.853112 -2.308218 -2.030199 -1.899943 -1.836561 -1.831957 -1.870852 -1.931942 -2.013314 -80.00000 -4.023337 -2.785321 -2.230105 -1.941386 -1.799270 -1.724013 -1.706349 -1.731169 -1.778575 -1.846782 -80.00000 -3.972941 -2.727573 -2.163147 -1.864771 -1.711869 -1.625652 -1.595937 -1.607802 -1.642530 -1.698434 -80.00000 -3.929204 -2.677225 -2.104455 -1.797247 -1.634414 -1.537993 -1.497051 -1.496868 -1.519737 -1.564054 -80.00000 -3.890563 -2.632562 -2.052143 -1.736777 -1.564717 -1.458724 -1.407249 -1.395774 -1.407475 -1.440814 -80.00000 -3.855947 -2.592407 -2.004913 -1.681949 -1.501254 -1.386234 -1.324818 -1.302698 -1.303820 -1.326712 -80.00000 -5.556537 -4.390999 -3.919565 -3.711874 -3.655663 -3.659522 -3.729640 -3.851435 -3.990743 -4.143871 -80.00000 -5.316346 -4.131464 -3.637384 -3.408600 -3.330292 -3.315552 -3.363988 -3.460382 -3.575928 -3.707962 -80.00000 -5.174779 -3.975737 -3.464555 -3.219110 -3.122993 -3.092018 -3.122272 -3.198391 -3.294830 -3.409333 -80.00000 -5.073848 -3.863400 -3.338176 -3.078676 -2.967294 -2.921802 -2.935989 -2.994542 -3.074265 -3.173141 -80.00000 -4.995274 -3.775172 -3.237896 -2.966096 -2.841192 -2.782472 -2.782086 -2.824857 -2.889428 -2.973939 -80.00000 -4.930887 -3.702357 -3.154448 -2.871633 -2.734498 -2.663566 -2.649748 -2.678052 -2.728617 -2.799705 -80.00000 -4.876316 -3.640273 -3.082802 -2.789963 -2.641605 -2.559292 -2.532960 -2.547827 -2.585289 -2.643705 -80.00000 -4.828945 -3.586102 -3.019914 -2.717845 -2.559080 -2.466081 -2.427996 -2.430271 -2.455374 -2.501748 -80.00000 -4.787083 -3.538014 -2.963794 -2.653148 -2.484656 -2.381564 -2.332378 -2.322770 -2.336147 -2.371020 -80.00000 -4.749576 -3.494751 -2.913071 -2.594397 -2.416754 -2.304086 -2.244363 -2.223485 -2.225685 -2.249535 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -80.00000 -4.606150 -4.137556 -4.077668 -4.168643 -4.336157 -4.531576 -4.755973 -5.003470 -5.258277 -5.519624 -80.00000 -4.813029 -4.343882 -4.283711 -4.374519 -4.541931 -4.737273 -4.961615 -5.209071 -5.463840 -5.725154 -80.00000 -5.025166 -4.555297 -4.494753 -4.585339 -4.752614 -4.947855 -5.172123 -5.419525 -5.674246 -5.935517 -80.00000 -5.243458 -4.772702 -4.711690 -4.801996 -4.969101 -5.164213 -5.388388 -5.635720 -5.890381 -6.151596 -80.00000 -5.467622 -4.995919 -4.934385 -5.024374 -5.191283 -5.386249 -5.610318 -5.857570 -6.112161 -6.373313 -80.00000 -5.693841 -5.221499 -5.159548 -5.249270 -5.416010 -5.610849 -5.834825 -6.082008 -6.336538 -6.597634 -80.00000 -5.909885 -5.438152 -5.376313 -5.466059 -5.632800 -5.827636 -6.051609 -6.298789 -6.553316 -6.814409 -80.00000 -6.022077 -5.551882 -5.490641 -5.580700 -5.747619 -5.942585 -6.166650 -6.413898 -6.668486 -6.929632 -80.00000 -6.093614 -5.624988 -5.564410 -5.654830 -5.821959 -6.017079 -6.241254 -6.488585 -6.743243 -7.004455 -80.00000 -6.207767 -5.730268 -5.667158 -5.756121 -5.922353 -6.116804 -6.340492 -6.587458 -6.841819 -7.102778 -80.00000 -4.357840 -3.831879 -3.719075 -3.763441 -3.886307 -4.043120 -4.230720 -4.442796 -4.667524 -4.903794 -80.00000 -4.564695 -4.038156 -3.925056 -3.969249 -4.092014 -4.248756 -4.436304 -4.648342 -4.873034 -5.109273 -80.00000 -4.776801 -4.249506 -4.136014 -4.179979 -4.302612 -4.459257 -4.646738 -4.858724 -5.083371 -5.319568 -80.00000 -4.995056 -4.466830 -4.352849 -4.396524 -4.518988 -4.675512 -4.862906 -5.074828 -5.299416 -5.535561 -80.00000 -5.219184 -4.689960 -4.575428 -4.618775 -4.741045 -4.897430 -5.084725 -5.296572 -5.521093 -5.757178 -80.00000 -5.445387 -4.915480 -4.800499 -4.843565 -4.965665 -5.121927 -5.309136 -5.520917 -5.745380 -5.981411 -80.00000 -5.661486 -5.132181 -5.017292 -5.060364 -5.182455 -5.338709 -5.525912 -5.737689 -5.962149 -6.198176 -80.00000 -5.773769 -5.246043 -5.131757 -5.175133 -5.297388 -5.453759 -5.641043 -5.852885 -6.077401 -6.313478 -80.00000 -5.845389 -5.319287 -5.205677 -5.249412 -5.371864 -5.528376 -5.715759 -5.927677 -6.152260 -6.388400 -80.00000 -5.959709 -5.424604 -5.308554 -5.350902 -5.472507 -5.628367 -5.815252 -6.026765 -6.250999 -6.486833 -80.00000 -4.211350 -3.648326 -3.499316 -3.509697 -3.598483 -3.723710 -3.880454 -4.062714 -4.261061 -4.474256 -80.00000 -4.418192 -3.854574 -3.705261 -3.715468 -3.804156 -3.929314 -4.086010 -4.268231 -4.466544 -4.679708 -80.00000 -4.630280 -4.065887 -3.916174 -3.926150 -4.014707 -4.139773 -4.296404 -4.478576 -4.676844 -4.889966 -80.00000 -4.848513 -4.283165 -4.132949 -4.142633 -4.231024 -4.355975 -4.512524 -4.694633 -4.892842 -5.105912 -80.00000 -5.072620 -4.506247 -4.355464 -4.364814 -4.453014 -4.577831 -4.734287 -4.916323 -5.114466 -5.327475 -80.00000 -5.298815 -4.731730 -4.580483 -4.589544 -4.677575 -4.802274 -4.958647 -5.140619 -5.338704 -5.551660 -80.00000 -5.514944 -4.948458 -4.797290 -4.806347 -4.894362 -5.019050 -5.175416 -5.357385 -5.555466 -5.768418 -80.00000 -5.627280 -5.062394 -4.911828 -4.921183 -5.009354 -5.134150 -5.290591 -5.472621 -5.670759 -5.883761 -80.00000 -5.698948 -5.135715 -4.985831 -4.995541 -5.083900 -5.208827 -5.365363 -5.547467 -5.745671 -5.958735 -80.00000 -5.813383 -5.241086 -5.088845 -5.097242 -5.184816 -5.309133 -5.465184 -5.646873 -5.844704 -6.057429 -80.00000 -4.106859 -3.515955 -3.338851 -3.321961 -3.382728 -3.481075 -3.611124 -3.767336 -3.941958 -4.133702 -80.00000 -4.313690 -3.722183 -3.544772 -3.527707 -3.588378 -3.686659 -3.816661 -3.972836 -4.147424 -4.339136 -80.00000 -4.525766 -3.933470 -3.755653 -3.738356 -3.798899 -3.897091 -4.027032 -4.183158 -4.357700 -4.549370 -80.00000 -4.743984 -4.150717 -3.972389 -3.954797 -4.015178 -4.113258 -4.243121 -4.399185 -4.573669 -4.765286 -80.00000 -4.968076 -4.373763 -4.194859 -4.176931 -4.237124 -4.335075 -4.464848 -4.620841 -4.795259 -4.986814 -80.00000 -5.194264 -4.599222 -4.419842 -4.401620 -4.461646 -4.559483 -4.689175 -4.845105 -5.019465 -5.210967 -80.00000 -5.410415 -4.815967 -4.636656 -4.618424 -4.678430 -4.776254 -4.905939 -5.061865 -5.236222 -5.427720 -80.00000 -5.522789 -4.929954 -4.751244 -4.733305 -4.793458 -4.891384 -5.021141 -5.177128 -5.351540 -5.543088 -80.00000 -5.594491 -5.003329 -4.825303 -4.807714 -4.868049 -4.966101 -5.095946 -5.252006 -5.426485 -5.618095 -80.00000 -5.709014 -5.108755 -4.928443 -4.909610 -4.969222 -5.066708 -5.196097 -5.351746 -5.525844 -5.717102 -80.00000 -4.025492 -3.412056 -3.211776 -3.171895 -3.208681 -3.283530 -3.389982 -3.522982 -3.676021 -3.847785 -80.00000 -4.232315 -3.618269 -3.417679 -3.377623 -3.414314 -3.489099 -3.595507 -3.728470 -3.881475 -4.053206 -80.00000 -4.444381 -3.829536 -3.628536 -3.588247 -3.624813 -3.699513 -3.805861 -3.938775 -4.091734 -4.263424 -80.00000 -4.662587 -4.046759 -3.845242 -3.804658 -3.841065 -3.915656 -4.021929 -4.154781 -4.307683 -4.479318 -80.00000 -4.886668 -4.269778 -4.067678 -4.026757 -4.062979 -4.137445 -4.243630 -4.376413 -4.529248 -4.700821 -80.00000 -5.112852 -4.495218 -4.292634 -4.251416 -4.287472 -4.361826 -4.467935 -4.600656 -4.753432 -4.924952 -80.00000 -5.329019 -4.711976 -4.509454 -4.468220 -4.504253 -4.578594 -4.684694 -4.817412 -4.970184 -5.141700 -80.00000 -5.441421 -4.826001 -4.624078 -4.583132 -4.619307 -4.693745 -4.799914 -4.932691 -5.085519 -5.257086 -80.00000 -5.513150 -4.899416 -4.698179 -4.657580 -4.693930 -4.768488 -4.874743 -5.007591 -5.160487 -5.332116 -80.00000 -5.627747 -5.004893 -4.801433 -4.759653 -4.795339 -4.869379 -4.975207 -5.107657 -5.260176 -5.431450 -80.00000 -3.958804 -3.326370 -3.106257 -3.046394 -3.062117 -3.116034 -3.201303 -3.313330 -3.446574 -3.599696 -80.00000 -4.165621 -3.532571 -3.312145 -3.252107 -3.267738 -3.321592 -3.406818 -3.518809 -3.652019 -3.805108 -80.00000 -4.377678 -3.743822 -3.522983 -3.462712 -3.478220 -3.531992 -3.617159 -3.729103 -3.862267 -4.015313 -80.00000 -4.595876 -3.961025 -3.739665 -3.679099 -3.694450 -3.748117 -3.833211 -3.945094 -4.078199 -4.231191 -80.00000 -4.819947 -4.184023 -3.962074 -3.901170 -3.916339 -3.969884 -4.054894 -4.166707 -4.299746 -4.452675 -80.00000 -5.046126 -4.409448 -4.187007 -4.125805 -4.140811 -4.194247 -4.279181 -4.390934 -4.523914 -4.676788 -80.00000 -5.262307 -4.626216 -4.403831 -4.342608 -4.357589 -4.411011 -4.495937 -4.607686 -4.740663 -4.893533 -80.00000 -5.374732 -4.740272 -4.518485 -4.457545 -4.472661 -4.526176 -4.611170 -4.722978 -4.856010 -5.008932 -80.00000 -5.446483 -4.813720 -4.592619 -4.532022 -4.547309 -4.600940 -4.686016 -4.797894 -4.930995 -5.083979 -80.00000 -5.561142 -4.919244 -4.695977 -4.634258 -4.648936 -4.702092 -4.786774 -4.898273 -5.031006 -5.183640 -80.00000 -3.902275 -3.253368 -3.015856 -2.938259 -2.935148 -2.970155 -3.036181 -3.129065 -3.244033 -3.379718 -80.00000 -4.109087 -3.459559 -3.221732 -3.143961 -3.140759 -3.175706 -3.241689 -3.334537 -3.449471 -3.585123 -80.00000 -4.321138 -3.670797 -3.432554 -3.354551 -3.351228 -3.386094 -3.452022 -3.544822 -3.659709 -3.795318 -80.00000 -4.539327 -3.887983 -3.649216 -3.570918 -3.567441 -3.602205 -3.668061 -3.760801 -3.875629 -4.011184 -80.00000 -4.763391 -4.110963 -3.871604 -3.792966 -3.789310 -3.823956 -3.889729 -3.982400 -4.097162 -4.232653 -80.00000 -4.989566 -4.336374 -4.096519 -4.017582 -4.013764 -4.048303 -4.114004 -4.206614 -4.321317 -4.456752 -80.00000 -5.205759 -4.553151 -4.313346 -4.234385 -4.230540 -4.265064 -4.330756 -4.423363 -4.538062 -4.673494 -80.00000 -5.318203 -4.667232 -4.428023 -4.349340 -4.345627 -4.380241 -4.445998 -4.538664 -4.653419 -4.788903 -80.00000 -5.389972 -4.740707 -4.502184 -4.423842 -4.420294 -4.455020 -4.520857 -4.613594 -4.728416 -4.863963 -80.00000 -5.504686 -4.846275 -4.605638 -4.526227 -4.522121 -4.556416 -4.621892 -4.714267 -4.828738 -4.963944 -80.00000 -3.853201 -3.189719 -2.936672 -2.843095 -2.822915 -2.840655 -2.889036 -2.964300 -3.062299 -3.181631 -80.00000 -4.060008 -3.395901 -3.142539 -3.048787 -3.028517 -3.046199 -3.094539 -3.169767 -3.267730 -3.387030 -80.00000 -4.272053 -3.607128 -3.353347 -3.259364 -3.238975 -3.256578 -3.304863 -3.380044 -3.477961 -3.597217 -80.00000 -4.490235 -3.824300 -3.569992 -3.475715 -3.455174 -3.472677 -3.520892 -3.596014 -3.693872 -3.813073 -80.00000 -4.714292 -4.047265 -3.792361 -3.697745 -3.677028 -3.694415 -3.742550 -3.817602 -3.915393 -4.034531 -80.00000 -4.940464 -4.272665 -4.017260 -3.922343 -3.901467 -3.918749 -3.966813 -4.041805 -4.139538 -4.258619 -80.00000 -5.156667 -4.489448 -4.234090 -4.139145 -4.118240 -4.135508 -4.183563 -4.258553 -4.356280 -4.475358 -80.00000 -5.269129 -4.603550 -4.348786 -4.254117 -4.233339 -4.250694 -4.298812 -4.373861 -4.471645 -4.590774 -80.00000 -5.340912 -4.677049 -4.422970 -4.328639 -4.308022 -4.325486 -4.373682 -4.448800 -4.546652 -4.665844 -80.00000 -5.455677 -4.782658 -4.526512 -4.431162 -4.410035 -4.427109 -4.474975 -4.549753 -4.647269 -4.766136 -80.00000 -3.809831 -3.133260 -2.866155 -2.758009 -2.722197 -2.724034 -2.756113 -2.815051 -2.897214 -3.001169 -80.00000 -4.016635 -3.339435 -3.072013 -2.963693 -2.927793 -2.929572 -2.961611 -3.020513 -3.102641 -3.206563 -80.00000 -4.228675 -3.550651 -3.282809 -3.174258 -3.138241 -3.139944 -3.171929 -3.230783 -3.312866 -3.416744 -80.00000 -4.446851 -3.767811 -3.499440 -3.390595 -3.354429 -3.356033 -3.387950 -3.446745 -3.528769 -3.632592 -80.00000 -4.670901 -3.990762 -3.721792 -3.612609 -3.576269 -3.577759 -3.609598 -3.668325 -3.750281 -3.854040 -80.00000 -4.897071 -4.216153 -3.946678 -3.837194 -3.800695 -3.802084 -3.833852 -3.892520 -3.974417 -4.078119 -80.00000 -5.113282 -4.432941 -4.163510 -4.053994 -4.017467 -4.018840 -4.050600 -4.109264 -4.191157 -4.294855 -80.00000 -5.225759 -4.547063 -4.278224 -4.168980 -4.132576 -4.134034 -4.165855 -4.224578 -4.306527 -4.410277 -80.00000 -5.297556 -4.620582 -4.352427 -4.243518 -4.207271 -4.208835 -4.240733 -4.299526 -4.381543 -4.485356 -80.00000 -5.412365 -4.726229 -4.456051 -4.346170 -4.309457 -4.310670 -4.342269 -4.400743 -4.482442 -4.585946 -80.00000 -3.770971 -3.082505 -2.802543 -2.680991 -2.630746 -2.617831 -2.634754 -2.678477 -2.745801 -2.835255 -80.00000 -3.977771 -3.288673 -3.008393 -2.886668 -2.836336 -2.823364 -2.840247 -2.883935 -2.951225 -3.040646 -80.00000 -4.189806 -3.499880 -3.219180 -3.097224 -3.046777 -3.033730 -3.050560 -3.094201 -3.161444 -3.250821 -80.00000 -4.407977 -3.717029 -3.435798 -3.313549 -3.262954 -3.249811 -3.266575 -3.310156 -3.377341 -3.466662 -80.00000 -4.632022 -3.939969 -3.658136 -3.535548 -3.484782 -3.471528 -3.488215 -3.531728 -3.598845 -3.688102 -80.00000 -4.858189 -4.165350 -3.883010 -3.760121 -3.709198 -3.695844 -3.712462 -3.755916 -3.822973 -3.912174 -80.00000 -5.074408 -4.382144 -4.099843 -3.976921 -3.925967 -3.912598 -3.929207 -3.972659 -4.039711 -4.128907 -80.00000 -5.186898 -4.496283 -4.214571 -4.091918 -4.041085 -4.027798 -4.044467 -4.087977 -4.155086 -4.244334 -80.00000 -5.258708 -4.569819 -4.288792 -4.166470 -4.115791 -4.102608 -4.119352 -4.162931 -4.230108 -4.319420 -80.00000 -5.373557 -4.675503 -4.392493 -4.269243 -4.218140 -4.204642 -4.221117 -4.264398 -4.331277 -4.420295 -80.00000 -3.999337 -3.544263 -3.494967 -3.593764 -3.767738 -3.967597 -4.195550 -4.445961 -4.702436 -4.964467 -80.00000 -4.207788 -3.752936 -3.703780 -3.802674 -3.976714 -4.176625 -4.404617 -4.655058 -4.911559 -5.173613 -80.00000 -4.413453 -3.958942 -3.909973 -4.008988 -4.183107 -4.383080 -4.611118 -4.861594 -5.118125 -5.380207 -80.00000 -4.614410 -4.160461 -4.111778 -4.210969 -4.385200 -4.585258 -4.813360 -5.063884 -5.320457 -5.582577 -80.00000 -4.813318 -4.359800 -4.311366 -4.410715 -4.585048 -4.785185 -5.013345 -5.263912 -5.520523 -5.782678 -80.00000 -5.044787 -4.588624 -4.539146 -4.637935 -4.811942 -5.011839 -5.239828 -5.490268 -5.746769 -6.008826 -80.00000 -5.484449 -5.006593 -4.947978 -5.041704 -5.212699 -5.410360 -5.636742 -5.885993 -6.141461 -6.402588 -80.00000 -6.092654 -5.557091 -5.474907 -5.555772 -5.719187 -5.911259 -6.133646 -6.379955 -6.632868 -6.891708 -80.00000 -6.935738 -6.259216 -6.125468 -6.179509 -6.327531 -6.508457 -6.722978 -6.963550 -7.211516 -7.465950 -80.00000 -7.778963 -6.877107 -6.675066 -6.695987 -6.825708 -6.993711 -7.199270 -7.433396 -7.675852 -7.925416 -80.00000 -3.731721 -3.217849 -3.115416 -3.168534 -3.299410 -3.462918 -3.656428 -3.873628 -4.102224 -4.341280 -80.00000 -3.940182 -3.426545 -3.324263 -3.377486 -3.508430 -3.671989 -3.865537 -4.082766 -4.311387 -4.550466 -80.00000 -4.145864 -3.632585 -3.530502 -3.583851 -3.714876 -3.878496 -4.072087 -4.289349 -4.517999 -4.757104 -80.00000 -4.346851 -3.834161 -3.732377 -3.785909 -3.917045 -4.080747 -4.274398 -4.491704 -4.720393 -4.959534 -80.00000 -4.545773 -4.033544 -3.932026 -3.985725 -4.116964 -4.280741 -4.474446 -4.691793 -4.920519 -5.159693 -80.00000 -4.777045 -4.262117 -4.159551 -4.212704 -4.343641 -4.507204 -4.700757 -4.917988 -5.146611 -5.385693 -80.00000 -5.215277 -4.678026 -4.566146 -4.614267 -4.742364 -4.903889 -5.096001 -5.312139 -5.539792 -5.778002 -80.00000 -5.819753 -5.223232 -5.087395 -5.122766 -5.243729 -5.400179 -5.588722 -5.802171 -6.027441 -6.263515 -80.00000 -6.653486 -5.913641 -5.726024 -5.735111 -5.841753 -5.988197 -6.169792 -6.378064 -6.598777 -6.830791 -80.00000 -7.481294 -6.515893 -6.260815 -6.237919 -6.327770 -6.462784 -6.636586 -6.839144 -7.054868 -7.282472 -80.00000 -3.573675 -3.021224 -2.881544 -2.900208 -2.996863 -3.129120 -3.292336 -3.480420 -3.683591 -3.900708 -80.00000 -3.782142 -3.229932 -3.090411 -3.109183 -3.205907 -3.338216 -3.501468 -3.689579 -3.892775 -4.109915 -80.00000 -3.987834 -3.435992 -3.296675 -3.315578 -3.412383 -3.544750 -3.708044 -3.896187 -4.099412 -4.316578 -80.00000 -4.188838 -3.637599 -3.498590 -3.517678 -3.614593 -3.747039 -3.910389 -4.098576 -4.301840 -4.519042 -80.00000 -4.387768 -3.837008 -3.698274 -3.717532 -3.814550 -3.947070 -4.110471 -4.298697 -4.501997 -4.719233 -80.00000 -4.618927 -4.065443 -3.925660 -3.944385 -4.041118 -4.173438 -4.336699 -4.524813 -4.728012 -4.945156 -80.00000 -5.056336 -4.480198 -4.331033 -4.344774 -4.438788 -4.569197 -4.731112 -4.918173 -5.120417 -5.336694 -80.00000 -5.658666 -5.022449 -4.849181 -4.850306 -4.937501 -5.063155 -5.221743 -5.406220 -5.606126 -5.820292 -80.00000 -6.487057 -5.706373 -5.481357 -5.456628 -5.530209 -5.646541 -5.798691 -5.978226 -6.173686 -6.383860 -80.00000 -7.306160 -6.300071 -6.008225 -5.952265 -6.009989 -6.115748 -6.260731 -6.434865 -6.625502 -6.831382 -80.00000 -3.460865 -2.879144 -2.710190 -2.700709 -2.768634 -2.873596 -3.009873 -3.171825 -3.351452 -3.547521 -80.00000 -3.669336 -3.087862 -2.919070 -2.909700 -2.977695 -3.082707 -3.219020 -3.380999 -3.560650 -3.756743 -80.00000 -3.875036 -3.293936 -3.125351 -3.116114 -3.184190 -3.289259 -3.425612 -3.587623 -3.767303 -3.963422 -80.00000 -4.076051 -3.495565 -3.327293 -3.318243 -3.386426 -3.491573 -3.627980 -3.790032 -3.969752 -4.165907 -80.00000 -4.274988 -3.694992 -3.527001 -3.518124 -3.586409 -3.691627 -3.828084 -3.990175 -4.169931 -4.366119 -80.00000 -4.506067 -3.923332 -3.754296 -3.744894 -3.812908 -3.917938 -4.054261 -4.216243 -4.395898 -4.591994 -80.00000 -4.942898 -4.337296 -4.158844 -4.144511 -4.209906 -4.313119 -4.448164 -4.609115 -4.787817 -4.983043 -80.00000 -5.543724 -4.877519 -4.674907 -4.648091 -4.706920 -4.805618 -4.937508 -5.095932 -5.272307 -5.465411 -80.00000 -6.368385 -5.557018 -5.302761 -5.250464 -5.296227 -5.386103 -5.511909 -5.665521 -5.837484 -6.026596 -80.00000 -7.181452 -6.144917 -5.824356 -5.741414 -5.772020 -5.851932 -5.970996 -6.119380 -6.286583 -6.471420 -80.00000 -3.372978 -2.767465 -2.574155 -2.540674 -2.583674 -2.664376 -2.776408 -2.914627 -3.072371 -3.248361 -80.00000 -3.581452 -2.976190 -2.783045 -2.749677 -2.792747 -2.873498 -2.985564 -3.123811 -3.281579 -3.457592 -80.00000 -3.787157 -3.182273 -2.989340 -2.956106 -2.999256 -3.080063 -3.192168 -3.330446 -3.488243 -3.664283 -80.00000 -3.988181 -3.383919 -3.191302 -3.158256 -3.201512 -3.282394 -3.394551 -3.532870 -3.690707 -3.866783 -80.00000 -4.187122 -3.583361 -3.391029 -3.358157 -3.401514 -3.482465 -3.594670 -3.733028 -3.890901 -4.067010 -80.00000 -4.418141 -3.811629 -3.618255 -3.584868 -3.627965 -3.708737 -3.820815 -3.959064 -4.116836 -4.292853 -80.00000 -4.854528 -4.224995 -4.022192 -3.983923 -4.024486 -4.103518 -4.214372 -4.351604 -4.508422 -4.683561 -80.00000 -5.454197 -4.763688 -4.536706 -4.486084 -4.520294 -4.595004 -4.702836 -4.837579 -4.992069 -5.165070 -80.00000 -6.276000 -5.439857 -5.161361 -5.085588 -5.107189 -5.173473 -5.275491 -5.405504 -5.555593 -5.724577 -80.00000 -7.084466 -6.023416 -5.679067 -5.573141 -5.580150 -5.636944 -5.732542 -5.857438 -6.002789 -6.167488 -80.00000 -3.300918 -2.675259 -2.460978 -2.406468 -2.427366 -2.486204 -2.576188 -2.692669 -2.830020 -2.986928 -80.00000 -3.509394 -2.883990 -2.669876 -2.615480 -2.636448 -2.695334 -2.785352 -2.901859 -3.039235 -3.196167 -80.00000 -3.715104 -3.090082 -2.876182 -2.821921 -2.842968 -2.901909 -2.991965 -3.108502 -3.245907 -3.402866 -80.00000 -3.916136 -3.291741 -3.078160 -3.024087 -3.045239 -3.104253 -3.194359 -3.310938 -3.448383 -3.605378 -80.00000 -4.115080 -3.491194 -3.277901 -3.224004 -3.245255 -3.304336 -3.394490 -3.511107 -3.648587 -3.805616 -80.00000 -4.346051 -3.719406 -3.505074 -3.450670 -3.471670 -3.530580 -3.620611 -3.737121 -3.874500 -4.031435 -80.00000 -4.782076 -4.132293 -3.908530 -3.849290 -3.867832 -3.925067 -4.013918 -4.129419 -4.265843 -4.421894 -80.00000 -5.380808 -4.669764 -4.421824 -4.350354 -4.362730 -4.415804 -4.501742 -4.614781 -4.748873 -4.902769 -80.00000 -6.200300 -5.343283 -5.043968 -4.947646 -4.947803 -4.992780 -5.073123 -5.181490 -5.311180 -5.461032 -80.00000 -7.005059 -5.923395 -5.558629 -5.432580 -5.418622 -5.454497 -5.528676 -5.632002 -5.756961 -5.902507 -80.00000 -3.239816 -2.596629 -2.363866 -2.290577 -2.291568 -2.330485 -2.400249 -2.496678 -2.614972 -2.753780 -80.00000 -3.448295 -2.805365 -2.572772 -2.499597 -2.500658 -2.539622 -2.609419 -2.705875 -2.824193 -2.963025 -80.00000 -3.654008 -3.011464 -2.779086 -2.706047 -2.707187 -2.746204 -2.816039 -2.912524 -3.030871 -3.169731 -80.00000 -3.855047 -3.213135 -2.981077 -2.908226 -2.909470 -2.948558 -3.018442 -3.114968 -3.233355 -3.372252 -80.00000 -4.053994 -3.412596 -3.180831 -3.108156 -3.109497 -3.148652 -3.218581 -3.315145 -3.433568 -3.572499 -80.00000 -4.284923 -3.640761 -3.407960 -3.334786 -3.335885 -3.374874 -3.444685 -3.541142 -3.659464 -3.798301 -80.00000 -4.720646 -4.053253 -3.811022 -3.733058 -3.731765 -3.769135 -3.837803 -3.933259 -4.050623 -4.188569 -80.00000 -5.318591 -4.589711 -4.323319 -4.233239 -4.225945 -4.259295 -4.325142 -4.418155 -4.533183 -4.668959 -80.00000 -6.136144 -5.261036 -4.943411 -4.828753 -4.809584 -4.835116 -4.895552 -4.983936 -5.094557 -5.226265 -80.00000 -6.937806 -5.838307 -5.455592 -5.311583 -5.278713 -5.295471 -5.349953 -5.433354 -5.539243 -5.666623 -80.00000 -3.186758 -2.528021 -2.278694 -2.188399 -2.171248 -2.191852 -2.242940 -2.320764 -2.421194 -2.542844 -80.00000 -3.395238 -2.736760 -2.487605 -2.397426 -2.380344 -2.400995 -2.452115 -2.529964 -2.630419 -2.752093 -80.00000 -3.600954 -2.942865 -2.693926 -2.603884 -2.586879 -2.607583 -2.658739 -2.736619 -2.837103 -2.958804 -80.00000 -3.801998 -3.144546 -2.895929 -2.806074 -2.789172 -2.809945 -2.861149 -2.939070 -3.039593 -3.161332 -80.00000 -4.000949 -3.344016 -3.095693 -3.006015 -2.989209 -3.010047 -3.061296 -3.139254 -3.239814 -3.361586 -80.00000 -4.231842 -3.572141 -3.322786 -3.232615 -3.215575 -3.236253 -3.287387 -3.365238 -3.465697 -3.587375 -80.00000 -4.667304 -3.984295 -3.725516 -3.630598 -3.611226 -3.630335 -3.680357 -3.757214 -3.856714 -3.977495 -80.00000 -5.264571 -4.519891 -4.236974 -4.130050 -4.104826 -4.120035 -4.167316 -4.241745 -4.338904 -4.457504 -80.00000 -6.080458 -5.189353 -4.855343 -4.724093 -4.687300 -4.694935 -4.736962 -4.806795 -4.899542 -5.014052 -80.00000 -6.879464 -5.764215 -5.365443 -5.205180 -5.155052 -5.154196 -5.190449 -5.255342 -5.343354 -5.453516 -80.00000 -3.139856 -2.467122 -2.202758 -2.096899 -2.063059 -2.066708 -2.100440 -2.160914 -2.244552 -2.349925 -80.00000 -3.348338 -2.675865 -2.411674 -2.305931 -2.272160 -2.275855 -2.309618 -2.370118 -2.453781 -2.559178 -80.00000 -3.554057 -2.881975 -2.618003 -2.512396 -2.478702 -2.482448 -2.516247 -2.576777 -2.660469 -2.765894 -80.00000 -3.755106 -3.083664 -2.820014 -2.714596 -2.681003 -2.684817 -2.718663 -2.779233 -2.862964 -2.968427 -80.00000 -3.954059 -3.283141 -3.019787 -2.914546 -2.881048 -2.884926 -2.918815 -2.979422 -3.063190 -3.168687 -80.00000 -4.184921 -3.511231 -3.246850 -3.141121 -3.107395 -3.111118 -3.144896 -3.205397 -3.289064 -3.394466 -80.00000 -4.620154 -3.923093 -3.649295 -3.538861 -3.502858 -3.505055 -3.537748 -3.597260 -3.679966 -3.784468 -80.00000 -5.216826 -4.457941 -4.160033 -4.037694 -3.995975 -3.994381 -4.024403 -4.081498 -4.161861 -4.264171 -80.00000 -6.031253 -5.125788 -4.776925 -4.630493 -4.577480 -4.568528 -4.593432 -4.645957 -4.721903 -4.820107 -80.00000 -6.827937 -5.698565 -5.285242 -5.110106 -5.044087 -5.026891 -5.046176 -5.093796 -5.165003 -5.258839 -80.00000 -3.097822 -2.412343 -2.134193 -2.013964 -1.964658 -1.952512 -1.970032 -2.014255 -2.082062 -2.171982 -80.00000 -3.306305 -2.621089 -2.343113 -2.223002 -2.173764 -2.161663 -2.179214 -2.223462 -2.291294 -2.381238 -80.00000 -3.512027 -2.827204 -2.549447 -2.429472 -2.380311 -2.368261 -2.385846 -2.430123 -2.497985 -2.587956 -80.00000 -3.713080 -3.028900 -2.751468 -2.631680 -2.582618 -2.570636 -2.588267 -2.632584 -2.700485 -2.790494 -80.00000 -3.912035 -3.228384 -2.951248 -2.831638 -2.782671 -2.770750 -2.788424 -2.832778 -2.900715 -2.990760 -80.00000 -4.142870 -3.456444 -3.178283 -3.058192 -3.009002 -2.996931 -3.014496 -3.058745 -3.126581 -3.216531 -80.00000 -4.577899 -3.868047 -3.580480 -3.455723 -3.404305 -3.390747 -3.407253 -3.450516 -3.517391 -3.606437 -80.00000 -5.174041 -4.402235 -4.090589 -3.954024 -3.897014 -3.879762 -3.893658 -3.934515 -3.999044 -4.085890 -80.00000 -5.987170 -5.068660 -4.706192 -4.545752 -4.477700 -4.453282 -4.462180 -4.498489 -4.558597 -4.641321 -80.00000 -6.781793 -5.639606 -5.212957 -5.024096 -4.943335 -4.910894 -4.914308 -4.945738 -5.001103 -5.079445 -80.00000 -4.590080 -4.152777 -4.116721 -4.224746 -4.405835 -4.610326 -4.841816 -5.095037 -5.353061 -5.615688 -80.00000 -4.796973 -4.359129 -4.322796 -4.430654 -4.611638 -4.816049 -5.047480 -5.300658 -5.558644 -5.821237 -80.00000 -5.009127 -4.570579 -4.533880 -4.641516 -4.822361 -5.026666 -5.258019 -5.511140 -5.769075 -6.031623 -80.00000 -5.227439 -4.788027 -4.750869 -4.858227 -5.038896 -5.243067 -5.474323 -5.727371 -5.985242 -6.247732 -80.00000 -5.451623 -5.011290 -4.973623 -5.080666 -5.261135 -5.465153 -5.696297 -5.949261 -6.207060 -6.469483 -80.00000 -5.677851 -5.236902 -5.198832 -5.305613 -5.485912 -5.689798 -5.920843 -6.173736 -6.431470 -6.693836 -80.00000 -5.893866 -5.453530 -5.415584 -5.522398 -5.702702 -5.906588 -6.137631 -6.390520 -6.648252 -6.910614 -80.00000 -6.006006 -5.567191 -5.529844 -5.636978 -5.817470 -6.021494 -6.252636 -6.505597 -6.763391 -7.025809 -80.00000 -6.077496 -5.640224 -5.603538 -5.711038 -5.891748 -6.095936 -6.327195 -6.580243 -6.838111 -7.100597 -80.00000 -6.191546 -5.745472 -5.706206 -5.812224 -5.992028 -6.195552 -6.426342 -6.679051 -6.936650 -7.198906 -80.00000 -4.300084 -3.803241 -3.714758 -3.779034 -3.919467 -4.090636 -4.290616 -4.513222 -4.745785 -4.987612 -80.00000 -4.506947 -4.009534 -3.920758 -3.984861 -4.125193 -4.296287 -4.496214 -4.718781 -4.951309 -5.193104 -80.00000 -4.719063 -4.220905 -4.131742 -4.195617 -4.335814 -4.506809 -4.706666 -4.929180 -5.161662 -5.403415 -80.00000 -4.937331 -4.438255 -4.348607 -4.412195 -4.552219 -4.723090 -4.922858 -5.145306 -5.377728 -5.619429 -80.00000 -5.161471 -4.661413 -4.571223 -4.634483 -4.774311 -4.945038 -5.144705 -5.367076 -5.599431 -5.841070 -80.00000 -5.387680 -4.886953 -4.796323 -4.859304 -4.998961 -5.169563 -5.369140 -5.591444 -5.823740 -6.065325 -80.00000 -5.603761 -5.103641 -5.013110 -5.076104 -5.215754 -5.386349 -5.585919 -5.808221 -6.040513 -6.282094 -80.00000 -5.716013 -5.217463 -5.127535 -5.190839 -5.330658 -5.501375 -5.701031 -5.923397 -6.155746 -6.397378 -80.00000 -5.787606 -5.290663 -5.201411 -5.265077 -5.405099 -5.575962 -5.775721 -5.998164 -6.230581 -6.472276 -80.00000 -5.901846 -5.395929 -5.304183 -5.366416 -5.505559 -5.675754 -5.875014 -6.097069 -6.329161 -6.570576 -80.00000 -4.128594 -3.591858 -3.465412 -3.495167 -3.601640 -3.742315 -3.912963 -4.107526 -4.315959 -4.537265 -80.00000 -4.335440 -3.798115 -3.671369 -3.700949 -3.807323 -3.947928 -4.118527 -4.313052 -4.521451 -4.742725 -80.00000 -4.547534 -4.009441 -3.882297 -3.911647 -4.017889 -4.158400 -4.328933 -4.523408 -4.731761 -4.952995 -80.00000 -4.765775 -4.226736 -4.099093 -4.128150 -4.234225 -4.374618 -4.545068 -4.739480 -4.947774 -5.168955 -80.00000 -4.989890 -4.449834 -4.321630 -4.350355 -4.456237 -4.596493 -4.766848 -4.961186 -5.169415 -5.390535 -80.00000 -5.216088 -4.675331 -4.546668 -4.575105 -4.680817 -4.820953 -4.991223 -5.185497 -5.393668 -5.614736 -80.00000 -5.432206 -4.892051 -4.763471 -4.791909 -4.897607 -5.037733 -5.207995 -5.402266 -5.610433 -5.831497 -80.00000 -5.544524 -5.005962 -4.877986 -4.906725 -5.012581 -5.152818 -5.323159 -5.517491 -5.725714 -5.946828 -80.00000 -5.616176 -5.079257 -4.951962 -4.981058 -5.087107 -5.227479 -5.397914 -5.592320 -5.800611 -6.021786 -80.00000 -5.730553 -5.184583 -5.054881 -5.082617 -5.187841 -5.327575 -5.497514 -5.691505 -5.899432 -6.120284 -80.00000 -4.006086 -3.438736 -3.281938 -3.282829 -3.360015 -3.473169 -3.616848 -3.785432 -3.970764 -4.171696 -80.00000 -4.212920 -3.644970 -3.487867 -3.488582 -3.565672 -3.678758 -3.822391 -3.990938 -4.176235 -4.377136 -80.00000 -4.424998 -3.856264 -3.698756 -3.699240 -3.776201 -3.889198 -4.032768 -4.201266 -4.386518 -4.587378 -80.00000 -4.643221 -4.073520 -3.915504 -3.915694 -3.992492 -4.105375 -4.248866 -4.417303 -4.602497 -4.803303 -80.00000 -4.867317 -4.296576 -4.137987 -4.137842 -4.214450 -4.327204 -4.470603 -4.638968 -4.824097 -5.024843 -80.00000 -5.093507 -4.522043 -4.362981 -4.362544 -4.438984 -4.551621 -4.694940 -4.863242 -5.048313 -5.249006 -80.00000 -5.309652 -4.738784 -4.579795 -4.579348 -4.655770 -4.768395 -4.911706 -5.080005 -5.265072 -5.465762 -80.00000 -5.422016 -4.852757 -4.694369 -4.694217 -4.770789 -4.883517 -5.026902 -5.195261 -5.380383 -5.581123 -80.00000 -5.493709 -4.926117 -4.768413 -4.768613 -4.845368 -4.958224 -5.101698 -5.270129 -5.455318 -5.656118 -80.00000 -5.608196 -5.031507 -4.871479 -4.870394 -4.946388 -5.058648 -5.201645 -5.369656 -5.554462 -5.754913 -80.00000 -3.910583 -3.318159 -3.135830 -3.111737 -3.163073 -3.251248 -3.370106 -3.514549 -3.677852 -3.858788 -80.00000 -4.117408 -3.524374 -3.341736 -3.317469 -3.368710 -3.456820 -3.575633 -3.720040 -3.883309 -4.064213 -80.00000 -4.329474 -3.735645 -3.552597 -3.528098 -3.579213 -3.667238 -3.785990 -3.930349 -4.093573 -4.274435 -80.00000 -4.547683 -3.952871 -3.769309 -3.744515 -3.795470 -3.883386 -4.002063 -4.146360 -4.309526 -4.490336 -80.00000 -4.771765 -4.175896 -3.991752 -3.966621 -4.017391 -4.105181 -4.223770 -4.367998 -4.531098 -4.711846 -80.00000 -4.997949 -4.401339 -4.216712 -4.191286 -4.241890 -4.329568 -4.448080 -4.592246 -4.755288 -4.935983 -80.00000 -5.214115 -4.618095 -4.433532 -4.408091 -4.458673 -4.546338 -4.664841 -4.809004 -4.972042 -5.152733 -80.00000 -5.326513 -4.732115 -4.548151 -4.522997 -4.573722 -4.661484 -4.780057 -4.924280 -5.087373 -5.268115 -80.00000 -5.398239 -4.805524 -4.622244 -4.597439 -4.648339 -4.736223 -4.854881 -4.999175 -5.162335 -5.343138 -80.00000 -5.512817 -4.910977 -4.725449 -4.699431 -4.749636 -4.836972 -4.955183 -5.099063 -5.261838 -5.442280 -80.00000 -3.832242 -3.218467 -3.013977 -2.967762 -2.995892 -3.061225 -3.157149 -3.279100 -3.421469 -3.582976 -80.00000 -4.039059 -3.424667 -3.219866 -3.173476 -3.201514 -3.266785 -3.362665 -3.484580 -3.626915 -3.788390 -80.00000 -4.251116 -3.635918 -3.430705 -3.384082 -3.411998 -3.477186 -3.573008 -3.694875 -3.837165 -3.998597 -80.00000 -4.469313 -3.853121 -3.647387 -3.600471 -3.628230 -3.693313 -3.789062 -3.910869 -4.053101 -4.214478 -80.00000 -4.693384 -4.076119 -3.869798 -3.822544 -3.850121 -3.915083 -4.010747 -4.132485 -4.274650 -4.435966 -80.00000 -4.919562 -4.301544 -4.094732 -4.047181 -4.074595 -4.139448 -4.235037 -4.356714 -4.498821 -4.660083 -80.00000 -5.135744 -4.518312 -4.311557 -4.263985 -4.291374 -4.356212 -4.451794 -4.573467 -4.715571 -4.876829 -80.00000 -5.248171 -4.632369 -4.426209 -4.378920 -4.406446 -4.471377 -4.567025 -4.688758 -4.830917 -4.992226 -80.00000 -5.319923 -4.705817 -4.500343 -4.453396 -4.481091 -4.546139 -4.641869 -4.763672 -4.905898 -5.067269 -80.00000 -5.434580 -4.811330 -4.603676 -4.555588 -4.582651 -4.647202 -4.742519 -4.863925 -5.005772 -5.166783 -80.00000 -3.765788 -3.133354 -2.909216 -2.843087 -2.850127 -2.894421 -2.969060 -3.069993 -3.192503 -3.335258 -80.00000 -3.972598 -3.339542 -3.115090 -3.048788 -3.055737 -3.099971 -3.174568 -3.275466 -3.397941 -3.540663 -80.00000 -4.184647 -3.550777 -3.325910 -3.259376 -3.266204 -3.310359 -3.384900 -3.485750 -3.608179 -3.750858 -80.00000 -4.402834 -3.767960 -3.542569 -3.475741 -3.482417 -3.526469 -3.600939 -3.701730 -3.824100 -3.966726 -80.00000 -4.626895 -3.990937 -3.764953 -3.697788 -3.704285 -3.748219 -3.822608 -3.923330 -4.045634 -4.188196 -80.00000 -4.853069 -4.216345 -3.989866 -3.922401 -3.928738 -3.972566 -4.046881 -4.147543 -4.269790 -4.412297 -80.00000 -5.069266 -4.433123 -4.206694 -4.139204 -4.145514 -4.189327 -4.263634 -4.364293 -4.486536 -4.629038 -80.00000 -5.181716 -4.547210 -4.321374 -4.254162 -4.260602 -4.304505 -4.378877 -4.479594 -4.601892 -4.744447 -80.00000 -5.253490 -4.620691 -4.395539 -4.328666 -4.335271 -4.379285 -4.453736 -4.554523 -4.676889 -4.819506 -80.00000 -5.368217 -4.726262 -4.498994 -4.431045 -4.437078 -4.480647 -4.554722 -4.655134 -4.777135 -4.919401 -80.00000 -3.708061 -3.059016 -2.817182 -2.732909 -2.720590 -2.745384 -2.800182 -2.881419 -2.985093 -3.109826 -80.00000 -3.914866 -3.265194 -3.023045 -2.938598 -2.926191 -2.950927 -3.005684 -3.086885 -3.190525 -3.315225 -80.00000 -4.126908 -3.476415 -3.233848 -3.149171 -3.136645 -3.161304 -3.216007 -3.297161 -3.400755 -3.525411 -80.00000 -4.345086 -3.693581 -3.450488 -3.365517 -3.352841 -3.377400 -3.432034 -3.513129 -3.616664 -3.741266 -80.00000 -4.569139 -3.916539 -3.672849 -3.587541 -3.574691 -3.599135 -3.653690 -3.734716 -3.838185 -3.962723 -80.00000 -4.795310 -4.141934 -3.897743 -3.812135 -3.799126 -3.823467 -3.877951 -3.958918 -4.062328 -4.186811 -80.00000 -5.011518 -4.358720 -4.114573 -4.028937 -4.015899 -4.040225 -4.094700 -4.175665 -4.279071 -4.403549 -80.00000 -5.123989 -4.472833 -4.229278 -4.143914 -4.131001 -4.155414 -4.209951 -4.290974 -4.394436 -4.518966 -80.00000 -5.195782 -4.546342 -4.303470 -4.218441 -4.205688 -4.230208 -4.284822 -4.365915 -4.469444 -4.594038 -80.00000 -5.310572 -4.651966 -4.407037 -4.320994 -4.307730 -4.331854 -4.386131 -4.466873 -4.570057 -4.694314 -80.00000 -3.657019 -2.992976 -2.735015 -2.634050 -2.603823 -2.610444 -2.646671 -2.709393 -2.795197 -2.902651 -80.00000 -3.863819 -3.199145 -2.940867 -2.839730 -2.809416 -2.815979 -2.852167 -2.914854 -3.000623 -3.108044 -80.00000 -4.075854 -3.410354 -3.151657 -3.050289 -3.019860 -3.026348 -3.062483 -3.125123 -3.210845 -3.318223 -80.00000 -4.294025 -3.627505 -3.368279 -3.266619 -3.236042 -3.242434 -3.278502 -3.341082 -3.426746 -3.534068 -80.00000 -4.518070 -3.850447 -3.590621 -3.488624 -3.457875 -3.464156 -3.500146 -3.562659 -3.648256 -3.755514 -80.00000 -4.744238 -4.075830 -3.815499 -3.713202 -3.682297 -3.688476 -3.724397 -3.786851 -3.872389 -3.979592 -80.00000 -4.960456 -4.292623 -4.032331 -3.930002 -3.899067 -3.905231 -3.941144 -4.003595 -4.089129 -4.196326 -80.00000 -5.072946 -4.406759 -4.147056 -4.044994 -4.014180 -4.020428 -4.056401 -4.118911 -4.204501 -4.311750 -80.00000 -5.144755 -4.480292 -4.221271 -4.119541 -4.088882 -4.095233 -4.131282 -4.193861 -4.279518 -4.386831 -80.00000 -5.259603 -4.585967 -4.324944 -4.222260 -4.191144 -4.197149 -4.232898 -4.295153 -4.380487 -4.487484 -80.00000 -3.611261 -2.933529 -2.660732 -2.544294 -2.497392 -2.486995 -2.505776 -2.551044 -2.619875 -2.710782 -80.00000 -3.818057 -3.139690 -2.866575 -2.749965 -2.702978 -2.692526 -2.711267 -2.756500 -2.825296 -2.916171 -80.00000 -4.030087 -3.350889 -3.077353 -2.960513 -2.913413 -2.902887 -2.921577 -2.966763 -3.035513 -3.126344 -80.00000 -4.248250 -3.568026 -3.293960 -3.176829 -3.129584 -3.118963 -3.137588 -3.182716 -3.251407 -3.342181 -80.00000 -4.472290 -3.790954 -3.516285 -3.398817 -3.351404 -3.340675 -3.359223 -3.404284 -3.472907 -3.563618 -80.00000 -4.698454 -4.016326 -3.741148 -3.623380 -3.575812 -3.564985 -3.583466 -3.628468 -3.697032 -3.787686 -80.00000 -4.914681 -4.233125 -3.957983 -3.840179 -3.792580 -3.781737 -3.800210 -3.845209 -3.913769 -4.004419 -80.00000 -5.027187 -4.347281 -4.072724 -3.955185 -3.907703 -3.896941 -3.915473 -3.960530 -4.029146 -4.119848 -80.00000 -5.099011 -4.420835 -4.146960 -4.029749 -3.982418 -3.971756 -3.990361 -4.035488 -4.104172 -4.194937 -80.00000 -5.213912 -4.526558 -4.250733 -4.132623 -4.084889 -4.073927 -4.092271 -4.137101 -4.205487 -4.295958 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -80.00000 -4.824951 -4.354719 -4.293616 -4.383717 -4.550628 -4.745571 -4.969611 -5.216838 -5.471406 -5.732532 -80.00000 -5.033405 -4.563397 -4.502436 -4.592635 -4.759613 -4.954607 -5.178686 -5.425942 -5.680535 -5.941686 -80.00000 -5.239073 -4.769411 -4.708639 -4.798959 -4.966016 -5.161071 -5.385196 -5.632486 -5.887108 -6.148287 -80.00000 -5.440037 -4.970942 -4.910459 -5.000956 -5.168123 -5.363264 -5.587450 -5.834786 -6.089450 -6.350666 -80.00000 -5.638948 -5.170291 -5.110059 -5.200716 -5.367985 -5.563202 -5.787446 -6.034825 -6.289526 -6.550776 -80.00000 -5.870373 -5.399060 -5.337787 -5.427888 -5.594838 -5.789822 -6.013899 -6.261155 -6.515748 -6.776901 -80.00000 -6.309711 -5.816583 -5.746153 -5.831219 -5.995209 -6.188010 -6.410521 -6.656613 -6.910192 -7.170434 -80.00000 -6.917065 -6.365926 -6.271893 -6.344174 -6.500716 -6.688067 -6.906692 -7.149907 -7.400981 -7.658980 -80.00000 -7.758000 -7.065470 -6.919932 -6.965611 -7.107067 -7.283574 -7.494563 -7.732183 -7.978419 -8.232110 -80.00000 -8.597626 -7.679856 -7.466349 -7.479285 -7.602862 -7.766837 -7.969155 -8.200513 -8.441377 -8.690321 -80.00000 -4.576595 -4.048885 -3.934760 -3.978174 -4.100406 -4.256740 -4.443992 -4.655807 -4.880300 -5.116357 -80.00000 -4.785057 -4.257583 -4.143612 -4.187130 -4.309432 -4.465816 -4.653106 -4.864949 -5.089467 -5.325547 -80.00000 -4.990741 -4.463628 -4.349855 -4.393503 -4.515884 -4.672329 -4.859661 -5.071537 -5.296084 -5.532191 -80.00000 -5.191732 -4.665211 -4.551740 -4.595570 -4.718061 -4.874588 -5.061978 -5.273898 -5.498486 -5.734627 -80.00000 -5.390656 -4.864600 -4.751398 -4.795394 -4.917988 -5.074590 -5.262034 -5.473994 -5.698618 -5.934793 -80.00000 -5.621902 -5.093143 -4.978892 -5.022346 -5.144644 -5.301034 -5.488328 -5.700173 -5.924695 -6.160778 -80.00000 -6.059944 -5.508791 -5.385217 -5.423658 -5.543147 -5.697531 -5.883406 -6.094167 -6.317721 -6.552934 -80.00000 -6.663919 -6.053325 -5.905776 -5.931515 -6.043953 -6.193343 -6.375706 -6.583799 -6.804981 -7.038066 -80.00000 -7.496398 -6.742249 -6.542958 -6.542546 -6.640849 -6.780405 -6.955940 -7.158905 -7.375554 -7.604597 -80.00000 -8.322132 -7.342512 -7.075946 -7.043766 -7.125523 -7.253863 -7.421755 -7.619073 -7.830771 -8.055435 -80.00000 -4.430078 -3.865240 -3.714849 -3.724237 -3.812375 -3.937126 -4.093531 -4.275534 -4.473648 -4.686629 -80.00000 -4.638546 -4.073951 -3.923718 -3.933215 -4.021422 -4.146224 -4.302666 -4.484696 -4.682836 -4.895840 -80.00000 -4.844239 -4.280013 -4.129986 -4.139614 -4.227902 -4.352762 -4.509245 -4.691308 -4.889475 -5.102506 -80.00000 -5.045245 -4.481625 -4.331906 -4.341720 -4.430117 -4.555056 -4.711595 -4.893701 -5.091908 -5.304974 -80.00000 -5.244177 -4.681038 -4.531595 -4.541580 -4.630080 -4.755091 -4.911682 -5.093827 -5.292070 -5.505169 -80.00000 -5.475320 -4.909454 -4.758964 -4.768417 -4.856635 -4.981449 -5.137900 -5.319933 -5.518075 -5.731083 -80.00000 -5.912614 -5.324052 -5.164172 -5.168653 -5.254174 -5.377097 -5.532215 -5.713197 -5.910382 -6.122521 -80.00000 -6.514644 -5.865898 -5.681902 -5.673798 -5.752553 -5.870772 -6.022596 -6.200999 -6.395842 -6.605864 -80.00000 -7.342285 -6.548930 -6.313203 -6.279327 -6.344587 -6.453588 -6.599042 -6.772516 -6.962911 -7.168934 -80.00000 -8.160154 -7.141438 -6.838987 -6.774008 -6.823563 -6.922120 -7.060491 -7.228585 -7.414158 -7.615883 -80.00000 -4.325567 -3.732805 -3.554277 -3.536367 -3.596480 -3.694357 -3.824076 -3.980035 -4.154424 -4.345951 -80.00000 -4.534039 -3.941524 -3.763159 -3.745360 -3.805543 -3.903470 -4.033224 -4.189210 -4.363624 -4.555174 -80.00000 -4.739738 -4.147599 -3.969443 -3.951777 -4.012040 -4.110024 -4.239818 -4.395836 -4.570279 -4.761856 -80.00000 -4.940756 -4.349230 -4.171388 -4.153909 -4.214280 -4.312340 -4.442188 -4.598248 -4.772730 -4.964344 -80.00000 -5.139692 -4.548660 -4.371099 -4.353794 -4.414267 -4.512397 -4.642295 -4.798394 -4.972912 -5.164559 -80.00000 -5.370764 -4.776989 -4.598383 -4.580555 -4.640759 -4.738702 -4.868468 -5.024457 -5.198874 -5.390428 -80.00000 -5.807534 -5.190866 -5.002839 -4.980083 -5.037681 -5.133820 -5.262315 -5.417272 -5.590733 -5.781413 -80.00000 -6.408198 -5.730864 -5.518662 -5.483440 -5.534503 -5.626155 -5.751513 -5.903941 -6.075068 -6.263618 -80.00000 -7.232457 -6.409866 -6.146015 -6.085354 -6.123420 -6.206311 -6.325621 -6.473234 -6.639937 -6.824478 -80.00000 -8.044863 -6.997104 -6.666991 -6.575751 -6.598746 -6.671745 -6.784358 -6.926744 -7.088675 -7.268926 -80.00000 -4.244185 -3.628856 -3.427121 -3.386201 -3.422330 -3.496715 -3.602845 -3.735595 -3.888401 -4.059946 -80.00000 -4.452659 -3.837581 -3.636013 -3.595205 -3.631404 -3.705838 -3.812003 -3.944779 -4.097610 -4.269178 -80.00000 -4.658364 -4.043665 -3.842309 -3.801636 -3.837914 -3.912404 -4.018608 -4.151415 -4.304275 -4.475871 -80.00000 -4.859389 -4.245313 -4.044272 -4.003787 -4.040172 -4.114737 -4.220992 -4.353842 -4.506741 -4.678373 -80.00000 -5.058330 -4.444755 -4.244000 -4.203690 -4.240175 -4.314809 -4.421113 -4.554000 -4.706936 -4.878602 -80.00000 -5.289347 -4.673019 -4.471222 -4.430397 -4.466623 -4.541078 -4.647255 -4.780035 -4.932868 -5.104441 -80.00000 -5.725713 -5.086349 -4.875116 -4.829409 -4.863107 -4.935828 -5.040783 -5.172543 -5.324420 -5.495111 -80.00000 -6.325327 -5.624950 -5.389520 -5.331461 -5.358819 -5.427231 -5.529172 -5.658437 -5.807978 -5.976522 -80.00000 -7.146993 -6.300916 -6.013946 -5.930744 -5.945519 -6.005531 -6.101673 -6.226198 -6.371323 -6.535835 -80.00000 -7.955228 -6.884198 -6.531365 -6.418025 -6.418244 -6.468796 -6.558535 -6.677933 -6.818304 -6.978514 -80.00000 -4.177485 -3.543130 -3.321537 -3.260619 -3.275685 -3.329144 -3.414099 -3.525880 -3.658890 -3.811790 -80.00000 -4.385961 -3.751860 -3.530435 -3.469632 -3.484768 -3.538276 -3.623263 -3.735070 -3.868106 -4.021030 -80.00000 -4.591670 -3.957952 -3.736741 -3.676073 -3.691288 -3.744851 -3.829876 -3.941714 -4.074779 -4.227730 -80.00000 -4.792702 -4.159612 -3.938719 -3.878239 -3.893559 -3.947195 -4.032271 -4.144150 -4.277255 -4.430243 -80.00000 -4.991647 -4.359065 -4.138461 -4.078156 -4.093576 -4.147279 -4.232402 -4.344320 -4.477460 -4.630482 -80.00000 -5.222619 -4.587277 -4.365633 -4.304821 -4.319991 -4.373522 -4.458523 -4.570333 -4.703372 -4.856300 -80.00000 -5.658657 -5.000170 -4.769085 -4.703434 -4.716143 -4.768000 -4.851820 -4.962618 -5.094699 -5.246739 -80.00000 -6.257420 -5.537653 -5.282370 -5.204476 -5.211015 -5.258710 -5.339617 -5.447946 -5.577687 -5.727565 -80.00000 -7.076985 -6.211196 -5.904490 -5.801722 -5.796034 -5.835631 -5.910940 -6.014584 -6.139908 -6.285730 -80.00000 -7.881856 -6.791332 -6.419119 -6.286593 -6.266785 -6.297276 -6.366417 -6.465006 -6.585584 -6.727083 -80.00000 -4.120945 -3.470093 -3.231081 -3.152419 -3.148651 -3.183208 -3.248925 -3.341565 -3.456299 -3.591761 -80.00000 -4.329424 -3.678828 -3.439986 -3.361439 -3.357741 -3.392345 -3.458095 -3.550761 -3.665520 -3.801006 -80.00000 -4.535137 -3.884927 -3.646300 -3.567888 -3.564269 -3.598927 -3.664715 -3.757411 -3.872199 -4.007712 -80.00000 -4.736175 -4.086596 -3.848290 -3.770067 -3.766551 -3.801281 -3.867118 -3.959855 -4.074682 -4.210233 -80.00000 -4.935122 -4.286057 -4.048043 -3.969996 -3.966579 -4.001374 -4.067257 -4.160032 -4.274896 -4.410480 -80.00000 -5.166056 -4.514227 -4.275176 -4.196628 -4.192967 -4.227598 -4.293362 -4.386030 -4.500792 -4.636282 -80.00000 -5.601819 -4.926757 -4.678265 -4.594918 -4.588858 -4.621865 -4.686482 -4.778147 -4.891949 -5.026546 -80.00000 -6.199866 -5.463313 -5.190632 -5.095145 -5.083066 -5.112039 -5.173828 -5.263041 -5.374502 -5.506924 -80.00000 -7.017670 -6.134849 -5.810866 -5.690749 -5.666756 -5.687888 -5.744249 -5.828819 -5.935859 -6.064203 -80.00000 -7.819727 -6.712386 -6.323215 -6.173679 -6.135942 -6.148270 -6.198658 -6.278227 -6.380522 -6.504523 -80.00000 -4.071862 -3.406415 -3.151851 -3.057199 -3.036363 -3.053659 -3.101738 -3.176761 -3.274525 -3.393633 -80.00000 -4.280342 -3.615154 -3.360761 -3.266225 -3.245459 -3.262802 -3.310913 -3.385961 -3.483750 -3.602883 -80.00000 -4.486058 -3.821258 -3.567082 -3.472682 -3.451993 -3.469389 -3.517537 -3.592616 -3.690433 -3.809593 -80.00000 -4.687101 -4.022936 -3.769082 -3.674871 -3.654285 -3.671751 -3.719947 -3.795066 -3.892923 -4.012121 -80.00000 -4.886051 -4.222405 -3.968845 -3.874810 -3.854321 -3.871852 -3.920092 -3.995249 -4.093143 -4.212375 -80.00000 -5.116952 -4.450537 -4.195944 -4.101414 -4.080689 -4.098059 -4.146184 -4.221235 -4.319027 -4.438165 -80.00000 -5.552477 -4.862758 -4.598728 -4.499437 -4.476367 -4.492159 -4.539167 -4.613220 -4.710051 -4.828290 -80.00000 -6.149909 -5.398524 -5.110322 -4.998987 -4.970034 -4.981904 -5.026158 -5.097774 -5.192261 -5.308314 -80.00000 -6.966197 -6.068352 -5.728968 -5.593229 -5.552640 -5.556893 -5.595865 -5.662870 -5.752933 -5.864890 -80.00000 -7.765839 -6.643682 -6.239401 -6.074548 -6.020547 -6.016257 -6.049423 -6.111470 -6.196785 -6.304382 -80.00000 -4.028485 -3.349931 -3.081293 -2.972064 -2.935599 -2.936998 -2.968781 -3.027479 -3.109408 -3.213138 -80.00000 -4.236967 -3.558673 -3.290208 -3.181096 -3.144700 -3.146144 -3.177959 -3.236682 -3.318636 -3.422390 -80.00000 -4.442685 -3.764781 -3.496535 -3.387559 -3.351240 -3.352737 -3.384587 -3.443340 -3.525323 -3.629105 -80.00000 -4.643732 -3.966467 -3.698544 -3.589756 -3.553540 -3.555104 -3.587001 -3.645796 -3.727818 -3.831638 -80.00000 -4.842684 -4.165942 -3.898314 -3.789705 -3.753583 -3.755212 -3.787153 -3.845984 -3.928044 -4.031898 -80.00000 -5.073558 -4.394043 -4.125385 -4.016285 -3.979934 -3.981407 -4.013235 -4.071961 -4.153919 -4.257678 -80.00000 -5.508874 -4.805995 -4.527906 -4.414082 -4.375435 -4.375370 -4.406106 -4.463839 -4.544836 -4.647693 -80.00000 -6.105763 -5.341074 -5.038834 -4.913057 -4.868650 -4.864763 -4.892810 -4.948119 -5.026768 -5.127430 -80.00000 -6.920724 -6.009419 -5.656117 -5.506143 -5.450352 -5.439046 -5.461938 -5.512663 -5.586885 -5.683435 -80.00000 -7.718253 -6.582838 -6.164904 -5.986095 -5.917191 -5.897570 -5.914800 -5.960600 -6.030073 -6.122249 -80.00000 -3.989617 -3.299153 -3.017646 -2.895005 -2.844109 -2.830761 -2.847393 -2.890878 -2.957968 -3.047196 -80.00000 -4.198100 -3.507898 -3.226565 -3.104041 -3.053213 -3.039911 -3.056573 -3.100084 -3.167199 -3.256452 -80.00000 -4.403821 -3.714010 -3.432897 -3.310509 -3.259758 -3.246508 -3.263205 -3.306745 -3.373890 -3.463170 -80.00000 -4.604872 -3.915703 -3.634914 -3.512715 -3.462064 -3.448881 -3.465624 -3.509205 -3.576389 -3.665707 -80.00000 -4.803826 -4.115184 -3.834692 -3.712670 -3.662114 -3.648993 -3.665780 -3.709398 -3.776618 -3.865971 -80.00000 -5.034674 -4.343257 -4.061737 -3.939231 -3.888451 -3.875178 -3.891854 -3.935367 -4.002486 -4.091743 -80.00000 -5.469805 -4.754972 -4.464027 -4.336832 -4.283802 -4.269027 -4.284635 -4.327158 -4.393315 -4.481668 -80.00000 -6.066213 -5.289444 -4.974374 -4.835312 -4.776634 -4.758127 -4.771102 -4.811212 -4.875020 -4.961171 -80.00000 -6.879991 -5.956482 -5.590465 -5.427400 -5.357567 -5.331818 -5.339751 -5.375299 -5.434678 -5.516704 -80.00000 -7.675644 -6.528217 -6.097817 -5.906171 -5.823495 -5.789636 -5.792034 -5.822684 -5.877311 -5.954950 -80.00000 -3.999337 -3.544263 -3.494967 -3.593764 -3.767738 -3.967597 -4.195550 -4.445961 -4.702436 -4.964467 -80.00000 -4.207788 -3.752936 -3.703780 -3.802674 -3.976714 -4.176625 -4.404617 -4.655058 -4.911559 -5.173613 -80.00000 -4.413453 -3.958942 -3.909973 -4.008988 -4.183107 -4.383080 -4.611118 -4.861594 -5.118125 -5.380207 -80.00000 -4.614410 -4.160461 -4.111778 -4.210969 -4.385200 -4.585258 -4.813360 -5.063884 -5.320457 -5.582577 -80.00000 -4.813318 -4.359800 -4.311366 -4.410715 -4.585048 -4.785185 -5.013345 -5.263912 -5.520523 -5.782678 -80.00000 -5.044787 -4.588624 -4.539146 -4.637935 -4.811942 -5.011839 -5.239828 -5.490268 -5.746769 -6.008826 -80.00000 -5.484449 -5.006593 -4.947978 -5.041704 -5.212699 -5.410360 -5.636742 -5.885993 -6.141461 -6.402588 -80.00000 -6.092654 -5.557091 -5.474907 -5.555772 -5.719187 -5.911259 -6.133646 -6.379955 -6.632868 -6.891708 -80.00000 -6.935738 -6.259216 -6.125468 -6.179509 -6.327531 -6.508457 -6.722978 -6.963550 -7.211516 -7.465950 -80.00000 -7.778963 -6.877107 -6.675066 -6.695987 -6.825708 -6.993711 -7.199270 -7.433396 -7.675852 -7.925416 -80.00000 -3.731721 -3.217849 -3.115416 -3.168534 -3.299410 -3.462918 -3.656428 -3.873628 -4.102224 -4.341280 -80.00000 -3.940182 -3.426545 -3.324263 -3.377486 -3.508430 -3.671989 -3.865537 -4.082766 -4.311387 -4.550466 -80.00000 -4.145864 -3.632585 -3.530502 -3.583851 -3.714876 -3.878496 -4.072087 -4.289349 -4.517999 -4.757104 -80.00000 -4.346851 -3.834161 -3.732377 -3.785909 -3.917045 -4.080747 -4.274398 -4.491704 -4.720393 -4.959534 -80.00000 -4.545773 -4.033544 -3.932026 -3.985725 -4.116964 -4.280741 -4.474446 -4.691793 -4.920519 -5.159693 -80.00000 -4.777045 -4.262117 -4.159551 -4.212704 -4.343641 -4.507204 -4.700757 -4.917988 -5.146611 -5.385693 -80.00000 -5.215277 -4.678026 -4.566146 -4.614267 -4.742364 -4.903889 -5.096001 -5.312139 -5.539792 -5.778002 -80.00000 -5.819753 -5.223232 -5.087395 -5.122766 -5.243729 -5.400179 -5.588722 -5.802171 -6.027441 -6.263515 -80.00000 -6.653486 -5.913641 -5.726024 -5.735111 -5.841753 -5.988197 -6.169792 -6.378064 -6.598777 -6.830791 -80.00000 -7.481294 -6.515893 -6.260815 -6.237919 -6.327770 -6.462784 -6.636586 -6.839144 -7.054868 -7.282472 -80.00000 -3.573675 -3.021224 -2.881544 -2.900208 -2.996863 -3.129120 -3.292336 -3.480420 -3.683591 -3.900708 -80.00000 -3.782142 -3.229932 -3.090411 -3.109183 -3.205907 -3.338216 -3.501468 -3.689579 -3.892775 -4.109915 -80.00000 -3.987834 -3.435992 -3.296675 -3.315578 -3.412383 -3.544750 -3.708044 -3.896187 -4.099412 -4.316578 -80.00000 -4.188838 -3.637599 -3.498590 -3.517678 -3.614593 -3.747039 -3.910389 -4.098576 -4.301840 -4.519042 -80.00000 -4.387768 -3.837008 -3.698274 -3.717532 -3.814550 -3.947070 -4.110471 -4.298697 -4.501997 -4.719233 -80.00000 -4.618927 -4.065443 -3.925660 -3.944385 -4.041118 -4.173438 -4.336699 -4.524813 -4.728012 -4.945156 -80.00000 -5.056336 -4.480198 -4.331033 -4.344774 -4.438788 -4.569197 -4.731112 -4.918173 -5.120417 -5.336694 -80.00000 -5.658666 -5.022449 -4.849181 -4.850306 -4.937501 -5.063155 -5.221743 -5.406220 -5.606126 -5.820292 -80.00000 -6.487057 -5.706373 -5.481357 -5.456628 -5.530209 -5.646541 -5.798691 -5.978226 -6.173686 -6.383860 -80.00000 -7.306160 -6.300071 -6.008225 -5.952265 -6.009989 -6.115748 -6.260731 -6.434865 -6.625502 -6.831382 -80.00000 -3.460865 -2.879144 -2.710190 -2.700709 -2.768634 -2.873596 -3.009873 -3.171825 -3.351452 -3.547521 -80.00000 -3.669336 -3.087862 -2.919070 -2.909700 -2.977695 -3.082707 -3.219020 -3.380999 -3.560650 -3.756743 -80.00000 -3.875036 -3.293936 -3.125351 -3.116114 -3.184190 -3.289259 -3.425612 -3.587623 -3.767303 -3.963422 -80.00000 -4.076051 -3.495565 -3.327293 -3.318243 -3.386426 -3.491573 -3.627980 -3.790032 -3.969752 -4.165907 -80.00000 -4.274988 -3.694992 -3.527001 -3.518124 -3.586409 -3.691627 -3.828084 -3.990175 -4.169931 -4.366119 -80.00000 -4.506067 -3.923332 -3.754296 -3.744894 -3.812908 -3.917938 -4.054261 -4.216243 -4.395898 -4.591994 -80.00000 -4.942898 -4.337296 -4.158844 -4.144511 -4.209906 -4.313119 -4.448164 -4.609115 -4.787817 -4.983043 -80.00000 -5.543724 -4.877519 -4.674907 -4.648091 -4.706920 -4.805618 -4.937508 -5.095932 -5.272307 -5.465411 -80.00000 -6.368385 -5.557018 -5.302761 -5.250464 -5.296227 -5.386103 -5.511909 -5.665521 -5.837484 -6.026596 -80.00000 -7.181452 -6.144917 -5.824356 -5.741414 -5.772020 -5.851932 -5.970996 -6.119380 -6.286583 -6.471420 -80.00000 -3.372978 -2.767465 -2.574155 -2.540674 -2.583674 -2.664376 -2.776408 -2.914627 -3.072371 -3.248361 -80.00000 -3.581452 -2.976190 -2.783045 -2.749677 -2.792747 -2.873498 -2.985564 -3.123811 -3.281579 -3.457592 -80.00000 -3.787157 -3.182273 -2.989340 -2.956106 -2.999256 -3.080063 -3.192168 -3.330446 -3.488243 -3.664283 -80.00000 -3.988181 -3.383919 -3.191302 -3.158256 -3.201512 -3.282394 -3.394551 -3.532870 -3.690707 -3.866783 -80.00000 -4.187122 -3.583361 -3.391029 -3.358157 -3.401514 -3.482465 -3.594670 -3.733028 -3.890901 -4.067010 -80.00000 -4.418141 -3.811629 -3.618255 -3.584868 -3.627965 -3.708737 -3.820815 -3.959064 -4.116836 -4.292853 -80.00000 -4.854528 -4.224995 -4.022192 -3.983923 -4.024486 -4.103518 -4.214372 -4.351604 -4.508422 -4.683561 -80.00000 -5.454197 -4.763688 -4.536706 -4.486084 -4.520294 -4.595004 -4.702836 -4.837579 -4.992069 -5.165070 -80.00000 -6.276000 -5.439857 -5.161361 -5.085588 -5.107189 -5.173473 -5.275491 -5.405504 -5.555593 -5.724577 -80.00000 -7.084466 -6.023416 -5.679067 -5.573141 -5.580150 -5.636944 -5.732542 -5.857438 -6.002789 -6.167488 -80.00000 -3.300918 -2.675259 -2.460978 -2.406468 -2.427366 -2.486204 -2.576188 -2.692669 -2.830020 -2.986928 -80.00000 -3.509394 -2.883990 -2.669876 -2.615480 -2.636448 -2.695334 -2.785352 -2.901859 -3.039235 -3.196167 -80.00000 -3.715104 -3.090082 -2.876182 -2.821921 -2.842968 -2.901909 -2.991965 -3.108502 -3.245907 -3.402866 -80.00000 -3.916136 -3.291741 -3.078160 -3.024087 -3.045239 -3.104253 -3.194359 -3.310938 -3.448383 -3.605378 -80.00000 -4.115080 -3.491194 -3.277901 -3.224004 -3.245255 -3.304336 -3.394490 -3.511107 -3.648587 -3.805616 -80.00000 -4.346051 -3.719406 -3.505074 -3.450670 -3.471670 -3.530580 -3.620611 -3.737121 -3.874500 -4.031435 -80.00000 -4.782076 -4.132293 -3.908530 -3.849290 -3.867832 -3.925067 -4.013918 -4.129419 -4.265843 -4.421894 -80.00000 -5.380808 -4.669764 -4.421824 -4.350354 -4.362730 -4.415804 -4.501742 -4.614781 -4.748873 -4.902769 -80.00000 -6.200300 -5.343283 -5.043968 -4.947646 -4.947803 -4.992780 -5.073123 -5.181490 -5.311180 -5.461032 -80.00000 -7.005059 -5.923395 -5.558629 -5.432580 -5.418622 -5.454497 -5.528676 -5.632002 -5.756961 -5.902507 -80.00000 -3.239816 -2.596629 -2.363866 -2.290577 -2.291568 -2.330485 -2.400249 -2.496678 -2.614972 -2.753780 -80.00000 -3.448295 -2.805365 -2.572772 -2.499597 -2.500658 -2.539622 -2.609419 -2.705875 -2.824193 -2.963025 -80.00000 -3.654008 -3.011464 -2.779086 -2.706047 -2.707187 -2.746204 -2.816039 -2.912524 -3.030871 -3.169731 -80.00000 -3.855047 -3.213135 -2.981077 -2.908226 -2.909470 -2.948558 -3.018442 -3.114968 -3.233355 -3.372252 -80.00000 -4.053994 -3.412596 -3.180831 -3.108156 -3.109497 -3.148652 -3.218581 -3.315145 -3.433568 -3.572499 -80.00000 -4.284923 -3.640761 -3.407960 -3.334786 -3.335885 -3.374874 -3.444685 -3.541142 -3.659464 -3.798301 -80.00000 -4.720646 -4.053253 -3.811022 -3.733058 -3.731765 -3.769135 -3.837803 -3.933259 -4.050623 -4.188569 -80.00000 -5.318591 -4.589711 -4.323319 -4.233239 -4.225945 -4.259295 -4.325142 -4.418155 -4.533183 -4.668959 -80.00000 -6.136144 -5.261036 -4.943411 -4.828753 -4.809584 -4.835116 -4.895552 -4.983936 -5.094557 -5.226265 -80.00000 -6.937806 -5.838307 -5.455592 -5.311583 -5.278713 -5.295471 -5.349953 -5.433354 -5.539243 -5.666623 -80.00000 -3.186758 -2.528021 -2.278694 -2.188399 -2.171248 -2.191852 -2.242940 -2.320764 -2.421194 -2.542844 -80.00000 -3.395238 -2.736760 -2.487605 -2.397426 -2.380344 -2.400995 -2.452115 -2.529964 -2.630419 -2.752093 -80.00000 -3.600954 -2.942865 -2.693926 -2.603884 -2.586879 -2.607583 -2.658739 -2.736619 -2.837103 -2.958804 -80.00000 -3.801998 -3.144546 -2.895929 -2.806074 -2.789172 -2.809945 -2.861149 -2.939070 -3.039593 -3.161332 -80.00000 -4.000949 -3.344016 -3.095693 -3.006015 -2.989209 -3.010047 -3.061296 -3.139254 -3.239814 -3.361586 -80.00000 -4.231842 -3.572141 -3.322786 -3.232615 -3.215575 -3.236253 -3.287387 -3.365238 -3.465697 -3.587375 -80.00000 -4.667304 -3.984295 -3.725516 -3.630598 -3.611226 -3.630335 -3.680357 -3.757214 -3.856714 -3.977495 -80.00000 -5.264571 -4.519891 -4.236974 -4.130050 -4.104826 -4.120035 -4.167316 -4.241745 -4.338904 -4.457504 -80.00000 -6.080458 -5.189353 -4.855343 -4.724093 -4.687300 -4.694935 -4.736962 -4.806795 -4.899542 -5.014052 -80.00000 -6.879464 -5.764215 -5.365443 -5.205180 -5.155052 -5.154196 -5.190449 -5.255342 -5.343354 -5.453516 -80.00000 -3.139856 -2.467122 -2.202758 -2.096899 -2.063059 -2.066708 -2.100440 -2.160914 -2.244552 -2.349925 -80.00000 -3.348338 -2.675865 -2.411674 -2.305931 -2.272160 -2.275855 -2.309618 -2.370118 -2.453781 -2.559178 -80.00000 -3.554057 -2.881975 -2.618003 -2.512396 -2.478702 -2.482448 -2.516247 -2.576777 -2.660469 -2.765894 -80.00000 -3.755106 -3.083664 -2.820014 -2.714596 -2.681003 -2.684817 -2.718663 -2.779233 -2.862964 -2.968427 -80.00000 -3.954059 -3.283141 -3.019787 -2.914546 -2.881048 -2.884926 -2.918815 -2.979422 -3.063190 -3.168687 -80.00000 -4.184921 -3.511231 -3.246850 -3.141121 -3.107395 -3.111118 -3.144896 -3.205397 -3.289064 -3.394466 -80.00000 -4.620154 -3.923093 -3.649295 -3.538861 -3.502858 -3.505055 -3.537748 -3.597260 -3.679966 -3.784468 -80.00000 -5.216826 -4.457941 -4.160033 -4.037694 -3.995975 -3.994381 -4.024403 -4.081498 -4.161861 -4.264171 -80.00000 -6.031253 -5.125788 -4.776925 -4.630493 -4.577480 -4.568528 -4.593432 -4.645957 -4.721903 -4.820107 -80.00000 -6.827937 -5.698565 -5.285242 -5.110106 -5.044087 -5.026891 -5.046176 -5.093796 -5.165003 -5.258839 -80.00000 -3.097822 -2.412343 -2.134193 -2.013964 -1.964658 -1.952512 -1.970032 -2.014255 -2.082062 -2.171982 -80.00000 -3.306305 -2.621089 -2.343113 -2.223002 -2.173764 -2.161663 -2.179214 -2.223462 -2.291294 -2.381238 -80.00000 -3.512027 -2.827204 -2.549447 -2.429472 -2.380311 -2.368261 -2.385846 -2.430123 -2.497985 -2.587956 -80.00000 -3.713080 -3.028900 -2.751468 -2.631680 -2.582618 -2.570636 -2.588267 -2.632584 -2.700485 -2.790494 -80.00000 -3.912035 -3.228384 -2.951248 -2.831638 -2.782671 -2.770750 -2.788424 -2.832778 -2.900715 -2.990760 -80.00000 -4.142870 -3.456444 -3.178283 -3.058192 -3.009002 -2.996931 -3.014496 -3.058745 -3.126581 -3.216531 -80.00000 -4.577899 -3.868047 -3.580480 -3.455723 -3.404305 -3.390747 -3.407253 -3.450516 -3.517391 -3.606437 -80.00000 -5.174041 -4.402235 -4.090589 -3.954024 -3.897014 -3.879762 -3.893658 -3.934515 -3.999044 -4.085890 -80.00000 -5.987170 -5.068660 -4.706192 -4.545752 -4.477700 -4.453282 -4.462180 -4.498489 -4.558597 -4.641321 -80.00000 -6.781793 -5.639606 -5.212957 -5.024096 -4.943335 -4.910894 -4.914308 -4.945738 -5.001103 -5.079445 -80.00000 -4.966093 -4.527210 -4.489989 -4.597168 -4.777660 -4.981668 -5.212789 -5.465729 -5.723504 -5.985903 -80.00000 -5.174541 -4.735877 -4.698793 -4.806068 -4.986626 -5.190687 -5.421847 -5.674819 -5.932620 -6.195044 -80.00000 -5.380201 -4.941874 -4.904975 -5.012370 -5.193007 -5.397130 -5.628338 -5.881345 -6.139178 -6.401630 -80.00000 -5.581150 -5.143378 -5.106762 -5.214333 -5.395083 -5.599294 -5.830567 -6.083622 -6.341498 -6.603988 -80.00000 -5.780054 -5.342706 -5.306335 -5.414062 -5.594915 -5.799206 -6.030539 -6.283639 -6.541553 -6.804080 -80.00000 -6.011578 -5.571594 -5.534178 -5.641338 -5.821856 -6.025900 -6.257055 -6.510026 -6.767828 -7.030254 -80.00000 -6.451639 -5.990105 -5.943566 -6.045623 -6.223064 -6.424804 -6.654300 -6.906048 -7.162791 -7.424265 -80.00000 -7.060889 -6.542002 -6.471915 -6.561003 -6.730693 -6.926670 -7.152036 -7.400756 -7.654879 -7.914005 -80.00000 -7.906620 -7.247265 -7.125499 -7.187457 -7.341360 -7.525812 -7.743024 -7.985824 -8.234859 -8.489454 -80.00000 -8.754304 -7.869443 -7.678930 -7.707260 -7.842323 -8.013360 -8.221247 -8.457365 -8.700709 -8.950279 -80.00000 -4.676040 -4.177485 -4.087713 -4.151058 -4.290861 -4.461544 -4.661169 -4.883509 -5.115835 -5.357447 -80.00000 -4.884500 -4.386177 -4.296555 -4.360003 -4.499875 -4.670610 -4.870273 -5.092641 -5.324993 -5.566628 -80.00000 -5.090178 -4.592212 -4.502786 -4.566361 -4.706314 -4.877110 -5.076817 -5.299219 -5.531600 -5.773261 -80.00000 -5.291160 -4.793778 -4.704651 -4.768408 -4.908472 -5.079351 -5.279119 -5.501565 -5.733986 -5.975684 -80.00000 -5.490079 -4.993155 -4.904291 -4.968213 -5.108380 -5.279336 -5.479159 -5.701647 -5.934104 -6.175836 -80.00000 -5.721385 -5.221766 -5.131852 -5.195224 -5.335084 -5.505821 -5.705488 -5.927859 -6.160214 -6.401852 -80.00000 -6.159853 -5.637991 -5.538773 -5.597089 -5.734067 -5.902728 -6.100925 -6.322193 -6.553571 -6.794332 -80.00000 -6.764947 -6.184017 -6.060853 -6.106354 -6.236094 -6.399579 -6.594136 -6.812684 -7.041662 -7.280274 -80.00000 -7.600235 -6.876245 -6.701234 -6.720273 -6.835457 -6.988722 -7.176182 -7.389484 -7.613864 -7.848383 -80.00000 -8.430625 -7.480941 -7.238212 -7.224987 -7.323072 -7.464636 -7.644115 -7.851614 -8.070948 -8.301010 -80.00000 -4.504517 -3.965991 -3.838185 -3.866960 -3.972788 -4.112982 -4.283287 -4.477592 -4.685791 -4.906884 -80.00000 -4.712982 -4.174697 -4.047048 -4.075931 -4.181828 -4.322074 -4.492415 -4.686748 -4.894972 -5.116088 -80.00000 -4.918673 -4.380754 -4.253308 -4.282321 -4.388299 -4.528604 -4.698987 -4.893352 -5.101605 -5.322748 -80.00000 -5.119673 -4.582355 -4.455215 -4.484414 -4.590502 -4.730887 -4.901327 -5.095735 -5.304028 -5.525206 -80.00000 -5.318602 -4.781760 -4.654894 -4.684262 -4.790453 -4.930912 -5.101405 -5.295852 -5.504181 -5.725391 -80.00000 -5.549781 -5.010217 -4.882302 -4.911133 -5.017037 -5.157293 -5.327643 -5.521978 -5.730206 -5.951325 -80.00000 -5.987333 -5.425166 -5.287875 -5.311706 -5.414864 -5.553185 -5.722172 -5.915452 -6.122725 -6.342981 -80.00000 -6.590039 -5.967916 -5.806533 -5.817707 -5.913977 -6.047481 -6.213100 -6.403787 -6.608723 -6.826871 -80.00000 -7.419370 -6.652943 -6.439776 -6.424987 -6.507493 -6.631544 -6.790640 -6.976364 -7.176853 -7.391013 -80.00000 -8.240025 -7.248112 -6.967970 -6.921781 -6.988240 -7.101557 -7.253381 -7.433671 -7.629330 -7.839193 -80.00000 -4.381985 -3.812791 -3.654583 -3.654463 -3.730997 -3.843677 -3.987023 -4.155354 -4.340453 -4.541172 -80.00000 -4.590455 -4.021507 -3.863461 -3.863451 -3.940055 -4.052785 -4.196167 -4.364525 -4.549650 -4.750391 -80.00000 -4.796153 -4.227579 -4.069740 -4.069863 -4.146547 -4.259335 -4.402758 -4.571147 -4.756299 -4.957067 -80.00000 -4.997167 -4.429204 -4.271678 -4.271986 -4.348780 -4.461645 -4.605122 -4.773553 -4.958745 -5.159549 -80.00000 -5.196103 -4.628629 -4.471383 -4.471865 -4.548759 -4.661696 -4.805223 -4.973693 -5.158921 -5.359757 -80.00000 -5.427193 -4.856982 -4.698690 -4.698646 -4.775267 -4.888014 -5.031406 -5.199768 -5.384894 -5.585639 -80.00000 -5.864103 -5.271055 -5.103355 -5.098369 -5.172356 -5.283272 -5.425377 -5.592708 -5.776886 -5.976763 -80.00000 -6.465135 -5.811563 -5.619714 -5.602224 -5.669603 -5.775967 -5.914895 -6.079700 -6.261558 -6.459324 -80.00000 -7.290312 -6.491685 -6.248188 -6.205159 -6.259384 -6.356850 -6.489646 -6.649640 -6.827099 -7.020888 -80.00000 -8.104232 -7.080418 -6.770552 -6.696789 -6.735746 -6.823156 -6.949155 -7.103917 -7.276627 -7.466156 -80.00000 -4.286464 -3.692153 -3.508377 -3.483251 -3.533931 -3.621641 -3.740175 -3.884369 -4.047440 -4.228160 -80.00000 -4.494937 -3.900878 -3.717267 -3.692253 -3.743003 -3.830762 -3.949330 -4.093551 -4.256647 -4.437390 -80.00000 -4.700642 -4.106960 -3.923560 -3.898680 -3.949510 -4.037325 -4.155933 -4.300185 -4.463309 -4.644079 -80.00000 -4.901666 -4.308605 -4.125520 -4.100828 -4.151764 -4.239655 -4.358315 -4.502607 -4.665771 -4.846577 -80.00000 -5.100607 -4.508045 -4.325245 -4.300727 -4.351763 -4.439723 -4.558432 -4.702763 -4.865963 -5.046802 -80.00000 -5.331630 -4.736319 -4.552477 -4.527443 -4.578218 -4.665998 -4.784579 -4.928803 -5.091902 -5.272648 -80.00000 -5.768046 -5.149732 -4.956469 -4.926551 -4.974786 -5.060820 -5.178172 -5.321380 -5.483529 -5.663402 -80.00000 -6.367793 -5.688549 -5.471126 -5.428849 -5.470713 -5.552407 -5.666728 -5.807453 -5.967283 -6.145028 -80.00000 -7.189791 -6.364992 -6.096078 -6.028636 -6.057852 -6.131085 -6.239572 -6.375577 -6.531023 -6.704769 -80.00000 -7.998584 -6.948918 -6.614156 -6.516533 -6.531109 -6.594811 -6.696854 -6.827753 -6.978477 -7.147957 -80.00000 -4.208108 -3.592412 -3.386446 -3.339180 -3.366655 -3.431531 -3.527139 -3.648844 -3.790982 -3.952269 -80.00000 -4.416584 -3.801142 -3.595345 -3.548192 -3.575737 -3.640661 -3.736303 -3.858034 -4.000196 -4.161507 -80.00000 -4.622294 -4.007235 -3.801650 -3.754632 -3.782256 -3.847235 -3.942915 -4.064677 -4.206868 -4.368206 -80.00000 -4.823327 -4.208894 -4.003627 -3.956797 -3.984526 -4.049578 -4.145309 -4.267112 -4.409342 -4.570717 -80.00000 -5.022271 -4.408346 -4.203368 -4.156713 -4.184541 -4.249661 -4.345438 -4.467279 -4.609545 -4.770954 -80.00000 -5.253240 -4.636558 -4.430542 -4.383380 -4.410958 -4.475906 -4.571561 -4.693295 -4.835460 -4.996775 -80.00000 -5.689255 -5.049444 -4.834006 -4.782014 -4.807134 -4.870407 -4.964880 -5.085610 -5.226823 -5.387256 -80.00000 -6.287961 -5.586913 -5.347324 -5.283113 -5.302068 -5.361179 -5.452742 -5.571015 -5.709905 -5.868191 -80.00000 -7.107389 -6.260431 -5.969519 -5.880480 -5.887219 -5.938230 -6.024199 -6.137815 -6.272318 -6.426579 -80.00000 -7.912059 -6.840551 -6.484250 -6.365508 -6.358137 -6.400044 -6.479848 -6.588442 -6.718232 -6.868204 -80.00000 -4.141641 -3.507258 -3.281620 -3.214427 -3.220812 -3.264657 -3.338989 -3.439680 -3.561957 -3.704490 -80.00000 -4.350120 -3.715994 -3.490525 -3.423447 -3.429902 -3.473795 -3.548159 -3.648876 -3.771178 -3.913735 -80.00000 -4.555833 -3.922093 -3.696840 -3.629898 -3.636430 -3.680377 -3.754778 -3.855525 -3.977856 -4.120440 -80.00000 -4.756873 -4.123765 -3.898832 -3.832077 -3.838714 -3.882731 -3.957182 -4.057970 -4.180339 -4.322960 -80.00000 -4.955822 -4.323228 -4.098587 -4.032008 -4.038742 -4.082825 -4.157321 -4.258146 -4.380552 -4.523207 -80.00000 -5.186744 -4.551388 -4.325713 -4.258636 -4.265128 -4.309046 -4.383425 -4.484144 -4.606449 -4.749010 -80.00000 -5.622423 -4.963839 -4.728745 -4.656890 -4.660998 -4.703302 -4.776540 -4.876262 -4.997612 -5.139285 -80.00000 -6.220255 -5.500192 -5.240972 -5.157027 -5.155154 -5.193450 -5.263876 -5.361163 -5.480184 -5.619693 -80.00000 -7.037532 -6.171295 -5.860919 -5.752455 -5.738747 -5.769250 -5.834281 -5.926956 -6.041584 -6.177039 -80.00000 -7.838759 -6.748283 -6.372930 -6.235187 -6.207826 -6.229585 -6.288682 -6.376393 -6.486307 -6.617448 -80.00000 -4.083903 -3.432884 -3.189530 -3.104182 -3.091211 -3.115564 -3.170063 -3.251060 -3.354501 -3.479011 -80.00000 -4.292384 -3.641625 -3.398442 -3.313210 -3.300308 -3.324708 -3.379238 -3.460261 -3.563727 -3.688260 -80.00000 -4.498102 -3.847731 -3.604765 -3.519669 -3.506844 -3.531296 -3.585863 -3.666915 -3.770410 -3.894972 -80.00000 -4.699147 -4.049413 -3.806769 -3.721861 -3.709138 -3.733660 -3.788274 -3.869367 -3.972901 -4.097499 -80.00000 -4.898098 -4.248886 -4.006535 -3.921803 -3.909177 -3.933762 -3.988421 -4.069551 -4.173121 -4.297754 -80.00000 -5.128982 -4.477002 -4.233622 -4.148399 -4.135539 -4.159966 -4.214510 -4.295535 -4.399004 -4.523543 -80.00000 -5.564372 -4.889081 -4.636292 -4.546340 -4.531162 -4.554029 -4.607468 -4.687500 -4.790013 -4.913657 -80.00000 -6.161451 -5.424488 -5.147602 -5.045684 -5.024691 -5.043683 -5.094395 -5.172008 -5.272186 -5.393652 -80.00000 -6.976879 -6.093542 -5.765667 -5.639514 -5.607024 -5.618489 -5.663977 -5.737011 -5.832789 -5.950176 -80.00000 -7.775158 -6.667880 -6.275403 -6.120351 -6.074613 -6.077643 -6.117392 -6.185507 -6.276565 -6.389615 -80.00000 -4.032851 -3.366813 -3.107314 -3.005266 -2.974390 -2.980577 -3.016512 -3.078997 -3.164567 -3.271796 -80.00000 -4.241333 -3.575558 -3.316232 -3.214300 -3.183492 -3.189725 -3.225692 -3.288201 -3.373796 -3.481050 -80.00000 -4.447054 -3.781670 -3.522562 -3.420767 -3.390035 -3.396320 -3.432321 -3.494860 -3.580485 -3.687766 -80.00000 -4.648106 -3.983361 -3.724576 -3.622969 -3.592338 -3.598690 -3.634738 -3.697317 -3.782981 -3.890300 -80.00000 -4.847059 -4.182841 -3.924352 -3.822921 -3.792385 -3.798800 -3.834891 -3.897507 -3.983208 -4.090561 -80.00000 -5.077908 -4.410920 -4.151405 -4.049490 -4.018729 -4.024990 -4.060970 -4.123481 -4.209080 -4.316339 -80.00000 -5.513043 -4.822678 -4.553766 -4.447167 -4.414148 -4.418897 -4.453802 -4.515326 -4.599967 -4.706326 -80.00000 -6.109464 -5.357263 -5.064290 -4.945843 -4.907158 -4.908150 -4.940403 -4.999520 -5.081821 -5.185992 -80.00000 -6.923273 -6.024544 -5.680744 -5.538325 -5.488449 -5.482151 -5.509326 -5.563890 -5.641784 -5.741855 -80.00000 -7.718976 -6.596593 -6.188535 -6.017565 -5.954802 -5.940340 -5.961943 -6.011621 -6.084789 -6.180501 -80.00000 -3.987085 -3.307339 -3.032988 -2.915460 -2.867913 -2.857089 -2.875584 -2.920617 -2.989214 -3.079896 -80.00000 -4.195569 -3.516087 -3.241910 -3.124499 -3.077020 -3.066242 -3.084766 -3.129825 -3.198447 -3.289153 -80.00000 -4.401292 -3.722204 -3.448247 -3.330972 -3.283569 -3.272840 -3.291399 -3.336488 -3.405139 -3.495872 -80.00000 -4.602348 -3.923903 -3.650271 -3.533183 -3.485879 -3.475217 -3.493821 -3.538949 -3.607640 -3.698411 -80.00000 -4.801305 -4.123390 -3.850055 -3.733144 -3.685934 -3.675333 -3.693980 -3.739144 -3.807871 -3.898678 -80.00000 -5.032123 -4.351435 -4.077078 -3.959690 -3.912261 -3.901511 -3.920050 -3.965110 -4.033736 -4.124447 -80.00000 -5.467032 -4.762911 -4.479169 -4.357141 -4.307510 -4.295291 -4.312781 -4.356857 -4.424524 -4.514333 -80.00000 -6.062865 -5.296772 -4.989009 -4.855243 -4.800083 -4.784214 -4.799119 -4.840796 -4.906121 -4.993731 -80.00000 -6.875235 -5.962495 -5.604062 -5.446569 -5.380496 -5.357545 -5.367503 -5.404648 -5.465559 -5.549053 -80.00000 -7.668656 -6.532536 -6.110163 -5.924438 -5.845806 -5.814931 -5.819462 -5.851748 -5.907925 -5.987043 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -80.00000 -3.362772 -3.183542 -3.156796 -3.174727 -3.214755 -3.280353 -3.368170 -3.487746 -3.635111 -3.808585 -80.00000 -3.569128 -3.389319 -3.362370 -3.380235 -3.420228 -3.485794 -3.573578 -3.693110 -3.840435 -4.013868 -80.00000 -3.780589 -3.600010 -3.572791 -3.590568 -3.630515 -3.696039 -3.783778 -3.903251 -4.050524 -4.223904 -80.00000 -3.998066 -3.816514 -3.788948 -3.806610 -3.846499 -3.911968 -3.999653 -4.119052 -4.266257 -4.439568 -80.00000 -4.221400 -4.038735 -4.010762 -4.028285 -4.068108 -4.133515 -4.221137 -4.340451 -4.487578 -4.660811 -80.00000 -4.447172 -4.263549 -4.235192 -4.252574 -4.292339 -4.357692 -4.445259 -4.564500 -4.711556 -4.884721 -80.00000 -4.664133 -4.480515 -4.452046 -4.469358 -4.509120 -4.574469 -4.662035 -4.781277 -4.928323 -5.101481 -80.00000 -4.778091 -4.595498 -4.567269 -4.584628 -4.624446 -4.689847 -4.777470 -4.896787 -5.043892 -5.217115 -80.00000 -4.851315 -4.669956 -4.642057 -4.659497 -4.699383 -4.764848 -4.852537 -4.971944 -5.119124 -5.292427 -80.00000 -5.032217 -4.839360 -4.809444 -4.826204 -4.865575 -4.930597 -5.017778 -5.136553 -5.283167 -5.455884 -80.00000 -3.573254 -3.392997 -3.366009 -3.383900 -3.423935 -3.489551 -3.577429 -3.697039 -3.844422 -4.017913 -80.00000 -3.779611 -3.598774 -3.571584 -3.589409 -3.629409 -3.694992 -3.782837 -3.902403 -4.049747 -4.223197 -80.00000 -3.991073 -3.809467 -3.782005 -3.799741 -3.839695 -3.905236 -3.993037 -4.112545 -4.259835 -4.433231 -80.00000 -4.208552 -4.025971 -3.998163 -4.015783 -4.055679 -4.121166 -4.208911 -4.328345 -4.475567 -4.648896 -80.00000 -4.431888 -4.248195 -4.219977 -4.237458 -4.277287 -4.342712 -4.430395 -4.549744 -4.696888 -4.870139 -80.00000 -4.657660 -4.473011 -4.444407 -4.461747 -4.501518 -4.566889 -4.654516 -4.773793 -4.920866 -5.094048 -80.00000 -4.874620 -4.689978 -4.661263 -4.678531 -4.718300 -4.783666 -4.871293 -4.990569 -5.137632 -5.310809 -80.00000 -4.988575 -4.804958 -4.776486 -4.793801 -4.833626 -4.899045 -4.986728 -5.106080 -5.253202 -5.426443 -80.00000 -5.061794 -4.879414 -4.851273 -4.868670 -4.908563 -4.974045 -5.061796 -5.181237 -5.328434 -5.501754 -80.00000 -5.242693 -5.048819 -5.018653 -5.035367 -5.074745 -5.139784 -5.227026 -5.345838 -5.492470 -5.665205 -80.00000 -3.780597 -3.599784 -3.572655 -3.590523 -3.630572 -3.696209 -3.784141 -3.903791 -4.051198 -4.224715 -80.00000 -3.986955 -3.805561 -3.778229 -3.796031 -3.836045 -3.901651 -3.989549 -4.109155 -4.256523 -4.429998 -80.00000 -4.198417 -4.016254 -3.988651 -4.006364 -4.046331 -4.111895 -4.199749 -4.319296 -4.466611 -4.640033 -80.00000 -4.415897 -4.232760 -4.204809 -4.222406 -4.262315 -4.327824 -4.415623 -4.535096 -4.682343 -4.855697 -80.00000 -4.639234 -4.454985 -4.426624 -4.444081 -4.483923 -4.549370 -4.637105 -4.756495 -4.903663 -5.076939 -80.00000 -4.865007 -4.679801 -4.651054 -4.668369 -4.708154 -4.773546 -4.861227 -4.980543 -5.127642 -5.300848 -80.00000 -5.081966 -4.896768 -4.867909 -4.885154 -4.924935 -4.990324 -5.078004 -5.197319 -5.344408 -5.517609 -80.00000 -5.195919 -5.011747 -4.983133 -5.000423 -5.040262 -5.105702 -5.193439 -5.312830 -5.459978 -5.633243 -80.00000 -5.269137 -5.086203 -5.057920 -5.075293 -5.115199 -5.180703 -5.268507 -5.387988 -5.535210 -5.708554 -80.00000 -5.450009 -5.255590 -5.225278 -5.241966 -5.281357 -5.346418 -5.433713 -5.552565 -5.699223 -5.871984 -80.00000 -3.983210 -3.802222 -3.775060 -3.792930 -3.833004 -3.898674 -3.986665 -4.106367 -4.253813 -4.427367 -80.00000 -4.189568 -4.007999 -3.980634 -3.998438 -4.038477 -4.104115 -4.192073 -4.311730 -4.459136 -4.632650 -80.00000 -4.401031 -4.218692 -4.191056 -4.208770 -4.248764 -4.314359 -4.402272 -4.521872 -4.669224 -4.842685 -80.00000 -4.618511 -4.435198 -4.407213 -4.424812 -4.464746 -4.530288 -4.618146 -4.737671 -4.884956 -5.058348 -80.00000 -4.841848 -4.657423 -4.629028 -4.646487 -4.686355 -4.751834 -4.839628 -4.959069 -5.106276 -5.279590 -80.00000 -5.067621 -4.882240 -4.853458 -4.870775 -4.910585 -4.976009 -5.063749 -5.183117 -5.330254 -5.503499 -80.00000 -5.284579 -5.099207 -5.070314 -5.087560 -5.127367 -5.192787 -5.280526 -5.399894 -5.547020 -5.720259 -80.00000 -5.398532 -5.214186 -5.185537 -5.202830 -5.242693 -5.308166 -5.395962 -5.515405 -5.662590 -5.835894 -80.00000 -5.471750 -5.288642 -5.260325 -5.277699 -5.317631 -5.383167 -5.471030 -5.590563 -5.737823 -5.911206 -80.00000 -5.652572 -5.457985 -5.427638 -5.444327 -5.483743 -5.548837 -5.636191 -5.755095 -5.901793 -6.074592 -80.00000 -4.184042 -4.002437 -3.975193 -3.993064 -4.033159 -4.098860 -4.186923 -4.306671 -4.454148 -4.627735 -80.00000 -4.390401 -4.208215 -4.180768 -4.198572 -4.238632 -4.304301 -4.392331 -4.512034 -4.659472 -4.833018 -80.00000 -4.601866 -4.418909 -4.391190 -4.408905 -4.448918 -4.514545 -4.602530 -4.722175 -4.869559 -5.043052 -80.00000 -4.819348 -4.635417 -4.607347 -4.624946 -4.664902 -4.730474 -4.818404 -4.937974 -5.085291 -5.258716 -80.00000 -5.042687 -4.857643 -4.829163 -4.846621 -4.886509 -4.952020 -5.039886 -5.159372 -5.306611 -5.479957 -80.00000 -5.268462 -5.082460 -5.053593 -5.070909 -5.110740 -5.176195 -5.264006 -5.383420 -5.530588 -5.703865 -80.00000 -5.485419 -5.299428 -5.270449 -5.287694 -5.327521 -5.392972 -5.480783 -5.600196 -5.747354 -5.920625 -80.00000 -5.599367 -5.414406 -5.385672 -5.402963 -5.442848 -5.508352 -5.596219 -5.715707 -5.862924 -6.036260 -80.00000 -5.672581 -5.488860 -5.460460 -5.477833 -5.517785 -5.583353 -5.671287 -5.790866 -5.938158 -6.111572 -80.00000 -5.853409 -5.658194 -5.627755 -5.644442 -5.683877 -5.749002 -5.836429 -5.955379 -6.102108 -6.274941 -80.00000 -4.415754 -4.229695 -4.201447 -4.219106 -4.259074 -4.324683 -4.412735 -4.532346 -4.679691 -4.853142 -80.00000 -4.622121 -4.435478 -4.407024 -4.424614 -4.464548 -4.530125 -4.618144 -4.737710 -4.885015 -5.058426 -80.00000 -4.833597 -4.646179 -4.617448 -4.634948 -4.674835 -4.740369 -4.828344 -4.947852 -5.095103 -5.268461 -80.00000 -5.051092 -4.862693 -4.833609 -4.850990 -4.890819 -4.956299 -5.044218 -5.163652 -5.310836 -5.484126 -80.00000 -5.274445 -5.084928 -5.055428 -5.072666 -5.112427 -5.177845 -5.265701 -5.385051 -5.532157 -5.705368 -80.00000 -5.500229 -5.309753 -5.279861 -5.296956 -5.336658 -5.402022 -5.489821 -5.609099 -5.756135 -5.929277 -80.00000 -5.717174 -5.526720 -5.496716 -5.513739 -5.553438 -5.618798 -5.706597 -5.825874 -5.972899 -6.146036 -80.00000 -5.831096 -5.641690 -5.611937 -5.629006 -5.668763 -5.734175 -5.822030 -5.941382 -6.088467 -6.261668 -80.00000 -5.904284 -5.716136 -5.686720 -5.703874 -5.743698 -5.809174 -5.897097 -6.016540 -6.163699 -6.336978 -80.00000 -6.085593 -5.885877 -5.854381 -5.870831 -5.910135 -5.975165 -6.062579 -6.181392 -6.327987 -6.500682 -80.00000 -4.837816 -4.629900 -4.595754 -4.611917 -4.650866 -4.715601 -4.802882 -4.921247 -5.067499 -5.239815 -80.00000 -5.044222 -4.835704 -4.801341 -4.817430 -4.856344 -4.921047 -5.008295 -5.126616 -5.272828 -5.445105 -80.00000 -5.255748 -5.046433 -5.011779 -5.027770 -5.066637 -5.131297 -5.218501 -5.336765 -5.482923 -5.655146 -80.00000 -5.473304 -5.262984 -5.227958 -5.243820 -5.282628 -5.347234 -5.434381 -5.552574 -5.698664 -5.870820 -80.00000 -5.696720 -5.485260 -5.449796 -5.465504 -5.504244 -5.568787 -5.655871 -5.773981 -5.919993 -6.092071 -80.00000 -5.922541 -5.710119 -5.674245 -5.689798 -5.728478 -5.792967 -5.879996 -5.998034 -6.143977 -6.315986 -80.00000 -6.139428 -5.927081 -5.891095 -5.906575 -5.945250 -6.009736 -6.096765 -6.214802 -6.360735 -6.532739 -80.00000 -6.253231 -6.042009 -6.006294 -6.021829 -6.060560 -6.125099 -6.212184 -6.330296 -6.476289 -6.648357 -80.00000 -6.326300 -6.116409 -6.081057 -6.096687 -6.135485 -6.200088 -6.287240 -6.405441 -6.551509 -6.723656 -80.00000 -6.510488 -6.288781 -6.251164 -6.265977 -6.304245 -6.368386 -6.455019 -6.572580 -6.718059 -6.889603 -80.00000 -5.388522 -5.133624 -5.086216 -5.098801 -5.135325 -5.197906 -5.283000 -5.398366 -5.542037 -5.711675 -80.00000 -5.595006 -5.339473 -5.291826 -5.304324 -5.340813 -5.403360 -5.488423 -5.603747 -5.747378 -5.916976 -80.00000 -5.806634 -5.550261 -5.502294 -5.514677 -5.551118 -5.613623 -5.698642 -5.813910 -5.957488 -6.127033 -80.00000 -6.024314 -5.766887 -5.718509 -5.730743 -5.767123 -5.829574 -5.914538 -6.029737 -6.173246 -6.342725 -80.00000 -6.247859 -5.989245 -5.940388 -5.952444 -5.988754 -6.051144 -6.136045 -6.251163 -6.394594 -6.563997 -80.00000 -6.473756 -6.214173 -6.164869 -6.176750 -6.212997 -6.275333 -6.360179 -6.475229 -6.618591 -6.787927 -80.00000 -6.690524 -6.431124 -6.381712 -6.393516 -6.429756 -6.492090 -6.576935 -6.691986 -6.835340 -7.004671 -80.00000 -6.804076 -6.545966 -6.496866 -6.508745 -6.545038 -6.607426 -6.692327 -6.807451 -6.950867 -7.120262 -80.00000 -6.876902 -6.620273 -6.571585 -6.583582 -6.619942 -6.682395 -6.767362 -6.882573 -7.026065 -7.195538 -80.00000 -7.067628 -6.798372 -6.746986 -6.757888 -6.793684 -6.855627 -6.940041 -7.054571 -7.197399 -7.366216 -80.00000 -6.086549 -5.736460 -5.663528 -5.669044 -5.701033 -5.759499 -5.840299 -5.950081 -6.088976 -6.253710 -80.00000 -6.293190 -5.942389 -5.869175 -5.874584 -5.906534 -5.964969 -6.045737 -6.155479 -6.294334 -6.459029 -80.00000 -6.505019 -6.153284 -6.079694 -6.084957 -6.116858 -6.175251 -6.255976 -6.365665 -6.504466 -6.669110 -80.00000 -6.722943 -6.370043 -6.295973 -6.301049 -6.332886 -6.391226 -6.471898 -6.581520 -6.720253 -6.884832 -80.00000 -6.946741 -6.592554 -6.517925 -6.522778 -6.554542 -6.612820 -6.693431 -6.802978 -6.941632 -7.106138 -80.00000 -7.172785 -6.817607 -6.742466 -6.747105 -6.778801 -6.837028 -6.917586 -7.027069 -7.165654 -7.330095 -80.00000 -7.389312 -7.034544 -6.959303 -6.963862 -6.995544 -7.053772 -7.134329 -7.243814 -7.382396 -7.546833 -80.00000 -7.502366 -7.149234 -7.074387 -7.079058 -7.110791 -7.169074 -7.249685 -7.359242 -7.497889 -7.662389 -80.00000 -7.574706 -7.223372 -7.149033 -7.153868 -7.185665 -7.244015 -7.324689 -7.434331 -7.573057 -7.737634 -80.00000 -7.778598 -7.411273 -7.333159 -7.336288 -7.367418 -7.425136 -7.505156 -7.613992 -7.751877 -7.915664 -80.00000 -6.708221 -6.230752 -6.127708 -6.124612 -6.151793 -6.205739 -6.281927 -6.385771 -6.519541 -6.679142 -80.00000 -6.915055 -6.436769 -6.333393 -6.330163 -6.357305 -6.411218 -6.487376 -6.591182 -6.724911 -6.884474 -80.00000 -7.127135 -6.647779 -6.543960 -6.540551 -6.567640 -6.621512 -6.697628 -6.801385 -6.935060 -7.094574 -80.00000 -7.345362 -6.864684 -6.760302 -6.756662 -6.783684 -6.837503 -6.913568 -7.017262 -7.150869 -7.310320 -80.00000 -7.569471 -7.087361 -6.982326 -6.978414 -7.005357 -7.059117 -7.135123 -7.238746 -7.372274 -7.531655 -80.00000 -7.795692 -7.312558 -7.206934 -7.202765 -7.229634 -7.283345 -7.359298 -7.462862 -7.596323 -7.755641 -80.00000 -8.011904 -7.529495 -7.423786 -7.419536 -7.446384 -7.500098 -7.576050 -7.679619 -7.813079 -7.972394 -80.00000 -8.124324 -7.644034 -7.538822 -7.534726 -7.561622 -7.615393 -7.691398 -7.795037 -7.928565 -8.087942 -80.00000 -8.196043 -7.717993 -7.613407 -7.609526 -7.636486 -7.690324 -7.766391 -7.870111 -8.003721 -8.163173 -80.00000 -8.415733 -7.914117 -7.804304 -7.797955 -7.824114 -7.877178 -7.952462 -8.055232 -8.187799 -8.346309 -80.00000 -2.737264 -2.512251 -2.473704 -2.488488 -2.527817 -2.593170 -2.682213 -2.801646 -2.948365 -3.121262 -80.00000 -2.946057 -2.721198 -2.682783 -2.697637 -2.736995 -2.802367 -2.891451 -3.010915 -3.157654 -3.330573 -80.00000 -3.152145 -2.927567 -2.889311 -2.904237 -2.943628 -3.009025 -3.098149 -3.217647 -3.364413 -3.537360 -80.00000 -3.353708 -3.129640 -3.091608 -3.106623 -3.146057 -3.211488 -3.300662 -3.420206 -3.567013 -3.740000 -80.00000 -3.553061 -3.329447 -3.291631 -3.306736 -3.346209 -3.411673 -3.500900 -3.620486 -3.767328 -3.940352 -80.00000 -3.781866 -3.556185 -3.517786 -3.532764 -3.572125 -3.637497 -3.726662 -3.846117 -3.992840 -4.165739 -80.00000 -4.199772 -3.956304 -3.912213 -3.925623 -3.963947 -4.028432 -4.116703 -4.234966 -4.380634 -4.552421 -80.00000 -4.750925 -4.461810 -4.403347 -4.412683 -4.448486 -4.510788 -4.596733 -4.712124 -4.855263 -5.024389 -80.00000 -5.458298 -5.069575 -4.982200 -4.983298 -5.014344 -5.072489 -5.153978 -5.264013 -5.402444 -5.566679 -80.00000 -6.095620 -5.570292 -5.448264 -5.439302 -5.465268 -5.518859 -5.595579 -5.699913 -5.833291 -5.992398 -80.00000 -2.946057 -2.721198 -2.682783 -2.697637 -2.736995 -2.802367 -2.891451 -3.010914 -3.157654 -3.330573 -80.00000 -3.154867 -2.930150 -2.891864 -2.906785 -2.946172 -3.011565 -3.100693 -3.220185 -3.366946 -3.539886 -80.00000 -3.360969 -3.136524 -3.098393 -3.113386 -3.152805 -3.218223 -3.307392 -3.426919 -3.573707 -3.746675 -80.00000 -3.562544 -3.338600 -3.300691 -3.315772 -3.355234 -3.420686 -3.509905 -3.629480 -3.776307 -3.949316 -80.00000 -3.761912 -3.538412 -3.500716 -3.515886 -3.555386 -3.620871 -3.710146 -3.829763 -3.976624 -4.149670 -80.00000 -3.990753 -3.765157 -3.726871 -3.741913 -3.781302 -3.846694 -3.935911 -4.055398 -4.202139 -4.375058 -80.00000 -4.408729 -4.165285 -4.121296 -4.134769 -4.173121 -4.237626 -4.325956 -4.444252 -4.589936 -4.761740 -80.00000 -4.959941 -4.670790 -4.612419 -4.621821 -4.657651 -4.719973 -4.805980 -4.921404 -5.064559 -5.233700 -80.00000 -5.667356 -5.278538 -5.191250 -5.192421 -5.223495 -5.281657 -5.363202 -5.473274 -5.611722 -5.775970 -80.00000 -6.304711 -5.779235 -5.657291 -5.648410 -5.674406 -5.728012 -5.804777 -5.909152 -6.042547 -6.201668 -80.00000 -3.152145 -2.927567 -2.889311 -2.904237 -2.943628 -3.009025 -3.098149 -3.217647 -3.364413 -3.537360 -80.00000 -3.360969 -3.136524 -3.098393 -3.113386 -3.152805 -3.218223 -3.307392 -3.426919 -3.573707 -3.746675 -80.00000 -3.567081 -3.342902 -3.304924 -3.319987 -3.359438 -3.424880 -3.514092 -3.633655 -3.780469 -3.953465 -80.00000 -3.768664 -3.544981 -3.507223 -3.522374 -3.561868 -3.627344 -3.716607 -3.836217 -3.983071 -4.156107 -80.00000 -3.968045 -3.744797 -3.707249 -3.722487 -3.762020 -3.827529 -3.916848 -4.036501 -4.183389 -4.356462 -80.00000 -4.196909 -3.971547 -3.933404 -3.948514 -3.987935 -4.053352 -4.142617 -4.262139 -4.408906 -4.581851 -80.00000 -4.614928 -4.371678 -4.327825 -4.341366 -4.379750 -4.444279 -4.532661 -4.650994 -4.796703 -4.968531 -80.00000 -5.166158 -4.877170 -4.818933 -4.828408 -4.864270 -4.926614 -5.012676 -5.128139 -5.271316 -5.440480 -80.00000 -5.873547 -5.484882 -5.397735 -5.398992 -5.430098 -5.488280 -5.569876 -5.679987 -5.818459 -5.982728 -80.00000 -6.510850 -5.985538 -5.863749 -5.854966 -5.880994 -5.934620 -6.011428 -6.115844 -6.249265 -6.408406 -80.00000 -3.353708 -3.129640 -3.091608 -3.106623 -3.146057 -3.211488 -3.300662 -3.420206 -3.567013 -3.740000 -80.00000 -3.562543 -3.338600 -3.300691 -3.315772 -3.355234 -3.420686 -3.509905 -3.629480 -3.776307 -3.949316 -80.00000 -3.768664 -3.544981 -3.507223 -3.522374 -3.561868 -3.627344 -3.716607 -3.836217 -3.983071 -4.156107 -80.00000 -3.970254 -3.747063 -3.709523 -3.724761 -3.764297 -3.829808 -3.919122 -4.038780 -4.185673 -4.358750 -80.00000 -4.169644 -3.946882 -3.909550 -3.924875 -3.964450 -4.029994 -4.119365 -4.239067 -4.385993 -4.559106 -80.00000 -4.398526 -4.173635 -4.135705 -4.150901 -4.190364 -4.255815 -4.345136 -4.464706 -4.611511 -4.784496 -80.00000 -4.816563 -4.573761 -4.530118 -4.543747 -4.582173 -4.646736 -4.735178 -4.853560 -4.999306 -5.171172 -80.00000 -5.367770 -5.079224 -5.021204 -5.030776 -5.066680 -5.129058 -5.215181 -5.330693 -5.473906 -5.643106 -80.00000 -6.075060 -5.686869 -5.599965 -5.601338 -5.632487 -5.690702 -5.772354 -5.882515 -6.021024 -6.185328 -80.00000 -6.712221 -6.187450 -6.065939 -6.057296 -6.083368 -6.137025 -6.213883 -6.318349 -6.451808 -6.610982 -80.00000 -3.553061 -3.329447 -3.291631 -3.306736 -3.346209 -3.411673 -3.500900 -3.620486 -3.767328 -3.940352 -80.00000 -3.761913 -3.538412 -3.500716 -3.515886 -3.555386 -3.620871 -3.710146 -3.829763 -3.976624 -4.149670 -80.00000 -3.968045 -3.744797 -3.707249 -3.722487 -3.762020 -3.827529 -3.916848 -4.036501 -4.183389 -4.356462 -80.00000 -4.169644 -3.946882 -3.909550 -3.924875 -3.964450 -4.029994 -4.119365 -4.239067 -4.385993 -4.559106 -80.00000 -4.369047 -4.146705 -4.109578 -4.124989 -4.164602 -4.230179 -4.319611 -4.439354 -4.586315 -4.759463 -80.00000 -4.597955 -4.373463 -4.335734 -4.351016 -4.390517 -4.456001 -4.545385 -4.664999 -4.811836 -4.984856 -80.00000 -5.016038 -4.773587 -4.730142 -4.743860 -4.782323 -4.846919 -4.935433 -5.053857 -5.199633 -5.371531 -80.00000 -5.567274 -5.279031 -5.221214 -5.230883 -5.266826 -5.329235 -5.415432 -5.530987 -5.674230 -5.843460 -80.00000 -6.274566 -5.886627 -5.799945 -5.801433 -5.832622 -5.890865 -5.972587 -6.082794 -6.221333 -6.385664 -80.00000 -6.911717 -6.387146 -6.265883 -6.257376 -6.283490 -6.337173 -6.414091 -6.518607 -6.652097 -6.811299 -80.00000 -3.781866 -3.556185 -3.517786 -3.532764 -3.572125 -3.637497 -3.726662 -3.846117 -3.992840 -4.165739 -80.00000 -3.990753 -3.765157 -3.726871 -3.741913 -3.781302 -3.846694 -3.935911 -4.055398 -4.202139 -4.375058 -80.00000 -4.196909 -3.971547 -3.933405 -3.948514 -3.987935 -4.053352 -4.142617 -4.262139 -4.408906 -4.581851 -80.00000 -4.398526 -4.173635 -4.135705 -4.150901 -4.190364 -4.255815 -4.345135 -4.464706 -4.611511 -4.784496 -80.00000 -4.597955 -4.373463 -4.335734 -4.351016 -4.390517 -4.456001 -4.545385 -4.664999 -4.811836 -4.984856 -80.00000 -4.826948 -4.600240 -4.561900 -4.577048 -4.616437 -4.681828 -4.771176 -4.890657 -5.037370 -5.210258 -80.00000 -5.245336 -5.000460 -4.956361 -4.969928 -5.008279 -5.072782 -5.161278 -5.279570 -5.425214 -5.596979 -80.00000 -5.797143 -5.506102 -5.447542 -5.457020 -5.492852 -5.555164 -5.641354 -5.756783 -5.899888 -6.068983 -80.00000 -6.505537 -6.114044 -6.026445 -6.027662 -6.058742 -6.116881 -6.198590 -6.308686 -6.447083 -6.611280 -80.00000 -7.144126 -6.614897 -6.492501 -6.483630 -6.509637 -6.563209 -6.640098 -6.744521 -6.877870 -7.036941 -80.00000 -4.199772 -3.956304 -3.912213 -3.925623 -3.963947 -4.028432 -4.116703 -4.234966 -4.380634 -4.552421 -80.00000 -4.408729 -4.165285 -4.121296 -4.134769 -4.173121 -4.237626 -4.325956 -4.444252 -4.589936 -4.761740 -80.00000 -4.614928 -4.371678 -4.327825 -4.341366 -4.379750 -4.444278 -4.532661 -4.650994 -4.796703 -4.968531 -80.00000 -4.816563 -4.573761 -4.530118 -4.543747 -4.582173 -4.646736 -4.735178 -4.853560 -4.999306 -5.171172 -80.00000 -5.016038 -4.773587 -4.730142 -4.743860 -4.782323 -4.846920 -4.935433 -5.053857 -5.199633 -5.371531 -80.00000 -5.245336 -5.000460 -4.956361 -4.969928 -5.008279 -5.072782 -5.161278 -5.279570 -5.425214 -5.596979 -80.00000 -5.665260 -5.401314 -5.351190 -5.363031 -5.400349 -5.463958 -5.551643 -5.668754 -5.813314 -5.983953 -80.00000 -6.220446 -5.908392 -5.843173 -5.850573 -5.885374 -5.946781 -6.032190 -6.146465 -6.288467 -6.456444 -80.00000 -6.935884 -6.518989 -6.423406 -6.421852 -6.451897 -6.509109 -6.590046 -6.699043 -6.836311 -6.999413 -80.00000 -7.583800 -7.022573 -6.890522 -6.878085 -6.903036 -6.955668 -7.031774 -7.135166 -7.267370 -7.425375 -80.00000 -4.750925 -4.461810 -4.403347 -4.412683 -4.448486 -4.510788 -4.596733 -4.712124 -4.855263 -5.024389 -80.00000 -4.959941 -4.670790 -4.612419 -4.621821 -4.657651 -4.719973 -4.805980 -4.921404 -5.064559 -5.233700 -80.00000 -5.166157 -4.877170 -4.818933 -4.828408 -4.864270 -4.926614 -5.012676 -5.128139 -5.271316 -5.440480 -80.00000 -5.367770 -5.079224 -5.021204 -5.030776 -5.066680 -5.129058 -5.215181 -5.330693 -5.473906 -5.643106 -80.00000 -5.567274 -5.279031 -5.221214 -5.230883 -5.266826 -5.329235 -5.415432 -5.530987 -5.674230 -5.843460 -80.00000 -5.797143 -5.506102 -5.447542 -5.457020 -5.492852 -5.555164 -5.641354 -5.756783 -5.899888 -6.068983 -80.00000 -6.220446 -5.908392 -5.843173 -5.850573 -5.885374 -5.946781 -6.032190 -6.146465 -6.288467 -6.456444 -80.00000 -6.783565 -6.418826 -6.336940 -6.339028 -6.371310 -6.430497 -6.513669 -6.625162 -6.764568 -6.929914 -80.00000 -7.516218 -7.035778 -6.920217 -6.911634 -6.939129 -6.994095 -7.072839 -7.179145 -7.313758 -7.474286 -80.00000 -8.187698 -7.546170 -7.389936 -7.368502 -7.390830 -7.441206 -7.515153 -7.615971 -7.745474 -7.900979 -80.00000 -5.458298 -5.069575 -4.982200 -4.983298 -5.014344 -5.072489 -5.153978 -5.264013 -5.402444 -5.566679 -80.00000 -5.667356 -5.278538 -5.191250 -5.192421 -5.223495 -5.281657 -5.363202 -5.473274 -5.611722 -5.775970 -80.00000 -5.873547 -5.484882 -5.397735 -5.398992 -5.430098 -5.488280 -5.569876 -5.679987 -5.818459 -5.982728 -80.00000 -6.075060 -5.686869 -5.599965 -5.601338 -5.632487 -5.690702 -5.772354 -5.882515 -6.021024 -6.185328 -80.00000 -6.274566 -5.886627 -5.799945 -5.801433 -5.832622 -5.890865 -5.972587 -6.082794 -6.221333 -6.385664 -80.00000 -6.505537 -6.114044 -6.026445 -6.027662 -6.058742 -6.116881 -6.198590 -6.308686 -6.447083 -6.611280 -80.00000 -6.935884 -6.518989 -6.423406 -6.421852 -6.451897 -6.509109 -6.590046 -6.699043 -6.836311 -6.999413 -80.00000 -7.516218 -7.035779 -6.920217 -6.911634 -6.939129 -6.994095 -7.072839 -7.179145 -7.313758 -7.474286 -80.00000 -8.288185 -7.665206 -7.508898 -7.486246 -7.508854 -7.559566 -7.633972 -7.735241 -7.864949 -8.020769 -80.00000 -9.017617 -8.189793 -7.983696 -7.944280 -7.961530 -8.007655 -8.077369 -8.173332 -8.297847 -8.448777 -80.00000 -6.095620 -5.570292 -5.448264 -5.439302 -5.465268 -5.518859 -5.595579 -5.699913 -5.833291 -5.992398 -80.00000 -6.304711 -5.779235 -5.657291 -5.648410 -5.674406 -5.728012 -5.804777 -5.909152 -6.042547 -6.201668 -80.00000 -6.510850 -5.985538 -5.863749 -5.854966 -5.880994 -5.934620 -6.011428 -6.115844 -6.249265 -6.408406 -80.00000 -6.712221 -6.187450 -6.065939 -6.057296 -6.083368 -6.137025 -6.213883 -6.318349 -6.451808 -6.610982 -80.00000 -6.911717 -6.387146 -6.265883 -6.257376 -6.283490 -6.337173 -6.414091 -6.518607 -6.652097 -6.811299 -80.00000 -7.144126 -6.614897 -6.492501 -6.483630 -6.509637 -6.563209 -6.640098 -6.744521 -6.877870 -7.036941 -80.00000 -7.583800 -7.022573 -6.890522 -6.878085 -6.903036 -6.955668 -7.031774 -7.135166 -7.267370 -7.425375 -80.00000 -8.187698 -7.546170 -7.389936 -7.368502 -7.390830 -7.441206 -7.515153 -7.615971 -7.745474 -7.900979 -80.00000 -9.017617 -8.189793 -7.983696 -7.944280 -7.961530 -8.007655 -8.077369 -8.173332 -8.297847 -8.448777 -80.00000 -9.844418 -8.732322 -8.464256 -8.403527 -8.415097 -8.456674 -8.521815 -8.612678 -8.731930 -8.878117 -80.00000 -3.230772 -3.017479 -2.982324 -2.998208 -3.037865 -3.103425 -3.191239 -3.310815 -3.458180 -3.631654 -80.00000 -3.437168 -3.223285 -3.187909 -3.203718 -3.243339 -3.308867 -3.396648 -3.516179 -3.663505 -3.836938 -80.00000 -3.648681 -3.434017 -3.398345 -3.414054 -3.453626 -3.519111 -3.606848 -3.726321 -3.873593 -4.046973 -80.00000 -3.866221 -3.650571 -3.614521 -3.630100 -3.669610 -3.735041 -3.822723 -3.942122 -4.089326 -4.262638 -80.00000 -4.089620 -3.872851 -3.836357 -3.851779 -3.891220 -3.956588 -4.044206 -4.163520 -4.310647 -4.483880 -80.00000 -4.315430 -4.097715 -4.060809 -4.076073 -4.115451 -4.180764 -4.268328 -4.387569 -4.534626 -4.707790 -80.00000 -4.532329 -4.314684 -4.277671 -4.292859 -4.332232 -4.397542 -4.485105 -4.604346 -4.751392 -4.924551 -80.00000 -4.646159 -4.429615 -4.392884 -4.408127 -4.447559 -4.512920 -4.600540 -4.719856 -4.866961 -5.040184 -80.00000 -4.719255 -4.504011 -4.467655 -4.482993 -4.522495 -4.587920 -4.675607 -4.795013 -4.942194 -5.115496 -80.00000 -4.900947 -4.673876 -4.635214 -4.649734 -4.688691 -4.753669 -4.840847 -4.959623 -5.106236 -5.278953 -80.00000 -3.439757 -3.226485 -3.191420 -3.207360 -3.247044 -3.312623 -3.400498 -3.520108 -3.667491 -3.840983 -80.00000 -3.646153 -3.432291 -3.397005 -3.412870 -3.452517 -3.518064 -3.605906 -3.725472 -3.872816 -4.046266 -80.00000 -3.857666 -3.643023 -3.607440 -3.623206 -3.662804 -3.728309 -3.816107 -3.935614 -4.082904 -4.256301 -80.00000 -4.075206 -3.859577 -3.823616 -3.839251 -3.878788 -3.944238 -4.031981 -4.151414 -4.298636 -4.471965 -80.00000 -4.298605 -4.081857 -4.045452 -4.060931 -4.100397 -4.165785 -4.253464 -4.372813 -4.519957 -4.693208 -80.00000 -4.524415 -4.306721 -4.269903 -4.285224 -4.324628 -4.389961 -4.477586 -4.596862 -4.743936 -4.917118 -80.00000 -4.741314 -4.523690 -4.486766 -4.502010 -4.541410 -4.606739 -4.694363 -4.813639 -4.960702 -5.133878 -80.00000 -4.855145 -4.638621 -4.601979 -4.617278 -4.656736 -4.722117 -4.809797 -4.929149 -5.076271 -5.249512 -80.00000 -4.928240 -4.713017 -4.676750 -4.692144 -4.731673 -4.797117 -4.884865 -5.004306 -5.151504 -5.324823 -80.00000 -5.109916 -4.882867 -4.844295 -4.858875 -4.897858 -4.962857 -5.050096 -5.168907 -5.315539 -5.488274 -80.00000 -3.645993 -3.432905 -3.397963 -3.413964 -3.453678 -3.519281 -3.607210 -3.726860 -3.874268 -4.047784 -80.00000 -3.852388 -3.638711 -3.603547 -3.619474 -3.659152 -3.724723 -3.812618 -3.932224 -4.079592 -4.253067 -80.00000 -4.063901 -3.849442 -3.813983 -3.829809 -3.869438 -3.934966 -4.022818 -4.142365 -4.289680 -4.463102 -80.00000 -4.281441 -4.065996 -4.030158 -4.045855 -4.085422 -4.150896 -4.238692 -4.358165 -4.505412 -4.678766 -80.00000 -4.504840 -4.288276 -4.251994 -4.267534 -4.307031 -4.372442 -4.460175 -4.579564 -4.726732 -4.900008 -80.00000 -4.730650 -4.513140 -4.476444 -4.491827 -4.531262 -4.596618 -4.684296 -4.803612 -4.950711 -5.123918 -80.00000 -4.947549 -4.730109 -4.693307 -4.708613 -4.748044 -4.813396 -4.901073 -5.020389 -5.167477 -5.340678 -80.00000 -5.061379 -4.845040 -4.808520 -4.823881 -4.863370 -4.928774 -5.016508 -5.135899 -5.283047 -5.456312 -80.00000 -5.134476 -4.919437 -4.883293 -4.898748 -4.938307 -5.003775 -5.091576 -5.211057 -5.358280 -5.531623 -80.00000 -5.316119 -5.089255 -5.050808 -5.065453 -5.104468 -5.169491 -5.256783 -5.375634 -5.522293 -5.695053 -80.00000 -3.847684 -3.635024 -3.600274 -3.616354 -3.656108 -3.721746 -3.809734 -3.929436 -4.076882 -4.250436 -80.00000 -4.054080 -3.840829 -3.805858 -3.821863 -3.861582 -3.927187 -4.015142 -4.134800 -4.282206 -4.455719 -80.00000 -4.265591 -4.051560 -4.016293 -4.032198 -4.071868 -4.137431 -4.225342 -4.344941 -4.492293 -4.665754 -80.00000 -4.483130 -4.268113 -4.232468 -4.248243 -4.287852 -4.353360 -4.441216 -4.560740 -4.708025 -4.881417 -80.00000 -4.706529 -4.490392 -4.454303 -4.469922 -4.509460 -4.574906 -4.662697 -4.782138 -4.929345 -5.102659 -80.00000 -4.932338 -4.715255 -4.678753 -4.694215 -4.733691 -4.799082 -4.886818 -5.006186 -5.153323 -5.326568 -80.00000 -5.149239 -4.932225 -4.895616 -4.911001 -4.950473 -5.015859 -5.103596 -5.222963 -5.370089 -5.543328 -80.00000 -5.263070 -5.047157 -5.010830 -5.026269 -5.065800 -5.131238 -5.219031 -5.338474 -5.485660 -5.658963 -80.00000 -5.336168 -5.121555 -5.085603 -5.101137 -5.140737 -5.206239 -5.294099 -5.413632 -5.560893 -5.734275 -80.00000 -5.517755 -5.291318 -5.253067 -5.267795 -5.306852 -5.371909 -5.459260 -5.578165 -5.724862 -5.897662 -80.00000 -4.047205 -3.834882 -3.800312 -3.816470 -3.856262 -3.921932 -4.009993 -4.129740 -4.277217 -4.450804 -80.00000 -4.253601 -4.040688 -4.005896 -4.021980 -4.061735 -4.127373 -4.215401 -4.335104 -4.482541 -4.656087 -80.00000 -4.465113 -4.251418 -4.216331 -4.232315 -4.272022 -4.337616 -4.425600 -4.545245 -4.692628 -4.866121 -80.00000 -4.682652 -4.467971 -4.432505 -4.448359 -4.488005 -4.553545 -4.641473 -4.761044 -4.908360 -5.081785 -80.00000 -4.906051 -4.690249 -4.654340 -4.670038 -4.709613 -4.775091 -4.862955 -4.982441 -5.129680 -5.303026 -80.00000 -5.131860 -4.915112 -4.878789 -4.894331 -4.933844 -4.999267 -5.087076 -5.206490 -5.353657 -5.526935 -80.00000 -5.348761 -5.132082 -5.095653 -5.111117 -5.150626 -5.216044 -5.303853 -5.423265 -5.570423 -5.743695 -80.00000 -5.462593 -5.247015 -5.210866 -5.226385 -5.265952 -5.331424 -5.419288 -5.538776 -5.685993 -5.859329 -80.00000 -5.535690 -5.321413 -5.285640 -5.301253 -5.340889 -5.406425 -5.494356 -5.613935 -5.761227 -5.934641 -80.00000 -5.717254 -5.491151 -5.453079 -5.467890 -5.506984 -5.572074 -5.659498 -5.778448 -5.925178 -6.098010 -80.00000 -4.276267 -4.061663 -4.026472 -4.042497 -4.082175 -4.147755 -4.235805 -4.355415 -4.502760 -4.676212 -80.00000 -4.482667 -4.267470 -4.232057 -4.248007 -4.287649 -4.353197 -4.441213 -4.560780 -4.708084 -4.881495 -80.00000 -4.694186 -4.478204 -4.442493 -4.458343 -4.497936 -4.563441 -4.651413 -4.770921 -4.918172 -5.091530 -80.00000 -4.911732 -4.694760 -4.658670 -4.674388 -4.713921 -4.779371 -4.867287 -4.986722 -5.133905 -5.307195 -80.00000 -5.135139 -4.917044 -4.880507 -4.896068 -4.935530 -5.000917 -5.088770 -5.208120 -5.355226 -5.528437 -80.00000 -5.360953 -5.141911 -5.104959 -5.120361 -5.159761 -5.225094 -5.312891 -5.432168 -5.579204 -5.752346 -80.00000 -5.577847 -5.358879 -5.321821 -5.337145 -5.376541 -5.441869 -5.529666 -5.648943 -5.795969 -5.969105 -80.00000 -5.691664 -5.473806 -5.437031 -5.452412 -5.491865 -5.557246 -5.645100 -5.764452 -5.911536 -6.084737 -80.00000 -5.764748 -5.548200 -5.511802 -5.527278 -5.566801 -5.632246 -5.720167 -5.839609 -5.986768 -6.160048 -80.00000 -5.946694 -5.718318 -5.679600 -5.694261 -5.733240 -5.798237 -5.885649 -6.004461 -6.151056 -6.323751 -80.00000 -4.694187 -4.461630 -4.420826 -4.435322 -4.473969 -4.538672 -4.625951 -4.744317 -4.890568 -5.062884 -80.00000 -4.900617 -4.667456 -4.626421 -4.640837 -4.679447 -4.744119 -4.831364 -4.949686 -5.095898 -5.268174 -80.00000 -5.112174 -4.878213 -4.836870 -4.851179 -4.889740 -4.954369 -5.041570 -5.159834 -5.305993 -5.478216 -80.00000 -5.329767 -5.094801 -5.053063 -5.067232 -5.105731 -5.170305 -5.257451 -5.375643 -5.521733 -5.693889 -80.00000 -5.553222 -5.317117 -5.274918 -5.288919 -5.327348 -5.391859 -5.478941 -5.597050 -5.743062 -5.915140 -80.00000 -5.779065 -5.542010 -5.499383 -5.513217 -5.551582 -5.616039 -5.703065 -5.821104 -5.967046 -6.139055 -80.00000 -5.995913 -5.758972 -5.716239 -5.729996 -5.768354 -5.832808 -5.919834 -6.037871 -6.183805 -6.355808 -80.00000 -6.109636 -5.873862 -5.831429 -5.845249 -5.883665 -5.948171 -6.035253 -6.153365 -6.299358 -6.471426 -80.00000 -6.182628 -5.948216 -5.906178 -5.920104 -5.958590 -6.023160 -6.110310 -6.228510 -6.374578 -6.546726 -80.00000 -6.367208 -6.120936 -6.076426 -6.089422 -6.127352 -6.191458 -6.278088 -6.395649 -6.541128 -6.712672 -80.00000 -5.244203 -4.966525 -4.911729 -4.922292 -4.958437 -5.020977 -5.106070 -5.221436 -5.365107 -5.534744 -80.00000 -5.450703 -5.172394 -5.117347 -5.127818 -5.163925 -5.226433 -5.311492 -5.426816 -5.570447 -5.740045 -80.00000 -5.662351 -5.383207 -5.327826 -5.338172 -5.374230 -5.436696 -5.521711 -5.636980 -5.780557 -5.950102 -80.00000 -5.880054 -5.599864 -5.544056 -5.554242 -5.590236 -5.652647 -5.737607 -5.852806 -5.996315 -6.165794 -80.00000 -6.103623 -5.822259 -5.765952 -5.775946 -5.811867 -5.874216 -5.959114 -6.074232 -6.217663 -6.387066 -80.00000 -6.329533 -6.047215 -5.990450 -6.000256 -6.036111 -6.098406 -6.183249 -6.298299 -6.441660 -6.610996 -80.00000 -6.546273 -6.264162 -6.207297 -6.217023 -6.252869 -6.315162 -6.400004 -6.515055 -6.658409 -6.827740 -80.00000 -6.659772 -6.378966 -6.322440 -6.332251 -6.368152 -6.430499 -6.515397 -6.630520 -6.773936 -6.943331 -80.00000 -6.732547 -6.453229 -6.397145 -6.407085 -6.443055 -6.505467 -6.590431 -6.705642 -6.849134 -7.018607 -80.00000 -6.923392 -6.631717 -6.572722 -6.581428 -6.616801 -6.678699 -6.763110 -6.877640 -7.020468 -7.189285 -80.00000 -5.948152 -5.572895 -5.490105 -5.492732 -5.524164 -5.582573 -5.663369 -5.773150 -5.912045 -6.076779 -80.00000 -6.154800 -5.778845 -5.695763 -5.698274 -5.729666 -5.788043 -5.868807 -5.978548 -6.117403 -6.282098 -80.00000 -6.366641 -5.989765 -5.906296 -5.908650 -5.939991 -5.998324 -6.079046 -6.188735 -6.327535 -6.492179 -80.00000 -6.584577 -6.206557 -6.122593 -6.124746 -6.156019 -6.214300 -6.294967 -6.404590 -6.543322 -6.707902 -80.00000 -6.808386 -6.429104 -6.344565 -6.346479 -6.377675 -6.435894 -6.516501 -6.626048 -6.764701 -6.929207 -80.00000 -7.034435 -6.654185 -6.569126 -6.570811 -6.601935 -6.660101 -6.740655 -6.850138 -6.988723 -7.153165 -80.00000 -7.250942 -6.871111 -6.785965 -6.787570 -6.818678 -6.876846 -6.957398 -7.066884 -7.205465 -7.369902 -80.00000 -7.363964 -6.985756 -6.901034 -6.902763 -6.933924 -6.992148 -7.072754 -7.182312 -7.320958 -7.485459 -80.00000 -7.436275 -7.059845 -6.975661 -6.977569 -7.008798 -7.067089 -7.147759 -7.257400 -7.396126 -7.560703 -80.00000 -7.640072 -7.248333 -7.160064 -7.160048 -7.190557 -7.248210 -7.328225 -7.437061 -7.574946 -7.738733 -80.00000 -6.580416 -6.071862 -5.955612 -5.948540 -5.974949 -6.028814 -6.104997 -6.208840 -6.342610 -6.502211 -80.00000 -6.787255 -6.277901 -6.161309 -6.154093 -6.180460 -6.234294 -6.310445 -6.414251 -6.547980 -6.707543 -80.00000 -6.999343 -6.488941 -6.371894 -6.364485 -6.390797 -6.444588 -6.520698 -6.624454 -6.758130 -6.917643 -80.00000 -7.217579 -6.705883 -6.588258 -6.580601 -6.606841 -6.660580 -6.736638 -6.840332 -6.973938 -7.133389 -80.00000 -7.441697 -6.928600 -6.810308 -6.802360 -6.828515 -6.882194 -6.958192 -7.061815 -7.195344 -7.354724 -80.00000 -7.667920 -7.153827 -7.034939 -7.026717 -7.052793 -7.106421 -7.182368 -7.285932 -7.419393 -7.578710 -80.00000 -7.884113 -7.370748 -7.251793 -7.243489 -7.269543 -7.323174 -7.399120 -7.502689 -7.636148 -7.795464 -80.00000 -7.996507 -7.485231 -7.366808 -7.358675 -7.384780 -7.438469 -7.514468 -7.618106 -7.751634 -7.911012 -80.00000 -8.068205 -7.559131 -7.441368 -7.433470 -7.459643 -7.513401 -7.589461 -7.693181 -7.826790 -7.986242 -80.00000 -8.287830 -7.756152 -7.632677 -7.621985 -7.647281 -7.700254 -7.775532 -7.878301 -8.010868 -8.169377 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -80.00000 -5.184338 -3.933285 -3.404408 -3.152925 -3.063718 -3.039050 -3.088031 -3.194686 -3.320667 -3.461262 -80.00000 -4.717525 -3.484817 -2.960571 -2.709306 -2.614938 -2.586425 -2.625327 -2.715541 -2.825409 -2.951867 -80.00000 -4.442243 -3.215334 -2.688026 -2.431153 -2.327768 -2.290847 -2.317780 -2.392566 -2.487634 -2.600554 -80.00000 -4.245890 -3.020652 -2.488149 -2.224101 -2.110798 -2.064111 -2.078705 -2.138805 -2.219810 -2.319624 -80.00000 -4.092977 -2.867547 -2.329109 -2.057395 -1.934011 -1.877086 -1.879352 -1.925342 -1.992779 -2.079781 -80.00000 -3.967634 -2.741036 -2.196423 -1.916944 -1.783568 -1.716280 -1.706377 -1.738735 -1.792983 -1.867394 -80.00000 -3.861370 -2.633048 -2.082233 -1.795052 -1.651876 -1.574264 -1.552409 -1.571557 -1.612937 -1.674945 -80.00000 -3.769104 -2.538727 -1.981782 -1.687034 -1.534291 -1.446475 -1.412915 -1.419235 -1.448035 -1.497815 -80.00000 -3.687550 -2.454919 -1.891960 -1.589813 -1.427750 -1.329893 -1.284887 -1.278734 -1.295226 -1.332950 -80.00000 -3.614462 -2.379456 -1.810622 -1.501258 -1.330121 -1.222410 -1.166219 -1.147927 -1.152369 -1.178214 -80.00000 -5.662270 -4.459811 -3.960716 -3.731321 -3.657717 -3.647090 -3.705270 -3.817111 -3.947828 -4.093391 -80.00000 -5.357076 -4.144942 -3.630514 -3.385705 -3.294505 -3.268956 -3.308422 -3.397271 -3.506243 -3.632458 -80.00000 -5.177448 -3.956761 -3.429493 -3.171365 -3.065032 -3.025455 -3.048535 -3.118578 -3.209671 -3.319411 -80.00000 -5.049494 -3.821356 -3.283065 -3.013266 -2.893602 -2.841118 -2.849461 -2.903038 -2.978348 -3.073259 -80.00000 -4.949950 -3.715211 -3.167206 -2.886969 -2.755307 -2.690882 -2.685729 -2.724433 -2.785369 -2.866592 -80.00000 -4.868422 -3.627741 -3.071011 -2.781290 -2.638663 -2.563108 -2.545442 -2.570470 -2.618089 -2.686495 -80.00000 -4.799354 -3.553255 -2.988576 -2.690132 -2.537370 -2.451373 -2.422005 -2.434306 -2.469452 -2.525751 -80.00000 -4.739421 -3.488331 -2.916332 -2.609792 -2.447579 -2.351732 -2.311346 -2.311704 -2.335080 -2.379871 -80.00000 -4.686477 -3.430753 -2.851953 -2.537842 -2.366757 -2.261574 -2.210759 -2.199841 -2.212047 -2.245852 -80.00000 -4.639052 -3.378995 -2.793836 -2.472601 -2.293141 -2.179075 -2.118346 -2.096730 -2.098291 -2.121573 -80.00000 -4.851911 -3.651302 -3.155030 -2.927927 -2.856623 -2.847476 -2.907515 -3.021615 -3.154149 -3.301030 -80.00000 -4.521451 -3.314887 -2.805980 -2.565775 -2.478827 -2.456719 -2.499592 -2.591853 -2.703694 -2.832265 -80.00000 -4.326786 -3.113313 -2.592587 -2.339941 -2.238581 -2.203241 -2.230350 -2.304260 -2.398697 -2.511309 -80.00000 -4.188041 -2.968013 -2.436678 -2.172685 -2.058201 -2.010223 -2.022764 -2.080291 -2.159087 -2.257076 -80.00000 -4.080056 -2.853955 -2.313024 -2.038634 -1.912085 -1.852137 -1.851080 -1.893578 -1.957915 -2.042194 -80.00000 -3.991583 -2.759857 -2.210153 -1.926157 -1.788411 -1.717115 -1.703265 -1.731767 -1.782531 -1.853801 -80.00000 -3.916609 -2.679649 -2.121849 -1.828905 -1.680686 -1.598603 -1.572646 -1.587983 -1.625893 -1.684728 -80.00000 -3.851535 -2.609679 -2.044346 -1.743013 -1.584934 -1.492569 -1.455100 -1.457971 -1.483631 -1.530524 -80.00000 -3.794036 -2.547578 -1.975190 -1.665947 -1.498538 -1.396341 -1.347886 -1.338893 -1.352828 -1.388216 -80.00000 -3.742522 -2.491719 -1.912685 -1.595949 -1.419672 -1.308053 -1.249080 -1.228752 -1.231429 -1.255704 -80.00000 -5.837502 -4.636609 -4.141909 -3.916162 -3.846472 -3.838186 -3.899652 -4.015720 -4.149822 -4.297785 -80.00000 -5.477294 -4.275699 -3.772073 -3.536251 -3.453392 -3.434514 -3.480642 -3.576212 -3.690795 -3.821579 -80.00000 -5.264874 -4.058769 -3.544843 -3.297846 -3.201602 -3.170562 -3.201762 -3.279598 -3.377388 -3.492838 -80.00000 -5.113365 -3.902059 -3.378221 -3.120428 -3.011455 -2.968225 -2.985177 -3.046835 -3.129241 -3.230376 -80.00000 -4.995378 -3.778831 -3.245686 -2.977673 -2.856675 -2.801553 -2.804895 -2.851451 -2.919393 -3.006882 -80.00000 -4.898669 -3.677023 -3.135159 -2.857490 -2.725115 -2.658479 -2.648789 -2.681068 -2.735230 -2.809571 -80.00000 -4.816683 -3.590137 -3.040082 -2.753270 -2.610093 -2.532335 -2.510135 -2.528813 -2.569749 -2.631348 -80.00000 -4.745500 -3.514261 -2.956480 -2.660987 -2.507517 -2.419017 -2.384780 -2.390435 -2.418619 -2.467828 -80.00000 -4.682584 -3.446853 -2.881758 -2.577992 -2.414686 -2.315806 -2.269964 -2.263104 -2.278955 -2.316092 -80.00000 -4.626201 -3.386167 -2.814122 -2.502451 -2.329717 -2.220797 -2.163748 -2.144829 -2.148727 -2.174088 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -80.00000 -4.858207 -4.385446 -4.321264 -4.406442 -4.568845 -4.757713 -4.976205 -5.218534 -5.467265 -5.721876 -80.00000 -5.065102 -4.591804 -4.527344 -4.612353 -4.774650 -4.963438 -5.181871 -5.424156 -5.672849 -5.927425 -80.00000 -5.277260 -4.803259 -4.738434 -4.823221 -4.985377 -5.174058 -5.392413 -5.634640 -5.883282 -6.137812 -80.00000 -5.495577 -5.020715 -4.955431 -5.039938 -5.201918 -5.390463 -5.608719 -5.850872 -6.099451 -6.353922 -80.00000 -5.719766 -5.243986 -5.178192 -5.262384 -5.424163 -5.612554 -5.830697 -6.072765 -6.321270 -6.575675 -80.00000 -5.945995 -5.469603 -5.403407 -5.487337 -5.648943 -5.837202 -6.055246 -6.297242 -6.545681 -6.800028 -80.00000 -6.162003 -5.686226 -5.620156 -5.704119 -5.865732 -6.053991 -6.272034 -6.514026 -6.762463 -7.016806 -80.00000 -6.274131 -5.799872 -5.734406 -5.818691 -5.980494 -6.168892 -6.387035 -6.629100 -6.877600 -7.132000 -80.00000 -6.345610 -5.872892 -5.808086 -5.892741 -6.054766 -6.243329 -6.461590 -6.703743 -6.952319 -7.206786 -80.00000 -6.459653 -5.978157 -5.910775 -5.993951 -6.155070 -6.342970 -6.560760 -6.802571 -7.050873 -7.305109 -80.00000 -4.502484 -3.979948 -3.870980 -3.918352 -4.044686 -4.203798 -4.393501 -4.607303 -4.832243 -5.067453 -80.00000 -4.709350 -4.186244 -4.076983 -4.124182 -4.250414 -4.409451 -4.599101 -4.812862 -5.037768 -5.272945 -80.00000 -4.921470 -4.397620 -4.287971 -4.334942 -4.461038 -4.619975 -4.809554 -5.023263 -5.248121 -5.483256 -80.00000 -5.139741 -4.614977 -4.504844 -4.551525 -4.677448 -4.836259 -5.025749 -5.239390 -5.464189 -5.699270 -80.00000 -5.363885 -4.838142 -4.727466 -4.773818 -4.899543 -5.058211 -5.247597 -5.461162 -5.685892 -5.920912 -80.00000 -5.590096 -5.063686 -4.952570 -4.998644 -5.124197 -5.282738 -5.472034 -5.685531 -5.910202 -6.145167 -80.00000 -5.806170 -5.280370 -5.169356 -5.215443 -5.340989 -5.499523 -5.688813 -5.902307 -6.126974 -6.361936 -80.00000 -5.918413 -5.394181 -5.283773 -5.330172 -5.455890 -5.614546 -5.803923 -6.017481 -6.242206 -6.477219 -80.00000 -5.989997 -5.467370 -5.357640 -5.404402 -5.530325 -5.689129 -5.878610 -6.092247 -6.317041 -6.552116 -80.00000 -6.104225 -5.572643 -5.460419 -5.505754 -5.630802 -5.788943 -5.977928 -6.191177 -6.415645 -6.650439 -80.00000 -4.292488 -3.735716 -3.593298 -3.609765 -3.705028 -3.835953 -3.998119 -4.185256 -4.387126 -4.602634 -80.00000 -4.499336 -3.941977 -3.799258 -3.815551 -3.910714 -4.041567 -4.203684 -4.390783 -4.592618 -4.808095 -80.00000 -4.711433 -4.153307 -4.010191 -4.026251 -4.121282 -4.252041 -4.414092 -4.601140 -4.802929 -5.018364 -80.00000 -4.929677 -4.370608 -4.226992 -4.242760 -4.337622 -4.468262 -4.630228 -4.817212 -5.018943 -5.234325 -80.00000 -5.153796 -4.593712 -4.449535 -4.464968 -4.559637 -4.690139 -4.852009 -5.038919 -5.240584 -5.455905 -80.00000 -5.379995 -4.819212 -4.674577 -4.689723 -4.784220 -4.914601 -5.076385 -5.263232 -5.464838 -5.680106 -80.00000 -5.596108 -5.035929 -4.891379 -4.906526 -5.001010 -5.131381 -5.293158 -5.480000 -5.681602 -5.896867 -80.00000 -5.708417 -5.149831 -5.005887 -5.021337 -5.115981 -5.246464 -5.408320 -5.595224 -5.796883 -6.012198 -80.00000 -5.780061 -5.223117 -5.079854 -5.095664 -5.190502 -5.321122 -5.483074 -5.670053 -5.871779 -6.087155 -80.00000 -5.894424 -5.328443 -5.182774 -5.197227 -5.291247 -5.421234 -5.582695 -5.769263 -5.970627 -6.185681 -80.00000 -4.142632 -3.559238 -3.389695 -3.379948 -3.448111 -3.553321 -3.689986 -3.852317 -4.032010 -4.227862 -80.00000 -4.349468 -3.765475 -3.595626 -3.585703 -3.653769 -3.758912 -3.895529 -4.057823 -4.237481 -4.433302 -80.00000 -4.561549 -3.976773 -3.806520 -3.796365 -3.864301 -3.969353 -4.105907 -4.268152 -4.447765 -4.643545 -80.00000 -4.779775 -4.194034 -4.023273 -4.012823 -4.080594 -4.185532 -4.322007 -4.484189 -4.663744 -4.859470 -80.00000 -5.003874 -4.417096 -4.245761 -4.234975 -4.302556 -4.407363 -4.543746 -4.705856 -4.885345 -5.081010 -80.00000 -5.230065 -4.642566 -4.470759 -4.459680 -4.527093 -4.631783 -4.768084 -4.930131 -5.109561 -5.305173 -80.00000 -5.446206 -4.859304 -4.687572 -4.676485 -4.743879 -4.848557 -4.984849 -5.146894 -5.326320 -5.521929 -80.00000 -5.558562 -4.973269 -4.802140 -4.791349 -4.858894 -4.963676 -5.100044 -5.262148 -5.441630 -5.637290 -80.00000 -5.630248 -5.046620 -4.876176 -4.865739 -4.933470 -5.038380 -5.174838 -5.337015 -5.516565 -5.712286 -80.00000 -5.744720 -5.152008 -4.979238 -4.967518 -5.034492 -5.138814 -5.274800 -5.436563 -5.615734 -5.811108 -80.00000 -4.025902 -3.420516 -3.227963 -3.195343 -3.239445 -3.321206 -3.434342 -3.573613 -3.732169 -3.908752 -80.00000 -4.232728 -3.626735 -3.433872 -3.401077 -3.445083 -3.526780 -3.639870 -3.779104 -3.937626 -4.114177 -80.00000 -4.444797 -3.838009 -3.644737 -3.611709 -3.655589 -3.737199 -3.850229 -3.989414 -4.147891 -4.324399 -80.00000 -4.663008 -4.055240 -3.861453 -3.828130 -3.871849 -3.953349 -4.066302 -4.205427 -4.363845 -4.540300 -80.00000 -4.887094 -4.278269 -4.083900 -4.050240 -4.093773 -4.175146 -4.288012 -4.427065 -4.585417 -4.761811 -80.00000 -5.113278 -4.503716 -4.308866 -4.274909 -4.318275 -4.399535 -4.512322 -4.651315 -4.809608 -4.985948 -80.00000 -5.329440 -4.720469 -4.525684 -4.491713 -4.535058 -4.616304 -4.729083 -4.868072 -5.026363 -5.202698 -80.00000 -5.441831 -4.834482 -4.640297 -4.606616 -4.650104 -4.731449 -4.844298 -4.983347 -5.141693 -5.318079 -80.00000 -5.513550 -4.907883 -4.714384 -4.681052 -4.724718 -4.806186 -4.919121 -5.058241 -5.216654 -5.393103 -80.00000 -5.628113 -5.013330 -4.817579 -4.783036 -4.826010 -4.906936 -5.019429 -5.158143 -5.316175 -5.492267 -80.00000 -3.930206 -3.305981 -3.093340 -3.040360 -3.062789 -3.123053 -3.214431 -3.332233 -3.470737 -3.628642 -80.00000 -4.137025 -3.512185 -3.299231 -3.246077 -3.268413 -3.328614 -3.419948 -3.537714 -3.676183 -3.834057 -80.00000 -4.349084 -3.723439 -3.510073 -3.456686 -3.478898 -3.539016 -3.630292 -3.748009 -3.886433 -4.044264 -80.00000 -4.567283 -3.940646 -3.726760 -3.673078 -3.695132 -3.755145 -3.846348 -3.964004 -4.102369 -4.260146 -80.00000 -4.791357 -4.163649 -3.949176 -3.895155 -3.917027 -3.976916 -4.068034 -4.185621 -4.323920 -4.481635 -80.00000 -5.017537 -4.389077 -4.174114 -4.119796 -4.141503 -4.201283 -4.292325 -4.409851 -4.548092 -4.705752 -80.00000 -5.233715 -4.605843 -4.390937 -4.336599 -4.358283 -4.418048 -4.509082 -4.626605 -4.764842 -4.922497 -80.00000 -5.346135 -4.719893 -4.505585 -4.451531 -4.473351 -4.533211 -4.624312 -4.741894 -4.880187 -5.037894 -80.00000 -5.417881 -4.793334 -4.579712 -4.526002 -4.547994 -4.607971 -4.699155 -4.816807 -4.955167 -5.112937 -80.00000 -5.532522 -4.898839 -4.683033 -4.628180 -4.649541 -4.709025 -4.799801 -4.917063 -5.055049 -5.212464 -80.00000 -3.849072 -3.208306 -2.977778 -2.906406 -2.909090 -2.949525 -3.020708 -3.118469 -3.237984 -3.377914 -80.00000 -4.055884 -3.414497 -3.183655 -3.112109 -3.114702 -3.155077 -3.226217 -3.323942 -3.443423 -3.583320 -80.00000 -4.267935 -3.625736 -3.394478 -3.322700 -3.325171 -3.365465 -3.436549 -3.534227 -3.653662 -3.793516 -80.00000 -4.486124 -3.842923 -3.611141 -3.539068 -3.541386 -3.581577 -3.652590 -3.750207 -3.869584 -4.009384 -80.00000 -4.710188 -4.065904 -3.833530 -3.761118 -3.763257 -3.803330 -3.874260 -3.971808 -4.091119 -4.230855 -80.00000 -4.936364 -4.291316 -4.058446 -3.985735 -3.987712 -4.027678 -4.098536 -4.196023 -4.315275 -4.454957 -80.00000 -5.152556 -4.508091 -4.275273 -4.202538 -4.204489 -4.244440 -4.315289 -4.412773 -4.532021 -4.671698 -80.00000 -5.265001 -4.622172 -4.389948 -4.317493 -4.319575 -4.359616 -4.430530 -4.528074 -4.647377 -4.787106 -80.00000 -5.336769 -4.695646 -4.464108 -4.391993 -4.394240 -4.434394 -4.505388 -4.603002 -4.722373 -4.862164 -80.00000 -5.451479 -4.801207 -4.567547 -4.494352 -4.496028 -4.535738 -4.606360 -4.703603 -4.822615 -4.962060 -80.00000 -3.778624 -3.123078 -2.876387 -2.788211 -2.772743 -2.794783 -2.847143 -2.926142 -3.027682 -3.150378 -80.00000 -3.985431 -3.329258 -3.082252 -2.993902 -2.978345 -3.000326 -3.052645 -3.131608 -3.233114 -3.355778 -80.00000 -4.197474 -3.540483 -3.293059 -3.204478 -3.188802 -3.210705 -3.262969 -3.341885 -3.443344 -3.565965 -80.00000 -4.415655 -3.757652 -3.509702 -3.420827 -3.405000 -3.426803 -3.478998 -3.557854 -3.659255 -3.781821 -80.00000 -4.639710 -3.980615 -3.732068 -3.642855 -3.626852 -3.648540 -3.700655 -3.779442 -3.880776 -4.003279 -80.00000 -4.865882 -4.206013 -3.956965 -3.867452 -3.851290 -3.872874 -3.924917 -4.003645 -4.104920 -4.227367 -80.00000 -5.082086 -4.422797 -4.173795 -4.084254 -4.068063 -4.089632 -4.141667 -4.220393 -4.321663 -4.444106 -80.00000 -5.194552 -4.536904 -4.288495 -4.199227 -4.183164 -4.204820 -4.256917 -4.335701 -4.437028 -4.559522 -80.00000 -5.266339 -4.610407 -4.362681 -4.273751 -4.257848 -4.279612 -4.331787 -4.410641 -4.512035 -4.634592 -80.00000 -5.381113 -4.716020 -4.466230 -4.376280 -4.359862 -4.381231 -4.433070 -4.511577 -4.612630 -4.734855 -80.00000 -3.716357 -3.047425 -2.785965 -2.682299 -2.650019 -2.654905 -2.689651 -2.751031 -2.835543 -2.941754 -80.00000 -3.923158 -3.253596 -2.991820 -2.887980 -2.855613 -2.860442 -2.895148 -2.956493 -3.040969 -3.147147 -80.00000 -4.135195 -3.464808 -3.202613 -3.098542 -3.066058 -3.070812 -3.105464 -3.166762 -3.251193 -3.357327 -80.00000 -4.353368 -3.681963 -3.419239 -3.314875 -3.282243 -3.286899 -3.321484 -3.382723 -3.467095 -3.573174 -80.00000 -4.577416 -3.904909 -3.641585 -3.536884 -3.504079 -3.508623 -3.543130 -3.604301 -3.688605 -3.794621 -80.00000 -4.803585 -4.130295 -3.866466 -3.761464 -3.728502 -3.732945 -3.767383 -3.828494 -3.912739 -4.018699 -80.00000 -5.019799 -4.347086 -4.083298 -3.978265 -3.945273 -3.949700 -3.984129 -4.045238 -4.129479 -4.235434 -80.00000 -5.132284 -4.461216 -4.198018 -4.093255 -4.060385 -4.064896 -4.099386 -4.160553 -4.244851 -4.350857 -80.00000 -5.204088 -4.534743 -4.272228 -4.167798 -4.135084 -4.139700 -4.174265 -4.235502 -4.319867 -4.425937 -80.00000 -5.318919 -4.640406 -4.375881 -4.270487 -4.237313 -4.241580 -4.275846 -4.336760 -4.420804 -4.526560 -80.00000 -3.660554 -2.979373 -2.704298 -2.586247 -2.538299 -2.527117 -2.545319 -2.590106 -2.658466 -2.748920 -80.00000 -3.867351 -3.185537 -2.910144 -2.791919 -2.743886 -2.732648 -2.750811 -2.795563 -2.863889 -2.954309 -80.00000 -4.079383 -3.396738 -3.120925 -3.002471 -2.954323 -2.943011 -2.961122 -3.005827 -3.074106 -3.164483 -80.00000 -4.297549 -3.613879 -3.337535 -3.218789 -3.170496 -3.159089 -3.177134 -3.221780 -3.290001 -3.380322 -80.00000 -4.521590 -3.836811 -3.559864 -3.440781 -3.392318 -3.380802 -3.398771 -3.443349 -3.511503 -3.601759 -80.00000 -4.747756 -4.062187 -3.784731 -3.665347 -3.616729 -3.605114 -3.623015 -3.667534 -3.735628 -3.825829 -80.00000 -4.963980 -4.278984 -4.001565 -3.882146 -3.833497 -3.821867 -3.839760 -3.884276 -3.952366 -4.042562 -80.00000 -5.076481 -4.393134 -4.116302 -3.997150 -3.948619 -3.937069 -3.955022 -3.999596 -4.067742 -4.157990 -80.00000 -5.148300 -4.466682 -4.190533 -4.071710 -4.023331 -4.011883 -4.029909 -4.074553 -4.142766 -4.233078 -80.00000 -5.263184 -4.572392 -4.294282 -4.174551 -4.125762 -4.114009 -4.131771 -4.176118 -4.244034 -4.334051 -80.00000 -4.282172 -3.819340 -3.762209 -3.851621 -4.017264 -4.207515 -4.427024 -4.670253 -4.918962 -5.172861 -80.00000 -4.490616 -4.027997 -3.971002 -4.060507 -4.226217 -4.416522 -4.636072 -4.879333 -5.128070 -5.381994 -80.00000 -4.696267 -4.233980 -4.177166 -4.266792 -4.432582 -4.622952 -4.842551 -5.085848 -5.334618 -5.588572 -80.00000 -4.897202 -4.435461 -4.378928 -4.468729 -4.634636 -4.825096 -5.044763 -5.288111 -5.536924 -5.790918 -80.00000 -5.096100 -4.634770 -4.578478 -4.668436 -4.834446 -5.024990 -5.244719 -5.488113 -5.736968 -5.990999 -80.00000 -5.327719 -4.863764 -4.806417 -4.895794 -5.061455 -5.251737 -5.471280 -5.714539 -5.963276 -6.217203 -80.00000 -5.768466 -5.283144 -5.216642 -5.300821 -5.463287 -5.651156 -5.868955 -6.110933 -6.358567 -6.611503 -80.00000 -6.379511 -5.837281 -5.747127 -5.818082 -5.972491 -6.154318 -6.367771 -6.606571 -6.851469 -7.101960 -80.00000 -7.229795 -6.547571 -6.405259 -6.448430 -6.586364 -6.756060 -6.960904 -7.193469 -7.433040 -7.678800 -80.00000 -8.085139 -7.176602 -6.964445 -6.972982 -7.091151 -7.246657 -7.441609 -7.667105 -7.900695 -8.141185 -80.00000 -3.895622 -3.384220 -3.284685 -3.339652 -3.472857 -3.637331 -3.831646 -4.049337 -4.276869 -4.513607 -80.00000 -4.104078 -3.592905 -3.493519 -3.548588 -3.681862 -3.846389 -4.040743 -4.258464 -4.486021 -4.722783 -80.00000 -4.309752 -3.798931 -3.699739 -3.754935 -3.888290 -4.052880 -4.247279 -4.465034 -4.692621 -4.929410 -80.00000 -4.510724 -4.000482 -3.901587 -3.956965 -4.090434 -4.255109 -4.449570 -4.667370 -4.894999 -5.131824 -80.00000 -4.709639 -4.199846 -4.101212 -4.156755 -4.290328 -4.455082 -4.649600 -4.867443 -5.095109 -5.331968 -80.00000 -4.941006 -4.428524 -4.328832 -4.383816 -4.517072 -4.681599 -4.875955 -5.093678 -5.321239 -5.558004 -80.00000 -5.379928 -4.845307 -4.736283 -4.786144 -4.916438 -5.078817 -5.271653 -5.488243 -5.714807 -5.950679 -80.00000 -5.986206 -5.392767 -5.259711 -5.296580 -5.419429 -5.576454 -5.765519 -5.979313 -6.203426 -6.437107 -80.00000 -6.824463 -6.088169 -5.902922 -5.912895 -6.020738 -6.167164 -6.348862 -6.557252 -6.776657 -7.006157 -80.00000 -7.659759 -6.697113 -6.443418 -6.420492 -6.510653 -6.644909 -6.818297 -7.020685 -7.234907 -7.459840 -80.00000 -3.667100 -3.121033 -2.988095 -3.012813 -3.115893 -3.253586 -3.421875 -3.614395 -3.820464 -4.039141 -80.00000 -3.875563 -3.329735 -3.196952 -3.221777 -3.324927 -3.462672 -3.630998 -3.823547 -4.029641 -4.248341 -80.00000 -4.081250 -3.535785 -3.403204 -3.428159 -3.531390 -3.669196 -3.837565 -4.030147 -4.236269 -4.454996 -80.00000 -4.282244 -3.737376 -3.605101 -3.630241 -3.733584 -3.871471 -4.039898 -4.232523 -4.438686 -4.657448 -80.00000 -4.481169 -3.936772 -3.804768 -3.830079 -3.933525 -4.071487 -4.239968 -4.432634 -4.638833 -4.857628 -80.00000 -4.712392 -4.165275 -4.032217 -4.056983 -4.160134 -4.297889 -4.466223 -4.658775 -4.864872 -5.083575 -80.00000 -5.150264 -4.580609 -4.438149 -4.457864 -4.558210 -4.693979 -4.860918 -5.052398 -5.257531 -5.475365 -80.00000 -5.753805 -5.124348 -4.957723 -4.964646 -5.057952 -5.188780 -5.352263 -5.541111 -5.743884 -5.959593 -80.00000 -6.585218 -5.811548 -5.592874 -5.573515 -5.652735 -5.773850 -5.930634 -6.114430 -6.312706 -6.524390 -80.00000 -7.409276 -6.409596 -6.123419 -6.072212 -6.134976 -6.245040 -6.394341 -6.572596 -6.765974 -6.973312 -80.00000 -3.503878 -2.930345 -2.769618 -2.767806 -2.843633 -2.955802 -3.098940 -3.267134 -3.451756 -3.651698 -80.00000 -3.712346 -3.139059 -2.978491 -2.976790 -3.052687 -3.164907 -3.308081 -3.476302 -3.660949 -3.860914 -80.00000 -3.918042 -3.345125 -3.184765 -3.183196 -3.259174 -3.371452 -3.514668 -3.682921 -3.867596 -4.067588 -80.00000 -4.119051 -3.546744 -3.386694 -3.385312 -3.461400 -3.573756 -3.717027 -3.885323 -4.070038 -4.270065 -80.00000 -4.317984 -3.746162 -3.586391 -3.585182 -3.661372 -3.773801 -3.917123 -4.085458 -4.270209 -4.470269 -80.00000 -4.549106 -3.974547 -3.813726 -3.811985 -3.887897 -4.000132 -4.143317 -4.311542 -4.496192 -4.696160 -80.00000 -4.986242 -4.388888 -4.218638 -4.211917 -4.285150 -4.395519 -4.537393 -4.704578 -4.888276 -5.087376 -80.00000 -5.587867 -4.930085 -4.735627 -4.716300 -4.782812 -4.888541 -5.027180 -5.191817 -5.373184 -5.570168 -80.00000 -6.414515 -5.611716 -5.365406 -5.320304 -5.373428 -5.470078 -5.602467 -5.762244 -5.939190 -6.132182 -80.00000 -7.230824 -6.202433 -5.889370 -5.813212 -5.850778 -5.937153 -6.062604 -6.217089 -6.389254 -6.577967 -80.00000 -3.376651 -2.780157 -2.595476 -2.570041 -2.621118 -2.709375 -2.828653 -2.973598 -3.137151 -3.318109 -80.00000 -3.585124 -2.988879 -2.804363 -2.779040 -2.830186 -2.918494 -3.037806 -3.182778 -3.346356 -3.527337 -80.00000 -3.790826 -3.194959 -3.010653 -2.985464 -3.036690 -3.125055 -3.244406 -3.389410 -3.553016 -3.734024 -80.00000 -3.991847 -3.396598 -3.212607 -3.187606 -3.238940 -3.327380 -3.446784 -3.591830 -3.755475 -3.936519 -80.00000 -4.190786 -3.596034 -3.412327 -3.387500 -3.438935 -3.527445 -3.646899 -3.791983 -3.955664 -4.136741 -80.00000 -4.421831 -3.824330 -3.639577 -3.614230 -3.665401 -3.753728 -3.873053 -4.018028 -4.181609 -4.362593 -80.00000 -4.858403 -4.237925 -4.043736 -4.013475 -4.062074 -4.148631 -4.266711 -4.410666 -4.573296 -4.753406 -80.00000 -5.458557 -4.777209 -4.558814 -4.516121 -4.558269 -4.640426 -4.755436 -4.896896 -5.057202 -5.235184 -80.00000 -6.281565 -5.454672 -5.184639 -5.116613 -5.145947 -5.219519 -5.328618 -5.465333 -5.621244 -5.795226 -80.00000 -7.091989 -6.039934 -5.703784 -5.605352 -5.619844 -5.683737 -5.786300 -5.917875 -6.069053 -6.238761 -80.00000 -3.272296 -2.655962 -2.450138 -2.403377 -2.431809 -2.497737 -2.594512 -2.717365 -2.860457 -3.022527 -80.00000 -3.480772 -2.864691 -2.659034 -2.612387 -2.640889 -2.706866 -2.803674 -2.926553 -3.069670 -3.231764 -80.00000 -3.686480 -3.070781 -2.865337 -2.818825 -2.847406 -2.913438 -3.010285 -3.133194 -3.276340 -3.438461 -80.00000 -3.887511 -3.272437 -3.067311 -3.020987 -3.049674 -3.115779 -3.212677 -3.335628 -3.478813 -3.640970 -80.00000 -4.086454 -3.471887 -3.267049 -3.220900 -3.249686 -3.315860 -3.412805 -3.535793 -3.679015 -3.841205 -80.00000 -4.317436 -3.700112 -3.494234 -3.447576 -3.476109 -3.542109 -3.638931 -3.761812 -3.904932 -4.067030 -80.00000 -4.753551 -4.113113 -3.897801 -3.846294 -3.872348 -3.936658 -4.032289 -4.154163 -4.296331 -4.457547 -80.00000 -5.352516 -4.650877 -4.411383 -4.347607 -4.367445 -4.427554 -4.520248 -4.639662 -4.779506 -4.938576 -80.00000 -6.172584 -5.325034 -5.034122 -4.945408 -4.952922 -5.004853 -5.091906 -5.206650 -5.342104 -5.497150 -80.00000 -6.978284 -5.905991 -5.549516 -5.430955 -5.424229 -5.466963 -5.547796 -5.657500 -5.788238 -5.938995 -80.00000 -3.183782 -2.549914 -2.325106 -2.258881 -2.266445 -2.311499 -2.387081 -2.488987 -2.612355 -2.755870 -80.00000 -3.392260 -2.758649 -2.534011 -2.467901 -2.475534 -2.520636 -2.596250 -2.698183 -2.821576 -2.965114 -80.00000 -3.597973 -2.964748 -2.740325 -2.674350 -2.682062 -2.727217 -2.802868 -2.904831 -3.028253 -3.171819 -80.00000 -3.799011 -3.166418 -2.942315 -2.876528 -2.884344 -2.929570 -3.005271 -3.107275 -3.230736 -3.374338 -80.00000 -3.997959 -3.365880 -3.142068 -3.076457 -3.084370 -3.129663 -3.205409 -3.307450 -3.430948 -3.574584 -80.00000 -4.228889 -3.594046 -3.369200 -3.303089 -3.310760 -3.355886 -3.431515 -3.533449 -3.656846 -3.800388 -80.00000 -4.664620 -4.006557 -3.772287 -3.701387 -3.706662 -3.750167 -3.824649 -3.925586 -4.048028 -4.190682 -80.00000 -5.262587 -4.543064 -4.284651 -4.201635 -4.200902 -4.240377 -4.312035 -4.410534 -4.530648 -4.671141 -80.00000 -6.080197 -5.214500 -4.904882 -4.797289 -4.784662 -4.816303 -4.882542 -4.976426 -5.092146 -5.228587 -80.00000 -6.881960 -5.791924 -5.417239 -5.280291 -5.253942 -5.276791 -5.337067 -5.425981 -5.536988 -5.669117 -80.00000 -3.106897 -2.457280 -2.215208 -2.131057 -2.119267 -2.144757 -2.200366 -2.282427 -2.386861 -2.512300 -80.00000 -3.315377 -2.666021 -2.424120 -2.340085 -2.328363 -2.353900 -2.409541 -2.491627 -2.596086 -2.721549 -80.00000 -3.521095 -2.872126 -2.630443 -2.546543 -2.534899 -2.560489 -2.616166 -2.698282 -2.802770 -2.928260 -80.00000 -3.722141 -3.073809 -2.832447 -2.748734 -2.737193 -2.762852 -2.818576 -2.900733 -3.005260 -3.130787 -80.00000 -3.921092 -3.273280 -3.032212 -2.948676 -2.937231 -2.962954 -3.018723 -3.100917 -3.205480 -3.331042 -80.00000 -4.151977 -3.501398 -3.259300 -3.175273 -3.163594 -3.189158 -3.244813 -3.326901 -3.431363 -3.556831 -80.00000 -4.587377 -3.913492 -3.661984 -3.573226 -3.559226 -3.583228 -3.637775 -3.718872 -3.822379 -3.946952 -80.00000 -5.184486 -4.448934 -4.173329 -4.072600 -4.052777 -4.072899 -4.124718 -4.203395 -4.304568 -4.426965 -80.00000 -5.999986 -5.118067 -4.791467 -4.666490 -4.635157 -4.647742 -4.694330 -4.768430 -4.865205 -4.983525 -80.00000 -6.798382 -5.692509 -5.301292 -5.147401 -5.102803 -5.106941 -5.147783 -5.216965 -5.309022 -5.423008 -80.00000 -3.038918 -2.374978 -2.117048 -2.016265 -1.986424 -1.993527 -2.030284 -2.093532 -2.179832 -2.287760 -80.00000 -3.247401 -2.583723 -2.325965 -2.225300 -2.195527 -2.202676 -2.239464 -2.302737 -2.389062 -2.497014 -80.00000 -3.453122 -2.789835 -2.532296 -2.431766 -2.402071 -2.409270 -2.446093 -2.509396 -2.595750 -2.703730 -80.00000 -3.654173 -2.991528 -2.734311 -2.633969 -2.604374 -2.611641 -2.648510 -2.711853 -2.798247 -2.906264 -80.00000 -3.853128 -3.191008 -2.934088 -2.833922 -2.804421 -2.811751 -2.848664 -2.912044 -2.998473 -3.106525 -80.00000 -4.083973 -3.419083 -3.161138 -3.060489 -3.030763 -3.037940 -3.074742 -3.138017 -3.224345 -3.332303 -80.00000 -4.519084 -3.830817 -3.563479 -3.458153 -3.426174 -3.431842 -3.467570 -3.529858 -3.615230 -3.722287 -80.00000 -5.115441 -4.365337 -4.073953 -3.956792 -3.919160 -3.921078 -3.954160 -4.014043 -4.097077 -4.201947 -80.00000 -5.929095 -5.032481 -4.690304 -4.549201 -4.500402 -4.495047 -4.523061 -4.578396 -4.657024 -4.757798 -80.00000 -6.724554 -5.604355 -5.197971 -5.028356 -4.966700 -4.953199 -4.975652 -5.026107 -5.100013 -5.196430 -80.00000 -2.977980 -2.300885 -2.028271 -1.911965 -1.865208 -1.854976 -1.873905 -1.919301 -1.988252 -2.079276 -80.00000 -3.186465 -2.509634 -2.237194 -2.121006 -2.074316 -2.064129 -2.083088 -2.128509 -2.197485 -2.288533 -80.00000 -3.392189 -2.715752 -2.443532 -2.327479 -2.280866 -2.270728 -2.289722 -2.335172 -2.404178 -2.495253 -80.00000 -3.593246 -2.917454 -2.645557 -2.529692 -2.483177 -2.473105 -2.492144 -2.537634 -2.606679 -2.697792 -80.00000 -3.792203 -3.116942 -2.845343 -2.729654 -2.683233 -2.673222 -2.692303 -2.737830 -2.806911 -2.898059 -80.00000 -4.023014 -3.344980 -3.072361 -2.956197 -2.909558 -2.899399 -2.918373 -2.963795 -3.032775 -3.123827 -80.00000 -4.457868 -3.756397 -3.474403 -3.353613 -3.304783 -3.293163 -3.311092 -3.355532 -3.423554 -3.513704 -80.00000 -5.053555 -4.290107 -3.984121 -3.851624 -3.797296 -3.782044 -3.797400 -3.839444 -3.905125 -3.993078 -80.00000 -5.865571 -4.955506 -4.598921 -4.442769 -4.377586 -4.355293 -4.365723 -4.403242 -4.464512 -4.548351 -80.00000 -6.658429 -5.525129 -5.104720 -4.920421 -4.842750 -4.812578 -4.817607 -4.850276 -4.906816 -4.986281 -80.00000 -4.911003 -4.460180 -4.410909 -4.504488 -4.672977 -4.864077 -5.084160 -5.327978 -5.576476 -5.829592 -80.00000 -5.117920 -4.666578 -4.617034 -4.710443 -4.878822 -5.069836 -5.289855 -5.533625 -5.782082 -6.035162 -80.00000 -5.330107 -4.878086 -4.828184 -4.921370 -5.089602 -5.280501 -5.500435 -5.744143 -5.992546 -6.245576 -80.00000 -5.548456 -5.095605 -5.045257 -5.138162 -5.306209 -5.496964 -5.716791 -5.960419 -6.208753 -6.461721 -80.00000 -5.772677 -5.318946 -5.268102 -5.360691 -5.528529 -5.719119 -5.938824 -6.182362 -6.430616 -6.683514 -80.00000 -5.998920 -5.544611 -5.493382 -5.585713 -5.753375 -5.943824 -6.163423 -6.406882 -6.655068 -6.907903 -80.00000 -6.214879 -5.761196 -5.710110 -5.802487 -5.970162 -6.160615 -6.380213 -6.623670 -6.871853 -7.124683 -80.00000 -6.326925 -5.874735 -5.824260 -5.916974 -6.084854 -6.275460 -6.495168 -6.738703 -6.986954 -7.239845 -80.00000 -6.398330 -5.947643 -5.897831 -5.990925 -6.159042 -6.349828 -6.569665 -6.813296 -7.061628 -7.314591 -80.00000 -6.512231 -6.052898 -6.000464 -6.092066 -6.259279 -6.449416 -6.668803 -6.912116 -7.160195 -7.412942 -80.00000 -4.488105 -3.991845 -3.904485 -3.968661 -4.109614 -4.279815 -4.478804 -4.700277 -4.930193 -5.168231 -80.00000 -4.694983 -4.198166 -4.110517 -4.174520 -4.315366 -4.485488 -4.684422 -4.905853 -5.135734 -5.373738 -80.00000 -4.907121 -4.409575 -4.321543 -4.385317 -4.526023 -4.696042 -4.894900 -5.116276 -5.346108 -5.584069 -80.00000 -5.125412 -4.626972 -4.538463 -4.601947 -4.742475 -4.912362 -5.111126 -5.332433 -5.562203 -5.800109 -80.00000 -5.349576 -4.850181 -4.761138 -4.824294 -4.964619 -5.134355 -5.333011 -5.554238 -5.783938 -6.021780 -80.00000 -5.575796 -5.075756 -4.986286 -5.049166 -5.189315 -5.358919 -5.557480 -5.778637 -6.008276 -6.246063 -80.00000 -5.791842 -5.292418 -5.203062 -5.265963 -5.406110 -5.575709 -5.774265 -5.995417 -6.225052 -6.462835 -80.00000 -5.904034 -5.406164 -5.317419 -5.380641 -5.520970 -5.690699 -5.889346 -6.110566 -6.340261 -6.578096 -80.00000 -5.975571 -5.479286 -5.391218 -5.454812 -5.595356 -5.765241 -5.963998 -6.185300 -6.415065 -6.652965 -80.00000 -6.089677 -5.584496 -5.493870 -5.555991 -5.695633 -5.864850 -6.063125 -6.284066 -6.513537 -6.751187 -80.00000 -4.237630 -3.707036 -3.587146 -3.622574 -3.735105 -3.880620 -4.055663 -4.253900 -4.464286 -4.686106 -80.00000 -4.444487 -3.913313 -3.793125 -3.828378 -3.940806 -4.086248 -4.261240 -4.459438 -4.669789 -4.891578 -80.00000 -4.656595 -4.124664 -4.004082 -4.039103 -4.151396 -4.296740 -4.471663 -4.669810 -4.880115 -5.101861 -80.00000 -4.874852 -4.341991 -4.220914 -4.255641 -4.367762 -4.512983 -4.687819 -4.885901 -5.096148 -5.317842 -80.00000 -5.098983 -4.565124 -4.443492 -4.477886 -4.589808 -4.734888 -4.909625 -5.107631 -5.317811 -5.539443 -80.00000 -5.325189 -4.790645 -4.668562 -4.702670 -4.814420 -4.959374 -5.134023 -5.331964 -5.542084 -5.763664 -80.00000 -5.541284 -5.007349 -4.885360 -4.919474 -5.031213 -5.176158 -5.350799 -5.548736 -5.758853 -5.980429 -80.00000 -5.653560 -5.121210 -4.999830 -5.034254 -5.146159 -5.291221 -5.465945 -5.663944 -5.874117 -6.095744 -80.00000 -5.725174 -5.194452 -5.073756 -5.108543 -5.220649 -5.365854 -5.540676 -5.738751 -5.948993 -6.170681 -80.00000 -5.839444 -5.299712 -5.176544 -5.209920 -5.321166 -5.465714 -5.640039 -5.837717 -6.047618 -6.269010 -80.00000 -4.058516 -3.499962 -3.352001 -3.361005 -3.446529 -3.567123 -3.717771 -3.892548 -4.082589 -4.286926 -80.00000 -4.265357 -3.706209 -3.557943 -3.566772 -3.652197 -3.772722 -3.923322 -4.098061 -4.288068 -4.492373 -80.00000 -4.477445 -3.917521 -3.768852 -3.777448 -3.862742 -3.983175 -4.133710 -4.308401 -4.498362 -4.702626 -80.00000 -4.695679 -4.134798 -3.985624 -3.993926 -4.079052 -4.199368 -4.349823 -4.524450 -4.714354 -4.918564 -80.00000 -4.919786 -4.357877 -4.208135 -4.216100 -4.301034 -4.421216 -4.571576 -4.746131 -4.935969 -5.140120 -80.00000 -5.145981 -4.583360 -4.433151 -4.440825 -4.525588 -4.645651 -4.795928 -4.970420 -5.160200 -5.364297 -80.00000 -5.362110 -4.800091 -4.649961 -4.657630 -4.742377 -4.862428 -5.012697 -5.187185 -5.376961 -5.581055 -80.00000 -5.474447 -4.914031 -4.764506 -4.772476 -4.857378 -4.977536 -5.127882 -5.302430 -5.492262 -5.696406 -80.00000 -5.546115 -4.987356 -4.838517 -4.846843 -4.931935 -5.052225 -5.202662 -5.377285 -5.567183 -5.771388 -80.00000 -5.660521 -5.092686 -4.941466 -4.948458 -5.032747 -5.152415 -5.302363 -5.476568 -5.666094 -5.869966 -80.00000 -3.918781 -3.336449 -3.163750 -3.148560 -3.208808 -3.305223 -3.431898 -3.583488 -3.752810 -3.938748 -80.00000 -4.125610 -3.542673 -3.369666 -3.354300 -3.414452 -3.510802 -3.637430 -3.788984 -3.958272 -4.144178 -80.00000 -4.337682 -3.753954 -3.580539 -3.564941 -3.624965 -3.721227 -3.847795 -3.999300 -4.168543 -4.354407 -80.00000 -4.555897 -3.971194 -3.797265 -3.781372 -3.841235 -3.937385 -4.063876 -4.215320 -4.384505 -4.570317 -80.00000 -4.779987 -4.194232 -4.019726 -4.003495 -4.063169 -4.159192 -4.285594 -4.436967 -4.606087 -4.791837 -80.00000 -5.006174 -4.419686 -4.244700 -4.228175 -4.287682 -4.383590 -4.509912 -4.661224 -4.830287 -5.015984 -80.00000 -5.222330 -4.636436 -4.461519 -4.444981 -4.504467 -4.600362 -4.726676 -4.877985 -5.047042 -5.232736 -80.00000 -5.334712 -4.750436 -4.576119 -4.559873 -4.619505 -4.715500 -4.841886 -4.993254 -5.162367 -5.348112 -80.00000 -5.406421 -4.823824 -4.650193 -4.634297 -4.694109 -4.790228 -4.916701 -5.068140 -5.237320 -5.423125 -80.00000 -5.520945 -4.929230 -4.753306 -4.736155 -4.795233 -4.890777 -5.016782 -5.167802 -5.336596 -5.522045 -80.00000 -3.804087 -3.200962 -3.006093 -2.968645 -3.005286 -3.078574 -3.182066 -3.311047 -3.459662 -3.626698 -80.00000 -4.010906 -3.407167 -3.211987 -3.174364 -3.210912 -3.284137 -3.387585 -3.516531 -3.665111 -3.832115 -80.00000 -4.222966 -3.618424 -3.422831 -3.384976 -3.421400 -3.494542 -3.597931 -3.726830 -3.875365 -4.042326 -80.00000 -4.441166 -3.835633 -3.639522 -3.601373 -3.637639 -3.710675 -3.813990 -3.942827 -4.091305 -4.258213 -80.00000 -4.665240 -4.058639 -3.861942 -3.823455 -3.859538 -3.932451 -4.035681 -4.164449 -4.312861 -4.479708 -80.00000 -4.891420 -4.284069 -4.086884 -4.048100 -4.084019 -4.156821 -4.259975 -4.388683 -4.537037 -4.703830 -80.00000 -5.107598 -4.500834 -4.303708 -4.264904 -4.300800 -4.373588 -4.476734 -4.605438 -4.753788 -4.920577 -80.00000 -5.220016 -4.614881 -4.418352 -4.379833 -4.415865 -4.488749 -4.591962 -4.720725 -4.869131 -5.035970 -80.00000 -5.291760 -4.688318 -4.492474 -4.454299 -4.490505 -4.563505 -4.666801 -4.795635 -4.944107 -5.111009 -80.00000 -5.406387 -4.793800 -4.595747 -4.556398 -4.591940 -4.664418 -4.767282 -4.895707 -5.043793 -5.210330 -80.00000 -3.706748 -3.085080 -2.870081 -2.812035 -2.826592 -2.877882 -2.959128 -3.066248 -3.194441 -3.342421 -80.00000 -3.913558 -3.291270 -3.075958 -3.017737 -3.032204 -3.083433 -3.164637 -3.271722 -3.399880 -3.547828 -80.00000 -4.125607 -3.502506 -3.286779 -3.228327 -3.242673 -3.293822 -3.374970 -3.482008 -3.610121 -3.758025 -80.00000 -4.343795 -3.719691 -3.503440 -3.444695 -3.458888 -3.509934 -3.591012 -3.697989 -3.826045 -3.973895 -80.00000 -4.567857 -3.942669 -3.725827 -3.666744 -3.680758 -3.731687 -3.812682 -3.919591 -4.047580 -4.195369 -80.00000 -4.794031 -4.168079 -3.950742 -3.891361 -3.905214 -3.956036 -4.036958 -4.143807 -4.271739 -4.419472 -80.00000 -5.010227 -4.384856 -4.167570 -4.108164 -4.121990 -4.172798 -4.253712 -4.360558 -4.488485 -4.636215 -80.00000 -5.122676 -4.498941 -4.282248 -4.223120 -4.237077 -4.287975 -4.368953 -4.475858 -4.603841 -4.751622 -80.00000 -5.194449 -4.572420 -4.356411 -4.297622 -4.311744 -4.362752 -4.443810 -4.550785 -4.678835 -4.826678 -80.00000 -5.309167 -4.677977 -4.459836 -4.399952 -4.413484 -4.464028 -4.544693 -4.651280 -4.778955 -4.926438 -80.00000 -3.622157 -2.983714 -2.750249 -2.673032 -2.666870 -2.697271 -2.757255 -2.843340 -2.951576 -3.080608 -80.00000 -3.828960 -3.189891 -2.956110 -2.878720 -2.872470 -2.902813 -2.962756 -3.048805 -3.157008 -3.286007 -80.00000 -4.041000 -3.401110 -3.166912 -3.089291 -3.082924 -3.113189 -3.173078 -3.259081 -3.367238 -3.496194 -80.00000 -4.259176 -3.618272 -3.383548 -3.305636 -3.299119 -3.329286 -3.389106 -3.475049 -3.583148 -3.712049 -80.00000 -4.483227 -3.841228 -3.605907 -3.527658 -3.520967 -3.551019 -3.610761 -3.696637 -3.804668 -3.933507 -80.00000 -4.709397 -4.066620 -3.830799 -3.752250 -3.745402 -3.775352 -3.835022 -3.920838 -4.028812 -4.157595 -80.00000 -4.925608 -4.283408 -4.047630 -3.969052 -3.962174 -3.992109 -4.051771 -4.137585 -4.245555 -4.374333 -80.00000 -5.038085 -4.397526 -4.162337 -4.084030 -4.077278 -4.107299 -4.167023 -4.252895 -4.360920 -4.489750 -80.00000 -5.109881 -4.471040 -4.236533 -4.158560 -4.151966 -4.182094 -4.241894 -4.327836 -4.435928 -4.564822 -80.00000 -5.224684 -4.576668 -4.340105 -4.261114 -4.254000 -4.283722 -4.343174 -4.428755 -4.536493 -4.665041 -80.00000 -3.547333 -2.893545 -2.642998 -2.547847 -2.522188 -2.532755 -2.572446 -2.638349 -2.727203 -2.837579 -80.00000 -3.754130 -3.099710 -2.848847 -2.753523 -2.727778 -2.738289 -2.777941 -2.843809 -2.932628 -3.042971 -80.00000 -3.966161 -3.310914 -3.059632 -2.964078 -2.938220 -2.948655 -2.988255 -3.054076 -3.142849 -3.253149 -80.00000 -4.184328 -3.528058 -3.276247 -3.180403 -3.154398 -3.164738 -3.204272 -3.270034 -3.358749 -3.468993 -80.00000 -4.408370 -3.750992 -3.498582 -3.402402 -3.376227 -3.386457 -3.425914 -3.491609 -3.580257 -3.690438 -80.00000 -4.634535 -3.976370 -3.723453 -3.626974 -3.600644 -3.610775 -3.650163 -3.715800 -3.804388 -3.914513 -80.00000 -4.850759 -4.193166 -3.940287 -3.843774 -3.817414 -3.827529 -3.866909 -3.932543 -4.021128 -4.131248 -80.00000 -4.963259 -4.307312 -4.055018 -3.958771 -3.932531 -3.942728 -3.982168 -4.047860 -4.136501 -4.246673 -80.00000 -5.035078 -4.380856 -4.129242 -4.033325 -4.007236 -4.017537 -4.057051 -4.122812 -4.211520 -4.321755 -80.00000 -5.149957 -4.486554 -4.232954 -4.136092 -4.109554 -4.119507 -4.158719 -4.224151 -4.312531 -4.422444 -80.00000 -3.480233 -2.812284 -2.545831 -2.433825 -2.389762 -2.381480 -2.401813 -2.448381 -2.518483 -2.610617 -80.00000 -3.687025 -3.018439 -2.751668 -2.639491 -2.595345 -2.587007 -2.607302 -2.653836 -2.723903 -2.816004 -80.00000 -3.899050 -3.229629 -2.962438 -2.850033 -2.805775 -2.797365 -2.817610 -2.864096 -2.934117 -3.026175 -80.00000 -4.117208 -3.446757 -3.179035 -3.066340 -3.021940 -3.013438 -3.033617 -3.080046 -3.150008 -3.242010 -80.00000 -4.341240 -3.669673 -3.401349 -3.288320 -3.243753 -3.235144 -3.255250 -3.301611 -3.371506 -3.463444 -80.00000 -4.567402 -3.895038 -3.626203 -3.512874 -3.468155 -3.459450 -3.479489 -3.525792 -3.595628 -3.687509 -80.00000 -4.783638 -4.111841 -3.843038 -3.729672 -3.684922 -3.676201 -3.696232 -3.742532 -3.812364 -3.904240 -80.00000 -4.896159 -4.226012 -3.957790 -3.844686 -3.800050 -3.791408 -3.811497 -3.857855 -3.927743 -4.019671 -80.00000 -4.967997 -4.299582 -4.032039 -3.919259 -3.874770 -3.866227 -3.886388 -3.932816 -4.002770 -4.094763 -80.00000 -5.082947 -4.405346 -4.135884 -4.022231 -3.977359 -3.968528 -3.988434 -4.034565 -4.104223 -4.195920 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -80.00000 -5.029798 -3.646362 -2.966173 -2.566482 -2.324662 -2.157533 -2.055391 -2.001674 -1.974630 -1.971751 -80.00000 -6.441417 -4.900475 -4.097798 -3.596125 -3.271232 -3.031503 -2.871080 -2.771265 -2.703022 -2.662146 -80.00000 -5.844942 -4.461506 -3.781317 -3.381626 -3.139806 -2.972677 -2.870535 -2.816818 -2.789774 -2.786896 -80.00000 -5.029798 -3.646362 -2.966173 -2.566482 -2.324662 -2.157533 -2.055391 -2.001674 -1.974630 -1.971751 -80.00000 -6.002128 -4.618692 -3.938503 -3.538812 -3.296991 -3.129862 -3.027721 -2.974004 -2.946960 -2.944081 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -80.00000 -7.048404 -5.535229 -4.751764 -4.264628 -3.950667 -3.719866 -3.566206 -3.471500 -3.407647 -3.370681 -80.00000 -6.314210 -4.790828 -4.000196 -3.507579 -3.189464 -2.955249 -2.798991 -2.702315 -2.636764 -2.598282 -80.00000 -7.374624 -5.839289 -5.040419 -4.541588 -4.218810 -3.980795 -3.821662 -3.722817 -3.655404 -3.615265 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -80.00000 -4.918716 -4.157902 -3.822617 -3.656769 -3.573855 -3.534145 -3.530099 -3.556367 -3.606786 -3.679802 -80.00000 -5.125541 -4.364116 -4.028518 -3.862493 -3.779484 -3.739709 -3.735618 -3.761849 -3.812232 -3.885214 -80.00000 -5.337608 -4.575384 -4.239372 -4.073112 -3.989976 -3.950116 -3.945964 -3.972145 -4.022480 -4.095418 -80.00000 -5.555817 -4.792606 -4.456075 -4.289516 -4.206220 -4.166250 -4.162023 -4.188140 -4.238414 -4.311295 -80.00000 -5.779900 -5.015627 -4.678507 -4.511608 -4.428124 -4.388029 -4.383713 -4.409758 -4.459962 -4.532778 -80.00000 -6.006084 -5.241067 -4.903459 -4.736259 -4.652608 -4.612401 -4.608006 -4.633987 -4.684131 -4.756888 -80.00000 -6.222248 -5.457822 -5.120277 -4.953061 -4.869386 -4.829164 -4.824762 -4.850739 -4.900878 -4.973631 -80.00000 -6.334644 -5.571845 -5.234903 -5.067976 -4.984444 -4.944320 -4.939987 -4.966026 -5.016223 -5.089030 -80.00000 -6.406367 -5.645257 -5.309007 -5.142430 -5.059074 -5.019072 -5.014825 -5.040938 -5.091206 -5.164077 -80.00000 -6.520971 -5.750772 -5.412347 -5.244664 -5.160732 -5.120303 -5.115719 -5.141509 -5.191466 -5.264040 -80.00000 -4.322268 -3.559557 -3.222805 -3.055902 -2.972322 -2.932144 -2.927773 -2.953786 -3.003962 -3.076748 -80.00000 -4.530741 -3.768283 -3.431698 -3.264910 -3.181400 -3.141272 -3.136935 -3.162975 -3.213177 -3.285988 -80.00000 -4.736445 -3.974367 -3.637995 -3.471343 -3.387914 -3.347842 -3.343545 -3.369617 -3.419849 -3.492688 -80.00000 -4.937469 -4.176013 -3.839960 -3.673498 -3.590177 -3.550180 -3.545936 -3.572051 -3.622324 -3.695202 -80.00000 -5.136409 -4.375455 -4.039690 -3.873405 -3.790186 -3.750259 -3.746064 -3.772218 -3.822529 -3.895442 -80.00000 -5.367438 -4.603726 -4.266910 -4.100106 -4.016626 -3.976520 -3.972197 -3.998240 -4.048446 -4.121262 -80.00000 -5.803893 -5.017097 -4.670773 -4.499040 -4.413011 -4.371163 -4.365608 -4.390596 -4.439808 -4.511702 -80.00000 -6.403732 -5.555793 -5.185086 -5.000881 -4.908458 -4.862278 -4.853682 -4.876089 -4.922869 -4.992517 -80.00000 -7.225934 -6.231940 -5.809299 -5.599708 -5.494599 -5.439976 -5.425526 -5.443027 -5.485204 -5.550629 -80.00000 -8.034966 -6.815389 -6.326401 -6.086388 -5.966605 -5.902472 -5.881552 -5.893740 -5.930954 -5.991864 -80.00000 -4.918716 -4.157902 -3.822617 -3.656769 -3.573855 -3.534145 -3.530099 -3.556367 -3.606786 -3.679802 -80.00000 -5.125541 -4.364116 -4.028518 -3.862493 -3.779484 -3.739709 -3.735618 -3.761849 -3.812232 -3.885214 -80.00000 -5.337608 -4.575384 -4.239372 -4.073112 -3.989976 -3.950116 -3.945964 -3.972145 -4.022480 -4.095418 -80.00000 -5.555817 -4.792606 -4.456075 -4.289516 -4.206220 -4.166250 -4.162023 -4.188140 -4.238414 -4.311295 -80.00000 -5.779900 -5.015627 -4.678507 -4.511608 -4.428124 -4.388029 -4.383713 -4.409758 -4.459962 -4.532778 -80.00000 -6.006084 -5.241067 -4.903459 -4.736259 -4.652608 -4.612401 -4.608006 -4.633987 -4.684131 -4.756888 -80.00000 -6.222248 -5.457822 -5.120277 -4.953061 -4.869386 -4.829164 -4.824762 -4.850739 -4.900878 -4.973631 -80.00000 -6.334644 -5.571845 -5.234903 -5.067976 -4.984444 -4.944320 -4.939987 -4.966026 -5.016223 -5.089030 -80.00000 -6.406367 -5.645257 -5.309007 -5.142430 -5.059074 -5.019072 -5.014825 -5.040938 -5.091206 -5.164077 -80.00000 -6.520971 -5.750772 -5.412347 -5.244664 -5.160732 -5.120303 -5.115719 -5.141509 -5.191466 -5.264040 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -80.00000 -6.173131 -5.323970 -4.917761 -4.692434 -4.562865 -4.483012 -4.446393 -4.445475 -4.469877 -4.517684 -80.00000 -6.379984 -5.530238 -5.123724 -4.898220 -4.768548 -4.688622 -4.651952 -4.650992 -4.675356 -4.723129 -80.00000 -6.592089 -5.741576 -5.334661 -5.108921 -4.979113 -4.899090 -4.862351 -4.861337 -4.885651 -4.933377 -80.00000 -6.810341 -5.958886 -5.551467 -5.325428 -5.195447 -5.115303 -5.078476 -5.077393 -5.101643 -5.149311 -80.00000 -7.034466 -6.182000 -5.774015 -5.547637 -5.417457 -5.337171 -5.300244 -5.299081 -5.323258 -5.370859 -80.00000 -7.260668 -6.407507 -5.999060 -5.772388 -5.642032 -5.561623 -5.524608 -5.523375 -5.547487 -5.595030 -80.00000 -7.476769 -6.624213 -6.215854 -5.989183 -5.858815 -5.778395 -5.741373 -5.740137 -5.764245 -5.811783 -80.00000 -7.589058 -6.738095 -6.330349 -6.103988 -5.973783 -5.893479 -5.856540 -5.855371 -5.879540 -5.927134 -80.00000 -7.660683 -6.811361 -6.404305 -6.178310 -6.048305 -5.968142 -5.931302 -5.930214 -5.954458 -6.002119 -80.00000 -7.775058 -6.916767 -6.507374 -6.280119 -6.149405 -6.068715 -6.031476 -6.030045 -6.053973 -6.101340 -80.00000 -5.662110 -4.803673 -4.390572 -4.159925 -4.026485 -3.943504 -3.904473 -3.901616 -3.924217 -3.970332 -80.00000 -5.870573 -5.012374 -4.599431 -4.368894 -4.235526 -4.152598 -4.113605 -4.110777 -4.133406 -4.179546 -80.00000 -6.076256 -5.218421 -4.805683 -4.575279 -4.441995 -4.359129 -4.320181 -4.317388 -4.340048 -4.386217 -80.00000 -6.277246 -5.420009 -5.007579 -4.777365 -4.644197 -4.561413 -4.522524 -4.519779 -4.542482 -4.588691 -80.00000 -6.476170 -5.619403 -5.207248 -4.977208 -4.844146 -4.761440 -4.722606 -4.719904 -4.742647 -4.788892 -80.00000 -6.707426 -5.847933 -5.434709 -5.204114 -5.070751 -4.987832 -4.948848 -4.946023 -4.968655 -5.014799 -80.00000 -7.145533 -6.263455 -5.840702 -5.604959 -5.468725 -5.383781 -5.343354 -5.339369 -5.360948 -5.406134 -80.00000 -7.749667 -6.807647 -6.360393 -6.111607 -5.968171 -5.878184 -5.834187 -5.827353 -5.846348 -5.889192 -80.00000 -8.582506 -7.495760 -6.995712 -6.720123 -6.562279 -6.462387 -6.411467 -6.399171 -6.413245 -6.451657 -80.00000 -9.408694 -8.094799 -7.526274 -7.218209 -7.043551 -6.932402 -6.873755 -6.855472 -6.864188 -6.897820 -80.00000 -6.351840 -5.486268 -5.068067 -4.833418 -4.696971 -4.611486 -4.570484 -4.566029 -4.587145 -4.631860 -80.00000 -6.558698 -5.692545 -5.274041 -5.039214 -4.902662 -4.817103 -4.776048 -4.771551 -4.792629 -4.837309 -80.00000 -6.770810 -5.903896 -5.484991 -5.249927 -5.113237 -5.027580 -4.986454 -4.981902 -5.002929 -5.047563 -80.00000 -6.989070 -6.121222 -5.701813 -5.466450 -5.329585 -5.243803 -5.202589 -5.197965 -5.218928 -5.263504 -80.00000 -7.213204 -6.344352 -5.924380 -5.688675 -5.551609 -5.465683 -5.424367 -5.419663 -5.440552 -5.485060 -80.00000 -7.439410 -6.569871 -6.149439 -5.913442 -5.776197 -5.690146 -5.648739 -5.643965 -5.664789 -5.709238 -80.00000 -7.655499 -6.786569 -6.366230 -6.130237 -5.992981 -5.906920 -5.865506 -5.860728 -5.881548 -5.925992 -80.00000 -7.767766 -6.900425 -6.480703 -6.245024 -6.107936 -6.021994 -5.980665 -5.975955 -5.996837 -6.041337 -80.00000 -7.839372 -6.973665 -6.554636 -6.319326 -6.182443 -6.096644 -6.055417 -6.050790 -6.071747 -6.116314 -80.00000 -7.953701 -7.079052 -6.657660 -6.421071 -6.283463 -6.197127 -6.155497 -6.150525 -6.171169 -6.215446 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 + 0.1000000 1 3 2 2 1 99 1.500000 2000000. 1 3.000000 0.3000000 1.250000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4784600 7.5000010E-02 0.000000 7.5000010E-02 7.5000010E-02 7.5000010E-02 0.3163693 0.2886351 + 0.4783076 -1.9147592E-02 0.000000 -1.9147592E-02 -1.9147592E-02 -1.9147592E-02 0.3153805 0.2879003 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4784600 7.4999973E-02 0.000000 7.4999973E-02 7.4999973E-02 7.4999973E-02 0.3068853 0.2880961 + 0.4783076 -1.9147532E-02 0.000000 -1.9147532E-02 -1.9147532E-02 -1.9147532E-02 0.3073024 0.2880341 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4784600 7.5000130E-02 0.000000 7.5000130E-02 7.5000130E-02 7.5000130E-02 0.2800793 0.2898342 + 0.4783076 -1.9147471E-02 0.000000 -1.9147471E-02 -1.9147471E-02 -1.9147471E-02 0.3177486 0.2871970 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4784601 7.5000130E-02 0.000000 7.5000130E-02 7.5000130E-02 7.5000130E-02 0.2913238 0.2890683 + 0.4783076 -1.9147471E-02 0.000000 -1.9147471E-02 -1.9147471E-02 -1.9147471E-02 0.2868260 0.2893926 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4784601 7.5000107E-02 0.000000 7.5000107E-02 7.5000107E-02 7.5000107E-02 0.2840272 0.2889895 + 0.4783076 -1.9147592E-02 0.000000 -1.9147592E-02 -1.9147592E-02 -1.9147592E-02 0.2820784 0.2893572 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4784602 7.5002939E-02 0.000000 7.5002939E-02 7.5002939E-02 7.5002939E-02 0.2759585 0.2892948 + 0.4783076 -1.9147532E-02 0.000000 -1.9147532E-02 -1.9147532E-02 -1.9147532E-02 0.2641478 0.2906641 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4784417 -2.1197716E-02 0.000000 -2.1197716E-02 -2.1197716E-02 -2.1197716E-02 0.2712187 0.2898652 + 0.4783076 -1.9147532E-02 0.000000 -1.9147532E-02 -1.9147532E-02 -1.9147532E-02 0.2699688 0.2899385 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4783720 -1.9896181E-02 0.000000 -1.9896181E-02 -1.9896181E-02 -1.9896181E-02 0.2645561 0.2903771 + 0.4783076 -1.9147532E-02 0.000000 -1.9147532E-02 -1.9147532E-02 -1.9147532E-02 0.2676961 0.2897517 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4782532 -1.8636629E-02 0.000000 -1.8636629E-02 -1.8636629E-02 -1.8636629E-02 0.2596111 0.2904732 + 0.4783076 -1.9147532E-02 0.000000 -1.9147532E-02 -1.9147532E-02 -1.9147532E-02 0.2591998 0.2906038 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4780889 -1.7417923E-02 0.000000 -1.7417923E-02 -1.7417923E-02 -1.7417923E-02 0.2509876 0.2913552 + 0.4783076 -1.9147592E-02 0.000000 -1.9147592E-02 -1.9147592E-02 -1.9147592E-02 0.2469824 0.2913281 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4778818 -1.6236659E-02 0.000000 -1.6236659E-02 -1.6236659E-02 -1.6236659E-02 0.2487207 0.2911650 + 0.4783076 -1.9147532E-02 0.000000 -1.9147532E-02 -1.9147532E-02 -1.9147532E-02 0.2376421 0.2925015 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4776349 -1.5092185E-02 0.000000 -1.5092185E-02 -1.5092185E-02 -1.5092185E-02 0.2408774 0.2923807 + 2.4844154E-05 1.979818 0.000000 1.979818 1.979818 1.979818 7.6438352E-02 0.2844439 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4773506 -1.3981891E-02 0.000000 -1.3981891E-02 -1.3981891E-02 -1.3981891E-02 0.2420107 0.2916057 + 1.8895038E-04 1.437861 0.000000 1.437861 1.437861 1.437861 9.2777915E-02 0.2797469 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4770314 -1.2904593E-02 0.000000 -1.2904593E-02 -1.2904593E-02 -1.2904593E-02 0.2377426 0.2918707 + 5.4961536E-04 1.176702 0.000000 1.176702 1.176702 1.176702 0.1278977 0.2685379 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711293E-02 0.000000 -1.2711293E-02 -1.2711293E-02 -1.2711293E-02 0.2286080 0.2933984 + 2.9500702E-04 1.318128 0.000000 1.318128 1.318128 1.318128 0.1315335 0.2670913 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711348E-02 0.000000 -1.2711348E-02 -1.2711348E-02 -1.2711348E-02 0.2255936 0.2935506 + 5.1378080E-04 1.186079 0.000000 1.186079 1.186079 1.186079 0.1157877 0.2721292 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711271E-02 0.000000 -1.2711271E-02 -1.2711271E-02 -1.2711271E-02 0.2186673 0.2953194 + 1.0064862E-03 1.037451 0.000000 1.037451 1.037451 1.037451 0.1356250 0.2650152 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711370E-02 0.000000 -1.2711370E-02 -1.2711370E-02 -1.2711370E-02 0.2119150 0.2959971 + 1.8162336E-03 0.9156142 0.000000 0.9156142 0.9156142 0.9156142 0.1450167 0.2613052 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711293E-02 0.000000 -1.2711293E-02 -1.2711293E-02 -1.2711293E-02 0.2111476 0.2960085 + 2.8280108E-03 0.8301957 0.000000 0.8301957 0.8301957 0.8301957 0.1697991 0.2516775 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711238E-02 0.000000 -1.2711238E-02 -1.2711238E-02 -1.2711238E-02 0.2069420 0.2970260 + 3.9938800E-03 0.7678729 0.000000 0.7678729 0.7678729 0.7678729 0.1522826 0.2581238 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711304E-02 0.000000 -1.2711304E-02 -1.2711304E-02 -1.2711304E-02 0.2032788 0.2972401 + 5.2387328E-03 0.7219035 0.000000 0.7219035 0.7219035 0.7219035 0.1457555 0.2605119 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711304E-02 0.000000 -1.2711304E-02 -1.2711304E-02 -1.2711304E-02 0.2026216 0.2964845 + 3.4252023E-03 0.7922329 0.000000 0.7922329 0.7922329 0.7922329 0.1345217 0.2652215 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711370E-02 0.000000 -1.2711370E-02 -1.2711370E-02 -1.2711370E-02 0.1955251 0.2988587 + 4.1244021E-03 0.7597927 0.000000 0.7597927 0.7597927 0.7597927 0.1438663 0.2605921 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711238E-02 0.000000 -1.2711238E-02 -1.2711238E-02 -1.2711238E-02 0.1923143 0.2992087 + 4.8604910E-03 0.7320148 0.000000 0.7320148 0.7320148 0.7320148 0.1353169 0.2642723 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711304E-02 0.000000 -1.2711304E-02 -1.2711304E-02 -1.2711304E-02 0.1898649 0.2993440 + 5.6622145E-03 0.7067810 0.000000 0.7067810 0.7067810 0.7067810 0.1191807 0.2723483 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711282E-02 0.000000 -1.2711282E-02 -1.2711282E-02 -1.2711282E-02 0.1872506 0.2996109 + 6.5410016E-03 0.6832730 0.000000 0.6832730 0.6832730 0.6832730 0.1176440 0.2730434 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711260E-02 0.000000 -1.2711260E-02 -1.2711260E-02 -1.2711260E-02 0.1831489 0.3007121 + 7.5906473E-03 0.6596574 0.000000 0.6596574 0.6596574 0.6596574 0.1132139 0.2752853 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711249E-02 0.000000 -1.2711249E-02 -1.2711249E-02 -1.2711249E-02 0.1793855 0.3016111 + 8.7444251E-03 0.6377299 0.000000 0.6377299 0.6377299 0.6377299 0.1073531 0.2786835 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711315E-02 0.000000 -1.2711315E-02 -1.2711315E-02 -1.2711315E-02 0.1769157 0.3024805 + 1.0069592E-02 0.6166386 0.000000 0.6166386 0.6166386 0.6166386 0.1046959 0.2801740 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711315E-02 0.000000 -1.2711315E-02 -1.2711315E-02 -1.2711315E-02 0.1727718 0.3040961 + 1.1561365E-02 0.5965281 0.000000 0.5965281 0.5965281 0.5965281 0.1017992 0.2818947 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711282E-02 0.000000 -1.2711282E-02 -1.2711282E-02 -1.2711282E-02 0.1716061 0.3031873 + 1.3826866E-02 0.5722299 0.000000 0.5722299 0.5722299 0.5722299 9.9235199E-02 0.2834653 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711227E-02 0.000000 -1.2711227E-02 -1.2711227E-02 -1.2711227E-02 0.1678527 0.3046894 + 1.6780637E-02 0.5472134 0.000000 0.5472134 0.5472134 0.5472134 9.6805707E-02 0.2850151 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711304E-02 0.000000 -1.2711304E-02 -1.2711304E-02 -1.2711304E-02 0.1651911 0.3055761 + 2.0266024E-02 0.5237331 0.000000 0.5237331 0.5237331 0.5237331 9.3851157E-02 0.2870691 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711315E-02 0.000000 -1.2711315E-02 -1.2711315E-02 -1.2711315E-02 0.1625013 0.3059463 + 2.4462132E-02 0.5011683 0.000000 0.5011683 0.5011683 0.5011683 9.1960944E-02 0.2883203 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711227E-02 0.000000 -1.2711227E-02 -1.2711227E-02 -1.2711227E-02 0.1609505 0.3070959 + 2.9330507E-02 0.4802006 0.000000 0.4802006 0.4802006 0.4802006 8.9675017E-02 0.2899836 + 1.004193 + 1.002665 + 1.000896 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711315E-02 0.000000 -1.2711315E-02 -1.2711315E-02 -1.2711315E-02 0.1586565 0.3068953 + 3.4593113E-02 0.4617205 0.000000 0.4617205 0.4617205 0.4617205 8.7362990E-02 0.2917393 + 1.013753 + 1.013753 + 1.009823 + 1.001205 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711249E-02 0.000000 -1.2711249E-02 -1.2711249E-02 -1.2711249E-02 0.1571228 0.3071170 + 4.0318623E-02 0.4450981 0.000000 0.4450981 0.4450981 0.4450981 8.4953189E-02 0.2936525 + 1.024357 + 1.024357 + 1.019037 + 1.009667 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711282E-02 0.000000 -1.2711282E-02 -1.2711282E-02 -1.2711282E-02 0.1538989 0.3084470 + 4.6288978E-02 0.4305656 0.000000 0.4305656 0.4305656 0.4305656 8.2632191E-02 0.2955837 + 1.036255 + 1.035465 + 1.029510 + 1.019188 + 1.004265 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711260E-02 0.000000 -1.2711260E-02 -1.2711260E-02 -1.2711260E-02 0.1511137 0.3098045 + 5.1656634E-02 0.4192487 0.000000 0.4192487 0.4192487 0.4192487 8.0259889E-02 0.2976696 + 1.001575 + 1.047736 + 1.001575 + 1.030140 + 1.013180 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711249E-02 0.000000 -1.2711249E-02 -1.2711249E-02 -1.2711249E-02 0.1499397 0.3094364 + 5.7542704E-02 0.4084352 0.000000 0.4084352 0.4084352 0.4084352 7.7726506E-02 0.2999533 + 1.048330 + 1.038901 + 1.036155 + 1.023494 + 1.023494 + 1.001462 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711293E-02 0.000000 -1.2711293E-02 -1.2711293E-02 -1.2711293E-02 0.1468134 0.3109180 + 6.3986994E-02 0.3981268 0.000000 0.3981268 0.3981268 0.3981268 7.5272545E-02 0.3022834 + 1.041292 + 1.076712 + 1.068336 + 1.054314 + 1.034675 + 1.010532 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711293E-02 0.000000 -1.2711293E-02 -1.2711293E-02 -1.2711293E-02 0.1450735 0.3117052 + 7.1211390E-02 0.3880293 0.000000 0.3880293 0.3880293 0.3880293 7.2813138E-02 0.3047221 + 1.095922 + 1.093509 + 1.084006 + 1.068524 + 1.046965 + 1.021311 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711260E-02 0.000000 -1.2711260E-02 -1.2711260E-02 -1.2711260E-02 0.1431406 0.3124745 + 7.8990094E-02 0.3784911 0.000000 0.3784911 0.3784911 0.3784911 7.0175111E-02 0.3074637 + 1.045865 + 1.111856 + 1.101231 + 1.084149 + 1.060450 + 1.032365 + 1.003370 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711260E-02 0.000000 -1.2711260E-02 -1.2711260E-02 -1.2711260E-02 0.1405777 0.3131779 + 8.7410904E-02 0.3694108 0.000000 0.3694108 0.3694108 0.3694108 6.7554027E-02 0.3103114 + 1.135037 + 1.132070 + 1.120489 + 1.101104 + 1.074639 + 1.043258 + 1.010241 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711293E-02 0.000000 -1.2711293E-02 -1.2711293E-02 -1.2711293E-02 0.1473215 0.2867481 + 9.6314721E-02 0.3609467 0.000000 0.3609467 0.3609467 0.3609467 6.5171227E-02 0.3130047 + 1.050442 + 1.153704 + 1.141255 + 1.119407 + 1.091060 + 1.056694 + 1.020652 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711249E-02 0.000000 -1.2711249E-02 -1.2711249E-02 -1.2711249E-02 0.1428914 0.2895068 + 0.1051085 0.3534955 0.000000 0.3534955 0.3534955 0.3534955 6.2810548E-02 0.3157819 + 1.182103 + 1.177868 + 1.164066 + 1.140320 + 1.108483 + 1.071702 + 1.033194 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711282E-02 0.000000 -1.2711282E-02 -1.2711282E-02 -1.2711282E-02 0.1412583 0.2894540 + 0.1138893 0.3468024 0.000000 0.3468024 0.3468024 0.3468024 6.0762323E-02 0.3182755 + 1.054087 + 1.204127 + 1.188111 + 1.163376 + 1.128767 + 1.088479 + 1.046213 + 1.005498 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711359E-02 0.000000 -1.2711359E-02 -1.2711359E-02 -1.2711359E-02 0.1412814 0.2878322 + 0.1226223 0.3407778 0.000000 0.3407778 0.3407778 0.3407778 5.9091795E-02 0.3203530 + 1.237626 + 1.232183 + 1.215265 + 1.187902 + 1.151155 + 1.107049 + 1.060514 + 1.016848 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711249E-02 0.000000 -1.2711249E-02 -1.2711249E-02 -1.2711249E-02 0.1401128 0.2866692 + 0.1318058 0.3350409 0.000000 0.3350409 0.3350409 0.3350409 5.7509463E-02 0.3223892 + 1.055909 + 1.262451 + 1.244625 + 1.214608 + 1.174705 + 1.126397 + 1.076380 + 1.028404 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711282E-02 0.000000 -1.2711282E-02 -1.2711282E-02 -1.2711282E-02 0.1383814 0.2871231 + 0.1413052 0.3296390 0.000000 0.3296390 0.3296390 0.3296390 5.6194711E-02 0.3241084 + 1.301563 + 1.295180 + 1.276192 + 1.244396 + 1.200509 + 1.149081 + 1.094027 + 1.042250 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711249E-02 0.000000 -1.2711249E-02 -1.2711249E-02 -1.2711249E-02 0.1356877 0.2887647 + 0.1510443 0.3245823 0.000000 0.3245823 0.3245823 0.3245823 5.4997623E-02 0.3257155 + 1.058309 + 1.329161 + 1.308789 + 1.276594 + 1.230066 + 1.058309 + 1.090740 + 1.055862 + 1.006831 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711337E-02 0.000000 -1.2711337E-02 -1.2711337E-02 -1.2711337E-02 0.1339569 0.2885847 + 0.1609592 0.3198682 0.000000 0.3198682 0.3198682 0.3198682 5.3850085E-02 0.3273056 + 1.374473 + 1.365365 + 1.344529 + 1.310178 + 1.260936 + 1.199495 + 1.134363 + 1.072303 + 1.018720 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711271E-02 0.000000 -1.2711271E-02 -1.2711271E-02 -1.2711271E-02 0.1330809 0.2876835 + 0.1706139 0.3156338 0.000000 0.3156338 0.3156338 0.3156338 5.2806027E-02 0.3287643 + 1.086585 + 1.404351 + 1.382092 + 1.345701 + 1.294034 + 1.230035 + 1.157347 + 1.090025 + 1.030698 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711315E-02 0.000000 -1.2711315E-02 -1.2711315E-02 -1.2711315E-02 0.1312274 0.2886890 + 0.1799211 0.3118455 0.000000 0.3118455 0.3118455 0.3118455 5.1601607E-02 0.3305530 + 1.474254 + 1.463629 + 1.439672 + 1.399692 + 1.343239 + 1.271057 + 1.189200 + 1.112319 + 1.046623 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711260E-02 0.000000 -1.2711260E-02 -1.2711260E-02 -1.2711260E-02 0.1292305 0.2893606 + 0.1889303 0.3084250 0.000000 0.3084250 0.3084250 0.3084250 5.0484098E-02 0.3322380 + 1.059348 + 1.505548 + 1.479934 + 1.439952 + 1.380913 + 1.305601 + 1.059348 + 1.116626 + 1.062251 + 1.005848 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711271E-02 0.000000 -1.2711271E-02 -1.2711271E-02 -1.2711271E-02 0.1283189 0.2885022 + 0.1970350 0.3055241 0.000000 0.3055241 0.3055241 0.3055241 4.9183942E-02 0.3343021 + 1.559689 + 1.548109 + 1.522580 + 1.481013 + 1.422056 + 1.342865 + 1.250749 + 1.158502 + 1.079037 + 1.016581 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711327E-02 0.000000 -1.2711327E-02 -1.2711327E-02 -1.2711327E-02 0.1286079 0.2869927 + 0.2055503 0.3026599 0.000000 0.3026599 0.3026599 0.3026599 4.7889471E-02 0.3364215 + 1.059323 + 1.592860 + 1.566122 + 1.524615 + 1.464111 + 1.383877 + 1.285450 + 1.184819 + 1.096889 + 1.029478 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711282E-02 0.000000 -1.2711282E-02 -1.2711282E-02 -1.2711282E-02 0.1267483 0.2876770 + 0.2144399 0.2998491 0.000000 0.2998491 0.2998491 0.2998491 4.6483427E-02 0.3388197 + 1.651331 + 1.639370 + 1.611993 + 1.569772 + 1.507696 + 1.424941 + 1.323738 + 1.214275 + 1.118062 + 1.042408 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711304E-02 0.000000 -1.2711304E-02 -1.2711304E-02 -1.2711304E-02 0.1244953 0.2889753 + 0.2239636 0.2970170 0.000000 0.2970170 0.2970170 0.2970170 4.5039982E-02 0.3413691 + 1.060223 + 1.687538 + 1.659678 + 1.615622 + 1.553745 + 1.469911 + 1.363841 + 1.247120 + 1.140101 + 1.058486 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711304E-02 0.000000 -1.2711304E-02 -1.2711304E-02 -1.2711304E-02 0.1231628 0.2889822 + 0.2339286 0.2942319 0.000000 0.2942319 0.2942319 0.2942319 4.3546848E-02 0.3441052 + 1.751481 + 1.737119 + 1.709219 + 1.664490 + 1.601813 + 1.517006 + 1.407806 + 1.282515 + 1.165377 + 1.075121 + 1.007978 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711216E-02 0.000000 -1.2711216E-02 -1.2711216E-02 -1.2711216E-02 0.1236181 0.2865308 + 0.2443145 0.2915022 0.000000 0.2915022 0.2915022 0.2915022 4.2050440E-02 0.3469568 + 1.060026 + 1.788688 + 1.759731 + 1.714643 + 1.649270 + 1.563671 + 1.452633 + 1.321294 + 1.193487 + 1.092567 + 1.019843 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711293E-02 0.000000 -1.2711293E-02 -1.2711293E-02 -1.2711293E-02 0.1206869 0.2885556 + 0.2551285 0.2888289 0.000000 0.2888289 0.2888289 0.2888289 4.0642869E-02 0.3497066 + 1.859163 + 1.843560 + 1.812538 + 1.766068 + 1.700642 + 1.612909 + 1.501267 + 1.363789 + 1.225831 + 1.112913 + 1.033395 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711271E-02 0.000000 -1.2711271E-02 -1.2711271E-02 -1.2711271E-02 0.1211835 0.2862061 + 0.2661828 0.2862567 0.000000 0.2862567 0.2862567 0.2862567 3.9241135E-02 0.3525488 + 1.058638 + 1.899335 + 1.867952 + 1.820045 + 1.752886 + 1.663379 + 1.548975 + 1.408554 + 1.259635 + 1.135569 + 1.046596 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711304E-02 0.000000 -1.2711304E-02 -1.2711304E-02 -1.2711304E-02 0.1177855 0.2892419 + 0.2773827 0.2837988 0.000000 0.2837988 0.2837988 0.2837988 3.7932016E-02 0.3552931 + 1.975500 + 1.958128 + 1.925845 + 1.875373 + 1.806035 + 1.715145 + 1.599936 + 1.456008 + 1.297274 + 1.160576 + 1.061598 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711271E-02 0.000000 -1.2711271E-02 -1.2711271E-02 -1.2711271E-02 0.1166333 0.2892393 + 0.2889636 0.2814006 0.000000 0.2814006 0.2814006 0.2814006 3.6581647E-02 0.3582292 + 1.056644 + 2.019929 + 1.985418 + 1.934210 + 1.862977 + 1.768873 + 1.651243 + 1.506373 + 1.339554 + 1.187936 + 1.079620 + 1.005692 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711293E-02 0.000000 -1.2711293E-02 -1.2711293E-02 -1.2711293E-02 0.1159262 0.2888154 + 0.3008910 0.2790702 0.000000 0.2790702 0.2790702 0.2790702 3.5523549E-02 0.3605664 + 2.102026 + 2.083700 + 2.047525 + 1.994251 + 1.920446 + 1.825421 + 1.705330 + 1.556862 + 1.384286 + 1.218936 + 1.098019 + 1.017482 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711271E-02 0.000000 -1.2711271E-02 -1.2711271E-02 -1.2711271E-02 0.1153295 0.2882972 + 0.3133992 0.2767613 0.000000 0.2767613 0.2767613 0.2767613 3.4398355E-02 0.3631373 + 1.054221 + 2.149355 + 2.113113 + 2.056841 + 1.981898 + 1.882099 + 1.759753 + 1.609922 + 1.432723 + 1.253690 + 1.119016 + 1.030481 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711249E-02 0.000000 -1.2711249E-02 -1.2711249E-02 -1.2711249E-02 0.1137351 0.2885300 + 0.3264791 0.2744792 0.000000 0.2744792 0.2744792 0.2744792 3.3271372E-02 0.3657906 + 2.240169 + 2.219355 + 2.180631 + 2.123197 + 2.043952 + 1.942484 + 1.815559 + 1.663794 + 1.482391 + 1.291827 + 1.141950 + 1.043409 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711282E-02 0.000000 -1.2711282E-02 -1.2711282E-02 -1.2711282E-02 0.1130333 0.2887261 + 0.3400829 0.2722361 0.000000 0.2722361 0.2722361 0.2722361 3.2143570E-02 0.3685320 + 1.050978 + 2.291815 + 2.251287 + 2.191572 + 2.109344 + 2.004199 + 1.874355 + 1.718884 + 1.534232 + 1.333596 + 1.168492 + 1.058899 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711260E-02 0.000000 -1.2711260E-02 -1.2711260E-02 -1.2711260E-02 0.1126109 0.2873148 + 0.3539420 0.2700762 0.000000 0.2700762 0.2700762 0.2700762 3.1038079E-02 0.3713087 + 2.390633 + 2.367183 + 2.325651 + 2.262137 + 2.177074 + 2.067840 + 1.933421 + 1.773601 + 1.587213 + 1.378729 + 1.197015 + 1.075262 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711249E-02 0.000000 -1.2711249E-02 -1.2711249E-02 -1.2711249E-02 0.1104408 0.2896006 + 0.3677633 0.2680357 0.000000 0.2680357 0.2680357 0.2680357 3.0033007E-02 0.3738982 + 1.046886 + 2.446352 + 2.402763 + 2.338055 + 2.249169 + 2.135873 + 1.996729 + 1.831958 + 1.643041 + 1.427037 + 1.228190 + 1.092864 + 1.009174 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711271E-02 0.000000 -1.2711271E-02 -1.2711271E-02 -1.2711271E-02 0.1099567 0.2884735 + 0.3816538 0.2660894 0.000000 0.2660894 0.2660894 0.2660894 2.9067826E-02 0.3764578 + 2.554611 + 2.529632 + 2.483311 + 2.415907 + 2.323402 + 2.205552 + 2.061095 + 1.892203 + 1.698631 + 1.478693 + 1.264280 + 1.113368 + 1.021241 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711238E-02 0.000000 -1.2711238E-02 -1.2711238E-02 -1.2711238E-02 0.1089850 0.2880219 + 0.3952803 0.2642747 0.000000 0.2642747 0.2642747 0.2642747 2.7512660E-02 0.3808725 + 1.042225 + 2.614631 + 2.567257 + 2.496921 + 2.400408 + 2.277519 + 2.128586 + 1.953851 + 1.756521 + 1.532921 + 1.303600 + 1.135432 + 1.032773 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711327E-02 0.000000 -1.2711327E-02 -1.2711327E-02 -1.2711327E-02 0.1074713 0.2888181 + 0.4091276 0.2625212 0.000000 0.2625212 0.2625212 0.2625212 2.6564104E-02 0.3835788 + 2.733060 + 2.705536 + 2.655243 + 2.582217 + 2.481933 + 2.354060 + 2.199095 + 2.019288 + 1.815886 + 1.587503 + 1.347253 + 1.161361 + 1.047750 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711271E-02 0.000000 -1.2711271E-02 -1.2711271E-02 -1.2711271E-02 0.1077013 0.2866570 + 0.4230802 0.2608377 0.000000 0.2608377 0.2608377 0.2608377 2.6856406E-02 0.3825538 + 1.037608 + 2.798736 + 2.747689 + 2.670414 + 2.565594 + 2.431968 + 2.270247 + 2.083225 + 1.874717 + 1.643335 + 1.394287 + 1.187805 + 1.062533 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711304E-02 0.000000 -1.2711304E-02 -1.2711304E-02 -1.2711304E-02 0.1063087 0.2881356 + 0.4369675 0.2592399 0.000000 0.2592399 0.2592399 0.2592399 2.6144616E-02 0.3846390 + 2.927760 + 2.896708 + 2.842001 + 2.762659 + 2.653572 + 2.514201 + 2.346974 + 2.152619 + 1.936746 + 1.701224 + 1.443379 + 1.219858 + 1.079462 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711304E-02 0.000000 -1.2711304E-02 -1.2711304E-02 -1.2711304E-02 0.1044168 0.2894797 + 0.4508574 0.2577138 0.000000 0.2577138 0.2577138 0.2577138 2.5682431E-02 0.3859743 + 1.037013 + 2.998013 + 2.942763 + 2.859873 + 2.746906 + 2.602018 + 2.426162 + 2.224933 + 2.000772 + 1.759876 + 1.497383 + 1.254079 + 1.097886 + 1.005528 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711315E-02 0.000000 -1.2711315E-02 -1.2711315E-02 -1.2711315E-02 0.1049704 0.2871007 + 0.4642936 0.2562993 0.000000 0.2562993 0.2562993 0.2562993 2.5343146E-02 0.3869666 + 3.160807 + 3.126590 + 3.065536 + 2.977191 + 2.855908 + 2.699699 + 2.514040 + 2.301895 + 2.068332 + 1.819956 + 1.553686 + 1.292703 + 1.117780 + 1.017132 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711249E-02 0.000000 -1.2711249E-02 -1.2711249E-02 -1.2711249E-02 0.1043503 0.2866003 + 0.4774751 0.2549680 0.000000 0.2549680 0.2549680 0.2549680 2.4841987E-02 0.3884672 + 1.028258 + 3.240354 + 3.177558 + 3.084510 + 2.958113 + 2.794958 + 2.598951 + 2.378407 + 2.136201 + 1.880471 + 1.608561 + 1.335135 + 1.140814 + 1.029931 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711293E-02 0.000000 -1.2711293E-02 -1.2711293E-02 -1.2711293E-02 0.1018994 0.2892803 + 0.4903046 0.2537226 0.000000 0.2537226 0.2537226 0.2537226 2.4431990E-02 0.3897090 + 3.394994 + 3.357463 + 3.293073 + 3.197113 + 3.066320 + 2.895246 + 2.691687 + 2.459052 + 2.207679 + 1.944403 + 1.667317 + 1.382268 + 1.166543 + 1.044643 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711271E-02 0.000000 -1.2711271E-02 -1.2711271E-02 -1.2711271E-02 0.1016817 0.2884851 + 0.5022722 0.2526005 0.000000 0.2526005 0.2526005 0.2526005 2.4077442E-02 0.3908201 + 1.024734 + 3.479998 + 3.412951 + 3.314299 + 3.179421 + 3.002062 + 2.787989 + 2.545868 + 2.282710 + 2.009170 + 1.727484 + 1.432607 + 1.194541 + 1.059006 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711337E-02 0.000000 -1.2711337E-02 -1.2711337E-02 -1.2711337E-02 0.1009445 0.2880983 + 0.5147078 0.2514774 0.000000 0.2514774 0.2514774 0.2514774 2.3738453E-02 0.3918876 + 3.646100 + 3.606523 + 3.538218 + 3.436800 + 3.297279 + 3.113863 + 2.889598 + 2.636108 + 2.361329 + 2.076785 + 1.787885 + 1.485648 + 1.226838 + 1.075578 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711293E-02 0.000000 -1.2711293E-02 -1.2711293E-02 -1.2711293E-02 9.9847920E-02 0.2881166 + 0.5274006 0.2503732 0.000000 0.2503732 0.2503732 0.2503732 2.3580819E-02 0.3923520 + 1.021675 + 3.735864 + 3.666625 + 3.564181 + 3.420726 + 3.231871 + 2.998190 + 2.730999 + 2.444556 + 2.147982 + 1.850602 + 1.543157 + 1.262264 + 1.021675 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711348E-02 0.000000 -1.2711348E-02 -1.2711348E-02 -1.2711348E-02 9.9942833E-02 0.2862549 + 0.5405464 0.2492717 0.000000 0.2492717 0.2492717 0.2492717 2.3000896E-02 0.3943135 + 3.913564 + 3.870223 + 3.799563 + 3.693106 + 3.545692 + 3.350976 + 3.107469 + 2.826246 + 2.527889 + 2.219056 + 1.913073 + 1.600399 + 1.301641 + 1.112630 + 1.009612 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711271E-02 0.000000 -1.2711271E-02 -1.2711271E-02 -1.2711271E-02 9.8594099E-02 0.2878547 + 0.5539875 0.2481864 0.000000 0.2481864 0.2481864 0.2481864 2.2750981E-02 0.3951215 + 1.018619 + 4.008440 + 3.935192 + 3.827889 + 3.676383 + 3.474773 + 3.221815 + 2.927938 + 2.614813 + 2.293555 + 1.976223 + 1.658751 + 1.346299 + 1.135496 + 1.021690 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711315E-02 0.000000 -1.2711315E-02 -1.2711315E-02 -1.2711315E-02 9.7068518E-02 0.2895552 + 0.5680013 0.2470964 0.000000 0.2470964 0.2470964 0.2470964 2.2523567E-02 0.3958824 + 4.196096 + 4.151337 + 4.077156 + 3.967196 + 3.814716 + 3.607656 + 3.346317 + 3.040068 + 2.710003 + 2.375562 + 2.045020 + 1.718981 + 1.393667 + 1.158698 + 1.034167 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711315E-02 0.000000 -1.2711315E-02 -1.2711315E-02 -1.2711315E-02 9.7385630E-02 0.2869769 + 0.5822462 0.2460287 0.000000 0.2460287 0.2460287 0.2460287 2.2152739E-02 0.3971704 + 1.015630 + 4.297097 + 4.221244 + 4.111254 + 3.954375 + 3.744136 + 3.474869 + 3.154986 + 2.808925 + 2.457439 + 2.114684 + 1.779789 + 1.444787 + 1.185991 + 1.015630 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711238E-02 0.000000 -1.2711238E-02 -1.2711238E-02 -1.2711238E-02 9.6823581E-02 0.2864825 + 0.5968595 0.2449728 0.000000 0.2449728 0.2449728 0.2449728 2.1841863E-02 0.3982702 + 4.495546 + 4.446405 + 4.369878 + 4.255904 + 4.097840 + 3.881623 + 3.603963 + 3.270604 + 2.908795 + 2.541379 + 2.185274 + 1.842753 + 1.499595 + 1.216845 + 1.063322 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711260E-02 0.000000 -1.2711260E-02 -1.2711260E-02 -1.2711260E-02 9.4971441E-02 0.2889322 + 0.6121201 0.2439102 0.000000 0.2439102 0.2439102 0.2439102 2.1553876E-02 0.3993089 + 1.012815 + 4.601172 + 4.522062 + 4.408549 + 4.246559 + 4.027431 + 3.744430 + 3.398607 + 3.017845 + 2.632502 + 2.259909 + 1.905944 + 1.557523 + 1.252240 + 1.012815 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711260E-02 0.000000 -1.2711260E-02 -1.2711260E-02 -1.2711260E-02 9.4490916E-02 0.2879451 + 0.6276565 0.2428675 0.000000 0.2428675 0.2428675 0.2428675 2.1281501E-02 0.4003007 + 4.810093 + 4.758334 + 4.678466 + 4.561393 + 4.398654 + 4.175588 + 3.882915 + 3.525645 + 3.128121 + 2.724231 + 2.337051 + 1.971692 + 1.615978 + 1.290610 + 1.098036 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711249E-02 0.000000 -1.2711249E-02 -1.2711249E-02 -1.2711249E-02 9.3312129E-02 0.2893743 + 0.6439142 0.2418164 0.000000 0.2418164 0.2418164 0.2418164 2.0991789E-02 0.4013879 + 1.010145 + 4.919133 + 4.838910 + 4.720980 + 4.554450 + 4.327725 + 4.029392 + 3.661938 + 3.248002 + 2.822085 + 2.417062 + 2.038611 + 1.675914 + 1.333021 + 1.010145 + 1.005274 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711249E-02 0.000000 -1.2711249E-02 -1.2711249E-02 -1.2711249E-02 9.2654288E-02 0.2893505 + 0.6607784 0.2407661 0.000000 0.2407661 0.2407661 0.2407661 2.0698218E-02 0.4025090 + 5.136541 + 5.082704 + 5.002583 + 4.886651 + 4.720455 + 4.489786 + 4.188566 + 3.810028 + 3.376035 + 2.930599 + 2.504328 + 2.109199 + 1.737285 + 1.380694 + 1.141113 + 1.017217 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711348E-02 0.000000 -1.2711348E-02 -1.2711348E-02 -1.2711348E-02 9.3061537E-02 0.2862999 + 0.6782909 0.2397156 0.000000 0.2397156 0.2397156 0.2397156 2.0374091E-02 0.4038115 + 1.006802 + 5.250255 + 1.006802 + 5.050385 + 4.881399 + 4.649359 + 4.340653 + 3.953466 + 3.504298 + 3.037242 + 2.589501 + 2.180079 + 1.799505 + 1.429845 + 1.165094 + 1.006802 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711249E-02 0.000000 -1.2711249E-02 -1.2711249E-02 -1.2711249E-02 9.1323651E-02 0.2885591 + 0.6962546 0.2386777 0.000000 0.2386777 0.2386777 0.2386777 1.9991122E-02 0.4053217 + 5.478687 + 5.422425 + 5.338916 + 5.220568 + 5.051257 + 4.814783 + 4.500710 + 4.105412 + 3.641237 + 3.150589 + 2.682561 + 2.254394 + 1.862987 + 1.484992 + 1.193759 + 1.043189 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711293E-02 0.000000 -1.2711293E-02 -1.2711293E-02 -1.2711293E-02 9.1253251E-02 0.2874872 + 0.7151238 0.2376279 0.000000 0.2376279 0.2376279 0.2376279 1.9943748E-02 0.4054416 + 1.002172 + 5.597500 + 1.002172 + 5.392606 + 5.224119 + 4.985819 + 4.667295 + 4.262033 + 3.784277 + 3.270565 + 2.777852 + 2.331225 + 1.926456 + 1.542245 + 1.224465 + 1.002172 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711293E-02 0.000000 -1.2711293E-02 -1.2711293E-02 -1.2711293E-02 9.0878233E-02 0.2870467 + 0.7349309 0.2365675 0.000000 0.2365675 0.2365675 0.2365675 1.9541956E-02 0.4071473 + 5.835246 + 0.8155829 + 5.689698 + 0.8155829 + 5.396883 + 5.157732 + 4.832711 + 4.421313 + 3.929329 + 3.394542 + 2.879309 + 2.411669 + 1.991979 + 1.600445 + 1.261004 + 0.8155829 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769695 -1.2711249E-02 0.000000 -1.2711249E-02 -1.2711249E-02 -1.2711249E-02 8.9518882E-02 0.2885097 + 0.7552241 0.2355217 0.000000 0.2355217 0.2355217 0.2355217 1.9262124E-02 0.4083249 + 6.020889 + 0.8136917 + 5.871113 + 0.8136917 + 5.574956 + 5.334093 + 5.005230 + 4.584319 + 4.082823 + 3.526807 + 2.984110 + 2.493142 + 2.059378 + 1.659873 + 1.299098 + 0.8136917 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711315E-02 0.000000 -1.2711315E-02 -1.2711315E-02 -1.2711315E-02 8.8323668E-02 0.2895455 + 0.7764452 0.2344694 0.000000 0.2344694 0.2344694 0.2344694 1.9012958E-02 0.4093693 + 6.211015 + 6.147581 + 6.059934 + 5.933917 + 5.761522 + 5.519917 + 5.188444 + 4.761071 + 4.244343 + 3.668196 + 3.097630 + 2.583091 + 2.130277 + 1.721963 + 1.342819 + 1.111084 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4769696 -1.2711293E-02 0.000000 -1.2711293E-02 -1.2711293E-02 -1.2711293E-02 8.9087307E-02 0.2864422 + 0.7983788 0.2334230 0.000000 0.2334230 0.2334230 0.2334230 1.8776570E-02 0.4104146 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.176471 7.5000070E-02 0.000000 7.5000070E-02 7.5000070E-02 7.5000070E-02 0.3553223 0.2648763 + 1.176029 -2.7165476E-02 0.000000 -2.7165476E-02 -2.7165476E-02 -2.7165476E-02 0.3370869 0.2657429 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.176471 7.5000070E-02 0.000000 7.5000070E-02 7.5000070E-02 7.5000070E-02 0.3349442 0.2654466 + 1.176029 -2.7165340E-02 0.000000 -2.7165340E-02 -2.7165340E-02 -2.7165340E-02 0.3526931 0.2649310 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.176471 7.4999988E-02 0.000000 7.4999988E-02 7.4999988E-02 7.4999988E-02 0.3601459 0.2645176 + 1.176029 -2.7165225E-02 0.000000 -2.7165225E-02 -2.7165225E-02 -2.7165225E-02 0.3428988 0.2650517 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.176471 7.5000100E-02 0.000000 7.5000100E-02 7.5000100E-02 7.5000100E-02 0.3478045 0.2653945 + 1.176029 -2.7165286E-02 0.000000 -2.7165286E-02 -2.7165286E-02 -2.7165286E-02 0.3318514 0.2660054 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.176471 7.5000353E-02 0.000000 7.5000353E-02 7.5000353E-02 7.5000353E-02 0.3339748 0.2654868 + 1.176029 -2.7165363E-02 0.000000 -2.7165363E-02 -2.7165363E-02 -2.7165363E-02 0.3299992 0.2654098 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.176471 7.4999467E-02 0.000000 7.4999467E-02 7.4999467E-02 7.4999467E-02 0.3107632 0.2673607 + 1.176029 -2.7165165E-02 0.000000 -2.7165165E-02 -2.7165165E-02 -2.7165165E-02 0.3199376 0.2664773 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.176418 -2.9583538E-02 0.000000 -2.9583538E-02 -2.9583538E-02 -2.9583538E-02 0.3068110 0.2676714 + 1.176029 -2.7165370E-02 0.000000 -2.7165370E-02 -2.7165370E-02 -2.7165370E-02 0.3205964 0.2660260 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.176215 -2.8046999E-02 0.000000 -2.8046999E-02 -2.8046999E-02 -2.8046999E-02 0.3051840 0.2674930 + 1.176029 -2.7165249E-02 0.000000 -2.7165249E-02 -2.7165249E-02 -2.7165249E-02 0.3099458 0.2666905 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.175872 -2.6565518E-02 0.000000 -2.6565518E-02 -2.6565518E-02 -2.6565518E-02 0.3020145 0.2670901 + 1.176029 -2.7165424E-02 0.000000 -2.7165424E-02 -2.7165424E-02 -2.7165424E-02 0.3002219 0.2670574 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.175398 -2.5134848E-02 0.000000 -2.5134848E-02 -2.5134848E-02 -2.5134848E-02 0.2903904 0.2683315 + 1.176029 -2.7165348E-02 0.000000 -2.7165348E-02 -2.7165348E-02 -2.7165348E-02 0.2875658 0.2685704 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.174802 -2.3752918E-02 0.000000 -2.3752918E-02 -2.3752918E-02 -2.3752918E-02 0.2845141 0.2687794 + 1.176029 -2.7165301E-02 0.000000 -2.7165301E-02 -2.7165301E-02 -2.7165301E-02 0.2787209 0.2696586 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.174094 -2.2416757E-02 0.000000 -2.2416757E-02 -2.2416757E-02 -2.2416757E-02 0.2743280 0.2698936 + 5.8491019E-05 1.840161 0.000000 1.840161 1.840161 1.840161 8.1413060E-02 0.2698353 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.173280 -2.1123918E-02 0.000000 -2.1123918E-02 -2.1123918E-02 -2.1123918E-02 0.2783497 0.2687562 + 4.6669523E-04 1.310749 0.000000 1.310749 1.310749 1.310749 9.4598152E-02 0.2647678 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172370 -1.9872168E-02 0.000000 -1.9872168E-02 -1.9872168E-02 -1.9872168E-02 0.2670092 0.2703587 + 1.4122514E-03 1.059914 0.000000 1.059914 1.059914 1.059914 0.1531329 0.2481282 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647868E-02 0.000000 -1.9647868E-02 -1.9647868E-02 -1.9647868E-02 0.2631330 0.2700812 + 4.0172716E-04 1.320986 0.000000 1.320986 1.320986 1.320986 0.1480981 0.2485337 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647913E-02 0.000000 -1.9647913E-02 -1.9647913E-02 -1.9647913E-02 0.2601868 0.2700932 + 1.3993388E-03 1.088418 0.000000 1.088418 1.088418 1.088418 0.1726186 0.2408968 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647907E-02 0.000000 -1.9647907E-02 -1.9647907E-02 -1.9647907E-02 0.2535631 0.2712023 + 3.3633765E-03 0.9085118 0.000000 0.9085118 0.9085118 0.9085118 0.1819971 0.2373830 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647894E-02 0.000000 -1.9647894E-02 -1.9647894E-02 -1.9647894E-02 0.2471847 0.2721590 + 6.1451066E-03 0.7957442 0.000000 0.7957442 0.7957442 0.7957442 0.1810811 0.2373465 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647948E-02 0.000000 -1.9647948E-02 -1.9647948E-02 -1.9647948E-02 0.2425310 0.2725714 + 9.6585788E-03 0.7185279 0.000000 0.7185279 0.7185279 0.7185279 0.1942324 0.2328627 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647896E-02 0.000000 -1.9647896E-02 -1.9647896E-02 -1.9647896E-02 0.2370017 0.2730874 + 1.3735596E-02 0.6636450 0.000000 0.6636450 0.6636450 0.6636450 0.1936103 0.2324826 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647943E-02 0.000000 -1.9647943E-02 -1.9647943E-02 -1.9647943E-02 0.2318039 0.2742402 + 1.8116891E-02 0.6243395 0.000000 0.6243395 0.6243395 0.6243395 0.1818151 0.2359090 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647900E-02 0.000000 -1.9647900E-02 -1.9647900E-02 -1.9647900E-02 0.2270661 0.2752936 + 9.3589649E-03 0.7407458 0.000000 0.7407458 0.7407458 0.7407458 0.1795940 0.2362612 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647930E-02 0.000000 -1.9647930E-02 -1.9647930E-02 -1.9647930E-02 0.2233901 0.2751994 + 1.1286074E-02 0.7122810 0.000000 0.7122810 0.7122810 0.7122810 0.1660683 0.2409161 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647883E-02 0.000000 -1.9647883E-02 -1.9647883E-02 -1.9647883E-02 0.2190209 0.2763148 + 1.3338655E-02 0.6877492 0.000000 0.6877492 0.6877492 0.6877492 0.1671265 0.2399904 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647874E-02 0.000000 -1.9647874E-02 -1.9647874E-02 -1.9647874E-02 0.2155326 0.2768393 + 1.5532766E-02 0.6657420 0.000000 0.6657420 0.6657420 0.6657420 0.1568943 0.2436684 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647891E-02 0.000000 -1.9647891E-02 -1.9647891E-02 -1.9647891E-02 0.2136251 0.2765491 + 1.7895915E-02 0.6454040 0.000000 0.6454040 0.6454040 0.6454040 0.1465123 0.2479757 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647907E-02 0.000000 -1.9647907E-02 -1.9647907E-02 -1.9647907E-02 0.2080132 0.2778891 + 2.0685503E-02 0.6246717 0.000000 0.6246717 0.6246717 0.6246717 0.1420308 0.2495920 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647878E-02 0.000000 -1.9647878E-02 -1.9647878E-02 -1.9647878E-02 0.2042366 0.2788081 + 2.3819879E-02 0.6049200 0.000000 0.6049200 0.6049200 0.6049200 0.1373291 0.2514572 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647907E-02 0.000000 -1.9647907E-02 -1.9647907E-02 -1.9647907E-02 0.1993273 0.2800200 + 2.7627628E-02 0.5847360 0.000000 0.5847360 0.5847360 0.5847360 0.1335267 0.2529578 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647917E-02 0.000000 -1.9647917E-02 -1.9647917E-02 -1.9647917E-02 0.1992286 0.2794121 + 3.4109641E-02 0.5572104 0.000000 0.5572104 0.5572104 0.5572104 0.1319452 0.2532820 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647906E-02 0.000000 -1.9647906E-02 -1.9647906E-02 -1.9647906E-02 0.1931735 0.2811992 + 4.1619357E-02 0.5322860 0.000000 0.5322860 0.5322860 0.5322860 0.1297332 0.2539677 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647906E-02 0.000000 -1.9647906E-02 -1.9647906E-02 -1.9647906E-02 0.1907429 0.2815607 + 5.0799470E-02 0.5083147 0.000000 0.5083147 0.5083147 0.5083147 0.1277781 0.2545388 + 1.000000 + 1.000000 + 1.4012985E-45 + 1.005003 + 1.4012985E-45 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647922E-02 0.000000 -1.9647922E-02 -1.9647922E-02 -1.9647922E-02 0.1879997 0.2821386 + 6.1672769E-02 0.4858317 0.000000 0.4858317 0.4858317 0.4858317 0.1248532 0.2557340 + 1.003716 + 1.006812 + 1.011024 + 1.008401 + 1.007910 + 1.003078 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647924E-02 0.000000 -1.9647924E-02 -1.9647924E-02 -1.9647924E-02 0.1833875 0.2836374 + 7.4828573E-02 0.4641732 0.000000 0.4641732 0.4641732 0.4641732 0.1232597 0.2561253 + 1.014788 + 1.012921 + 1.020912 + 1.011949 + 1.018874 + 1.009121 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647911E-02 0.000000 -1.9647911E-02 -1.9647911E-02 -1.9647911E-02 0.1820455 0.2834765 + 9.0162426E-02 0.4440593 0.000000 0.4440593 0.4440593 0.4440593 0.1201001 0.2576124 + 1.026999 + 1.018369 + 1.031831 + 1.031831 + 1.027342 + 1.016670 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647907E-02 0.000000 -1.9647907E-02 -1.9647907E-02 -1.9647907E-02 0.1790791 0.2845322 + 0.1068317 0.4263912 0.000000 0.4263912 0.4263912 0.4263912 0.1174123 0.2588429 + 1.040412 + 1.024369 + 1.044110 + 1.043028 + 1.036947 + 1.024769 + 1.005810 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647885E-02 0.000000 -1.9647885E-02 -1.9647885E-02 -1.9647885E-02 0.1777492 0.2842050 + 0.1250649 0.4105343 0.000000 0.4105343 0.4105343 0.4105343 0.1145646 0.2602527 + 1.055745 + 1.031359 + 1.058371 + 1.056109 + 1.047733 + 1.032825 + 1.010220 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647917E-02 0.000000 -1.9647917E-02 -1.9647917E-02 -1.9647917E-02 0.1805597 0.2645739 + 0.1441829 0.3967350 0.000000 0.3967350 0.3967350 0.3967350 0.1113034 0.2620464 + 1.071428 + 1.038608 + 1.073137 + 1.069357 + 1.059256 + 1.042641 + 1.018201 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647922E-02 0.000000 -1.9647922E-02 -1.9647922E-02 -1.9647922E-02 0.1768094 0.2660789 + 0.1615264 0.3861257 0.000000 0.3861257 0.3861257 0.3861257 0.1085346 0.2635535 + 1.088875 + 1.046237 + 1.088842 + 1.083731 + 1.072393 + 1.053863 + 1.027235 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647906E-02 0.000000 -1.9647906E-02 -1.9647906E-02 -1.9647906E-02 0.1767939 0.2641743 + 0.1806117 0.3759796 0.000000 0.3759796 0.3759796 0.3759796 0.1055895 0.2652705 + 1.107378 + 1.054949 + 1.106208 + 1.099676 + 1.086598 + 1.066033 + 1.037064 + 1.004445 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647907E-02 0.000000 -1.9647907E-02 -1.9647907E-02 -1.9647907E-02 0.1736973 0.2649629 + 0.2015847 0.3662998 0.000000 0.3662998 0.3662998 0.3662998 0.1029149 0.2668766 + 1.127543 + 1.127543 + 1.124924 + 1.117114 + 1.102329 + 1.079028 + 1.047864 + 1.012470 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647889E-02 0.000000 -1.9647889E-02 -1.9647889E-02 -1.9647889E-02 0.1714589 0.2639365 + 0.2252162 0.3567722 0.000000 0.3567722 0.3567722 0.3567722 9.9624000E-02 0.2690470 + 1.148809 + 1.148809 + 1.145407 + 1.135639 + 1.119055 + 1.093878 + 1.060449 + 1.021944 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647919E-02 0.000000 -1.9647919E-02 -1.9647919E-02 -1.9647919E-02 0.1695924 0.2641931 + 0.2508085 0.3477590 0.000000 0.3477590 0.3477590 0.3477590 9.6591316E-02 0.2711133 + 1.171680 + 1.171048 + 1.167034 + 1.156232 + 1.137578 + 1.109906 + 1.073426 + 1.032144 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647924E-02 0.000000 -1.9647924E-02 -1.9647924E-02 -1.9647924E-02 0.1679116 0.2637735 + 0.2786809 0.3391593 0.000000 0.3391593 0.3391593 0.3391593 9.3568146E-02 0.2732785 + 1.047213 + 1.195041 + 1.189691 + 1.047213 + 1.157298 + 1.047213 + 1.088107 + 1.043119 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647906E-02 0.000000 -1.9647906E-02 -1.9647906E-02 -1.9647906E-02 0.1644284 0.2646334 + 0.3083073 0.3311512 0.000000 0.3311512 0.3311512 0.3311512 9.0816185E-02 0.2753020 + 1.180822 + 1.152839 + 1.194318 + 1.106901 + 1.179090 + 1.145947 + 1.103482 + 1.055513 + 1.009494 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647891E-02 0.000000 -1.9647891E-02 -1.9647891E-02 -1.9647891E-02 0.1624112 0.2644936 + 0.3377856 0.3241370 0.000000 0.3241370 0.3241370 0.3241370 8.8031776E-02 0.2774425 + 1.166013 + 1.246837 + 1.240057 + 1.225816 + 1.201900 + 1.166854 + 1.120380 + 1.069066 + 1.019229 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647900E-02 0.000000 -1.9647900E-02 -1.9647900E-02 -1.9647900E-02 0.1592852 0.2658424 + 0.3674165 0.3178639 0.000000 0.3178639 0.3178639 0.3178639 8.5549228E-02 0.2793876 + 1.276894 + 1.274421 + 1.267437 + 1.252402 + 1.227211 + 1.189398 + 1.140183 + 1.084464 + 1.030156 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647917E-02 0.000000 -1.9647917E-02 -1.9647917E-02 -1.9647917E-02 0.1593258 0.2643539 + 0.3970683 0.3122468 0.000000 0.3122468 0.3122468 0.3122468 8.3293125E-02 0.2811718 + 1.167466 + 1.303501 + 1.295382 + 1.280163 + 1.253203 + 1.213157 + 1.160541 + 1.101079 + 1.042697 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647907E-02 0.000000 -1.9647907E-02 -1.9647907E-02 -1.9647907E-02 0.1562507 0.2655766 + 0.4283697 0.3069023 0.000000 0.3069023 0.3069023 0.3069023 8.1356376E-02 0.2827064 + 1.336945 + 1.334059 + 1.325458 + 1.308997 + 1.281168 + 1.239843 + 1.183188 + 1.118767 + 1.054945 + 1.001282 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647932E-02 0.000000 -1.9647932E-02 -1.9647932E-02 -1.9647932E-02 0.1551011 0.2643273 + 0.4608878 0.3018795 0.000000 0.3018795 0.3018795 0.3018795 7.9532892E-02 0.2841588 + 1.169284 + 1.365752 + 1.356610 + 1.339462 + 1.310611 + 1.266985 + 1.207297 + 1.138160 + 1.070441 + 1.011114 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647896E-02 0.000000 -1.9647896E-02 -1.9647896E-02 -1.9647896E-02 0.1525114 0.2658420 + 0.4943990 0.2971865 0.000000 0.2971865 0.2971865 0.2971865 7.7896036E-02 0.2854931 + 1.402182 + 1.398656 + 1.389232 + 1.371619 + 1.341512 + 1.296321 + 1.233765 + 1.159695 + 1.085648 + 1.021526 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647900E-02 0.000000 -1.9647900E-02 -1.9647900E-02 -1.9647900E-02 0.1509373 0.2648854 + 0.5287033 0.2928212 0.000000 0.2928212 0.2928212 0.2928212 7.6377705E-02 0.2867293 + 1.171111 + 1.433018 + 1.423048 + 1.404311 + 1.373702 + 1.327965 + 1.262241 + 1.183520 + 1.103879 + 1.034178 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647907E-02 0.000000 -1.9647907E-02 -1.9647907E-02 -1.9647907E-02 0.1501601 0.2640030 + 0.5623450 0.2889246 0.000000 0.2889246 0.2889246 0.2889246 7.4932963E-02 0.2879258 + 1.472396 + 1.468081 + 1.457984 + 1.438762 + 1.407501 + 1.360009 + 1.293121 + 1.209303 + 1.122937 + 1.048187 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647891E-02 0.000000 -1.9647891E-02 -1.9647891E-02 -1.9647891E-02 0.1482905 0.2644186 + 0.5950466 0.2854611 0.000000 0.2854611 0.2854611 0.2854611 7.3491275E-02 0.2891659 + 1.569006 + 1.562137 + 1.546166 + 1.518605 + 1.478393 + 1.421111 + 1.343442 + 1.249117 + 1.151758 + 1.068231 + 1.002319 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647919E-02 0.000000 -1.9647919E-02 -1.9647919E-02 -1.9647919E-02 0.1465741 0.2641566 + 0.6269398 0.2823553 0.000000 0.2823553 0.2823553 0.2823553 7.2000012E-02 0.2905174 + 1.170808 + 1.601004 + 1.583878 + 1.556217 + 1.514377 + 1.455758 + 1.377536 + 1.279719 + 1.175397 + 1.083662 + 1.013838 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647919E-02 0.000000 -1.9647919E-02 -1.9647919E-02 -1.9647919E-02 0.1443852 0.2653055 + 0.6559999 0.2797587 0.000000 0.2797587 0.2797587 0.2797587 7.0452727E-02 0.2919959 + 1.648887 + 1.641788 + 1.624108 + 1.595740 + 1.552978 + 1.492281 + 1.412357 + 1.312391 + 1.200758 + 1.101960 + 1.024788 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647919E-02 0.000000 -1.9647919E-02 -1.9647919E-02 -1.9647919E-02 0.1422291 0.2657098 + 0.6865985 0.2771880 0.000000 0.2771880 0.2771880 0.2771880 6.8907179E-02 0.2935320 + 1.173699 + 1.684007 + 1.666392 + 1.636328 + 1.592993 + 1.531911 + 1.450631 + 1.347035 + 1.229732 + 1.121680 + 1.038051 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647911E-02 0.000000 -1.9647911E-02 -1.9647911E-02 -1.9647911E-02 0.1418346 0.2644467 + 0.7186263 0.2746606 0.000000 0.2746606 0.2746606 0.2746606 6.7095190E-02 0.2955060 + 1.737389 + 1.728614 + 1.709926 + 1.679816 + 1.634774 + 1.572173 + 1.489143 + 1.383195 + 1.259509 + 1.143512 + 1.052740 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647894E-02 0.000000 -1.9647894E-02 -1.9647894E-02 -1.9647894E-02 0.1406278 0.2637114 + 0.7530501 0.2720949 0.000000 0.2720949 0.2720949 0.2720949 6.5443099E-02 0.2973154 + 1.173616 + 1.775520 + 1.756079 + 1.724566 + 1.678099 + 1.614280 + 1.529447 + 1.421379 + 1.292903 + 1.166605 + 1.068164 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647919E-02 0.000000 -1.9647919E-02 -1.9647919E-02 -1.9647919E-02 0.1390184 0.2638869 + 0.7891780 0.2695663 0.000000 0.2695663 0.2695663 0.2695663 6.3716382E-02 0.2993105 + 1.833821 + 1.824363 + 1.803657 + 1.771296 + 1.723264 + 1.657977 + 1.571096 + 1.460833 + 1.328175 + 1.193705 + 1.084393 + 1.007303 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647885E-02 0.000000 -1.9647885E-02 -1.9647885E-02 -1.9647885E-02 0.1370935 0.2647251 + 0.8269725 0.2670825 0.000000 0.2670825 0.2670825 0.2670825 6.2031623E-02 0.3013197 + 1.171934 + 1.874961 + 1.854230 + 1.820899 + 1.771520 + 1.703438 + 1.614145 + 1.502080 + 1.366360 + 1.222203 + 1.103994 + 1.019899 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647913E-02 0.000000 -1.9647913E-02 -1.9647913E-02 -1.9647913E-02 0.1356898 0.2648145 + 0.8664582 0.2646464 0.000000 0.2646464 0.2646464 0.2646464 6.0141474E-02 0.3037431 + 1.939430 + 1.928390 + 1.907045 + 1.871441 + 1.820786 + 1.750470 + 1.659745 + 1.544502 + 1.405837 + 1.253768 + 1.124600 + 1.031873 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647896E-02 0.000000 -1.9647896E-02 -1.9647896E-02 -1.9647896E-02 0.1336914 0.2656524 + 0.9069813 0.2623050 0.000000 0.2623050 0.2623050 0.2623050 5.8674350E-02 0.3055556 + 1.167986 + 1.984471 + 1.961844 + 1.926266 + 1.873667 + 1.801315 + 1.707949 + 1.589632 + 1.447638 + 1.288754 + 1.146768 + 1.045234 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647902E-02 0.000000 -1.9647902E-02 -1.9647902E-02 -1.9647902E-02 0.1339362 0.2631721 + 0.9482072 0.2600730 0.000000 0.2600730 0.2600730 0.2600730 5.7076756E-02 0.3076590 + 2.054347 + 2.042939 + 2.018839 + 1.981690 + 1.927767 + 1.852896 + 1.756446 + 1.636203 + 1.491268 + 1.325319 + 1.171427 + 1.061502 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647917E-02 0.000000 -1.9647917E-02 -1.9647917E-02 -1.9647917E-02 0.1329016 0.2633072 + 0.9909984 0.2578927 0.000000 0.2578927 0.2578927 0.2578927 5.5522420E-02 0.3097678 + 1.163352 + 2.103169 + 2.079058 + 2.039924 + 1.983812 + 1.906078 + 1.806220 + 1.682240 + 1.533788 + 1.364730 + 1.199481 + 1.078420 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647913E-02 0.000000 -1.9647913E-02 -1.9647913E-02 -1.9647913E-02 0.1301228 0.2651674 + 1.035170 0.2557772 0.000000 0.2557772 0.2557772 0.2557772 5.4028586E-02 0.3118482 + 2.180051 + 2.167048 + 2.141324 + 2.101164 + 2.042138 + 1.962420 + 1.859080 + 1.731040 + 1.580248 + 1.405696 + 1.229704 + 1.096236 + 1.007796 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647891E-02 0.000000 -1.9647891E-02 -1.9647891E-02 -1.9647891E-02 0.1284176 0.2655563 + 1.081626 0.2536753 0.000000 0.2536753 0.2536753 0.2536753 5.2544381E-02 0.3139866 + 1.158262 + 2.233946 + 2.207502 + 2.165913 + 2.105173 + 2.022900 + 1.916025 + 1.783612 + 1.628128 + 1.449107 + 1.263276 + 1.116775 + 1.020665 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647883E-02 0.000000 -1.9647883E-02 -1.9647883E-02 -1.9647883E-02 0.1289222 0.2631748 + 1.130402 0.2515906 0.000000 0.2515906 0.2515906 0.2515906 5.1110789E-02 0.3161028 + 2.316838 + 2.302986 + 2.275311 + 2.232825 + 2.170048 + 2.084206 + 1.973243 + 1.836770 + 1.676336 + 1.494707 + 1.298837 + 1.138058 + 1.032700 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647896E-02 0.000000 -1.9647896E-02 -1.9647896E-02 -1.9647896E-02 0.1276369 0.2630644 + 1.181264 0.2495402 0.000000 0.2495402 0.2495402 0.2495402 4.9691360E-02 0.3182469 + 1.152216 + 2.374138 + 2.346427 + 2.301150 + 2.236417 + 2.146462 + 2.031603 + 1.890108 + 1.726256 + 1.539570 + 1.337623 + 1.163046 + 1.047479 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647842E-02 0.000000 -1.9647842E-02 -1.9647842E-02 -1.9647842E-02 0.1249313 0.2654905 + 1.233310 0.2475676 0.000000 0.2475676 0.2475676 0.2475676 4.8350278E-02 0.3203737 + 2.464684 + 2.449056 + 2.420027 + 2.374100 + 2.306629 + 2.214542 + 2.094797 + 1.948675 + 1.778039 + 1.587478 + 1.378280 + 1.189308 + 1.062678 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647911E-02 0.000000 -1.9647911E-02 -1.9647911E-02 -1.9647911E-02 0.1239732 0.2646979 + 1.285463 0.2457121 0.000000 0.2457121 0.2457121 0.2457121 4.7042266E-02 0.3224569 + 1.145980 + 2.526685 + 2.496132 + 2.449259 + 2.379519 + 2.282750 + 2.159324 + 2.006769 + 1.830622 + 1.635337 + 1.421522 + 1.219409 + 1.080144 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647911E-02 0.000000 -1.9647911E-02 -1.9647911E-02 -1.9647911E-02 0.1227186 0.2655155 + 1.338097 0.2439480 0.000000 0.2439480 0.2439480 0.2439480 4.5851167E-02 0.3243895 + 2.623287 + 2.606094 + 2.576197 + 2.527440 + 2.455701 + 2.356854 + 2.227466 + 2.069486 + 1.887470 + 1.685541 + 1.467143 + 1.251701 + 1.098378 + 1.004271 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647922E-02 0.000000 -1.9647922E-02 -1.9647922E-02 -1.9647922E-02 0.1217753 0.2648889 + 1.389989 0.2423146 0.000000 0.2423146 0.2423146 0.2423146 4.4773489E-02 0.3261494 + 1.140581 + 2.689092 + 2.658980 + 2.609678 + 2.535602 + 2.432369 + 2.298541 + 2.135071 + 1.945030 + 1.736721 + 1.513594 + 1.287381 + 1.118454 + 1.015688 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647894E-02 0.000000 -1.9647894E-02 -1.9647894E-02 -1.9647894E-02 0.1209614 0.2646737 + 1.442848 0.2407411 0.000000 0.2407411 0.2407411 0.2407411 4.3791566E-02 0.3277519 + 2.792509 + 2.774784 + 2.743437 + 2.693167 + 2.618196 + 2.512026 + 2.372581 + 2.201462 + 2.005601 + 1.789790 + 1.561261 + 1.326209 + 1.140352 + 1.028222 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647911E-02 0.000000 -1.9647911E-02 -1.9647911E-02 -1.9647911E-02 0.1191426 0.2654316 + 1.496338 0.2392335 0.000000 0.2392335 0.2392335 0.2392335 4.2919617E-02 0.3291642 + 1.136189 + 2.862676 + 2.830584 + 2.780975 + 2.703227 + 2.593887 + 2.449250 + 2.271937 + 2.067037 + 1.844759 + 1.610355 + 1.365959 + 1.165193 + 1.041230 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647889E-02 0.000000 -1.9647889E-02 -1.9647889E-02 -1.9647889E-02 0.1183684 0.2653025 + 1.549691 0.2378131 0.000000 0.2378131 0.2378131 0.2378131 4.2155363E-02 0.3303734 + 2.971770 + 2.953471 + 2.921366 + 2.870743 + 2.794018 + 2.681762 + 2.530977 + 2.346320 + 2.133651 + 1.902316 + 1.660700 + 1.409861 + 1.192518 + 1.055844 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647932E-02 0.000000 -1.9647932E-02 -1.9647932E-02 -1.9647932E-02 0.1180270 0.2641883 + 1.603283 0.2364611 0.000000 0.2364611 0.2364611 0.2364611 4.1515090E-02 0.3313273 + 1.210375 + 3.045795 + 3.014423 + 2.964394 + 2.885875 + 2.771479 + 2.616109 + 2.424170 + 2.202292 + 1.962273 + 1.712846 + 1.456421 + 1.222019 + 1.072435 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647866E-02 0.000000 -1.9647866E-02 -1.9647866E-02 -1.9647866E-02 0.1176407 0.2631617 + 1.655415 0.2352194 0.000000 0.2352194 0.2352194 0.2352194 4.0870432E-02 0.3323277 + 3.240116 + 3.217561 + 3.179031 + 3.117500 + 3.025939 + 2.894321 + 2.721236 + 2.511476 + 2.275602 + 2.023775 + 1.766406 + 1.503253 + 1.256001 + 1.089988 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647911E-02 0.000000 -1.9647911E-02 -1.9647911E-02 -1.9647911E-02 0.1146902 0.2660100 + 1.706816 0.2340586 0.000000 0.2340586 0.2340586 0.2340586 4.0249474E-02 0.3333024 + 1.134066 + 3.325495 + 3.285846 + 3.224450 + 3.131883 + 2.997782 + 2.817770 + 2.597932 + 2.350562 + 2.088068 + 1.821176 + 1.552241 + 1.291943 + 1.110013 + 1.005289 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647911E-02 0.000000 -1.9647911E-02 -1.9647911E-02 -1.9647911E-02 0.1138953 0.2656121 + 1.757051 0.2329834 0.000000 0.2329834 0.2329834 0.2329834 3.9555967E-02 0.3344980 + 3.460113 + 3.436574 + 3.396884 + 3.335611 + 3.241633 + 3.103963 + 2.918755 + 2.690181 + 2.431182 + 2.156090 + 1.878620 + 1.602906 + 1.330179 + 1.131026 + 1.016745 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647913E-02 0.000000 -1.9647913E-02 -1.9647913E-02 -1.9647913E-02 0.1132138 0.2649659 + 1.804360 0.2320288 0.000000 0.2320288 0.2320288 0.2320288 3.9060745E-02 0.3352186 + 1.130914 + 3.550617 + 3.511232 + 3.449489 + 3.355023 + 3.215621 + 3.024393 + 2.784980 + 2.513377 + 2.227143 + 1.938678 + 1.654090 + 1.372570 + 1.154355 + 1.029584 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647894E-02 0.000000 -1.9647894E-02 -1.9647894E-02 -1.9647894E-02 0.1125137 0.2643759 + 1.853522 0.2310702 0.000000 0.2310702 0.2310702 0.2310702 3.8513575E-02 0.3361039 + 3.692035 + 3.666832 + 3.627230 + 3.565512 + 3.469992 + 3.328357 + 3.132833 + 2.883327 + 2.599443 + 2.299454 + 1.999362 + 1.705539 + 1.418185 + 1.180947 + 1.042845 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647932E-02 0.000000 -1.9647932E-02 -1.9647932E-02 -1.9647932E-02 0.1114043 0.2651876 + 1.903650 0.2301307 0.000000 0.2301307 0.2301307 0.2301307 3.7984982E-02 0.3369692 + 1.127399 + 3.787365 + 3.747623 + 3.686051 + 3.589224 + 3.445834 + 3.244728 + 2.986150 + 2.688604 + 2.374942 + 2.062260 + 1.759312 + 1.464272 + 1.209383 + 1.057738 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647941E-02 0.000000 -1.9647941E-02 -1.9647941E-02 -1.9647941E-02 0.1102266 0.2656816 + 1.955532 0.2291921 0.000000 0.2291921 0.2291921 0.2291921 3.7510008E-02 0.3377185 + 3.936356 + 3.910824 + 3.871397 + 3.809712 + 3.712970 + 3.568588 + 3.364400 + 3.097017 + 2.784667 + 2.456279 + 2.129645 + 1.816240 + 1.512255 + 1.240972 + 1.073189 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647906E-02 0.000000 -1.9647906E-02 -1.9647906E-02 -1.9647906E-02 0.1093598 0.2654011 + 2.008554 0.2282691 0.000000 0.2282691 0.2282691 0.2282691 3.7002634E-02 0.3385838 + 1.123598 + 4.037717 + 3.997540 + 3.937090 + 3.842093 + 3.696351 + 3.488559 + 3.212513 + 2.886590 + 2.541626 + 2.199484 + 1.874431 + 1.562906 + 1.275606 + 1.091034 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647906E-02 0.000000 -1.9647906E-02 -1.9647906E-02 -1.9647906E-02 0.1092167 0.2641415 + 2.063852 0.2273379 0.000000 0.2273379 0.2273379 0.2273379 3.6533304E-02 0.3393675 + 4.193677 + 4.166514 + 4.127565 + 4.068144 + 3.973244 + 3.827406 + 3.616460 + 3.334686 + 2.993963 + 2.631897 + 2.273257 + 1.934182 + 1.615098 + 1.315140 + 1.110894 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647924E-02 0.000000 -1.9647924E-02 -1.9647924E-02 -1.9647924E-02 0.1082553 0.2637528 + 2.119989 0.2264298 0.000000 0.2264298 0.2264298 0.2264298 3.6079735E-02 0.3401399 + 1.117469 + 4.298889 + 4.259837 + 4.199584 + 4.105281 + 3.958913 + 3.743718 + 3.455071 + 3.101293 + 2.720772 + 2.347910 + 1.995368 + 1.666057 + 1.355657 + 1.132587 + 1.007947 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647874E-02 0.000000 -1.9647874E-02 -1.9647874E-02 -1.9647874E-02 0.1070456 0.2649322 + 2.177571 0.2255321 0.000000 0.2255321 0.2255321 0.2255321 3.5625987E-02 0.3409343 + 4.463238 + 4.434484 + 4.394582 + 4.334704 + 4.240495 + 4.093864 + 3.877636 + 3.582084 + 3.216580 + 2.817268 + 2.426349 + 2.059058 + 1.720776 + 1.399631 + 1.156469 + 1.020395 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647883E-02 0.000000 -1.9647883E-02 -1.9647883E-02 -1.9647883E-02 0.1054051 0.2660502 + 2.237722 0.2246243 0.000000 0.2246243 0.2246243 0.2246243 3.5200771E-02 0.3416700 + 1.108417 + 4.574275 + 4.533312 + 4.474967 + 4.381863 + 4.236319 + 4.017729 + 3.716377 + 3.337602 + 2.920390 + 2.509580 + 2.125370 + 1.775183 + 1.447527 + 1.182962 + 1.033128 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647922E-02 0.000000 -1.9647922E-02 -1.9647922E-02 -1.9647922E-02 0.1052872 0.2649833 + 2.298857 0.2237373 0.000000 0.2237373 0.2237373 0.2237373 3.4855612E-02 0.3421909 + 4.745664 + 4.716688 + 4.676680 + 4.617574 + 4.525848 + 4.381248 + 4.163377 + 3.856379 + 3.467642 + 3.030484 + 2.597353 + 2.196636 + 1.832695 + 1.495884 + 1.212474 + 1.047553 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647919E-02 0.000000 -1.9647919E-02 -1.9647919E-02 -1.9647919E-02 0.1045359 0.2644160 + 2.362799 0.2228392 0.000000 0.2228392 0.2228392 0.2228392 3.4308728E-02 0.3433410 + 1.098363 + 4.863680 + 4.822981 + 4.763100 + 4.669769 + 4.525814 + 4.305568 + 3.994703 + 3.595303 + 3.140612 + 2.687675 + 2.268078 + 1.890543 + 1.545768 + 1.244789 + 1.062409 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647863E-02 0.000000 -1.9647863E-02 -1.9647863E-02 -1.9647863E-02 0.1033708 0.2654175 + 2.429013 0.2219416 0.000000 0.2219416 0.2219416 0.2219416 3.3917032E-02 0.3440537 + 5.044687 + 5.014315 + 4.973632 + 4.914071 + 4.822069 + 4.679116 + 4.460488 + 4.145417 + 3.736005 + 3.263242 + 2.784933 + 2.345627 + 1.951300 + 1.596835 + 1.279990 + 1.079525 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647911E-02 0.000000 -1.9647911E-02 -1.9647911E-02 -1.9647911E-02 0.1033398 0.2636976 + 2.497702 0.2210426 0.000000 0.2210426 0.2210426 0.2210426 3.3467725E-02 0.3449580 + 1.088703 + 5.168709 + 5.126691 + 5.065443 + 4.972095 + 4.827306 + 4.608184 + 4.290200 + 3.873787 + 3.383352 + 2.882619 + 2.422650 + 2.012865 + 1.649343 + 1.318237 + 1.099272 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647896E-02 0.000000 -1.9647896E-02 -1.9647896E-02 -1.9647896E-02 0.1012567 0.2659483 + 2.568010 0.2201568 0.000000 0.2201568 0.2201568 0.2201568 3.3041321E-02 0.3458200 + 5.359532 + 5.326888 + 5.285823 + 5.224598 + 5.128705 + 4.983513 + 4.764481 + 4.444159 + 4.019129 + 3.513252 + 2.988614 + 2.504923 + 2.078526 + 1.702944 + 1.359816 + 1.119119 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647919E-02 0.000000 -1.9647919E-02 -1.9647919E-02 -1.9647919E-02 0.1010250 0.2653014 + 2.641828 0.2192567 0.000000 0.2192567 0.2192567 0.2192567 3.2614131E-02 0.3467102 + 1.081982 + 5.489281 + 5.448575 + 5.388022 + 5.291779 + 5.146612 + 4.927837 + 4.606750 + 4.172878 + 3.651061 + 3.100574 + 2.593103 + 2.146677 + 1.758590 + 1.404573 + 1.142173 + 1.009936 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647911E-02 0.000000 -1.9647911E-02 -1.9647911E-02 -1.9647911E-02 0.1010077 0.2638454 + 2.719297 0.2183432 0.000000 0.2183432 0.2183432 0.2183432 3.2187827E-02 0.3476233 + 5.687713 + 5.655340 + 5.614879 + 5.555741 + 5.459547 + 5.312776 + 5.093855 + 4.772761 + 4.331863 + 3.795495 + 3.219542 + 2.685267 + 2.218076 + 1.814594 + 1.451537 + 1.167121 + 1.021256 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647896E-02 0.000000 -1.9647896E-02 -1.9647896E-02 -1.9647896E-02 0.1004358 0.2630208 + 2.798531 0.2174450 0.000000 0.2174450 0.2174450 0.2174450 3.1474989E-02 0.3494807 + 1.080546 + 5.822669 + 5.783765 + 5.725837 + 5.628356 + 5.477091 + 5.254507 + 4.933587 + 4.487518 + 3.938150 + 3.339993 + 2.778165 + 2.290345 + 1.871621 + 1.500830 + 1.195568 + 1.035746 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647924E-02 0.000000 -1.9647924E-02 -1.9647924E-02 -1.9647924E-02 9.9195935E-02 0.2641191 + 2.881289 0.2165390 0.000000 0.2165390 0.2165390 0.2165390 3.1314097E-02 0.3496020 + 6.024549 + 5.992111 + 5.954597 + 5.897725 + 5.801098 + 5.645670 + 5.418603 + 5.094443 + 4.646169 + 4.084007 + 3.465394 + 2.876594 + 2.366318 + 1.930901 + 1.551071 + 1.225295 + 1.050424 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.172193 -1.9647932E-02 0.000000 -1.9647932E-02 -1.9647932E-02 -1.9647932E-02 9.7604223E-02 0.2657056 + 2.966680 0.2156387 0.000000 0.2156387 0.2156387 0.2156387 3.0948425E-02 0.3503885 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4880013 7.5000100E-02 0.000000 7.5000100E-02 7.5000100E-02 7.5000100E-02 0.4559673 0.2405394 + 0.4877820 -3.6676232E-02 0.000000 -3.6676232E-02 -3.6676232E-02 -3.6676232E-02 0.4449362 0.2411990 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4880012 7.4999928E-02 0.000000 7.4999928E-02 7.4999928E-02 7.4999928E-02 0.4354544 0.2417284 + 0.4877821 -3.6676142E-02 0.000000 -3.6676142E-02 -3.6676142E-02 -3.6676142E-02 0.4396499 0.2410257 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4880013 7.5000092E-02 0.000000 7.5000092E-02 7.5000092E-02 7.5000092E-02 0.4347394 0.2406350 + 0.4877820 -3.6676262E-02 0.000000 -3.6676262E-02 -3.6676262E-02 -3.6676262E-02 0.3975375 0.2423927 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4880013 7.5000092E-02 0.000000 7.5000092E-02 7.5000092E-02 7.5000092E-02 0.3964529 0.2427927 + 0.4877821 -3.6676291E-02 0.000000 -3.6676291E-02 -3.6676291E-02 -3.6676291E-02 0.3962585 0.2428707 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4880012 7.4999787E-02 0.000000 7.4999787E-02 7.4999787E-02 7.4999787E-02 0.3923010 0.2425223 + 0.4877820 -3.6676355E-02 0.000000 -3.6676355E-02 -3.6676355E-02 -3.6676355E-02 0.3938185 0.2422362 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4880013 7.5000957E-02 0.000000 7.5000957E-02 7.5000957E-02 7.5000957E-02 0.3807386 0.2432015 + 0.4877820 -3.6676202E-02 0.000000 -3.6676202E-02 -3.6676202E-02 -3.6676202E-02 0.3770877 0.2434195 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4879748 -3.9568011E-02 0.000000 -3.9568011E-02 -3.9568011E-02 -3.9568011E-02 0.3769420 0.2426990 + 0.4877820 -3.6676079E-02 0.000000 -3.6676079E-02 -3.6676079E-02 -3.6676079E-02 0.3764967 0.2428974 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4878743 -3.7729040E-02 0.000000 -3.7729040E-02 -3.7729040E-02 -3.7729040E-02 0.3651241 0.2432011 + 0.4877820 -3.6676079E-02 0.000000 -3.6676079E-02 -3.6676079E-02 -3.6676079E-02 0.3590117 0.2437015 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4877044 -3.5960801E-02 0.000000 -3.5960801E-02 -3.5960801E-02 -3.5960801E-02 0.3504218 0.2445105 + 0.4877820 -3.6676172E-02 0.000000 -3.6676172E-02 -3.6676172E-02 -3.6676172E-02 0.3447021 0.2445742 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4874706 -3.4259405E-02 0.000000 -3.4259405E-02 -3.4259405E-02 -3.4259405E-02 0.3448280 0.2443971 + 0.4877820 -3.6676232E-02 0.000000 -3.6676232E-02 -3.6676232E-02 -3.6676232E-02 0.3352679 0.2456336 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4871778 -3.2620445E-02 0.000000 -3.2620445E-02 -3.2620445E-02 -3.2620445E-02 0.3393484 0.2446919 + 0.4877820 -3.6676202E-02 0.000000 -3.6676202E-02 -3.6676202E-02 -3.6676202E-02 0.3225307 0.2460818 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4868306 -3.1040335E-02 0.000000 -3.1040335E-02 -3.1040335E-02 -3.1040335E-02 0.3310201 0.2454203 + 3.0606720E-05 1.949620 0.000000 1.949620 1.949620 1.949620 0.1778267 0.2226839 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4864330 -2.9515525E-02 0.000000 -2.9515525E-02 -2.9515525E-02 -2.9515525E-02 0.3199384 0.2462219 + 2.2904463E-04 1.411229 0.000000 1.411229 1.411229 1.411229 0.1903481 0.2195134 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859891 -2.8043156E-02 0.000000 -2.8043156E-02 -2.8043156E-02 -2.8043156E-02 0.3126812 0.2468965 + 6.5676385E-04 1.153055 0.000000 1.153055 1.153055 1.153055 0.1902696 0.2191283 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859032 -2.7779670E-02 0.000000 -2.7779670E-02 -2.7779670E-02 -2.7779670E-02 0.3057483 0.2469367 + 3.3447935E-04 1.306159 0.000000 1.306159 1.306159 1.306159 0.1808526 0.2211053 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779760E-02 0.000000 -2.7779760E-02 -2.7779760E-02 -2.7779760E-02 0.2947608 0.2491040 + 5.7844265E-04 1.174823 0.000000 1.174823 1.174823 1.174823 0.1896478 0.2186754 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779693E-02 0.000000 -2.7779693E-02 -2.7779693E-02 -2.7779693E-02 0.2943707 0.2480630 + 1.1644777E-03 1.019838 0.000000 1.019838 1.019838 1.019838 0.1923558 0.2176991 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779737E-02 0.000000 -2.7779737E-02 -2.7779737E-02 -2.7779737E-02 0.2875527 0.2487264 + 2.0763166E-03 0.9001701 0.000000 0.9001701 0.9001701 0.9001701 0.2079246 0.2136783 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779715E-02 0.000000 -2.7779715E-02 -2.7779715E-02 -2.7779715E-02 0.2764405 0.2505375 + 3.1977573E-03 0.8166159 0.000000 0.8166159 0.8166159 0.8166159 0.2032644 0.2145489 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779682E-02 0.000000 -2.7779682E-02 -2.7779682E-02 -2.7779682E-02 0.2716458 0.2510991 + 4.4725556E-03 0.7558300 0.000000 0.7558300 0.7558300 0.7558300 0.2027770 0.2143326 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779682E-02 0.000000 -2.7779682E-02 -2.7779682E-02 -2.7779682E-02 0.2693086 0.2503885 + 5.8187856E-03 0.7110639 0.000000 0.7110639 0.7110639 0.7110639 0.1886090 0.2181772 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779693E-02 0.000000 -2.7779693E-02 -2.7779693E-02 -2.7779693E-02 0.2612943 0.2517436 + 3.7300135E-03 0.7845133 0.000000 0.7845133 0.7845133 0.7845133 0.1841896 0.2192542 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779737E-02 0.000000 -2.7779737E-02 -2.7779737E-02 -2.7779737E-02 0.2539868 0.2532093 + 4.4722594E-03 0.7524590 0.000000 0.7524590 0.7524590 0.7524590 0.1767083 0.2214283 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779737E-02 0.000000 -2.7779737E-02 -2.7779737E-02 -2.7779737E-02 0.2504452 0.2535360 + 5.2513555E-03 0.7249818 0.000000 0.7249818 0.7249818 0.7249818 0.1696228 0.2236169 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779693E-02 0.000000 -2.7779693E-02 -2.7779693E-02 -2.7779693E-02 0.2489822 0.2535487 + 6.0979626E-03 0.6999976 0.000000 0.6999976 0.6999976 0.6999976 0.1612290 0.2264244 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779693E-02 0.000000 -2.7779693E-02 -2.7779693E-02 -2.7779693E-02 0.2434484 0.2543969 + 7.0140548E-03 0.6769115 0.000000 0.6769115 0.6769115 0.6769115 0.1530605 0.2294184 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779726E-02 0.000000 -2.7779726E-02 -2.7779726E-02 -2.7779726E-02 0.2397028 0.2547842 + 8.1102103E-03 0.6536140 0.000000 0.6536140 0.6536140 0.6536140 0.1454693 0.2323438 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779661E-02 0.000000 -2.7779661E-02 -2.7779661E-02 -2.7779661E-02 0.2349532 0.2553342 + 9.3048112E-03 0.6320788 0.000000 0.6320788 0.6320788 0.6320788 0.1410366 0.2340502 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779737E-02 0.000000 -2.7779737E-02 -2.7779737E-02 -2.7779737E-02 0.2305784 0.2563636 + 1.0668375E-02 0.6114071 0.000000 0.6114071 0.6114071 0.6114071 0.1364754 0.2359311 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779704E-02 0.000000 -2.7779704E-02 -2.7779704E-02 -2.7779704E-02 0.2249108 0.2573437 + 1.2248383E-02 0.5911549 0.000000 0.5911549 0.5911549 0.5911549 0.1314205 0.2381363 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779693E-02 0.000000 -2.7779693E-02 -2.7779693E-02 -2.7779693E-02 0.2201284 0.2588045 + 1.4782262E-02 0.5656427 0.000000 0.5656427 0.5656427 0.5656427 0.1265800 0.2403839 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779661E-02 0.000000 -2.7779661E-02 -2.7779661E-02 -2.7779661E-02 0.2261290 0.2408098 + 1.7855205E-02 0.5411193 0.000000 0.5411193 0.5411193 0.5411193 0.1236223 0.2417061 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779737E-02 0.000000 -2.7779737E-02 -2.7779737E-02 -2.7779737E-02 0.2245597 0.2399928 + 2.1464480E-02 0.5181009 0.000000 0.5181009 0.5181009 0.5181009 0.1200432 0.2434542 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779704E-02 0.000000 -2.7779704E-02 -2.7779704E-02 -2.7779704E-02 0.2191502 0.2416337 + 2.5791844E-02 0.4959726 0.000000 0.4959726 0.4959726 0.4959726 0.1167521 0.2451252 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779726E-02 0.000000 -2.7779726E-02 -2.7779726E-02 -2.7779726E-02 0.2176260 0.2400912 + 3.0790698E-02 0.4754083 0.000000 0.4754083 0.4754083 0.4754083 0.1136154 0.2467860 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779749E-02 0.000000 -2.7779749E-02 -2.7779749E-02 -2.7779749E-02 0.2131821 0.2410515 + 3.6169618E-02 0.4572847 0.000000 0.4572847 0.4572847 0.4572847 0.1104448 0.2485448 + 1.005813 + 1.005246 + 1.000038 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779715E-02 0.000000 -2.7779715E-02 -2.7779715E-02 -2.7779715E-02 0.2090020 0.2413954 + 4.1997265E-02 0.4409835 0.000000 0.4409835 0.4409835 0.4409835 0.1072777 0.2503878 + 1.016245 + 1.015385 + 1.009455 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779704E-02 0.000000 -2.7779704E-02 -2.7779704E-02 -2.7779704E-02 0.2055971 0.2418208 + 4.8047833E-02 0.4267355 0.000000 0.4267355 0.4267355 0.4267355 0.1039265 0.2524334 + 1.027501 + 1.026570 + 1.019866 + 1.007631 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779693E-02 0.000000 -2.7779693E-02 -2.7779693E-02 -2.7779693E-02 0.2056034 0.2396408 + 5.3457286E-02 0.4156505 0.000000 0.4156505 0.4156505 0.4156505 0.1002871 0.2547803 + 1.040545 + 1.038844 + 1.031307 + 1.017791 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779693E-02 0.000000 -2.7779693E-02 -2.7779693E-02 -2.7779693E-02 0.2000851 0.2421306 + 5.9370562E-02 0.4050604 0.000000 0.4050604 0.4050604 0.4050604 9.7254187E-02 0.2568086 + 1.020911 + 1.052657 + 1.044020 + 1.029577 + 1.008907 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779670E-02 0.000000 -2.7779670E-02 -2.7779670E-02 -2.7779670E-02 0.1964611 0.2419379 + 6.5823965E-02 0.3949678 0.000000 0.3949678 0.3949678 0.3949678 9.4049081E-02 0.2590531 + 1.063540 + 1.036055 + 1.045367 + 1.041855 + 1.019378 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779715E-02 0.000000 -2.7779715E-02 -2.7779715E-02 -2.7779715E-02 0.1963132 0.2406583 + 7.3034629E-02 0.3850871 0.000000 0.3850871 0.3850871 0.3850871 9.0658300E-02 0.2615430 + 1.040212 + 1.083906 + 1.073556 + 1.055358 + 1.030901 + 1.002204 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779737E-02 0.000000 -2.7779737E-02 -2.7779737E-02 -2.7779737E-02 0.1910932 0.2422365 + 8.0768973E-02 0.3757603 0.000000 0.3757603 0.3757603 0.3757603 8.7326109E-02 0.2641048 + 1.105642 + 1.102289 + 1.090647 + 1.070637 + 1.043808 + 1.013196 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779715E-02 0.000000 -2.7779715E-02 -2.7779715E-02 -2.7779715E-02 0.1901318 0.2413100 + 8.9109667E-02 0.3668883 0.000000 0.3668883 0.3668883 0.3668883 8.3975486E-02 0.2668021 + 1.044522 + 1.122309 + 1.109507 + 1.087557 + 1.058114 + 1.025393 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779682E-02 0.000000 -2.7779682E-02 -2.7779682E-02 -2.7779682E-02 0.1898787 0.2399303 + 9.7895361E-02 0.3586233 0.000000 0.3586233 0.3586233 0.3586233 8.0735564E-02 0.2695233 + 1.148638 + 1.144237 + 1.129294 + 1.105350 + 1.073678 + 1.037706 + 1.000122 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859032 -2.7779682E-02 0.000000 -2.7779682E-02 -2.7779682E-02 -2.7779682E-02 0.1848278 0.2414551 + 0.1065298 0.3513568 0.000000 0.3513568 0.3513568 0.3513568 7.7957109E-02 0.2719556 + 1.048403 + 1.168130 + 1.151949 + 1.125038 + 1.090069 + 1.051392 + 1.011125 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779704E-02 0.000000 -2.7779704E-02 -2.7779704E-02 -2.7779704E-02 0.1812441 0.2425747 + 0.1151123 0.3448367 0.000000 0.3448367 0.3448367 0.3448367 7.5432412E-02 0.2742268 + 1.200356 + 1.194553 + 1.176940 + 1.147736 + 1.109436 + 1.065747 + 1.022488 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779749E-02 0.000000 -2.7779749E-02 -2.7779749E-02 -2.7779749E-02 0.1810751 0.2408210 + 0.1236136 0.3389720 0.000000 0.3389720 0.3389720 0.3389720 7.3112056E-02 0.2764117 + 1.049997 + 1.222705 + 1.203193 + 1.172703 + 1.130921 + 1.082725 + 1.036013 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779682E-02 0.000000 -2.7779682E-02 -2.7779682E-02 -2.7779682E-02 0.1789972 0.2407677 + 0.1325317 0.3333859 0.000000 0.3333859 0.3333859 0.3333859 7.1208030E-02 0.2782443 + 1.260786 + 1.253402 + 1.232874 + 1.199233 + 1.153481 + 1.101531 + 1.049816 + 1.002357 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779682E-02 0.000000 -2.7779682E-02 -2.7779682E-02 -2.7779682E-02 0.1754556 0.2417249 + 0.1417346 0.3281242 0.000000 0.3281242 0.3281242 0.3281242 6.9188967E-02 0.2802478 + 1.051267 + 1.286904 + 1.265119 + 1.228413 + 1.051267 + 1.118229 + 1.065204 + 1.014001 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779715E-02 0.000000 -2.7779715E-02 -2.7779715E-02 -2.7779715E-02 0.1746288 0.2403901 + 0.1511475 0.3231970 0.000000 0.3231970 0.3231970 0.3231970 6.7396633E-02 0.2820792 + 1.331028 + 1.322322 + 1.299014 + 1.259902 + 1.206918 + 1.144859 + 1.082548 + 1.026803 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779726E-02 0.000000 -2.7779726E-02 -2.7779726E-02 -2.7779726E-02 0.1707243 0.2425117 + 0.1607084 0.3186020 0.000000 0.3186020 0.3186020 0.3186020 6.5641999E-02 0.2839434 + 1.051822 + 1.359435 + 1.335284 + 1.295191 + 1.051822 + 1.170350 + 1.100556 + 1.039915 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779715E-02 0.000000 -2.7779715E-02 -2.7779715E-02 -2.7779715E-02 0.1701249 0.2409247 + 0.1699929 0.3144737 0.000000 0.3144737 0.3144737 0.3144737 6.4087264E-02 0.2856387 + 1.409571 + 1.399700 + 1.374212 + 1.331723 + 1.271615 + 1.197477 + 1.122256 + 1.054453 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779737E-02 0.000000 -2.7779737E-02 -2.7779737E-02 -2.7779737E-02 0.1675670 0.2414754 + 0.1789198 0.3107791 0.000000 0.3107791 0.3107791 0.3107791 6.2616408E-02 0.2872997 + 1.051834 + 1.456950 + 1.429826 + 1.382756 + 1.317131 + 1.051834 + 1.148711 + 1.073507 + 1.012775 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779693E-02 0.000000 -2.7779693E-02 -2.7779693E-02 -2.7779693E-02 0.1672501 0.2397428 + 0.1875370 0.3074433 0.000000 0.3074433 0.3074433 0.3074433 6.0806472E-02 0.2894314 + 1.512183 + 1.500816 + 1.471628 + 1.424322 + 1.355334 + 1.268383 + 1.174920 + 1.091803 + 1.025352 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779737E-02 0.000000 -2.7779737E-02 -2.7779737E-02 -2.7779737E-02 0.1630479 0.2426001 + 0.1952621 0.3046135 0.000000 0.3046135 0.3046135 0.3046135 5.9263233E-02 0.2912779 + 1.052395 + 1.544934 + 1.515350 + 1.468211 + 1.397979 + 1.305559 + 1.204073 + 1.110903 + 1.038081 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779749E-02 0.000000 -2.7779749E-02 -2.7779749E-02 -2.7779749E-02 0.1614919 0.2420745 + 0.2033644 0.3018206 0.000000 0.3018206 0.3018206 0.3018206 5.7480242E-02 0.2935181 + 1.604785 + 1.591783 + 1.561697 + 1.513014 + 1.441458 + 1.345912 + 1.235980 + 1.133932 + 1.054131 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779693E-02 0.000000 -2.7779693E-02 -2.7779693E-02 -2.7779693E-02 0.1622930 0.2397771 + 0.2118077 0.2990807 0.000000 0.2990807 0.2990807 0.2990807 5.5903699E-02 0.2955703 + 1.052623 + 1.640461 + 1.609539 + 1.560190 + 1.487807 + 1.389239 + 1.271990 + 1.159905 + 1.070368 + 1.003711 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779682E-02 0.000000 -2.7779682E-02 -2.7779682E-02 -2.7779682E-02 0.1590966 0.2411727 + 0.2208355 0.2963221 0.000000 0.2963221 0.2963221 0.2963221 5.3271256E-02 0.2992545 + 1.704706 + 1.689757 + 1.659119 + 1.609045 + 1.535830 + 1.434735 + 1.311200 + 1.186919 + 1.088541 + 1.015269 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779749E-02 0.000000 -2.7779749E-02 -2.7779749E-02 -2.7779749E-02 0.1559388 0.2421853 + 0.2302613 0.2936108 0.000000 0.2936108 0.2936108 0.2936108 5.2443303E-02 0.3003302 + 1.052553 + 1.742123 + 1.710778 + 1.658832 + 1.584386 + 1.482736 + 1.354166 + 1.218167 + 1.107665 + 1.028426 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779670E-02 0.000000 -2.7779670E-02 -2.7779670E-02 -2.7779670E-02 0.1561975 0.2403604 + 0.2400638 0.2909550 0.000000 0.2909550 0.2909550 0.2909550 5.0628293E-02 0.3029599 + 1.812768 + 1.796287 + 1.763406 + 1.711152 + 1.635604 + 1.532790 + 1.399146 + 1.254043 + 1.130552 + 1.043070 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779715E-02 0.000000 -2.7779715E-02 -2.7779715E-02 -2.7779715E-02 0.1539567 0.2411549 + 0.2502497 0.2883549 0.000000 0.2883549 0.2883549 0.2883549 4.8965637E-02 0.3054533 + 1.051413 + 1.852511 + 1.818371 + 1.764642 + 1.689120 + 1.584149 + 1.448207 + 1.291554 + 1.155758 + 1.057969 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779715E-02 0.000000 -2.7779715E-02 -2.7779715E-02 -2.7779715E-02 0.1534560 0.2397726 + 0.2606391 0.2858537 0.000000 0.2858537 0.2858537 0.2858537 4.7338925E-02 0.3079773 + 1.929478 + 1.911789 + 1.876247 + 1.821146 + 1.742373 + 1.637439 + 1.498645 + 1.334917 + 1.183471 + 1.074777 + 1.000404 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779737E-02 0.000000 -2.7779737E-02 -2.7779737E-02 -2.7779737E-02 0.1521119 0.2396525 + 0.2711421 0.2834640 0.000000 0.2834640 0.2834640 0.2834640 4.5838289E-02 0.3103755 + 1.049649 + 1.972812 + 1.936502 + 1.878549 + 1.799056 + 1.691180 + 1.551634 + 1.381119 + 1.214967 + 1.093938 + 1.012990 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779737E-02 0.000000 -2.7779737E-02 -2.7779737E-02 -2.7779737E-02 0.1496409 0.2403194 + 0.2819896 0.2811312 0.000000 0.2811312 0.2811312 0.2811312 4.4207804E-02 0.3130635 + 2.056382 + 2.036441 + 1.997540 + 1.939419 + 1.856870 + 1.746295 + 1.604491 + 1.429392 + 1.250536 + 1.113736 + 1.025636 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779715E-02 0.000000 -2.7779715E-02 -2.7779715E-02 -2.7779715E-02 0.1473142 0.2413612 + 0.2931427 0.2788643 0.000000 0.2788643 0.2788643 0.2788643 4.2757913E-02 0.3155620 + 1.046868 + 2.103029 + 2.063138 + 2.001774 + 1.917133 + 1.804683 + 1.660428 + 1.481389 + 1.288732 + 1.137987 + 1.038191 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779726E-02 0.000000 -2.7779726E-02 -2.7779726E-02 -2.7779726E-02 0.1459283 0.2413976 + 0.3048276 0.2766172 0.000000 0.2766172 0.2766172 0.2766172 4.1333821E-02 0.3180766 + 2.194380 + 2.172366 + 2.131788 + 2.068577 + 1.979621 + 1.863619 + 1.717213 + 1.536967 + 1.332602 + 1.163546 + 1.054158 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779726E-02 0.000000 -2.7779726E-02 -2.7779726E-02 -2.7779726E-02 0.1449744 0.2402842 + 0.3170297 0.2743961 0.000000 0.2743961 0.2743961 0.2743961 3.9855342E-02 0.3207740 + 1.043932 + 2.245564 + 2.201412 + 2.136397 + 2.044926 + 1.926278 + 1.776366 + 1.591757 + 1.378806 + 1.192895 + 1.070302 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779682E-02 0.000000 -2.7779682E-02 -2.7779682E-02 -2.7779682E-02 0.1435041 0.2403236 + 0.3297017 0.2722127 0.000000 0.2722127 0.2722127 0.2722127 3.8385063E-02 0.3235498 + 2.345950 + 2.321754 + 2.276139 + 2.207329 + 2.113041 + 1.989059 + 1.835769 + 1.649141 + 1.429106 + 1.225012 + 1.088848 + 1.003147 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779682E-02 0.000000 -2.7779682E-02 -2.7779682E-02 -2.7779682E-02 0.1425295 0.2400767 + 0.3426020 0.2701081 0.000000 0.2701081 0.2701081 0.2701081 3.6871612E-02 0.3265032 + 1.039897 + 2.400465 + 2.352948 + 2.280794 + 2.182258 + 2.054435 + 1.896188 + 1.706907 + 1.482404 + 1.261041 + 1.107554 + 1.014433 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779737E-02 0.000000 -2.7779737E-02 -2.7779737E-02 -2.7779737E-02 0.1394110 0.2421655 + 0.3554563 0.2681176 0.000000 0.2681176 0.2681176 0.2681176 3.5660919E-02 0.3289476 + 2.511281 + 2.482831 + 2.433754 + 2.358552 + 2.255950 + 2.123093 + 1.960562 + 1.766236 + 1.538080 + 1.300838 + 1.129603 + 1.027156 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779760E-02 0.000000 -2.7779760E-02 -2.7779760E-02 -2.7779760E-02 0.1389882 0.2410575 + 0.3683650 0.2662170 0.000000 0.2662170 0.2662170 0.2662170 3.4461915E-02 0.3314341 + 1.034849 + 2.570656 + 2.518416 + 2.440771 + 2.333143 + 2.196087 + 2.026263 + 1.827314 + 1.596576 + 1.345847 + 1.155662 + 1.041584 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779704E-02 0.000000 -2.7779704E-02 -2.7779704E-02 -2.7779704E-02 0.1387029 0.2398284 + 0.3810252 0.2644416 0.000000 0.2644416 0.2644416 0.2644416 3.3397153E-02 0.3337014 + 2.691191 + 2.661689 + 2.606626 + 2.525218 + 2.412567 + 2.269395 + 2.094247 + 1.888885 + 1.654999 + 1.395143 + 1.182523 + 1.055668 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779682E-02 0.000000 -2.7779682E-02 -2.7779682E-02 -2.7779682E-02 0.1364772 0.2411402 + 0.3938823 0.2627247 0.000000 0.2627247 0.2627247 0.2627247 3.2455735E-02 0.3357578 + 1.029852 + 2.757035 + 2.699156 + 2.613304 + 2.496414 + 2.347004 + 2.164632 + 1.953491 + 1.713877 + 1.447872 + 1.213850 + 1.071849 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779749E-02 0.000000 -2.7779749E-02 -2.7779749E-02 -2.7779749E-02 0.1345966 0.2415658 + 0.4068413 0.2610734 0.000000 0.2610734 0.2610734 0.2610734 3.1700775E-02 0.3374284 + 2.890414 + 2.856201 + 2.796047 + 2.706522 + 2.584488 + 2.428428 + 2.238255 + 2.018931 + 1.775791 + 1.502357 + 1.248610 + 1.090742 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779715E-02 0.000000 -2.7779715E-02 -2.7779715E-02 -2.7779715E-02 0.1339426 0.2410763 + 0.4197326 0.2595043 0.000000 0.2595043 0.2595043 0.2595043 3.1049317E-02 0.3388936 + 1.024175 + 2.959412 + 2.897245 + 2.803970 + 2.676595 + 2.513516 + 2.315029 + 2.088650 + 1.837946 + 1.560698 + 1.287956 + 1.109932 + 1.010765 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779715E-02 0.000000 -2.7779715E-02 -2.7779715E-02 -2.7779715E-02 0.1322892 0.2414597 + 0.4326290 0.2580032 0.000000 0.2580032 0.2580032 0.2580032 3.0578479E-02 0.3399530 + 3.104657 + 3.068279 + 3.003370 + 2.906782 + 2.774424 + 2.602932 + 2.396934 + 2.160803 + 1.903083 + 1.621169 + 1.331074 + 1.132727 + 1.022984 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779726E-02 0.000000 -2.7779726E-02 -2.7779726E-02 -2.7779726E-02 0.1324869 0.2396306 + 0.4451146 0.2566080 0.000000 0.2566080 0.2566080 0.2566080 2.9985398E-02 0.3413297 + 1.018360 + 3.203980 + 3.133518 + 3.028881 + 2.883919 + 2.701150 + 2.482294 + 2.234986 + 1.967325 + 1.681523 + 1.379919 + 1.158097 + 1.034750 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779682E-02 0.000000 -2.7779682E-02 -2.7779682E-02 -2.7779682E-02 0.1309872 0.2402328 + 0.4573699 0.2552922 0.000000 0.2552922 0.2552922 0.2552922 2.9461347E-02 0.3425715 + 3.367956 + 3.325843 + 3.252097 + 3.141941 + 2.991269 + 2.798239 + 2.568475 + 2.311656 + 2.035079 + 1.741466 + 1.431274 + 1.185780 + 1.050140 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779726E-02 0.000000 -2.7779726E-02 -2.7779726E-02 -2.7779726E-02 0.1284199 0.2420546 + 0.4693037 0.2540586 0.000000 0.2540586 0.2540586 0.2540586 2.8949467E-02 0.3438124 + 1.013491 + 3.452017 + 3.376021 + 3.260923 + 3.105124 + 2.902302 + 2.662207 + 2.391616 + 2.104661 + 1.805473 + 1.486507 + 1.217361 + 1.013491 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779760E-02 0.000000 -2.7779760E-02 -2.7779760E-02 -2.7779760E-02 0.1267365 0.2424538 + 0.4804631 0.2529420 0.000000 0.2529420 0.2529420 0.2529420 2.8447781E-02 0.3450555 + 3.630179 + 3.584201 + 3.505095 + 3.386178 + 3.223314 + 3.011720 + 2.758194 + 2.476204 + 2.177365 + 1.869716 + 1.545608 + 1.252365 + 1.083426 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779704E-02 0.000000 -2.7779704E-02 -2.7779704E-02 -2.7779704E-02 0.1256264 0.2424143 + 0.4920555 0.2518244 0.000000 0.2518244 0.2518244 0.2518244 2.7967192E-02 0.3462721 + 1.009335 + 3.719848 + 3.639276 + 3.517122 + 3.348659 + 3.127571 + 2.861545 + 2.566230 + 2.254143 + 1.934833 + 1.605911 + 1.291173 + 1.009335 + 0.9999624 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779682E-02 0.000000 -2.7779682E-02 -2.7779682E-02 -2.7779682E-02 0.1256499 0.2411283 + 0.5038850 0.2507253 0.000000 0.2507253 0.2507253 0.2507253 2.7491681E-02 0.3475028 + 3.912750 + 3.861857 + 3.777982 + 3.654480 + 3.478315 + 3.247796 + 2.969084 + 2.658631 + 2.333449 + 2.003760 + 1.667719 + 1.336629 + 1.123138 + 1.011413 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779715E-02 0.000000 -2.7779715E-02 -2.7779715E-02 -2.7779715E-02 0.1244249 0.2412631 + 0.5161387 0.2496283 0.000000 0.2496283 0.2496283 0.2496283 2.7058262E-02 0.3486371 + 1.005534 + 4.007903 + 1.005534 + 3.794571 + 3.613898 + 3.372761 + 3.081042 + 2.754902 + 2.414593 + 2.072548 + 1.730117 + 1.383914 + 1.005534 + 1.019614 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779726E-02 0.000000 -2.7779726E-02 -2.7779726E-02 -2.7779726E-02 0.1231385 0.2418158 + 0.5286635 0.2485474 0.000000 0.2485474 0.2485474 0.2485474 2.6648540E-02 0.3497432 + 4.212619 + 4.157897 + 4.070745 + 3.939884 + 3.754115 + 3.506312 + 3.200985 + 2.857111 + 2.501372 + 2.145731 + 1.793556 + 1.438501 + 1.173497 + 1.036510 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779693E-02 0.000000 -2.7779693E-02 -2.7779693E-02 -2.7779693E-02 0.1222890 0.2412635 + 0.5417243 0.2474614 0.000000 0.2474614 0.2474614 0.2474614 2.6165104E-02 0.3510757 + 1.001662 + 4.313301 + 1.001662 + 4.089523 + 3.899362 + 3.643380 + 3.324227 + 2.965362 + 2.590405 + 2.219722 + 1.859771 + 1.494549 + 1.201722 + 1.001662 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779715E-02 0.000000 -2.7779715E-02 -2.7779715E-02 -2.7779715E-02 0.1204354 0.2422676 + 0.5550005 0.2463971 0.000000 0.2463971 0.2463971 0.2463971 2.5901612E-02 0.3517979 + 4.531860 + 0.8333527 + 4.382752 + 4.245161 + 4.052232 + 3.789886 + 3.457674 + 3.079138 + 2.685392 + 2.298452 + 1.925449 + 1.554356 + 1.235031 + 0.8333527 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779726E-02 0.000000 -2.7779726E-02 -2.7779726E-02 -2.7779726E-02 0.1203202 0.2410141 + 0.5686196 0.2453441 0.000000 0.2453441 0.2453441 0.2453441 2.5432203E-02 0.3531409 + 4.699411 + 0.8309810 + 4.544677 + 4.406150 + 4.208659 + 3.937600 + 3.593795 + 3.196044 + 2.783456 + 2.378466 + 1.992461 + 1.615006 + 1.273244 + 0.8309810 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779726E-02 0.000000 -2.7779726E-02 -2.7779726E-02 -2.7779726E-02 0.1196782 0.2407868 + 0.5828431 0.2442843 0.000000 0.2442843 0.2442843 0.2442843 2.5200609E-02 0.3538008 + 4.870320 + 0.8287345 + 4.713171 + 4.570323 + 4.368590 + 4.091722 + 3.737384 + 3.322448 + 2.886731 + 2.462642 + 2.062417 + 1.678955 + 1.314865 + 0.8287345 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779704E-02 0.000000 -2.7779704E-02 -2.7779704E-02 -2.7779704E-02 0.1183159 0.2411345 + 0.5973189 0.2432441 0.000000 0.2432441 0.2432441 0.2432441 2.4860900E-02 0.3547980 + 5.045536 + 0.8251104 + 4.885365 + 4.741973 + 4.535168 + 4.254698 + 3.888755 + 3.454773 + 2.996351 + 2.552244 + 2.136361 + 1.741878 + 1.362069 + 0.8251104 + 1.005944 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779737E-02 0.000000 -2.7779737E-02 -2.7779737E-02 -2.7779737E-02 0.1179734 0.2400648 + 0.6124676 0.2421954 0.000000 0.2421954 0.2421954 0.2421954 2.4528252E-02 0.3557947 + 5.226617 + 0.8233734 + 5.061545 + 4.915300 + 4.706938 + 4.419030 + 4.044227 + 3.592310 + 3.111573 + 2.644372 + 2.210211 + 1.807157 + 1.413760 + 1.146856 + 0.8233734 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859032 -2.7779682E-02 0.000000 -2.7779682E-02 -2.7779682E-02 -2.7779682E-02 0.1169346 0.2401365 + 0.6281755 0.2411477 0.000000 0.2411477 0.2411477 0.2411477 2.4202207E-02 0.3567905 + 5.409703 + 0.8199569 + 5.241335 + 5.095042 + 4.881769 + 4.587982 + 4.204620 + 3.736836 + 3.231181 + 2.740878 + 2.288593 + 1.873224 + 1.469309 + 1.173841 + 0.8199569 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779726E-02 0.000000 -2.7779726E-02 -2.7779726E-02 -2.7779726E-02 0.1162614 0.2397409 + 0.6444854 0.2400997 0.000000 0.2400997 0.2400997 0.2400997 2.4091102E-02 0.3570750 + 5.598728 + 0.8185732 + 5.425717 + 5.276685 + 5.061291 + 4.760935 + 4.367507 + 3.885482 + 3.357479 + 2.840340 + 2.369338 + 1.938937 + 1.528195 + 1.203848 + 0.8185732 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779704E-02 0.000000 -2.7779704E-02 -2.7779704E-02 -2.7779704E-02 0.1146930 0.2408646 + 0.6612033 0.2390645 0.000000 0.2390645 0.2390645 0.2390645 2.3570878E-02 0.3587733 + 5.789510 + 0.8170255 + 5.613696 + 5.463000 + 5.246389 + 4.940289 + 4.536997 + 4.042634 + 3.489375 + 2.945291 + 2.452099 + 2.006788 + 1.588332 + 1.236770 + 0.8170255 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779737E-02 0.000000 -2.7779737E-02 -2.7779737E-02 -2.7779737E-02 0.1138605 0.2408614 + 0.6787638 0.2380175 0.000000 0.2380175 0.2380175 0.2380175 2.3158921E-02 0.3601146 + 5.984653 + 5.910878 + 5.807185 + 5.654213 + 5.435431 + 5.125011 + 4.713583 + 4.205241 + 3.629866 + 3.056557 + 2.539525 + 2.077869 + 1.651972 + 1.273766 + 0.8151861 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779726E-02 0.000000 -2.7779726E-02 -2.7779726E-02 -2.7779726E-02 0.1123936 0.2415672 + 0.6971943 0.2369599 0.000000 0.2369599 0.2369599 0.2369599 2.2960138E-02 0.3607639 + 6.184657 + 6.109631 + 6.001404 + 5.848313 + 5.625918 + 5.312241 + 4.890813 + 4.369726 + 3.772868 + 3.173998 + 2.629755 + 2.149952 + 1.714680 + 1.316347 + 0.8129618 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779715E-02 0.000000 -2.7779715E-02 -2.7779715E-02 -2.7779715E-02 0.1113147 0.2421708 + 0.7160764 0.2359167 0.000000 0.2359167 0.2359167 0.2359167 2.2648269E-02 0.3618103 + 6.390119 + 6.312205 + 6.203206 + 6.045745 + 5.824049 + 5.506789 + 5.078420 + 4.543221 + 3.927834 + 3.297354 + 2.725598 + 2.225235 + 1.777896 + 1.363356 + 0.8101814 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779737E-02 0.000000 -2.7779737E-02 -2.7779737E-02 -2.7779737E-02 0.1106290 0.2418278 + 0.7358075 0.2348674 0.000000 0.2348674 0.2348674 0.2348674 2.2359261E-02 0.3628047 + 6.601819 + 6.521196 + 6.407437 + 6.249462 + 6.021974 + 5.702157 + 5.267513 + 4.720917 + 4.085885 + 3.425275 + 2.825031 + 2.301860 + 1.844010 + 1.414772 + 1.136374 + 1.006986 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 1.000000 + 0.4859033 -2.7779737E-02 0.000000 -2.7779737E-02 -2.7779737E-02 -2.7779737E-02 0.1093545 0.2425040 + 0.7561991 0.2338238 0.000000 0.2338238 0.2338238 0.2338238 2.2029573E-02 0.3639462 diff --git a/modules/epos/epos.initl b/modules/epos/epos.initl new file mode 100644 index 0000000000000000000000000000000000000000..accce69a45cef3110829afcf344fe7b80bc7cd23 --- /dev/null +++ b/modules/epos/epos.initl @@ -0,0 +1,2 @@ + 3.9999999E-02 4.000000 0.2500000 3 1.0000000E+12 0.000000 + 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 -0.7894697 -0.8068819 -0.8210787 -0.8316811 -0.8382481 -0.8402750 -0.8371778 -0.8282939 -0.8128786 -0.7900795 -0.7589342 -0.7183751 -0.6672036 -0.6040560 -0.5273275 -0.4349932 -0.3241501 -0.1898437 -1.9940035E-02 0.3118532 -0.9503295 -1.020126 -1.086543 -1.149407 -1.208462 -1.263360 -1.313559 -1.358343 -1.396682 -1.427201 -1.448004 -1.456412 -1.448624 -1.419625 -1.362642 -1.268845 -1.127033 -0.9231534 -0.6344284 -7.9957083E-02 -0.9797196 -1.091104 -1.197168 -1.298094 -1.393965 -1.484754 -1.570264 -1.650341 -1.724442 -1.791813 -1.851301 -1.900776 -1.937214 -1.955264 -1.946096 -1.894941 -1.777415 -1.556768 -1.179904 -0.4074402 -0.9870713 -1.136852 -1.278119 -1.411560 -1.537586 -1.656562 -1.768793 -1.874396 -1.973358 -2.065409 -2.149886 -2.225665 -2.290524 -2.340753 -2.369077 -2.361607 -2.289416 -2.094330 -1.670919 -0.6887694 -0.9890559 -1.175785 -1.349801 -1.512488 -1.664686 -1.807390 -1.941392 -2.067134 -2.185125 -2.295527 -2.398031 -2.492114 -2.576363 -2.647939 -2.701548 -2.725904 -2.694976 -2.543505 -2.113196 -0.9353619 -0.9897087 -1.212401 -1.417478 -1.606918 -1.782512 -1.945786 -2.098031 -2.240380 -2.373630 -2.498332 -2.614704 -2.722485 -2.820873 -2.907868 -2.979275 -3.026058 -3.026462 -2.918771 -2.510231 -1.154860 -0.9897208 -1.247878 -1.482715 -1.696939 -1.893676 -2.075057 -2.243171 -2.399471 -2.545285 -2.681542 -2.808833 -2.927330 -3.036613 -3.135261 -3.219957 -3.283277 -3.306933 -3.236230 -2.865481 -1.352634 -0.9903132 -1.283017 -1.545822 -1.783612 -1.999426 -2.197129 -2.378939 -2.547258 -2.703706 -2.849534 -2.985717 -3.112783 -3.230664 -3.338417 -3.433433 -3.509478 -3.550888 -3.509741 -3.182739 -1.532598 -0.9897352 -1.318240 -1.609421 -1.865837 -2.100240 -2.312652 -2.506924 -2.685704 -2.851154 -3.005117 -3.148724 -3.282784 -3.407591 -3.522615 -3.625828 -3.711971 -3.767392 -3.749785 -3.466269 -1.697697 -0.9811710 -1.358195 -1.664667 -1.948754 -2.196973 -2.422718 -2.627460 -2.815752 -2.989441 -3.150282 -3.300156 -3.440065 -3.570575 -3.691487 -3.801307 -3.895607 -3.962385 -3.963829 -3.720427 -1.850200 -0.9506864 -1.394296 -1.735710 -2.030454 -2.289224 -2.526435 -2.743318 -2.938828 -3.119313 -3.286537 -3.441727 -3.586591 -3.721848 -3.847635 -3.962850 -4.063826 -4.139966 -4.157156 -3.949425 -1.991894 -1.280635 -1.215578 -1.816657 -2.103930 -2.389331 -2.628609 -2.850310 -3.054409 -3.241865 -3.414644 -3.574811 -3.723872 -3.863186 -3.993007 -4.112682 -4.219183 -4.303139 -4.333552 -4.157030 -2.124210 -1.648908 -1.658276 -1.783319 -2.167517 -2.466150 -2.723656 -2.958317 -3.167003 -3.359269 -3.536114 -3.700218 -3.853145 -3.995877 -4.129122 -4.252512 -4.363607 -4.454147 -4.495850 -4.346478 -2.248313 -1.682908 -2.173363 -2.435091 -2.104181 -2.587832 -2.800969 -3.049778 -3.268654 -3.469518 -3.651115 -3.818949 -3.975141 -4.120980 -4.257151 -4.383678 -4.498630 -4.594765 -4.646176 -4.520495 -2.365163 -1.682991 -2.207795 -2.640384 -2.968219 -2.613077 -2.877742 -3.181777 -3.367757 -3.576732 -3.760308 -3.931598 -4.090977 -4.239378 -4.378063 -4.507245 -4.625457 -4.726354 -4.786216 -4.681335 -2.475562 -1.682991 -2.239180 -2.692764 -3.072466 -3.374373 -2.989660 -3.277075 -3.457026 -3.664643 -3.864074 -4.040409 -4.200922 -4.351858 -4.492660 -4.624138 -4.745095 -4.850068 -4.917308 -4.830818 -2.580184 -1.682991 -2.270175 -2.743783 -3.137280 -3.472731 -3.745047 -3.283850 -3.546687 -3.775925 -3.960166 -4.143385 -4.306189 -4.458724 -4.601600 -4.735012 -4.858355 -4.966830 -5.040541 -4.970430 -2.679603 -1.682991 -2.300782 -2.793735 -3.200202 -3.544953 -3.843989 -4.066838 -3.419043 -3.852239 -4.075974 -4.237446 -4.404510 -4.561140 -4.705365 -4.840510 -4.965884 -5.077404 -5.156834 -5.101406 -2.774314 -1.682991 -2.331018 -2.842634 -3.261418 -3.614928 -3.920486 -4.184509 -3.700093 -3.953867 -4.173688 -4.333740 -4.501205 -4.658532 -4.804611 -4.941198 -5.068314 -5.182441 -5.266946 -5.224759 -2.864743 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -1.433705 -1.451334 -1.466283 -1.478281 -1.487018 -1.492143 -1.493251 -1.489890 -1.481540 -1.467615 -1.447446 -1.420266 -1.385179 -1.341112 -1.286721 -1.220193 -1.138771 -1.037555 -0.9043760 -0.6128114 -1.586878 -1.653000 -1.715932 -1.775502 -1.831461 -1.883466 -1.931056 -1.973599 -2.010213 -2.039770 -2.060773 -2.071186 -2.068248 -2.048469 -2.007265 -1.938696 -1.834952 -1.685158 -1.468639 -1.004622 -1.616891 -1.722862 -1.823881 -1.920068 -2.011484 -2.098099 -2.179705 -2.256123 -2.326818 -2.391055 -2.447712 -2.494846 -2.529731 -2.547835 -2.542152 -2.501813 -2.410122 -2.242660 -1.960628 -1.332105 -1.624495 -1.767198 -1.902038 -2.029554 -2.150167 -2.264184 -2.371865 -2.473288 -2.568386 -2.656867 -2.738045 -2.810782 -2.872925 -2.920899 -2.948036 -2.942332 -2.881152 -2.723808 -2.400102 -1.613434 -1.626571 -1.804562 -1.970842 -2.126561 -2.272564 -2.409737 -2.538759 -2.660032 -2.773968 -2.880651 -2.979766 -3.070706 -3.152053 -3.221021 -3.272425 -3.295589 -3.267459 -3.136941 -2.796276 -1.860027 -1.627149 -1.839588 -2.035660 -2.217248 -2.386000 -2.543320 -2.690325 -2.828027 -2.957136 -3.078117 -3.191108 -3.295805 -3.391330 -3.475670 -3.544681 -3.589546 -3.589638 -3.491484 -3.154631 -2.079525 -1.627310 -1.873610 -2.098152 -2.303829 -2.493156 -2.668257 -2.830890 -2.982484 -3.124161 -3.256747 -3.380749 -3.496254 -3.602775 -3.698835 -3.781122 -3.842324 -3.864673 -3.797519 -3.479213 -2.277299 -1.627355 -1.907021 -2.158856 -2.387072 -2.595238 -2.786301 -2.962654 -3.126223 -3.278538 -3.420779 -3.553778 -3.677965 -3.793209 -3.898490 -3.991153 -4.065019 -4.104763 -4.064480 -3.773360 -2.457263 -1.627368 -1.939948 -2.218003 -2.467386 -2.692904 -2.898418 -3.086951 -3.260991 -3.422477 -3.572915 -3.713430 -3.844734 -3.967030 -4.079710 -4.180670 -4.264643 -4.318217 -4.300323 -4.040199 -2.622362 -1.627372 -1.972437 -2.275734 -2.545061 -2.786550 -3.005174 -3.204693 -3.388009 -3.557516 -3.715028 -3.861917 -3.999183 -4.127299 -4.245996 -4.353682 -4.445872 -4.510702 -4.511307 -4.282684 -2.774865 -1.627373 -2.004508 -2.332124 -2.620160 -2.876554 -3.107152 -3.316547 -3.508185 -3.684797 -3.848495 -4.000904 -4.143229 -4.276200 -4.399871 -4.513072 -4.612029 -4.686182 -4.702188 -4.503658 -2.916559 -1.627373 -2.036172 -2.387163 -2.692960 -2.963115 -3.204768 -3.423119 -3.622256 -3.805220 -3.974390 -4.131629 -4.278318 -4.415407 -4.543222 -4.660998 -4.765578 -4.847560 -4.876542 -4.705747 -3.048875 -1.627373 -2.067439 -2.440961 -2.763527 -3.046567 -3.298315 -3.524896 -3.730821 -3.919502 -4.093568 -4.255071 -4.405578 -4.546204 -4.677526 -4.799116 -4.908401 -4.997015 -5.037093 -4.891331 -3.172978 -1.627373 -2.098317 -2.493583 -2.831996 -3.127022 -3.388169 -3.622285 -3.834393 -4.028255 -4.206728 -4.372036 -4.525905 -4.669620 -4.803931 -4.928745 -5.041986 -5.136263 -5.185915 -5.062533 -3.289828 -1.627373 -2.128814 -2.545071 -2.898524 -3.204775 -3.474606 -3.715647 -3.933418 -4.131985 -4.314451 -4.483188 -4.640057 -4.786479 -4.923378 -5.050925 -5.167514 -5.266635 -5.324647 -5.221210 -3.400226 -1.627373 -2.158908 -2.595396 -2.963119 -3.279909 -3.557832 -3.805293 -4.028269 -4.231150 -4.417236 -4.589075 -4.748643 -4.897467 -5.036629 -5.166525 -5.285959 -5.389248 -5.454594 -5.368939 -3.504848 -1.627373 -2.188643 -2.644680 -3.025983 -3.352667 -3.638114 -3.891510 -4.119288 -4.326124 -4.515525 -4.690181 -4.852188 -5.003167 -5.144331 -5.276247 -5.398117 -5.505001 -5.576817 -5.507067 -3.604268 -1.627373 -2.218020 -2.692962 -3.087146 -3.423136 -3.715649 -3.974553 -4.206770 -4.417247 -4.609690 -4.786913 -4.951137 -5.104069 -5.247009 -5.380692 -5.504653 -5.614652 -5.692207 -5.636741 -3.698979 -1.627373 -2.247051 -2.740258 -3.146706 -3.491493 -3.790593 -4.054648 -4.290977 -4.504818 -4.700064 -4.879652 -5.045895 -5.200591 -5.345121 -5.480374 -5.606136 -5.718835 -5.801501 -5.758926 -3.789407 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -1.803804 -1.809938 -1.813681 -1.814886 -1.813394 -1.809021 -1.801564 -1.790787 -1.776410 -1.758119 -1.735551 -1.708249 -1.675640 -1.636977 -1.591235 -1.536900 -1.471483 -1.390301 -1.281344 -1.018276 -2.101460 -2.152275 -2.198981 -2.241327 -2.278986 -2.311566 -2.338648 -2.359683 -2.373986 -2.380774 -2.379114 -2.367835 -2.345457 -2.310222 -2.259840 -2.191216 -2.099801 -1.977955 -1.807762 -1.410087 -2.188770 -2.282085 -2.369890 -2.452048 -2.528377 -2.598593 -2.662183 -2.718628 -2.767075 -2.806480 -2.835490 -2.852223 -2.854362 -2.838691 -2.800961 -2.735384 -2.633700 -2.483282 -2.258635 -1.737570 -2.213684 -2.344275 -2.467201 -2.582717 -2.691041 -2.792153 -2.885922 -2.971961 -3.049629 -3.117958 -3.175501 -3.220270 -3.249366 -3.258761 -3.242512 -3.191995 -3.094115 -2.928556 -2.658195 -2.018899 -2.220715 -2.385455 -2.539366 -2.683376 -2.818129 -2.944206 -3.061909 -3.171213 -3.271898 -3.363295 -3.444166 -3.512654 -3.565866 -3.599384 -3.606511 -3.576606 -3.492250 -3.324096 -3.018611 -2.265492 -2.222690 -2.420000 -2.602440 -2.771704 -2.929197 -3.076038 -3.213027 -3.340735 -3.459348 -3.568635 -3.667804 -3.755281 -3.828434 -3.882948 -3.911849 -3.903540 -3.837706 -3.676732 -3.347194 -2.484990 -2.223243 -2.452275 -2.661651 -2.854049 -3.031689 -3.196368 -3.349503 -3.492144 -3.624965 -3.748207 -3.861560 -3.963937 -4.053117 -4.125113 -4.173069 -4.185092 -4.139322 -3.991973 -3.648846 -2.682764 -2.223399 -2.483581 -2.718689 -2.932623 -3.128550 -3.309016 -3.476040 -3.631182 -3.775582 -3.909935 -4.034405 -4.148421 -4.250291 -4.336540 -4.400703 -4.430980 -4.404878 -4.274693 -3.927048 -2.862728 -2.223443 -2.514323 -2.774153 -3.008309 -3.221048 -3.415732 -3.594974 -3.760865 -3.914977 -4.058414 -4.191768 -4.314947 -4.426827 -4.524561 -4.602280 -4.648580 -4.640867 -4.529295 -4.184476 -3.027827 -2.223454 -2.544637 -2.828291 -3.081525 -3.309790 -3.517392 -3.707595 -3.882923 -4.045383 -4.196443 -4.337055 -4.467573 -4.587397 -4.694329 -4.783252 -4.843421 -4.852516 -4.759699 -4.423271 -3.180330 -2.223458 -2.574566 -2.881204 -3.152421 -3.395184 -3.614616 -3.814701 -3.998453 -4.168235 -4.325836 -4.472534 -4.609035 -4.735219 -4.849526 -4.947640 -5.019690 -5.043951 -4.969317 -4.645263 -3.322024 -2.223459 -2.604129 -2.932914 -3.221225 -3.477458 -3.707824 -3.916898 -4.108237 -4.284529 -4.447848 -4.599753 -4.741240 -4.872593 -4.992832 -5.098459 -5.180604 -5.218437 -5.161057 -4.852033 -3.454340 -2.223459 -2.633334 -2.983510 -3.288019 -3.556887 -3.797314 -4.014646 -4.212867 -4.395008 -4.563403 -4.719836 -4.865563 -5.001191 -5.126247 -5.237999 -5.328666 -5.378560 -5.337379 -5.044988 -3.578443 -2.223459 -2.662191 -3.033046 -3.352924 -3.633607 -3.883402 -4.108325 -4.312825 -4.500264 -4.673211 -4.833646 -4.983036 -5.122265 -5.251271 -5.368037 -5.465860 -5.526411 -5.500320 -5.225410 -3.695293 -2.223459 -2.690706 -3.081559 -3.416059 -3.707843 -3.966338 -4.198262 -4.408525 -4.600783 -4.777844 -4.941859 -5.094468 -5.236773 -5.369066 -5.489946 -5.593761 -5.663669 -5.651591 -5.394463 -3.805691 -2.223459 -2.718862 -3.129045 -3.477467 -3.779703 -4.046321 -4.284741 -4.500309 -4.696986 -4.877783 -5.045026 -5.200498 -5.345476 -5.480541 -5.604823 -5.713648 -5.791735 -5.792610 -5.553198 -3.910313 -2.223459 -2.746696 -3.175592 -3.537289 -3.849369 -4.123570 -4.368019 -4.588488 -4.789225 -4.973442 -5.143613 -5.301654 -5.448988 -5.586430 -5.713539 -5.826555 -5.911761 -5.924572 -5.702566 -4.009733 -2.223459 -2.774209 -3.221230 -3.595570 -3.916942 -4.198266 -4.448323 -4.673333 -4.877813 -5.065171 -5.238011 -5.398380 -5.547817 -5.687315 -5.816806 -5.933329 -6.024716 -6.048497 -5.843436 -4.104444 -2.223459 -2.801412 -3.265979 -3.652393 -3.982561 -4.270556 -4.525858 -4.755085 -4.963028 -5.153281 -5.328576 -5.491063 -5.642387 -5.783689 -5.915214 -6.034677 -6.131410 -6.165246 -5.976576 -4.194872 -0.5900738 -0.5887440 -0.5874081 -0.5860665 -0.5847188 -0.5833645 -0.5820047 -0.5806392 -0.5792672 -0.5778888 -0.5765051 -0.5751143 -0.5737172 -0.5723140 -0.5709034 -0.5694872 -0.5680640 -0.5666346 -0.5651984 -0.5637552 -1.467401 -1.490422 -1.510853 -1.528426 -1.542833 -1.553717 -1.560666 -1.563204 -1.560785 -1.552786 -1.538488 -1.517069 -1.487576 -1.448894 -1.399666 -1.338161 -1.262043 -1.167554 -1.047173 -0.8765848 -1.592416 -1.662673 -1.729648 -1.793201 -1.853113 -1.909080 -1.960672 -2.007309 -2.048128 -2.082081 -2.107685 -2.122881 -2.124903 -2.110140 -2.073739 -2.009279 -1.908483 -1.759818 -1.542826 -1.155581 -1.618154 -1.727746 -1.832154 -1.931533 -2.025973 -2.115471 -2.199872 -2.279032 -2.352424 -2.419420 -2.478891 -2.529046 -2.567204 -2.588842 -2.587049 -2.550627 -2.462294 -2.296116 -2.011165 -1.420779 -1.624816 -1.770793 -1.908591 -2.038799 -2.161870 -2.278167 -2.387958 -2.491394 -2.588402 -2.678776 -2.761816 -2.836497 -2.900687 -2.950936 -2.980721 -2.978075 -2.920231 -2.765214 -2.439683 -1.668270 -1.626654 -1.807628 -1.976522 -2.134541 -2.282596 -2.421594 -2.552271 -2.675088 -2.790443 -2.898478 -2.998938 -3.091201 -3.173922 -3.244422 -3.297556 -3.322865 -3.297457 -3.169722 -2.828856 -1.896005 -1.627170 -1.842331 -2.040720 -2.224291 -2.394756 -2.553570 -2.701917 -2.840803 -2.970999 -3.092986 -3.206945 -3.312618 -3.409118 -3.494502 -3.564706 -3.611051 -3.613145 -3.517600 -3.181833 -2.104543 -1.627316 -1.876090 -2.102684 -2.310073 -2.500845 -2.677180 -2.840883 -2.993418 -3.135939 -3.269295 -3.394017 -3.510226 -3.617458 -3.714271 -3.797413 -3.859657 -3.883436 -3.818423 -3.501913 -2.295615 -1.627357 -1.909259 -2.162898 -2.392586 -2.601967 -2.794051 -2.971275 -3.135595 -3.288571 -3.431409 -3.564961 -3.689672 -3.805439 -3.911269 -4.004549 -4.079168 -4.119946 -4.081314 -3.792218 -2.471236 -1.627369 -1.941956 -2.221588 -2.472229 -2.698772 -2.905118 -3.094359 -3.269005 -3.431016 -3.581920 -3.722849 -3.854549 -3.977238 -4.090324 -4.191740 -4.276262 -4.330595 -4.313942 -4.055766 -2.633317 -1.627372 -1.974221 -2.278886 -2.549274 -2.791617 -3.010934 -3.211018 -3.394820 -3.564748 -3.722620 -3.869833 -4.007401 -4.135808 -4.254806 -4.362826 -4.455421 -4.520815 -4.522346 -4.295441 -2.783617 -1.627373 -2.006073 -2.334861 -2.623789 -2.880888 -3.112046 -3.321906 -3.513925 -3.690871 -3.854848 -4.007510 -4.150066 -4.283255 -4.407146 -4.520597 -4.619849 -4.694418 -4.711118 -4.514006 -2.923614 -1.627373 -2.037524 -2.389501 -2.696041 -2.966766 -3.208868 -3.427593 -3.627032 -3.810256 -3.979645 -4.137078 -4.283943 -4.421195 -4.549176 -4.667128 -4.771926 -4.854217 -4.883712 -4.714046 -3.054372 -1.627373 -2.068583 -2.442922 -2.766086 -3.049585 -3.301691 -3.528560 -3.734720 -3.923606 -4.097841 -4.259492 -4.410130 -4.550882 -4.682320 -4.804039 -4.913477 -5.002317 -5.042769 -4.897882 -3.177408 -1.627373 -2.099259 -2.495181 -2.834068 -3.129449 -3.390871 -3.625210 -3.837501 -4.031513 -4.210114 -4.375534 -4.529503 -4.673301 -4.807697 -4.932600 -5.045951 -5.140387 -5.190319 -5.067582 -3.293311 -1.627373 -2.129558 -2.546320 -2.900133 -3.206650 -3.476687 -3.717893 -3.935796 -4.134476 -4.317032 -4.485847 -4.642792 -4.789268 -4.926230 -5.053840 -5.170504 -5.269742 -5.327940 -5.224964 -3.402863 -1.627373 -2.159460 -2.596313 -2.964293 -3.281271 -3.559339 -3.806912 -4.029981 -4.232935 -4.419086 -4.590979 -4.750594 -4.899459 -5.038666 -5.168592 -5.288079 -5.391436 -5.456914 -5.371569 -3.506726 -1.627373 -2.189006 -2.645279 -3.026744 -3.353546 -3.639083 -3.892545 -4.120382 -4.327264 -4.516705 -4.691397 -4.853430 -5.004435 -5.145614 -5.277563 -5.399454 -5.506380 -5.578283 -5.508705 -3.605459 -1.627373 -2.218199 -2.693254 -3.087517 -3.423561 -3.716115 -3.975055 -4.207297 -4.417794 -4.610257 -4.787501 -4.951731 -5.104671 -5.247615 -5.381316 -5.505294 -5.615305 -5.692902 -5.637512 -3.699547 -1.627373 -2.247051 -2.740258 -3.146706 -3.491493 -3.790593 -4.054648 -4.290977 -4.504818 -4.700064 -4.879652 -5.045895 -5.200591 -5.345121 -5.480374 -5.606136 -5.718835 -5.801501 -5.758926 -3.789407 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -1.433705 -1.451334 -1.466283 -1.478281 -1.487018 -1.492143 -1.493251 -1.489890 -1.481540 -1.467615 -1.447446 -1.420266 -1.385179 -1.341112 -1.286721 -1.220193 -1.138771 -1.037555 -0.9043760 -0.6128114 -1.586878 -1.653000 -1.715932 -1.775502 -1.831461 -1.883466 -1.931056 -1.973599 -2.010213 -2.039770 -2.060773 -2.071186 -2.068248 -2.048469 -2.007265 -1.938696 -1.834952 -1.685158 -1.468639 -1.004622 -1.616891 -1.722862 -1.823881 -1.920068 -2.011484 -2.098099 -2.179705 -2.256123 -2.326818 -2.391055 -2.447712 -2.494846 -2.529731 -2.547835 -2.542152 -2.501813 -2.410122 -2.242660 -1.960628 -1.332105 -1.624495 -1.767198 -1.902038 -2.029554 -2.150167 -2.264184 -2.371865 -2.473288 -2.568386 -2.656867 -2.738045 -2.810782 -2.872925 -2.920899 -2.948036 -2.942332 -2.881152 -2.723808 -2.400102 -1.613434 -1.626571 -1.804562 -1.970842 -2.126561 -2.272564 -2.409737 -2.538759 -2.660032 -2.773968 -2.880651 -2.979766 -3.070706 -3.152053 -3.221021 -3.272425 -3.295589 -3.267459 -3.136941 -2.796276 -1.860027 -1.627149 -1.839588 -2.035660 -2.217248 -2.386000 -2.543320 -2.690325 -2.828027 -2.957136 -3.078117 -3.191108 -3.295805 -3.391330 -3.475670 -3.544681 -3.589546 -3.589638 -3.491484 -3.154631 -2.079525 -1.627310 -1.873610 -2.098152 -2.303829 -2.493156 -2.668257 -2.830890 -2.982484 -3.124161 -3.256747 -3.380749 -3.496254 -3.602775 -3.698835 -3.781122 -3.842324 -3.864673 -3.797519 -3.479213 -2.277299 -1.627355 -1.907021 -2.158856 -2.387072 -2.595238 -2.786301 -2.962654 -3.126223 -3.278538 -3.420779 -3.553778 -3.677965 -3.793209 -3.898490 -3.991153 -4.065019 -4.104763 -4.064480 -3.773360 -2.457263 -1.627368 -1.939948 -2.218003 -2.467386 -2.692904 -2.898418 -3.086951 -3.260991 -3.422477 -3.572915 -3.713430 -3.844734 -3.967030 -4.079710 -4.180670 -4.264643 -4.318217 -4.300323 -4.040199 -2.622362 -1.627372 -1.972437 -2.275734 -2.545061 -2.786550 -3.005174 -3.204693 -3.388009 -3.557516 -3.715028 -3.861917 -3.999183 -4.127299 -4.245996 -4.353682 -4.445872 -4.510702 -4.511307 -4.282684 -2.774865 -1.627373 -2.004508 -2.332124 -2.620160 -2.876554 -3.107152 -3.316547 -3.508185 -3.684797 -3.848495 -4.000904 -4.143229 -4.276200 -4.399871 -4.513072 -4.612029 -4.686182 -4.702188 -4.503658 -2.916559 -1.627373 -2.036172 -2.387163 -2.692960 -2.963115 -3.204768 -3.423119 -3.622256 -3.805220 -3.974390 -4.131629 -4.278318 -4.415407 -4.543222 -4.660998 -4.765578 -4.847560 -4.876542 -4.705747 -3.048875 -1.627373 -2.067439 -2.440961 -2.763527 -3.046567 -3.298315 -3.524896 -3.730821 -3.919502 -4.093568 -4.255071 -4.405578 -4.546204 -4.677526 -4.799116 -4.908401 -4.997015 -5.037093 -4.891331 -3.172978 -1.627373 -2.098317 -2.493583 -2.831996 -3.127022 -3.388169 -3.622285 -3.834393 -4.028255 -4.206728 -4.372036 -4.525905 -4.669620 -4.803931 -4.928745 -5.041986 -5.136263 -5.185915 -5.062533 -3.289828 -1.627373 -2.128814 -2.545071 -2.898524 -3.204775 -3.474606 -3.715647 -3.933418 -4.131985 -4.314451 -4.483188 -4.640057 -4.786479 -4.923378 -5.050925 -5.167514 -5.266635 -5.324647 -5.221210 -3.400226 -1.627373 -2.158908 -2.595396 -2.963119 -3.279909 -3.557832 -3.805293 -4.028269 -4.231150 -4.417236 -4.589075 -4.748643 -4.897467 -5.036629 -5.166525 -5.285959 -5.389248 -5.454594 -5.368939 -3.504848 -1.627373 -2.188643 -2.644680 -3.025983 -3.352667 -3.638114 -3.891510 -4.119288 -4.326124 -4.515525 -4.690181 -4.852188 -5.003167 -5.144331 -5.276247 -5.398117 -5.505001 -5.576817 -5.507067 -3.604268 -1.627373 -2.218020 -2.692962 -3.087146 -3.423136 -3.715649 -3.974553 -4.206770 -4.417247 -4.609690 -4.786913 -4.951137 -5.104069 -5.247009 -5.380692 -5.504653 -5.614652 -5.692207 -5.636741 -3.698979 -1.627373 -2.247051 -2.740258 -3.146706 -3.491493 -3.790593 -4.054648 -4.290977 -4.504818 -4.700064 -4.879652 -5.045895 -5.200591 -5.345121 -5.480374 -5.606136 -5.718835 -5.801501 -5.758926 -3.789407 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -2.145541 -2.171706 -2.196530 -2.219902 -2.241699 -2.261769 -2.279936 -2.295989 -2.309666 -2.320662 -2.328614 -2.333054 -2.333388 -2.328829 -2.318298 -2.300204 -2.271962 -2.228769 -2.158472 -1.934567 -2.206491 -2.271077 -2.333317 -2.393173 -2.450551 -2.505318 -2.557335 -2.606359 -2.652029 -2.693907 -2.731413 -2.763726 -2.789691 -2.807819 -2.815982 -2.811086 -2.788335 -2.739514 -2.645720 -2.326377 -2.219090 -2.318734 -2.414187 -2.505587 -2.593069 -2.676739 -2.756541 -2.832499 -2.904402 -2.971960 -3.034702 -3.091769 -3.142003 -3.183470 -3.213237 -3.226694 -3.216274 -3.168982 -3.057136 -2.653861 -2.222264 -2.355350 -2.481493 -2.601179 -2.714892 -2.822970 -2.925730 -3.023368 -3.115984 -3.203541 -3.285781 -3.362203 -3.431779 -3.492810 -3.542191 -3.574584 -3.580187 -3.540689 -3.416957 -2.935190 -2.223110 -2.388786 -2.543933 -2.689700 -2.826850 -2.956244 -3.078540 -3.194196 -3.303643 -3.407131 -3.504643 -3.595992 -3.680520 -3.756825 -3.822247 -3.871483 -3.893781 -3.866488 -3.737528 -3.181782 -2.223453 -2.421019 -2.603921 -2.773867 -2.932380 -3.080713 -3.219934 -3.350954 -3.474466 -3.590979 -3.700810 -3.803984 -3.900187 -3.988432 -4.066518 -4.129707 -4.167417 -4.154518 -4.026433 -3.401281 -2.223379 -2.452477 -2.662145 -2.854731 -3.032834 -3.198169 -3.352395 -3.496694 -3.632149 -3.759568 -3.879525 -3.992322 -4.097903 -4.195625 -4.283749 -4.358219 -4.409251 -4.411113 -4.288905 -3.599054 -2.223814 -2.483825 -2.718700 -2.932940 -3.128948 -3.309759 -3.477233 -3.633190 -3.779001 -3.915705 -4.044166 -4.164937 -4.278200 -4.383601 -4.479813 -4.563404 -4.625612 -4.641444 -4.528756 -3.779018 -2.224115 -2.515303 -2.775609 -3.007616 -3.220975 -3.415946 -3.595512 -3.761832 -3.916579 -4.061336 -4.197072 -4.324548 -4.444200 -4.555936 -4.658771 -4.749823 -4.821326 -4.849779 -4.748973 -3.944117 -2.214866 -2.550777 -2.825016 -3.082866 -3.309513 -3.517484 -3.707495 -3.883295 -4.046264 -4.197933 -4.339947 -4.473159 -4.598207 -4.715230 -4.823560 -4.920789 -5.000052 -5.039616 -4.951967 -4.096621 -2.193193 -2.582292 -2.890491 -3.157414 -3.395084 -3.613457 -3.815150 -3.998594 -4.168624 -4.326684 -4.474103 -4.612278 -4.741940 -4.863444 -4.976384 -5.078786 -5.164576 -5.213807 -5.139772 -4.238315 -2.423728 -2.441999 -2.946571 -3.215034 -3.482997 -3.708509 -3.916174 -4.107872 -4.284471 -4.448196 -4.600667 -4.743117 -4.876781 -5.002102 -5.118947 -5.225726 -5.317054 -5.374659 -5.314113 -4.370631 -2.823014 -2.763878 -2.954967 -3.276414 -3.560096 -3.796336 -4.016458 -4.213472 -4.395356 -4.563716 -4.720281 -4.866675 -5.003795 -5.132422 -5.252604 -5.363105 -5.459174 -5.524056 -5.476479 -4.494734 -2.914409 -3.332312 -3.462206 -3.232963 -3.668132 -3.869133 -4.103462 -4.310430 -4.500538 -4.673327 -4.833747 -4.983590 -5.123863 -5.255383 -5.378443 -5.492137 -5.592295 -5.663516 -5.628175 -4.611584 -2.916596 -3.383422 -3.766948 -3.977849 -3.681593 -3.952583 -4.224710 -4.406145 -4.602657 -4.777674 -4.941781 -5.094818 -5.237778 -5.371799 -5.497355 -5.613804 -5.717502 -5.794290 -5.770347 -4.721982 -2.916604 -3.412006 -3.822027 -4.166535 -4.376577 -3.972798 -4.302297 -4.493393 -4.687398 -4.877155 -5.045839 -5.200662 -5.346152 -5.482373 -5.610110 -5.728937 -5.835712 -5.917403 -5.903990 -4.826604 -2.916607 -3.439843 -3.868735 -4.230353 -4.539696 -4.726095 -4.300926 -4.567507 -4.792013 -4.969276 -5.144878 -5.301699 -5.449384 -5.587660 -5.717301 -5.838221 -5.947683 -6.033713 -6.029978 -4.926024 -2.916606 -3.467356 -3.914377 -4.288715 -4.610034 -4.888842 -5.001362 -4.475535 -4.867128 -5.079768 -5.235584 -5.397313 -5.548233 -5.688088 -5.819476 -5.942223 -6.054048 -6.143947 -6.149083 -5.020735 -2.916607 -3.494559 -3.959126 -4.345540 -4.675686 -4.963215 -5.174767 -4.692850 -4.967165 -5.169177 -5.329293 -5.490220 -5.642591 -5.784307 -5.917115 -6.041464 -6.155361 -6.248720 -6.261975 -5.111163 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -2.085389 -2.106224 -2.125195 -2.142141 -2.156880 -2.169202 -2.178865 -2.185592 -2.189048 -2.188856 -2.184580 -2.175681 -2.161495 -2.141174 -2.113583 -2.077093 -2.029097 -1.964791 -1.872045 -1.624412 -2.193797 -2.256383 -2.316268 -2.373338 -2.427410 -2.478238 -2.525542 -2.568904 -2.607747 -2.641369 -2.668861 -2.689010 -2.700195 -2.700391 -2.686883 -2.655974 -2.602325 -2.517338 -2.382036 -2.016222 -2.215887 -2.314821 -2.409396 -2.499703 -2.585825 -2.667787 -2.745434 -2.818651 -2.887038 -2.950047 -3.006844 -3.056058 -3.095822 -3.123210 -3.133950 -3.121700 -3.076847 -2.984373 -2.815371 -2.343706 -2.221392 -2.354218 -2.480030 -2.599274 -2.712408 -2.819721 -2.921473 -3.017766 -3.108571 -3.193671 -3.272531 -3.344235 -3.407107 -3.458418 -3.493429 -3.504231 -3.477208 -3.389101 -3.196277 -2.625035 -2.222884 -2.388442 -2.543481 -2.689052 -2.825960 -2.955016 -3.076832 -3.191808 -3.300303 -3.402426 -3.497976 -3.586453 -3.666708 -3.736481 -3.791604 -3.824041 -3.818130 -3.743143 -3.537003 -2.871628 -2.223299 -2.420894 -2.603755 -2.773640 -2.932052 -3.080251 -3.219247 -3.349923 -3.472918 -3.588665 -3.697333 -3.798727 -3.892150 -3.975956 -4.046699 -4.097166 -4.111650 -4.054699 -3.845008 -3.091126 -2.223414 -2.452543 -2.662070 -2.854709 -3.032728 -3.198006 -3.352089 -3.496230 -3.631423 -3.758412 -3.877678 -3.989357 -4.093106 -4.187759 -4.270583 -4.335431 -4.367743 -4.330462 -4.125396 -3.288899 -2.223447 -2.483661 -2.718823 -2.932848 -3.128928 -3.309653 -3.477114 -3.632998 -3.778651 -3.915125 -4.043180 -4.163245 -4.275289 -4.378548 -4.470882 -4.547127 -4.594316 -4.576159 -4.381878 -3.468863 -2.223456 -2.514347 -2.774196 -3.008385 -3.221186 -3.415979 -3.595421 -3.761671 -3.916435 -4.061051 -4.196539 -4.323577 -4.442418 -4.552648 -4.652622 -4.738006 -4.797407 -4.796694 -4.617376 -3.633962 -2.223458 -2.544644 -2.828305 -3.081551 -3.309840 -3.517489 -3.707780 -3.883281 -4.046076 -4.197783 -4.339650 -4.472594 -4.597108 -4.713075 -4.819282 -4.912101 -4.981544 -4.996181 -4.834273 -3.786466 -2.223459 -2.574568 -2.881208 -3.152430 -3.395202 -3.614654 -3.814779 -3.998612 -4.168564 -4.326518 -4.473945 -4.611956 -4.741265 -4.862024 -4.973386 -5.072339 -5.150099 -5.178015 -5.034621 -3.928160 -2.223459 -2.604129 -2.932915 -3.221228 -3.477465 -3.707838 -3.916930 -4.108308 -4.284686 -4.448195 -4.600520 -4.742939 -4.876357 -5.001161 -5.116838 -5.220907 -5.305633 -5.344951 -5.220195 -4.060476 -2.223459 -2.633334 -2.983510 -3.288021 -3.556889 -3.797319 -4.014659 -4.212898 -4.395082 -4.563579 -4.720253 -4.866552 -5.003533 -5.131796 -5.251112 -5.359486 -5.450099 -5.499229 -5.392560 -4.184579 -2.223459 -2.662191 -3.033046 -3.352924 -3.633607 -3.883404 -4.108331 -4.312840 -4.500299 -4.673300 -4.833873 -4.983611 -5.123724 -5.254967 -5.377387 -5.489408 -5.585045 -5.642635 -5.553116 -4.301429 -2.223459 -2.690706 -3.081559 -3.416059 -3.707843 -3.966339 -4.198265 -4.408531 -4.600801 -4.777890 -4.941983 -5.094803 -5.237682 -5.371528 -5.496612 -5.611745 -5.711686 -5.776631 -5.703114 -4.411827 -2.223459 -2.718862 -3.129045 -3.477467 -3.779703 -4.046321 -4.284742 -4.500311 -4.696994 -4.877807 -5.045094 -5.200693 -5.346042 -5.482182 -5.609576 -5.727376 -5.831031 -5.902398 -5.843655 -4.516449 -2.223459 -2.746696 -3.175592 -3.537289 -3.849369 -4.123571 -4.368019 -4.588490 -4.789229 -4.973454 -5.143650 -5.301768 -5.449340 -5.587523 -5.716927 -5.837032 -5.943902 -6.020911 -5.975718 -4.615869 -2.223459 -2.774209 -3.221230 -3.595570 -3.916942 -4.198266 -4.448323 -4.673334 -4.877815 -5.065176 -5.238031 -5.398447 -5.548037 -5.688044 -5.819222 -5.941324 -6.050992 -6.132988 -6.100176 -4.710580 -2.223459 -2.801412 -3.265979 -3.652393 -3.982561 -4.270556 -4.525858 -4.755085 -4.963029 -5.153284 -5.328587 -5.491102 -5.642524 -5.784174 -5.916936 -6.040777 -6.152885 -6.239310 -6.217789 -4.801008 -1.525010 -1.524155 -1.523294 -1.522429 -1.521558 -1.520681 -1.519800 -1.518913 -1.518020 -1.517122 -1.516219 -1.515309 -1.514394 -1.513474 -1.512546 -1.511614 -1.510675 -1.509731 -1.508781 -1.507824 -2.108372 -2.133433 -2.156640 -2.177832 -2.196830 -2.213422 -2.227366 -2.238375 -2.246105 -2.250194 -2.250188 -2.245548 -2.235620 -2.219588 -2.196394 -2.164584 -2.122053 -2.065227 -1.986695 -1.862164 -2.197889 -2.264196 -2.327703 -2.388317 -2.445867 -2.500145 -2.550879 -2.597678 -2.639960 -2.677067 -2.708076 -2.731739 -2.746424 -2.750035 -2.739735 -2.711629 -2.660261 -2.576900 -2.443284 -2.158409 -2.216806 -2.319067 -2.416759 -2.509995 -2.598896 -2.683502 -2.763707 -2.839418 -2.910246 -2.975711 -3.034970 -3.086732 -3.129126 -3.159189 -3.172636 -3.162887 -3.120018 -3.028345 -2.858135 -2.429596 -2.221623 -2.357480 -2.486035 -2.607782 -2.723205 -2.832645 -2.936370 -3.034538 -3.127125 -3.213975 -3.294554 -3.368020 -3.432713 -3.485964 -3.523070 -3.536042 -3.511045 -3.424065 -3.230051 -2.679015 -2.222944 -2.391273 -2.548750 -2.696475 -2.835315 -2.966100 -3.089487 -3.205924 -3.315769 -3.419173 -3.515978 -3.605693 -3.687217 -3.758367 -3.814998 -3.849149 -3.845099 -3.771580 -3.564900 -2.907348 -2.223314 -2.423443 -2.608471 -2.780226 -2.940265 -3.089893 -3.230174 -3.361994 -3.486037 -3.602755 -3.712348 -3.814657 -3.908995 -3.993765 -4.065588 -4.117334 -4.133358 -4.077970 -3.868412 -3.116067 -2.223418 -2.454852 -2.666304 -2.860563 -3.039963 -3.206433 -3.361554 -3.506614 -3.642631 -3.770373 -3.890340 -4.002695 -4.107116 -4.202470 -4.286075 -4.351855 -4.385363 -4.349534 -4.145089 -3.307193 -2.223448 -2.485747 -2.722605 -2.938029 -3.135278 -3.316995 -3.485309 -3.641933 -3.788240 -3.925303 -4.053902 -4.174477 -4.287021 -4.390796 -4.483698 -4.560624 -4.608717 -4.591801 -4.398422 -3.482829 -2.223456 -2.516219 -2.777555 -3.012945 -3.226734 -3.422345 -3.602484 -3.769335 -3.924621 -4.069702 -4.205606 -4.333035 -4.452255 -4.562870 -4.663263 -4.749146 -4.809223 -4.809514 -4.631212 -3.644917 -2.223459 -2.546308 -2.831259 -3.085525 -3.314642 -3.522971 -3.713827 -3.889812 -4.053028 -4.205099 -4.347291 -4.480536 -4.605336 -4.721591 -4.828109 -4.921295 -4.991241 -5.006665 -4.845766 -3.795215 -2.223459 -2.576029 -2.883777 -3.155858 -3.399316 -3.619322 -3.819909 -4.004128 -4.174415 -4.332653 -4.480335 -4.618578 -4.748104 -4.869078 -4.980672 -5.079895 -5.158027 -5.186546 -5.044069 -3.935215 -2.223459 -2.605392 -2.935113 -3.224142 -3.480937 -3.711757 -3.921221 -4.112906 -4.289546 -4.453279 -4.605802 -4.748399 -4.881979 -5.006946 -5.122791 -5.227059 -5.312058 -5.351831 -5.227865 -4.065973 -2.223459 -2.634403 -2.985355 -3.290445 -3.559764 -3.800551 -4.018181 -4.216660 -4.399049 -4.567719 -4.724545 -4.870977 -5.008084 -5.136462 -5.255901 -5.364418 -5.455232 -5.504693 -5.398677 -4.189008 -2.223459 -2.663072 -3.034551 -3.354889 -3.635923 -3.885996 -4.111146 -4.315841 -4.503454 -4.676586 -4.837272 -4.987113 -5.127312 -5.258640 -5.381147 -5.493271 -5.589049 -5.646884 -5.557872 -4.304912 -2.223459 -2.691402 -3.082737 -3.417588 -3.709636 -3.968338 -4.200430 -4.410831 -4.603214 -4.780398 -4.944572 -5.097467 -5.240406 -5.374314 -5.499459 -5.614662 -5.714705 -5.779814 -5.706675 -4.414464 -2.223459 -2.719378 -3.129912 -3.478584 -3.781006 -4.047770 -4.286305 -4.501968 -4.698728 -4.879606 -5.046949 -5.202597 -5.347988 -5.484172 -5.611599 -5.729448 -5.833164 -5.904645 -5.846163 -4.518326 -2.223459 -2.747035 -3.176158 -3.538014 -3.850211 -4.124504 -4.369021 -4.589550 -4.790338 -4.974603 -5.144834 -5.302981 -5.450580 -5.588780 -5.718215 -5.838342 -5.945249 -6.022330 -5.977290 -4.617060 -2.223459 -2.774377 -3.221507 -3.595923 -3.917351 -4.198716 -4.448808 -4.673845 -4.878348 -5.065729 -5.238602 -5.399027 -5.548627 -5.688641 -5.819835 -5.941951 -6.051632 -6.133661 -6.100918 -4.711148 -2.223459 -2.801412 -3.265979 -3.652393 -3.982561 -4.270556 -4.525858 -4.755085 -4.963029 -5.153284 -5.328587 -5.491102 -5.642524 -5.784174 -5.916936 -6.040777 -6.152885 -6.239310 -6.217789 -4.801008 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 -0.8915960 -0.9073861 -0.9199458 -0.9288574 -0.9336657 -0.9338195 -0.9286776 -0.9175035 -0.8994586 -0.8735850 -0.8387767 -0.7938482 -0.7374599 -0.6680990 -0.5840205 -0.4830800 -0.3623019 -0.2166596 -3.4014609E-02 0.3118532 -1.051073 -1.117409 -1.180478 -1.240155 -1.296187 -1.348195 -1.395646 -1.437866 -1.473843 -1.502157 -1.520890 -1.527309 -1.517508 -1.486088 -1.425790 -1.326978 -1.177395 -0.9617128 -0.6562724 -7.9957083E-02 -1.080770 -1.186970 -1.288131 -1.384458 -1.475941 -1.562635 -1.644343 -1.720838 -1.791656 -1.855955 -1.912622 -1.959593 -1.993776 -2.009913 -1.999023 -1.945966 -1.825203 -1.597289 -1.205391 -0.4074402 -1.088257 -1.231201 -1.366155 -1.493725 -1.614386 -1.728428 -1.836187 -1.937670 -2.032911 -2.121525 -2.202906 -2.275825 -2.338146 -2.386094 -2.412539 -2.403564 -2.330034 -2.131794 -1.697469 -0.6887694 -1.090283 -1.268552 -1.434910 -1.590639 -1.736639 -1.873824 -2.002861 -2.124218 -2.238288 -2.345139 -2.444491 -2.535732 -2.617395 -2.686685 -2.738282 -2.760973 -2.728903 -2.576236 -2.139230 -0.9353619 -1.090943 -1.303589 -1.499726 -1.681310 -1.850037 -2.007293 -2.154339 -2.292141 -2.421406 -2.542595 -2.655843 -2.760878 -2.856817 -2.941618 -3.011070 -3.056154 -3.055280 -2.946887 -2.534829 -1.154860 -1.090962 -1.337514 -1.562223 -1.767763 -1.957111 -2.132204 -2.294952 -2.446652 -2.588505 -2.721331 -2.845634 -2.961511 -3.068481 -3.165070 -3.247930 -3.309624 -3.331941 -3.260494 -2.888155 -1.352634 -1.091590 -1.371103 -1.622722 -1.851152 -2.059163 -2.250378 -2.426746 -2.590489 -2.743057 -2.885572 -3.018903 -3.143492 -3.259203 -3.365039 -3.458349 -3.532875 -3.572973 -3.530963 -3.203339 -1.532598 -1.090732 -1.404851 -1.683877 -1.930226 -2.156563 -2.362363 -2.551235 -2.725513 -2.887200 -3.037983 -3.178878 -3.310610 -3.433382 -3.546619 -3.648246 -3.732975 -3.787152 -3.768610 -3.484850 -1.697697 -1.082334 -1.443287 -1.736772 -2.010265 -2.250220 -2.469310 -2.668656 -2.852577 -3.022640 -3.180442 -3.327750 -3.465453 -3.594053 -3.713298 -3.821643 -3.914629 -3.980236 -3.980735 -3.737170 -1.850200 -1.049208 -1.477765 -1.805461 -2.089241 -2.339511 -2.570202 -2.781814 -2.973051 -3.150038 -3.314374 -3.467119 -3.609902 -3.743363 -3.867587 -3.981427 -4.081183 -4.156228 -4.172489 -3.964545 -1.991894 -1.401057 -1.292308 -1.887556 -2.161526 -2.437622 -2.669796 -2.886308 -3.086291 -3.270429 -3.440453 -3.598298 -3.745391 -3.883015 -4.011368 -4.129756 -4.235114 -4.318047 -4.347580 -4.170742 -2.124210 -1.758475 -1.752259 -1.843236 -2.222619 -2.511197 -2.762608 -2.992239 -3.196896 -3.385954 -3.560144 -3.722047 -3.873106 -4.014244 -4.146105 -4.268288 -4.378315 -4.467902 -4.508758 -4.358998 -2.248313 -1.784194 -2.253733 -2.510727 -2.154747 -2.631526 -2.837793 -3.081679 -3.296702 -3.494488 -3.673579 -3.839319 -3.993738 -4.138063 -4.272933 -4.398317 -4.512265 -4.607509 -4.658129 -4.532001 -2.365163 -1.784234 -2.285977 -2.701997 -3.022830 -2.656585 -2.911285 -3.212063 -3.394106 -3.600196 -3.781380 -3.950670 -4.108369 -4.255331 -4.392788 -4.520890 -4.638165 -4.738219 -4.797329 -4.691967 -2.475562 -1.784234 -2.316084 -2.752503 -3.120305 -3.416385 -3.027542 -3.306261 -3.481849 -3.686752 -3.883896 -4.058336 -4.217232 -4.366817 -4.506450 -4.636907 -4.756970 -4.861164 -4.927691 -4.840698 -2.580184 -1.784234 -2.345821 -2.801779 -3.183271 -3.510375 -3.778571 -3.312898 -3.570661 -3.796908 -3.978876 -4.160283 -4.321552 -4.472788 -4.614548 -4.747002 -4.869498 -4.977233 -5.050281 -4.979662 -2.679603 -1.784234 -2.375180 -2.850063 -3.244512 -3.581001 -3.874156 -4.095170 -3.441159 -3.872128 -4.093690 -4.253418 -4.418999 -4.574401 -4.717567 -4.851803 -4.976380 -5.087192 -5.166000 -5.110068 -2.774314 -1.784234 -2.404197 -2.897377 -3.304130 -3.649500 -3.949316 -4.209645 -3.723093 -3.972415 -4.190644 -4.348841 -4.514924 -4.671067 -4.816141 -4.951856 -5.078219 -5.191682 -5.275589 -5.232904 -2.864743 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -1.487364 -1.503890 -1.517696 -1.528491 -1.535959 -1.539724 -1.539361 -1.534385 -1.524251 -1.508332 -1.485906 -1.456168 -1.418180 -1.370825 -1.312716 -1.242003 -1.155912 -1.049507 -0.9106094 -0.6128114 -1.641153 -1.705408 -1.766534 -1.824380 -1.878702 -1.929154 -1.975250 -2.016366 -2.051623 -2.079849 -2.099506 -2.108501 -2.103993 -2.082302 -2.038634 -1.966762 -1.858545 -1.702727 -1.478375 -1.004622 -1.671372 -1.774554 -1.872937 -1.966672 -2.055774 -2.140231 -2.219845 -2.294390 -2.363364 -2.425996 -2.481167 -2.526950 -2.560562 -2.577448 -2.570444 -2.528388 -2.434011 -2.261914 -1.972179 -1.332105 -1.679064 -1.818092 -1.949547 -2.073969 -2.191759 -2.303198 -2.408538 -2.507813 -2.600964 -2.687650 -2.767204 -2.838445 -2.899249 -2.946008 -2.972070 -2.965307 -2.902733 -2.742555 -2.412419 -1.613434 -1.681166 -1.854612 -2.016816 -2.168872 -2.311635 -2.445925 -2.572361 -2.691343 -2.803224 -2.908048 -3.005500 -3.094937 -3.174917 -3.242667 -3.292994 -3.315224 -3.286216 -3.154159 -2.808698 -1.860027 -1.681751 -1.888794 -2.080130 -2.257594 -2.422760 -2.576948 -2.721238 -2.856560 -2.983577 -3.102705 -3.214045 -3.317278 -3.411489 -3.494649 -3.562605 -3.606553 -3.605890 -3.506865 -3.166739 -2.079525 -1.681915 -1.921982 -2.141179 -2.342316 -2.527790 -2.699610 -2.859437 -3.008618 -3.148205 -3.278972 -3.401380 -3.515479 -3.620750 -3.715692 -3.796976 -3.857291 -3.878903 -3.811141 -3.490741 -2.277299 -1.681961 -1.954581 -2.200516 -2.423840 -2.627942 -2.815614 -2.989117 -3.150275 -3.300533 -3.441007 -3.572474 -3.695321 -3.809385 -3.913616 -4.005340 -4.078366 -4.117389 -4.076570 -3.784166 -2.457263 -1.681974 -1.986719 -2.258355 -2.502537 -2.723830 -2.925886 -3.111572 -3.283230 -3.442709 -3.591439 -3.730488 -3.860523 -3.981706 -4.093400 -4.193482 -4.276668 -4.329550 -4.311130 -4.050225 -2.622362 -1.681977 -2.018427 -2.314829 -2.578700 -2.815864 -3.030996 -3.227674 -3.408661 -3.576220 -3.732090 -3.877582 -4.013640 -4.140704 -4.258477 -4.365342 -4.456797 -4.520969 -4.521051 -4.291933 -2.774865 -1.681979 -2.049731 -2.370018 -2.652406 -2.904374 -3.131487 -3.338078 -3.527440 -3.702169 -3.864292 -4.015364 -4.156543 -4.288519 -4.411321 -4.523753 -4.622024 -4.695558 -4.711048 -4.512167 -2.916559 -1.681979 -2.080647 -2.423931 -2.723887 -2.989581 -3.227749 -3.443353 -3.640274 -3.821420 -3.989078 -4.145041 -4.290641 -4.426789 -4.553785 -4.670839 -4.774774 -4.856176 -4.884661 -4.713573 -3.048875 -1.681979 -2.111182 -2.476640 -2.793234 -3.071770 -3.320078 -3.543965 -3.747737 -3.934664 -4.107281 -4.267565 -4.417035 -4.556770 -4.687317 -4.808228 -4.916909 -5.004980 -5.044577 -4.898545 -3.172978 -1.681979 -2.141345 -2.528219 -2.860548 -3.151076 -3.408821 -3.640303 -3.850322 -4.042493 -4.219575 -4.383719 -4.536601 -4.679468 -4.813046 -4.937216 -5.049888 -5.143657 -5.192854 -5.069205 -3.289828 -1.681979 -2.171144 -2.578710 -2.925992 -3.227756 -3.494238 -3.732710 -3.948459 -4.145398 -4.326527 -4.494149 -4.650078 -4.795691 -4.931898 -5.058834 -5.174890 -5.273530 -5.331110 -5.227400 -3.400226 -1.681979 -2.200570 -2.628100 -2.989584 -3.301908 -3.576538 -3.821492 -4.042508 -4.243818 -4.428620 -4.599391 -4.758058 -4.906118 -5.044619 -5.173936 -5.292862 -5.395703 -5.460639 -5.374705 -3.504848 -1.681979 -2.229646 -2.676476 -3.051492 -3.373749 -3.655967 -3.906921 -4.132799 -4.338120 -4.526286 -4.699919 -4.861063 -5.011314 -5.151845 -5.283216 -5.404603 -5.511062 -5.582494 -5.512462 -3.604268 -1.681979 -2.258372 -2.723889 -3.111768 -3.443370 -3.732713 -3.989242 -4.219617 -4.428631 -4.619887 -4.796130 -4.959530 -5.111759 -5.254099 -5.387263 -5.510768 -5.620361 -5.697555 -5.641807 -3.698979 -1.681979 -2.286767 -2.770357 -3.170484 -3.510936 -3.806932 -4.068674 -4.303216 -4.515647 -4.709745 -4.888393 -5.053844 -5.207871 -5.351828 -5.486583 -5.611914 -5.724230 -5.806549 -5.763693 -3.789407 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -1.870182 -1.874627 -1.876580 -1.875877 -1.872352 -1.865805 -1.856013 -1.842722 -1.825637 -1.804421 -1.778672 -1.747919 -1.711569 -1.668854 -1.618726 -1.559653 -1.489139 -1.402472 -1.287629 -1.018276 -2.170143 -2.219052 -2.263884 -2.304400 -2.340271 -2.371082 -2.396373 -2.415581 -2.427992 -2.432751 -2.428851 -2.415042 -2.389757 -2.351069 -2.296547 -2.222933 -2.125514 -1.996455 -1.817715 -1.410087 -2.256291 -2.346719 -2.431777 -2.511371 -2.585272 -2.653216 -2.714700 -2.769151 -2.815737 -2.853352 -2.880613 -2.895592 -2.895832 -2.877989 -2.837546 -2.768378 -2.661781 -2.504550 -2.270675 -1.737570 -2.280777 -2.407473 -2.526771 -2.638937 -2.744181 -2.842465 -2.933662 -3.017339 -3.092870 -3.159237 -3.215005 -3.258124 -3.285677 -3.293516 -3.275548 -3.222779 -3.121529 -2.950502 -2.671358 -2.018899 -2.287678 -2.447559 -2.597038 -2.737008 -2.868138 -2.990961 -3.105722 -3.212404 -3.310737 -3.400014 -3.479001 -3.545808 -3.597508 -3.629666 -3.635489 -3.604118 -3.517624 -3.345514 -3.032289 -2.265492 -2.289617 -2.481134 -2.658383 -2.823043 -2.976469 -3.119708 -3.253535 -3.378447 -3.494589 -3.601686 -3.698909 -3.784679 -3.856328 -3.909525 -3.937259 -3.927839 -3.860622 -3.696969 -3.360984 -2.484990 -2.290161 -2.512485 -2.715969 -2.903255 -3.076473 -3.237326 -3.387141 -3.526894 -3.657193 -3.778227 -3.889645 -3.990324 -4.078017 -4.148718 -4.195556 -4.206605 -4.159843 -4.010734 -3.662465 -2.682764 -2.290313 -2.542900 -2.771473 -2.979855 -3.171074 -3.347541 -3.511151 -3.663367 -3.805244 -3.937412 -4.059980 -4.172335 -4.272755 -4.357742 -4.420821 -4.450180 -4.423265 -4.291908 -3.940305 -2.862728 -2.290356 -2.572776 -2.825461 -3.053675 -3.261481 -3.452046 -3.627840 -3.790806 -3.942425 -4.083721 -4.215225 -4.336797 -4.447275 -4.543788 -4.620456 -4.665870 -4.657423 -4.545023 -4.197241 -3.027827 -2.290368 -2.602230 -2.878175 -3.125138 -3.348309 -3.551716 -3.738447 -3.910886 -4.070901 -4.219878 -4.358703 -4.487669 -4.606143 -4.711903 -4.799811 -4.859122 -4.867519 -4.774064 -4.435468 -3.180330 -2.290371 -2.631313 -2.929722 -3.194404 -3.431919 -3.647128 -3.843757 -4.024661 -4.192057 -4.347641 -4.492611 -4.627623 -4.752512 -4.865695 -4.962834 -5.034056 -5.057642 -4.982464 -4.656847 -3.322024 -2.290372 -2.660047 -2.980142 -3.261657 -3.512559 -3.738675 -3.944335 -4.132879 -4.306849 -4.468216 -4.618457 -4.758515 -4.888630 -5.007793 -5.112485 -5.193830 -5.231009 -5.173137 -4.862985 -3.454340 -2.290373 -2.688441 -3.029485 -3.327004 -3.590458 -3.826657 -4.040618 -4.236104 -4.415988 -4.582498 -4.737331 -4.881687 -5.016130 -5.140157 -5.251015 -5.340914 -5.390175 -5.348521 -5.055320 -3.578443 -2.290373 -2.716502 -3.077815 -3.390533 -3.665774 -3.911362 -4.132967 -4.334796 -4.520045 -4.691169 -4.850065 -4.998140 -5.136235 -5.264258 -5.380167 -5.477252 -5.537191 -5.510647 -5.235143 -3.695293 -2.290373 -2.744237 -3.125171 -3.452371 -3.738694 -3.993021 -4.221689 -4.429348 -4.619484 -4.794785 -4.957318 -5.108666 -5.249883 -5.381238 -5.501297 -5.604408 -5.673722 -5.661198 -5.403625 -3.805691 -2.290373 -2.771643 -3.171565 -3.512568 -3.809339 -4.071834 -4.307060 -4.520090 -4.714709 -4.893806 -5.059621 -5.213880 -5.357821 -5.491987 -5.615484 -5.723630 -5.801151 -5.801589 -5.561825 -3.910313 -2.290373 -2.798736 -3.217046 -3.571233 -3.877866 -4.148003 -4.389321 -4.607318 -4.806059 -4.988632 -5.157428 -5.314304 -5.460644 -5.597221 -5.723584 -5.835948 -5.920607 -5.932996 -5.710701 -4.009733 -2.290373 -2.825516 -3.261660 -3.628431 -3.944379 -4.221693 -4.468689 -4.691291 -4.893836 -5.079604 -5.251122 -5.410371 -5.558848 -5.697521 -5.826298 -5.942198 -6.033055 -6.056427 -5.851112 -4.104444 -2.290373 -2.852000 -3.305431 -3.684223 -4.009006 -4.293054 -4.545361 -4.772242 -4.978309 -5.167021 -5.341043 -5.502449 -5.652854 -5.793365 -5.924201 -6.043071 -6.139296 -6.172729 -5.983828 -4.194872 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -1.550770 -1.566228 -1.578917 -1.588521 -1.594710 -1.597086 -1.595189 -1.588498 -1.576412 -1.558259 -1.533254 -1.500545 -1.459136 -1.407846 -1.345230 -1.269385 -1.177498 -1.064601 -0.9185007 -0.6128114 -1.704999 -1.767420 -1.826746 -1.882855 -1.935496 -1.984292 -2.028780 -2.068355 -2.102129 -2.128882 -2.147045 -2.154462 -2.148193 -2.124313 -2.077771 -2.001959 -1.888291 -1.724983 -1.490758 -1.004622 -1.735453 -1.835886 -1.931617 -2.022797 -2.109401 -2.191493 -2.268864 -2.341269 -2.408258 -2.469005 -2.522421 -2.566603 -2.598699 -2.614152 -2.605596 -2.561523 -2.463948 -2.286179 -1.986818 -1.332105 -1.743242 -1.878639 -2.006648 -2.127740 -2.242424 -2.350937 -2.453584 -2.550334 -2.641177 -2.725705 -2.803297 -2.872709 -2.931875 -2.977137 -3.001888 -2.993845 -2.929624 -2.766038 -2.427949 -1.613434 -1.745373 -1.914314 -2.072277 -2.220343 -2.359441 -2.490403 -2.613789 -2.730033 -2.839435 -2.941987 -3.037401 -3.124987 -3.203272 -3.269515 -3.318508 -3.339582 -3.309514 -3.175627 -2.824293 -1.860027 -1.745967 -1.947643 -2.133964 -2.306854 -2.467908 -2.618408 -2.759449 -2.891888 -3.016346 -3.133196 -3.242491 -3.343911 -3.436496 -3.518192 -3.584839 -3.627646 -3.626055 -3.525992 -3.181893 -2.079525 -1.746133 -1.979984 -2.193438 -2.389454 -2.570438 -2.738350 -2.894780 -3.041008 -3.178021 -3.306538 -3.426970 -3.539325 -3.643047 -3.736603 -3.816643 -3.875857 -3.896557 -3.828058 -3.505136 -2.277299 -1.746180 -2.011738 -2.251261 -2.468997 -2.668305 -2.851892 -3.021914 -3.180099 -3.327812 -3.466095 -3.595661 -3.716848 -3.829449 -3.932380 -4.022940 -4.094927 -4.133057 -4.091580 -3.797639 -2.457263 -1.746193 -2.043038 -2.307621 -2.545796 -2.762056 -2.959910 -3.142101 -3.310813 -3.467803 -3.614415 -3.751646 -3.880110 -3.999912 -4.110387 -4.209382 -4.291593 -4.343617 -4.324548 -4.062710 -2.622362 -1.746196 -2.073905 -2.362664 -2.620172 -2.852143 -3.063002 -3.256171 -3.434277 -3.599420 -3.753252 -3.897013 -4.031574 -4.157335 -4.273967 -4.379816 -4.470360 -4.533719 -4.533152 -4.303443 -2.774865 -1.746197 -2.104383 -2.416475 -2.692221 -2.938830 -3.161663 -3.364780 -3.551322 -3.723714 -3.883888 -4.033302 -4.173062 -4.303809 -4.425533 -4.537015 -4.634436 -4.707204 -4.722053 -4.522753 -2.916559 -1.746198 -2.134486 -2.469089 -2.762115 -3.022380 -3.256247 -3.468449 -3.662622 -3.841512 -4.007300 -4.161681 -4.305933 -4.440919 -4.566900 -4.683060 -4.786197 -4.866882 -4.894752 -4.723305 -3.048875 -1.746198 -2.164225 -2.520520 -2.829990 -3.103011 -3.347070 -3.567618 -3.768719 -3.953471 -4.124294 -4.283070 -4.431257 -4.569890 -4.699477 -4.819546 -4.927480 -5.014879 -5.053880 -4.907518 -3.172978 -1.746198 -2.193606 -2.570870 -2.895898 -3.180905 -3.434438 -3.662652 -3.870080 -4.060156 -4.235516 -4.398220 -4.549880 -4.691698 -4.824370 -4.947742 -5.059710 -5.152848 -5.201484 -5.077503 -3.289828 -1.746198 -2.222637 -2.620183 -2.960016 -3.256254 -3.518587 -3.753874 -3.967116 -4.162038 -4.341514 -4.507758 -4.662522 -4.807135 -4.942483 -5.068664 -5.184059 -5.282103 -5.339147 -5.235100 -3.400226 -1.746198 -2.251315 -2.668464 -3.022383 -3.329193 -3.599738 -3.841585 -4.060171 -4.259539 -4.442752 -4.612200 -4.769753 -4.916867 -5.054550 -5.183150 -5.301447 -5.403733 -5.468161 -5.381882 -3.504848 -1.746198 -2.279651 -2.715750 -3.083114 -3.399896 -3.678110 -3.926038 -4.149562 -4.353008 -4.539646 -4.712012 -4.872089 -5.021439 -5.161186 -5.291882 -5.412670 -5.518602 -5.589560 -5.519179 -3.604268 -1.746198 -2.307639 -2.762115 -3.142298 -3.468466 -3.753876 -4.007465 -4.235559 -4.442764 -4.632548 -4.807579 -4.969959 -5.121318 -5.262915 -5.395436 -5.518376 -5.627467 -5.704215 -5.648117 -3.698979 -1.746198 -2.335311 -2.807585 -3.199971 -3.535053 -3.827198 -4.086074 -4.318407 -4.529092 -4.721770 -4.899255 -5.063724 -5.216922 -5.360170 -5.494308 -5.619104 -5.730947 -5.812838 -5.769635 -3.789407 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -2.204917 -2.229482 -2.252644 -2.274281 -2.294263 -2.312426 -2.328577 -2.342487 -2.353875 -2.362415 -2.367697 -2.369235 -2.366401 -2.358371 -2.344026 -2.321733 -2.288873 -2.240584 -2.164661 -1.934567 -2.271822 -2.334260 -2.394377 -2.452150 -2.507488 -2.560244 -2.610247 -2.657252 -2.700889 -2.740667 -2.775958 -2.805889 -2.829244 -2.844388 -2.849061 -2.839984 -2.812143 -2.757008 -2.655380 -2.326377 -2.285570 -2.382186 -2.474734 -2.563388 -2.648239 -2.729408 -2.806850 -2.880533 -2.950273 -3.015724 -3.076402 -3.131426 -3.179543 -3.218753 -3.245935 -3.256234 -3.241688 -3.188658 -3.068660 -2.653861 -2.289055 -2.418190 -2.540635 -2.656888 -2.767421 -2.872550 -2.972590 -3.067690 -3.157959 -3.243305 -3.323477 -3.397917 -3.465590 -3.524708 -3.572092 -3.602166 -3.604736 -3.560657 -3.429393 -2.935190 -2.289989 -2.450784 -2.601472 -2.743165 -2.876649 -3.002731 -3.122014 -3.234956 -3.341933 -3.443150 -3.538586 -3.628010 -3.710725 -3.785309 -3.849029 -3.896449 -3.916515 -3.885770 -3.750295 -3.181782 -2.290356 -2.482121 -2.659823 -2.825154 -2.979581 -3.124286 -3.260313 -3.388492 -3.509471 -3.623709 -3.731481 -3.832791 -3.927281 -4.013928 -4.090488 -4.152144 -4.188124 -4.172653 -4.039170 -3.401281 -2.290288 -2.512678 -2.716452 -2.903919 -3.077594 -3.239093 -3.389984 -3.531373 -3.664276 -3.789443 -3.907398 -4.018403 -4.122360 -4.218590 -4.305314 -4.378430 -4.428032 -4.427940 -4.301370 -3.599054 -2.290745 -2.543136 -2.771477 -2.980167 -3.171463 -3.348274 -3.512326 -3.665346 -3.808619 -3.943115 -4.069637 -4.188693 -4.300417 -4.404422 -4.499343 -4.581707 -4.642675 -4.656964 -4.540800 -3.779018 -2.290921 -2.573745 -2.826958 -3.052955 -3.261399 -3.452255 -3.628372 -3.791761 -3.944008 -4.086613 -4.220478 -4.346316 -4.464510 -4.574936 -4.676572 -4.766497 -4.836892 -4.864069 -4.760509 -3.944117 -2.281766 -2.608501 -2.874896 -3.126480 -3.348030 -3.551805 -3.738341 -3.911251 -4.071774 -4.221354 -4.361569 -4.493211 -4.616877 -4.732667 -4.839879 -4.936068 -5.014322 -5.052790 -4.962950 -4.096621 -2.258794 -2.639364 -2.939001 -3.199454 -3.431772 -3.645968 -3.844222 -4.024800 -4.192439 -4.348484 -4.494168 -4.630843 -4.759191 -4.879530 -4.991423 -5.092860 -5.177722 -5.225982 -5.150185 -4.238315 -2.505154 -2.492696 -2.995377 -3.256073 -3.518332 -3.739370 -3.943579 -4.132493 -4.306783 -4.468561 -4.619365 -4.760380 -4.892794 -5.017013 -5.132872 -5.238750 -5.329222 -5.385952 -5.323958 -4.370631 -2.900810 -2.827842 -2.999032 -3.315578 -3.593582 -3.825720 -4.042450 -4.236713 -4.416343 -4.582810 -4.737772 -4.882792 -5.018721 -5.146301 -5.265553 -5.375211 -5.470487 -5.534564 -5.485780 -4.494734 -2.981910 -3.390311 -3.517221 -3.268939 -3.700605 -3.897029 -4.128055 -4.332358 -4.520316 -4.691286 -4.850166 -4.998691 -5.137825 -5.268352 -5.390530 -5.503430 -5.602849 -5.673331 -5.636961 -4.611584 -2.983514 -3.437080 -3.811933 -4.022362 -3.712299 -3.978929 -4.248381 -4.426864 -4.621361 -4.794612 -4.957237 -5.109015 -5.250883 -5.383960 -5.508677 -5.624381 -5.727385 -5.803484 -5.778648 -4.721982 -2.983518 -3.464788 -3.864589 -4.202267 -4.411527 -4.001047 -4.325328 -4.512965 -4.705060 -4.893172 -5.060442 -5.214041 -5.358495 -5.493811 -5.620752 -5.738869 -5.844998 -5.926048 -5.911841 -4.826604 -2.983520 -3.491883 -3.910191 -4.264316 -4.568575 -4.754859 -4.322309 -4.586447 -4.808850 -4.984458 -5.158701 -5.314354 -5.461038 -5.598447 -5.727334 -5.847579 -5.956431 -6.041866 -6.037416 -4.926024 -2.983520 -3.518663 -3.954808 -4.321577 -4.637482 -4.912576 -5.026351 -4.491984 -4.883068 -5.094244 -5.248689 -5.409297 -5.559265 -5.698291 -5.828959 -5.951067 -6.062312 -6.151656 -6.156139 -5.020735 -2.983520 -3.545147 -3.998578 -4.377369 -4.702135 -4.985781 -5.196485 -4.710163 -4.982450 -5.183031 -5.341749 -5.501606 -5.653058 -5.793982 -5.926097 -6.049840 -6.163190 -6.256022 -6.268675 -5.111163 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -2.146856 -2.166141 -2.183492 -2.198729 -2.211664 -2.222071 -2.229687 -2.234214 -2.235297 -2.232533 -2.225441 -2.213461 -2.195899 -2.171874 -2.140219 -2.099277 -2.046423 -1.976811 -1.878291 -1.624412 -2.259677 -2.320184 -2.378022 -2.433097 -2.485226 -2.534151 -2.579557 -2.621024 -2.657961 -2.689605 -2.714991 -2.732837 -2.741445 -2.738618 -2.721488 -2.686159 -2.627075 -2.535370 -2.391865 -2.016222 -2.282490 -2.378417 -2.470112 -2.557705 -2.641233 -2.720742 -2.796086 -2.867101 -2.933414 -2.994425 -3.049286 -3.096608 -3.134417 -3.159703 -3.167970 -3.152570 -3.103423 -3.004835 -2.827182 -2.343706 -2.288216 -2.417096 -2.539220 -2.655040 -2.765006 -2.869387 -2.968441 -3.062223 -3.150719 -3.233659 -3.310523 -3.380339 -3.441433 -3.490993 -3.524193 -3.532849 -3.502853 -3.409966 -3.209101 -2.625035 -2.289772 -2.450450 -2.601034 -2.742533 -2.875781 -3.001532 -3.120342 -3.232617 -3.338658 -3.438531 -3.532037 -3.618637 -3.697149 -3.765306 -3.818880 -3.849700 -3.841748 -3.763312 -3.550237 -2.871628 -2.290205 -2.482000 -2.659661 -2.824931 -2.979259 -3.123834 -3.259640 -3.387479 -3.507948 -3.621431 -3.728054 -3.827608 -3.919355 -4.001622 -4.070938 -4.120033 -4.133004 -4.073631 -3.858263 -3.091126 -2.290325 -2.512744 -2.716377 -2.903899 -3.077490 -3.238933 -3.389683 -3.530917 -3.663560 -3.788302 -3.905575 -4.015472 -4.117617 -4.210811 -4.292296 -4.355898 -4.386971 -4.347958 -4.138404 -3.288899 -2.290359 -2.542978 -2.771603 -2.980074 -3.171445 -3.348167 -3.512209 -3.665157 -3.808274 -3.942542 -4.068662 -4.187016 -4.297534 -4.399415 -4.490495 -4.565583 -4.611678 -4.592213 -4.394467 -3.468863 -2.290369 -2.572799 -2.825503 -3.053750 -3.261616 -3.452290 -3.628280 -3.791602 -3.943866 -4.086330 -4.219951 -4.345354 -4.462743 -4.571674 -4.670470 -4.754774 -4.813172 -4.811396 -4.629438 -3.633962 -2.290371 -2.602237 -2.878189 -3.125163 -3.348358 -3.551811 -3.738631 -3.911240 -4.071587 -4.221206 -4.361275 -4.492651 -4.615786 -4.730527 -4.835629 -4.927438 -4.995944 -5.009666 -4.845753 -3.786466 -2.290372 -2.631315 -2.929727 -3.194412 -3.431936 -3.647165 -3.843833 -4.024819 -4.192383 -4.348317 -4.494011 -4.630523 -4.758520 -4.878119 -4.988442 -5.086450 -5.163334 -5.190422 -5.045491 -3.928160 -2.290373 -2.660048 -2.980144 -3.261660 -3.512565 -3.738689 -3.944366 -4.132949 -4.307004 -4.468560 -4.619219 -4.760203 -4.892372 -5.016077 -5.130774 -5.233954 -5.317860 -5.356417 -5.230451 -4.060476 -2.290373 -2.688441 -3.029485 -3.327005 -3.590461 -3.826662 -4.040632 -4.236135 -4.416062 -4.582673 -4.737746 -4.882670 -5.018461 -5.145678 -5.264068 -5.371608 -5.461453 -5.509864 -5.402225 -4.184579 -2.290373 -2.716502 -3.077815 -3.390533 -3.665775 -3.911364 -4.132973 -4.334810 -4.520080 -4.691258 -4.850291 -4.998713 -5.137687 -5.267937 -5.389478 -5.500712 -5.595628 -5.652545 -5.562221 -4.301429 -2.290373 -2.744237 -3.125171 -3.452371 -3.738694 -3.993022 -4.221691 -4.429355 -4.619501 -4.794830 -4.957441 -5.108999 -5.250788 -5.383690 -5.507938 -5.622329 -5.721590 -5.785897 -5.711690 -4.411827 -2.290373 -2.771643 -3.171565 -3.512568 -3.809339 -4.071835 -4.307061 -4.520092 -4.714717 -4.893829 -5.059688 -5.214074 -5.358384 -5.493621 -5.620220 -5.737314 -5.840333 -5.911097 -5.851742 -4.516449 -2.290373 -2.798736 -3.217046 -3.571233 -3.877866 -4.148003 -4.389321 -4.607319 -4.806063 -4.988644 -5.157465 -5.314418 -5.460995 -5.598310 -5.726962 -5.846394 -5.952661 -6.029105 -5.983358 -4.615869 -2.290373 -2.825516 -3.261660 -3.628431 -3.944379 -4.221693 -4.468689 -4.691292 -4.893838 -5.079610 -5.251142 -5.410438 -5.559067 -5.698247 -5.828706 -5.950171 -6.059265 -6.140729 -6.107403 -4.710580 -2.290373 -2.852000 -3.305431 -3.684223 -4.009006 -4.293054 -4.545361 -4.772242 -4.978310 -5.167024 -5.341054 -5.502487 -5.652990 -5.793849 -5.925919 -6.049155 -6.160719 -6.246636 -6.224633 -4.801008 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.000000 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 -0.4485604 -0.4702687 -0.4869598 -0.5002296 -0.5077933 -0.5077389 -0.5208869 -0.5293941 -0.5323549 -0.5286139 -0.5146165 -0.4936208 -0.4613514 -0.4215487 -0.3807987 -0.3253292 -0.2505742 -0.1500059 -8.8861249E-03 0.3118532 -0.4649419 -0.4822412 -0.4979578 -0.5084959 -0.5118586 -0.5102661 -0.5220458 -0.5291181 -0.5306128 -0.5229609 -0.5094559 -0.4867689 -0.4527993 -0.4119596 -0.3709947 -0.3155678 -0.2411374 -0.1417874 -2.7920206E-03 0.3118532 -0.4796276 -0.4955266 -0.5081825 -0.5140883 -0.5155061 -0.5128832 -0.5232232 -0.5286321 -0.5284766 -0.5188963 -0.5036399 -0.4792326 -0.4435641 -0.4021724 -0.3607804 -0.3056128 -0.2315070 -0.1338337 3.4124972E-03 0.3118532 -0.4955472 -0.5080134 -0.5155207 -0.5193279 -0.5191910 -0.5157478 -0.5242138 -0.5278376 -0.5232718 -0.5142549 -0.4971353 -0.4709740 -0.4326865 -0.3921797 -0.3505152 -0.2954577 -0.2217028 -0.1253220 9.7033745E-03 0.3118532 -0.5106184 -0.5172809 -0.5228738 -0.5244867 -0.5234916 -0.5185915 -0.5249339 -0.5240080 -0.5198771 -0.5089691 -0.4899414 -0.4619603 -0.4228569 -0.3820030 -0.3399767 -0.2847938 -0.2117072 -0.1166642 1.6146023E-02 0.3118532 -0.5222022 -0.5268614 -0.5298982 -0.5306913 -0.5279300 -0.5212968 -0.5253986 -0.5220500 -0.5158502 -0.5029868 -0.4820134 -0.4506665 -0.4128913 -0.3710387 -0.3293159 -0.2738571 -0.2016592 -0.1078600 2.2721194E-02 0.3118532 -0.5346964 -0.5361603 -0.5382054 -0.5371866 -0.5324249 -0.5237808 -0.5226527 -0.5194713 -0.5111536 -0.4962932 -0.4710798 -0.4411210 -0.4028329 -0.3604575 -0.3184989 -0.2627198 -0.1916648 -9.8911099E-02 2.9441295E-02 0.3118532 -0.5469931 -0.5469809 -0.5468644 -0.5437223 -0.5345196 -0.5232648 -0.5219147 -0.5163001 -0.5058095 -0.4888552 -0.4621851 -0.4315834 -0.3916376 -0.3495063 -0.3070304 -0.2515267 -0.1812351 -8.9818902E-02 3.6307730E-02 0.3118532 -0.5609511 -0.5582891 -0.5557119 -0.5479038 -0.5384074 -0.5246764 -0.5206017 -0.5125865 -0.4997883 -0.4783108 -0.4534195 -0.4220941 -0.3814097 -0.3387766 -0.2952136 -0.2401108 -0.1718391 -8.0594294E-02 4.3369140E-02 0.3118532 -0.5756274 -0.5681177 -0.5625811 -0.5540258 -0.5419407 -0.5258179 -0.5189008 -0.5083282 -0.4904929 -0.4708577 -0.4449268 -0.4111117 -0.3707711 -0.3273847 -0.2833360 -0.2290358 -0.1611151 -7.1242131E-02 5.0638538E-02 0.3118532 -0.5891918 -0.5803052 -0.5717171 -0.5602203 -0.5454819 -0.5269042 -0.5138300 -0.5009243 -0.4849118 -0.4640516 -0.4348615 -0.4012786 -0.3608954 -0.3156570 -0.2717938 -0.2183235 -0.1503349 -6.1777506E-02 5.8163248E-02 0.3118532 -0.6055219 -0.5933205 -0.5817056 -0.5672325 -0.5495028 -0.5253507 -0.5129621 -0.4980469 -0.4805455 -0.4558373 -0.4265751 -0.3927401 -0.3534160 -0.3082736 -0.2609689 -0.2090370 -0.1395741 -5.2582476E-02 6.6010691E-02 0.3118532 -0.6238942 -0.6084946 -0.5934943 -0.5730978 -0.5523915 -0.5289562 -0.5145493 -0.4946061 -0.4752696 -0.4503997 -0.4204031 -0.3861384 -0.3467072 -0.3026050 -0.2525107 -0.1978171 -0.1289689 -4.2910110E-02 7.4305259E-02 0.3118532 -0.6435651 -0.6247932 -0.6064799 -0.5858119 -0.5622604 -0.5337248 -0.5168337 -0.4957541 -0.4741232 -0.4480627 -0.4167035 -0.3820879 -0.3432401 -0.2985969 -0.2479562 -0.1872131 -0.1186914 -3.3329230E-02 8.3151907E-02 0.3118532 -0.6732638 -0.6514342 -0.6272804 -0.6030505 -0.5746443 -0.5454385 -0.5257231 -0.5020987 -0.4768918 -0.4484572 -0.4167354 -0.3816974 -0.3441965 -0.2980398 -0.2429746 -0.1808817 -0.1103402 -2.3728061E-02 9.4021045E-02 0.3118532 -0.7142429 -0.6872735 -0.6607890 -0.6320127 -0.6017746 -0.5718006 -0.5397684 -0.5143551 -0.4863585 -0.4576527 -0.4254982 -0.3911981 -0.3463106 -0.2962674 -0.2403170 -0.1788314 -0.1046230 -1.4805300E-02 0.1073540 0.3118532 -0.7752334 -0.7446421 -0.7138515 -0.6834843 -0.6506289 -0.6197600 -0.5887617 -0.5530066 -0.5203802 -0.4806229 -0.4419534 -0.3993182 -0.3524843 -0.3001786 -0.2438349 -0.1765279 -9.7861655E-02 -3.2455483E-03 0.1226008 0.3118532 -0.8804467 -0.8422171 -0.8116419 -0.7766560 -0.7401189 -0.7028305 -0.6638404 -0.6225663 -0.5799833 -0.5346367 -0.4863539 -0.4396823 -0.3819483 -0.3214371 -0.2532898 -0.1771576 -8.9062408E-02 2.0244638E-02 0.1408293 0.3118532 -1.117577 -1.071443 -1.023901 -0.9801507 -0.9280753 -0.8742912 -0.8186269 -0.7630718 -0.7019728 -0.6385495 -0.5714800 -0.5001983 -0.4233805 -0.3393770 -0.2471141 -0.1503437 -5.0410483E-02 5.3720813E-02 0.1647986 0.3118532 -1.149407 -1.084508 -1.018205 -0.9505122 -0.8814400 -0.8110009 -0.7394511 -0.6660713 -0.5916098 -0.5158330 -0.4387487 -0.3603694 -0.2807073 -0.1997748 -0.1175841 -3.4145661E-02 5.0539941E-02 0.1364427 0.2235511 0.3118532 -0.4850833 -0.5458116 -0.5971192 -0.6797295 -0.7517280 -0.8205894 -0.8782399 -0.9243588 -0.9509905 -0.9806818 -1.022220 -1.051091 -1.060453 -1.049218 -1.006313 -0.9557736 -0.8822517 -0.7588071 -0.5557013 -7.9957083E-02 -0.5104620 -0.5640102 -0.6171914 -0.6962062 -0.7724913 -0.8405198 -0.8944848 -0.9355026 -0.9537765 -0.9845689 -1.025028 -1.048999 -1.057604 -1.042036 -0.9943087 -0.9424024 -0.8685243 -0.7458178 -0.5456743 -7.9957083E-02 -0.5358886 -0.5891110 -0.6466264 -0.7228739 -0.7969313 -0.8570653 -0.9081803 -0.9434924 -0.9588723 -0.9899186 -1.028047 -1.048578 -1.051862 -1.032887 -0.9810937 -0.9285550 -0.8543420 -0.7324849 -0.5354586 -7.9957083E-02 -0.5688868 -0.6203167 -0.6768658 -0.7535890 -0.8168293 -0.8738993 -0.9201039 -0.9479627 -0.9661851 -0.9960099 -1.027677 -1.047017 -1.045823 -1.022003 -0.9675243 -0.9141933 -0.8396922 -0.7187890 -0.5250526 -7.9957083E-02 -0.6081957 -0.6605460 -0.7157505 -0.7798911 -0.8383037 -0.8905186 -0.9281543 -0.9561501 -0.9747294 -1.002221 -1.029215 -1.044237 -1.037108 -1.009098 -0.9534950 -0.8992838 -0.8245616 -0.7045668 -0.5144534 -7.9957083E-02 -0.6562575 -0.7055953 -0.7505003 -0.8073625 -0.8603097 -0.9035618 -0.9391479 -0.9663028 -0.9834829 -1.004319 -1.029438 -1.036783 -1.027181 -0.9949878 -0.9389293 -0.8838050 -0.8089564 -0.6899525 -0.5036777 -7.9957083E-02 -0.7044531 -0.7471271 -0.7854325 -0.8364034 -0.8795416 -0.9191768 -0.9522885 -0.9771277 -0.9891081 -1.008020 -1.024894 -1.028550 -1.015225 -0.9806523 -0.9238400 -0.8677548 -0.7928879 -0.6749725 -0.4927328 -7.9957083E-02 -0.7551848 -0.7890289 -0.8217745 -0.8630251 -0.9016758 -0.9371158 -0.9665036 -0.9856636 -0.9960670 -1.010135 -1.020999 -1.019340 -1.001726 -0.9659301 -0.9082415 -0.8512008 -0.7763765 -0.6596371 -0.4816180 -7.9957083E-02 -0.8074355 -0.8319466 -0.8566104 -0.8926508 -0.9261400 -0.9561573 -0.9790221 -0.9953033 -1.001567 -1.006871 -1.013063 -1.007708 -0.9878970 -0.9508082 -0.8920944 -0.8341538 -0.7594300 -0.6439602 -0.4703365 -7.9957083E-02 -0.8587001 -0.8761187 -0.8952293 -0.9243541 -0.9514711 -0.9737002 -0.9925250 -1.003895 -1.002385 -1.002881 -1.004516 -0.9953057 -0.9735936 -0.9353526 -0.8755673 -0.8166989 -0.7415392 -0.6279734 -0.4588953 -7.9957083E-02 -0.9126514 -0.9236548 -0.9357647 -0.9558433 -0.9754193 -0.9920740 -1.003242 -1.008723 -1.002456 -0.9983063 -0.9949309 -0.9826695 -0.9590862 -0.9196416 -0.8587896 -0.7989783 -0.7229999 -0.6116977 -0.4473101 -7.9957083E-02 -0.9692359 -0.9718997 -0.9763706 -0.9881838 -0.9997521 -1.008307 -1.013731 -1.013129 -1.002258 -0.9930251 -0.9856480 -0.9703167 -0.9446529 -0.9039239 -0.8419540 -0.7810462 -0.7042689 -0.5952219 -0.4356070 -7.9957083E-02 -1.026335 -1.020593 -1.015435 -1.019181 -1.022194 -1.025055 -1.024645 -1.018092 -1.002620 -0.9888669 -0.9773508 -0.9588509 -0.9309373 -0.8886238 -0.8254420 -0.7618341 -0.6855270 -0.5787538 -0.4238351 -7.9957083E-02 -1.083498 -1.069839 -1.057032 -1.052616 -1.047927 -1.043645 -1.037088 -1.025259 -1.005424 -0.9869993 -0.9711496 -0.9493721 -0.9189029 -0.8746143 -0.8107821 -0.7431628 -0.6671020 -0.5625992 -0.4120809 -7.9957083E-02 -1.148717 -1.125320 -1.103932 -1.090903 -1.078231 -1.067027 -1.054617 -1.037472 -1.012933 -0.9896051 -0.9690396 -0.9435501 -0.9102830 -0.8634467 -0.8008817 -0.7259361 -0.6496596 -0.5471949 -0.4004924 -7.9957083E-02 -1.229352 -1.195629 -1.164378 -1.142044 -1.121225 -1.102255 -1.082965 -1.059650 -1.029484 -1.000488 -0.9746097 -0.9442071 -0.9076073 -0.8587581 -0.7952566 -0.7138849 -0.6347803 -0.5333870 -0.3902187 -7.9957083E-02 -1.344702 -1.299233 -1.255750 -1.222453 -1.191625 -1.162977 -1.134677 -1.102879 -1.064353 -1.026784 -0.9940480 -0.9586285 -0.9165079 -0.8641015 -0.7978038 -0.7168050 -0.6254213 -0.5229158 -0.3798801 -7.9957083E-02 -1.536192 -1.474229 -1.413451 -1.365248 -1.321920 -1.280058 -1.239926 -1.198035 -1.152319 -1.101846 -1.046549 -1.002512 -0.9530470 -0.8936099 -0.8227898 -0.7373506 -0.6356131 -0.5225991 -0.3724005 -7.9957083E-02 -1.923291 -1.847692 -1.774216 -1.702048 -1.636473 -1.569304 -1.505583 -1.447011 -1.385396 -1.320064 -1.249485 -1.173219 -1.089244 -0.9989557 -0.9100709 -0.8101620 -0.6884522 -0.5485054 -0.3713406 -7.9957083E-02 -3.430635 -3.299433 -3.162667 -3.020434 -2.872838 -2.719976 -2.561935 -2.399056 -2.230688 -2.057677 -1.879890 -1.697421 -1.510570 -1.318744 -1.122774 -0.9224970 -0.7179586 -0.5093080 -0.2966218 -7.9957083E-02 -0.3977660 -0.5307997 -0.6533186 -0.7490755 -0.8320481 -0.9507800 -1.063509 -1.162017 -1.246146 -1.299344 -1.343809 -1.420732 -1.476610 -1.509530 -1.505905 -1.450976 -1.395751 -1.266083 -1.014683 -0.4074402 -0.4069397 -0.5408933 -0.6631947 -0.7498275 -0.8431897 -0.9668166 -1.078274 -1.179606 -1.260843 -1.303865 -1.349304 -1.424603 -1.479267 -1.509292 -1.498750 -1.436957 -1.379914 -1.249411 -1.000615 -0.4074402 -0.4353223 -0.5621769 -0.6726861 -0.7667888 -0.8660747 -0.9879136 -1.099241 -1.197430 -1.271235 -1.307444 -1.359753 -1.432704 -1.482808 -1.506921 -1.488347 -1.422617 -1.363325 -1.232067 -0.9861958 -0.4074402 -0.4754623 -0.5875283 -0.6970760 -0.7964323 -0.8974851 -1.014962 -1.123108 -1.214168 -1.276149 -1.318340 -1.370705 -1.441109 -1.483818 -1.501929 -1.474383 -1.407656 -1.345863 -1.214026 -0.9714181 -0.4074402 -0.5189034 -0.6283186 -0.7367187 -0.8351286 -0.9341055 -1.046358 -1.146322 -1.226456 -1.285783 -1.331367 -1.384668 -1.445607 -1.483865 -1.493842 -1.458361 -1.391751 -1.327424 -1.195257 -0.9562717 -0.4074402 -0.5756011 -0.6828153 -0.7853208 -0.8801754 -0.9754827 -1.077977 -1.167123 -1.239351 -1.300437 -1.346991 -1.395488 -1.449399 -1.481421 -1.482290 -1.442020 -1.374790 -1.307828 -1.175733 -0.9408038 -0.4074402 -0.6480417 -0.7450781 -0.8398609 -0.9301273 -1.017689 -1.108705 -1.187389 -1.258009 -1.316606 -1.362747 -1.405688 -1.451733 -1.475516 -1.467072 -1.424938 -1.356591 -1.287243 -1.154593 -0.9250463 -0.4074402 -0.7251571 -0.8132929 -0.8997409 -0.9818379 -1.059280 -1.139604 -1.213358 -1.278924 -1.335204 -1.374891 -1.411578 -1.450522 -1.465477 -1.450356 -1.406747 -1.337041 -1.265531 -1.133433 -0.9089989 -0.4074402 -0.8114842 -0.8869009 -0.9631220 -1.034253 -1.102539 -1.175820 -1.242529 -1.302313 -1.351546 -1.385794 -1.415780 -1.444885 -1.450986 -1.432700 -1.387249 -1.316096 -1.242695 -1.111427 -0.8930549 -0.4074402 -0.9026629 -0.9650390 -1.029265 -1.090806 -1.150533 -1.215272 -1.274559 -1.324851 -1.366731 -1.395367 -1.416553 -1.434947 -1.434509 -1.413521 -1.366195 -1.293539 -1.218777 -1.088416 -0.8764202 -0.4074402 -0.9985805 -1.048633 -1.100867 -1.151303 -1.202337 -1.256551 -1.305800 -1.347210 -1.380836 -1.401727 -1.413297 -1.421983 -1.416465 -1.392611 -1.343541 -1.269535 -1.193784 -1.064645 -0.8600461 -0.4074402 -1.100546 -1.136904 -1.176609 -1.216596 -1.256175 -1.298360 -1.336926 -1.368935 -1.392377 -1.403890 -1.407259 -1.408133 -1.396889 -1.369897 -1.319266 -1.244193 -1.167679 -1.040218 -0.8435526 -0.4074402 -1.208642 -1.230755 -1.257129 -1.284866 -1.311890 -1.341301 -1.367963 -1.388384 -1.400726 -1.403905 -1.400324 -1.393653 -1.376136 -1.345902 -1.293679 -1.217839 -1.140562 -1.015305 -0.8260390 -0.4074402 -1.322435 -1.330075 -1.342494 -1.356361 -1.369653 -1.384296 -1.397486 -1.406910 -1.409097 -1.403875 -1.393198 -1.379120 -1.355245 -1.321369 -1.267490 -1.190923 -1.112213 -0.9902927 -0.8083373 -0.4074402 -1.444319 -1.436435 -1.431618 -1.429347 -1.428152 -1.429712 -1.430178 -1.428581 -1.420032 -1.405871 -1.387546 -1.366496 -1.336000 -1.298030 -1.241971 -1.163141 -1.083914 -0.9661159 -0.7906590 -0.4074402 -1.574012 -1.548215 -1.528346 -1.511869 -1.496589 -1.484591 -1.471549 -1.458344 -1.438348 -1.414688 -1.388000 -1.359534 -1.322106 -1.278784 -1.219241 -1.136628 -1.057033 -0.9431106 -0.7734023 -0.4074402 -1.737150 -1.691593 -1.652668 -1.618622 -1.587621 -1.561233 -1.533940 -1.508194 -1.475636 -1.440707 -1.403939 -1.366638 -1.319188 -1.268815 -1.208172 -1.124953 -1.034424 -0.9220606 -0.7574957 -0.4074402 -1.987976 -1.916086 -1.853048 -1.795660 -1.742336 -1.696582 -1.650971 -1.608371 -1.558756 -1.507262 -1.453407 -1.403552 -1.346238 -1.287134 -1.221386 -1.133322 -1.024567 -0.9088737 -0.7450240 -0.4074402 -2.479705 -2.369942 -2.271614 -2.179073 -2.090366 -2.000760 -1.929699 -1.862871 -1.796276 -1.726569 -1.648882 -1.565361 -1.483498 -1.401900 -1.311626 -1.205561 -1.073420 -0.9232599 -0.7453386 -0.4074402 -5.999882 -5.801231 -5.589682 -5.366308 -5.131182 -4.884620 -4.626924 -4.358483 -4.079573 -3.790549 -3.491744 -3.183389 -2.865869 -2.539397 -2.204276 -1.860775 -1.509080 -1.149503 -0.7824514 -0.4074402 -0.2688200 -0.4622210 -0.6450528 -0.8099453 -0.9309538 -1.038523 -1.191563 -1.332458 -1.460219 -1.563539 -1.602919 -1.701631 -1.796257 -1.868220 -1.906056 -1.862237 -1.832208 -1.711262 -1.423493 -0.6887694 -0.2306267 -0.4335587 -0.6274527 -0.7941763 -0.9048570 -1.029892 -1.194282 -1.343652 -1.476487 -1.576376 -1.602299 -1.709165 -1.804978 -1.876177 -1.907642 -1.850026 -1.817457 -1.693066 -1.405540 -0.6887694 -0.2377196 -0.4371268 -0.6270168 -0.7820377 -0.9072256 -1.049411 -1.214573 -1.363413 -1.493243 -1.579447 -1.615937 -1.724685 -1.816471 -1.883116 -1.905132 -1.838775 -1.802017 -1.673850 -1.386945 -0.6887694 -0.2716362 -0.4583375 -0.6354365 -0.7940503 -0.9396071 -1.083375 -1.243113 -1.387864 -1.506254 -1.582426 -1.637240 -1.742659 -1.829026 -1.887632 -1.898178 -1.827587 -1.785465 -1.653540 -1.367662 -0.6887694 -0.3244592 -0.4926223 -0.6667731 -0.8348777 -0.9808134 -1.124008 -1.276619 -1.410645 -1.514287 -1.597328 -1.662722 -1.761150 -1.840021 -1.888922 -1.885872 -1.816264 -1.767579 -1.631486 -1.348047 -0.6887694 -0.3928370 -0.5515190 -0.7225060 -0.8874166 -1.031899 -1.170608 -1.311391 -1.430649 -1.530188 -1.617717 -1.687305 -1.777989 -1.848486 -1.886278 -1.871509 -1.803176 -1.748116 -1.608585 -1.327949 -0.6887694 -0.4832903 -0.6334731 -0.7935467 -0.9479972 -1.089552 -1.220092 -1.344796 -1.455206 -1.554307 -1.641095 -1.709590 -1.791622 -1.852529 -1.878671 -1.857157 -1.788419 -1.727582 -1.584028 -1.307383 -0.6887694 -0.5917383 -0.7284073 -0.8730141 -1.017599 -1.150024 -1.268513 -1.381755 -1.487626 -1.583552 -1.665020 -1.729469 -1.801476 -1.851550 -1.865937 -1.842286 -1.771379 -1.704140 -1.558260 -1.286338 -0.6887694 -0.7083721 -0.8327825 -0.9639444 -1.092636 -1.211275 -1.320277 -1.426144 -1.524838 -1.613842 -1.688626 -1.746379 -1.806802 -1.845087 -1.851576 -1.824935 -1.751683 -1.678596 -1.530968 -1.264780 -0.6887694 -0.8376889 -0.9465469 -1.059469 -1.172493 -1.278497 -1.378695 -1.475252 -1.564077 -1.643549 -1.710729 -1.760174 -1.807625 -1.834016 -1.835352 -1.804731 -1.729867 -1.651514 -1.502104 -1.242708 -0.6887694 -0.9766544 -1.065187 -1.160457 -1.259545 -1.353242 -1.441896 -1.526675 -1.603494 -1.672139 -1.729759 -1.770032 -1.803829 -1.820727 -1.815820 -1.781001 -1.703480 -1.621239 -1.471636 -1.220120 -0.6887694 -1.122813 -1.191363 -1.270337 -1.354054 -1.433167 -1.507125 -1.578626 -1.643072 -1.698560 -1.745032 -1.774916 -1.797161 -1.804718 -1.792753 -1.754041 -1.673678 -1.588963 -1.439335 -1.197020 -0.6887694 -1.280232 -1.328696 -1.388168 -1.452924 -1.515587 -1.574294 -1.631194 -1.681290 -1.722370 -1.756132 -1.775506 -1.787366 -1.785132 -1.765899 -1.722344 -1.641255 -1.553831 -1.405403 -1.173400 -0.6887694 -1.445882 -1.472248 -1.510132 -1.556660 -1.601558 -1.643126 -1.684093 -1.718313 -1.743619 -1.763375 -1.772288 -1.773880 -1.761992 -1.735618 -1.687750 -1.605083 -1.516451 -1.370403 -1.149324 -0.6887694 -1.621606 -1.625340 -1.641152 -1.666550 -1.691995 -1.714901 -1.737632 -1.753764 -1.763069 -1.768900 -1.766417 -1.757610 -1.736370 -1.702740 -1.650229 -1.565946 -1.476613 -1.335023 -1.124894 -0.6887694 -1.813239 -1.794133 -1.785395 -1.786049 -1.788505 -1.790146 -1.794518 -1.793211 -1.786188 -1.776108 -1.761023 -1.741175 -1.711069 -1.669516 -1.612054 -1.525292 -1.436066 -1.300243 -1.100443 -0.6887694 -2.032191 -1.984197 -1.947597 -1.925310 -1.904940 -1.884480 -1.868624 -1.847417 -1.822540 -1.794327 -1.765631 -1.733657 -1.693115 -1.642080 -1.577540 -1.492793 -1.397645 -1.267706 -1.076779 -0.6887694 -2.338155 -2.252403 -2.180559 -2.128937 -2.081249 -2.034045 -1.994261 -1.950333 -1.903397 -1.852462 -1.804988 -1.754278 -1.697967 -1.635257 -1.563824 -1.474929 -1.369334 -1.241554 -1.056286 -0.6887694 -2.933463 -2.792673 -2.660432 -2.554575 -2.457202 -2.364600 -2.291259 -2.218495 -2.140988 -2.059693 -1.977463 -1.894387 -1.813268 -1.723334 -1.623833 -1.516744 -1.381576 -1.240156 -1.048107 -0.6887694 -8.816086 -8.548119 -8.258288 -7.947386 -7.616139 -7.265341 -6.895776 -6.508225 -6.103409 -5.682073 -5.244838 -4.792400 -4.325284 -3.844129 -3.349381 -2.841614 -2.321222 -1.788698 -1.244411 -0.6887694 -0.1755102 -0.3840109 -0.6177348 -0.8355017 -1.022115 -1.123234 -1.301300 -1.473330 -1.634699 -1.778222 -1.865915 -1.934602 -2.059338 -2.159767 -2.232683 -2.223538 -2.202359 -2.102967 -1.792907 -0.9353619 -6.6847108E-02 -0.3014934 -0.5492799 -0.7824207 -0.9736712 -1.081496 -1.281088 -1.468130 -1.643777 -1.794915 -1.862517 -1.944263 -2.073442 -2.175317 -2.244250 -2.215700 -2.191282 -2.085492 -1.772074 -0.9353619 -3.9398294E-02 -0.2790067 -0.5265813 -0.7539052 -0.9359648 -1.091624 -1.291809 -1.483741 -1.661370 -1.805059 -1.866009 -1.968556 -2.094249 -2.192021 -2.251598 -2.207254 -2.180315 -2.066614 -1.750292 -0.9353619 -5.6708246E-02 -0.2937331 -0.5323872 -0.7474385 -0.9448941 -1.116447 -1.319433 -1.510237 -1.682292 -1.807505 -1.890631 -2.001210 -2.118674 -2.207339 -2.254733 -2.200747 -2.169446 -2.046304 -1.727516 -0.9353619 -0.1078487 -0.3325609 -0.5606880 -0.7789865 -0.9780156 -1.160843 -1.358335 -1.543955 -1.700650 -1.823490 -1.922258 -2.033746 -2.142116 -2.220454 -2.252188 -2.194959 -2.156159 -2.024300 -1.703688 -0.9353619 -0.1834096 -0.3951793 -0.6184852 -0.8315328 -1.032758 -1.218006 -1.409137 -1.577948 -1.722872 -1.850240 -1.956061 -2.062773 -2.161840 -2.230412 -2.243939 -2.188895 -2.140786 -2.000396 -1.678784 -0.9353619 -0.2851104 -0.4834437 -0.6959934 -0.9045888 -1.102778 -1.286398 -1.459983 -1.616690 -1.757287 -1.882461 -1.987851 -2.088036 -2.177533 -2.234905 -2.236229 -2.181250 -2.122821 -1.974445 -1.653093 -0.9353619 -0.4088758 -0.5936905 -0.7954417 -0.9950910 -1.185006 -1.353658 -1.515767 -1.664170 -1.796804 -1.916050 -2.017793 -2.109578 -2.188656 -2.232349 -2.228315 -2.171240 -2.102569 -1.946275 -1.627085 -0.9353619 -0.5557927 -0.7250357 -0.9128355 -1.097466 -1.268165 -1.427824 -1.577560 -1.714086 -1.837502 -1.950096 -2.045908 -2.127893 -2.194926 -2.226376 -2.217799 -2.156163 -2.078434 -1.915631 -1.600613 -0.9353619 -0.7217538 -0.8735506 -1.038328 -1.204292 -1.362195 -1.506630 -1.640869 -1.765878 -1.879672 -1.983295 -2.071103 -2.142820 -2.195857 -2.218283 -2.203243 -2.136275 -2.049835 -1.882486 -1.573395 -0.9353619 -0.8995335 -1.027661 -1.173189 -1.320693 -1.458900 -1.587431 -1.707612 -1.820191 -1.922466 -2.014748 -2.092691 -2.152888 -2.193470 -2.206532 -2.183739 -2.111355 -2.017072 -1.846728 -1.545389 -0.9353619 -1.090136 -1.196059 -1.316308 -1.440102 -1.559263 -1.673192 -1.778737 -1.876287 -1.964139 -2.043672 -2.109205 -2.158026 -2.187138 -2.189727 -2.158017 -2.079887 -1.979808 -1.808096 -1.516566 -0.9353619 -1.294230 -1.372092 -1.465405 -1.567526 -1.667960 -1.764134 -1.851656 -1.931899 -2.004409 -2.068948 -2.120583 -2.157516 -2.174816 -2.166222 -2.126132 -2.041685 -1.937784 -1.766541 -1.486955 -0.9353619 -1.508601 -1.560457 -1.627769 -1.705382 -1.781792 -1.856468 -1.925233 -1.986750 -2.041659 -2.089963 -2.126275 -2.149196 -2.155119 -2.135609 -2.087206 -1.997388 -1.891169 -1.722437 -1.456549 -0.9353619 -1.740633 -1.761350 -1.798809 -1.849525 -1.901566 -1.952358 -1.998983 -2.039974 -2.076198 -2.104950 -2.124639 -2.133147 -2.127913 -2.097729 -2.041731 -1.947425 -1.839983 -1.676939 -1.425428 -0.9353619 -1.988204 -1.977875 -1.984909 -2.006238 -2.030829 -2.055039 -2.075499 -2.091269 -2.106592 -2.115500 -2.118750 -2.111310 -2.094358 -2.054207 -1.991100 -1.892995 -1.784295 -1.630030 -1.393734 -0.9353619 -2.270710 -2.227051 -2.197526 -2.184174 -2.176514 -2.169675 -2.161733 -2.150877 -2.143628 -2.129782 -2.114854 -2.089761 -2.060574 -2.010096 -1.939227 -1.836737 -1.727434 -1.583432 -1.361986 -0.9353619 -2.638855 -2.546597 -2.475569 -2.424610 -2.379827 -2.336899 -2.294443 -2.250742 -2.214500 -2.174415 -2.136669 -2.089974 -2.043593 -1.977530 -1.897468 -1.794508 -1.676908 -1.540494 -1.331484 -0.9353619 -3.337235 -3.167624 -3.020285 -2.904551 -2.802525 -2.701193 -2.602604 -2.510710 -2.433537 -2.356495 -2.278259 -2.195838 -2.113278 -2.028296 -1.922095 -1.801608 -1.658537 -1.516420 -1.309974 -0.9353619 -11.84672 -11.50831 -11.13606 -10.73146 -10.29597 -9.831173 -9.338581 -8.819549 -8.275471 -7.707613 -7.117062 -6.504939 -5.872247 -5.219848 -4.548626 -3.859365 -3.152752 -2.429479 -1.690164 -0.9353619 -9.3415476E-02 -0.3127278 -0.5990692 -0.8600177 -1.094927 -1.264776 -1.401720 -1.602840 -1.790313 -1.960782 -2.089750 -2.135885 -2.283127 -2.405419 -2.505432 -2.531384 -2.517326 -2.447001 -2.131383 -1.154860 8.2795545E-02 -0.1707803 -0.4714488 -0.7560481 -1.011591 -1.170771 -1.359757 -1.579256 -1.785968 -1.972938 -2.096204 -2.145237 -2.301179 -2.426357 -2.526379 -2.532260 -2.511295 -2.432226 -2.108644 -1.154860 0.1553604 -0.1158273 -0.4145543 -0.6986536 -0.9404883 -1.142887 -1.360507 -1.589026 -1.796093 -1.986888 -2.089014 -2.180404 -2.333241 -2.451661 -2.543673 -2.525869 -2.507761 -2.416078 -2.084606 -1.154860 0.1625013 -0.1160344 -0.4036953 -0.6747599 -0.9233964 -1.154939 -1.385074 -1.607135 -1.817912 -1.998778 -2.112977 -2.229680 -2.369401 -2.477745 -2.557475 -2.524628 -2.503423 -2.398196 -2.059197 -1.154860 0.1216178 -0.1527023 -0.4284649 -0.6942789 -0.9521304 -1.193171 -1.419024 -1.639464 -1.847814 -2.017569 -2.150426 -2.277255 -2.404336 -2.502407 -2.566060 -2.526989 -2.498127 -2.378173 -2.032336 -1.154860 4.3620124E-02 -0.2194014 -0.4905342 -0.7530736 -1.008312 -1.244697 -1.468603 -1.687312 -1.885204 -2.051952 -2.195615 -2.318725 -2.435851 -2.524205 -2.567152 -2.530498 -2.491713 -2.355590 -2.003938 -1.154860 -6.7664400E-02 -0.3191592 -0.5824242 -0.8385627 -1.080297 -1.310640 -1.534225 -1.746256 -1.932012 -2.097775 -2.236960 -2.355665 -2.463583 -2.540693 -2.566965 -2.533119 -2.480757 -2.330168 -1.974327 -1.154860 -0.2097085 -0.4452573 -0.6982549 -0.9371805 -1.168715 -1.394746 -1.612105 -1.810488 -1.986568 -2.145330 -2.277318 -2.389979 -2.488180 -2.550655 -2.567900 -2.531484 -2.466236 -2.301644 -1.943764 -1.154860 -0.3772802 -0.5930772 -0.8250491 -1.054310 -1.276758 -1.493832 -1.693251 -1.878436 -2.044430 -2.189411 -2.315754 -2.421573 -2.508982 -2.556379 -2.566762 -2.524906 -2.446022 -2.269720 -1.912120 -1.154860 -0.5650486 -0.7589132 -0.9740783 -1.190400 -1.399964 -1.594128 -1.778424 -1.948695 -2.097865 -2.231984 -2.351589 -2.449925 -2.524405 -2.561032 -2.562112 -2.512502 -2.420317 -2.234219 -1.879702 -1.154860 -0.7764147 -0.9485622 -1.143935 -1.336781 -1.522094 -1.701784 -1.865015 -2.014923 -2.151082 -2.274498 -2.384334 -2.472691 -2.534860 -2.561573 -2.551551 -2.492368 -2.388351 -2.194889 -1.846532 -1.154860 -1.010203 -1.154046 -1.319254 -1.489958 -1.653908 -1.807594 -1.949311 -2.083091 -2.206063 -2.316364 -2.412135 -2.489012 -2.540123 -2.555457 -2.533981 -2.463748 -2.349895 -2.151513 -1.812137 -1.154860 -1.254371 -1.371613 -1.508598 -1.650162 -1.785860 -1.915676 -2.038407 -2.154696 -2.260432 -2.355271 -2.434964 -2.498417 -2.537184 -2.540145 -2.507413 -2.426557 -2.304655 -2.103844 -1.776495 -1.154860 -1.519946 -1.601945 -1.704317 -1.816003 -1.927337 -2.032829 -2.131928 -2.226107 -2.312456 -2.389510 -2.451592 -2.498864 -2.523386 -2.513682 -2.470307 -2.380151 -2.252390 -2.052035 -1.739535 -1.154860 -1.801175 -1.847523 -1.916989 -1.996560 -2.077212 -2.153754 -2.227151 -2.296721 -2.360746 -2.417030 -2.460366 -2.487957 -2.497003 -2.474786 -2.421820 -2.324498 -2.192981 -1.996403 -1.701239 -1.154860 -2.106984 -2.113071 -2.143854 -2.188143 -2.235938 -2.280635 -2.324524 -2.366457 -2.404241 -2.435701 -2.458387 -2.466075 -2.458575 -2.423676 -2.362130 -2.259944 -2.126755 -1.938048 -1.661686 -1.154860 -2.447434 -2.411016 -2.399256 -2.404006 -2.414333 -2.420332 -2.427991 -2.438128 -2.445489 -2.450660 -2.450949 -2.437067 -2.411749 -2.363927 -2.294069 -2.188203 -2.053973 -1.877069 -1.621117 -1.154860 -2.884006 -2.790274 -2.723323 -2.679764 -2.643872 -2.606418 -2.570442 -2.542432 -2.512400 -2.484067 -2.457150 -2.418794 -2.371654 -2.307284 -2.224730 -2.115652 -1.980170 -1.816239 -1.580898 -1.154860 -3.685809 -3.497877 -3.333759 -3.212942 -3.106146 -2.997941 -2.892706 -2.803058 -2.711727 -2.627877 -2.561567 -2.484160 -2.399953 -2.311718 -2.204223 -2.080762 -1.924754 -1.767451 -1.547659 -1.154860 -15.06665 -14.65645 -14.19795 -13.69369 -13.14634 -12.55851 -11.93264 -11.27105 -10.57585 -9.848976 -9.092179 -8.307023 -7.494976 -6.657360 -5.795371 -4.910096 -4.002528 -3.073581 -2.124098 -1.154860 1.2279623E-02 -0.2661690 -0.5750152 -0.8813115 -1.162489 -1.388826 -1.503459 -1.728532 -1.932910 -2.124798 -2.286015 -2.312716 -2.481287 -2.619781 -2.740549 -2.797633 -2.788366 -2.749454 -2.443128 -1.352634 0.2597659 -3.7521955E-02 -0.3857493 -0.7263436 -1.040880 -1.263072 -1.434543 -1.683202 -1.913869 -2.132200 -2.298921 -2.320366 -2.501289 -2.645236 -2.769705 -2.808380 -2.788782 -2.738887 -2.419600 -1.352634 0.3863334 5.4985553E-02 -0.3010617 -0.6438344 -0.9455705 -1.191032 -1.425458 -1.681035 -1.920509 -2.145109 -2.287834 -2.369533 -2.542744 -2.678816 -2.796695 -2.806834 -2.792027 -2.727116 -2.394376 -1.352634 0.4098611 7.0801660E-02 -0.2771066 -0.6034757 -0.9007364 -1.179165 -1.437044 -1.698797 -1.944053 -2.157902 -2.308231 -2.436877 -2.589182 -2.715331 -2.821221 -2.810546 -2.797177 -2.713506 -2.367362 -1.352634 0.3707335 3.6561415E-02 -0.2933170 -0.6088874 -0.9128886 -1.199888 -1.471890 -1.734107 -1.971390 -2.176638 -2.353053 -2.495870 -2.636639 -2.750777 -2.841338 -2.821570 -2.803535 -2.697357 -2.338450 -1.352634 0.2880534 -3.1104898E-02 -0.3520049 -0.6608890 -0.9590368 -1.251072 -1.525511 -1.781174 -2.012107 -2.222986 -2.407610 -2.551858 -2.680054 -2.783915 -2.854320 -2.835341 -2.806440 -2.678235 -2.307520 -1.352634 0.1693032 -0.1358142 -0.4464408 -0.7459190 -1.039038 -1.324543 -1.591577 -1.840741 -2.071533 -2.286453 -2.461350 -2.605092 -2.721903 -2.813160 -2.863701 -2.848603 -2.804427 -2.655701 -2.274792 -1.352634 1.4620077E-02 -0.2726393 -0.5701958 -0.8596180 -1.142588 -1.412920 -1.669151 -1.917707 -2.147122 -2.346169 -2.518001 -2.652758 -2.761643 -2.837537 -2.875937 -2.858263 -2.797491 -2.629369 -2.240870 -1.352634 -0.1723456 -0.4382865 -0.7190631 -0.9968783 -1.258152 -1.515224 -1.766814 -2.009553 -2.219772 -2.408203 -2.567774 -2.695361 -2.796438 -2.858160 -2.887675 -2.863517 -2.784596 -2.598705 -2.205612 -1.352634 -0.3850942 -0.6286941 -0.8884183 -1.142895 -1.391319 -1.638486 -1.880681 -2.097039 -2.294233 -2.465017 -2.612018 -2.733344 -2.824949 -2.877154 -2.895727 -2.861478 -2.764848 -2.563395 -2.168853 -1.352634 -0.6241416 -0.8375727 -1.074147 -1.312220 -1.545979 -1.772821 -1.986315 -2.187835 -2.363928 -2.517172 -2.653336 -2.765917 -2.846846 -2.891023 -2.897780 -2.850496 -2.737864 -2.523046 -2.130348 -1.352634 -0.8854823 -1.071331 -1.285713 -1.501648 -1.705869 -1.905048 -2.097447 -2.271377 -2.428410 -2.569330 -2.691916 -2.792195 -2.862668 -2.896843 -2.890840 -2.829778 -2.703074 -2.477362 -2.091001 -1.352634 -1.175237 -1.329005 -1.508452 -1.692670 -1.872714 -2.040382 -2.201320 -2.352911 -2.494055 -2.620502 -2.726737 -2.812768 -2.870405 -2.891893 -2.872386 -2.797937 -2.659575 -2.425723 -2.049823 -1.352634 -1.481719 -1.600030 -1.744287 -1.894413 -2.037761 -2.174912 -2.311078 -2.439436 -2.559167 -2.666901 -2.755707 -2.824501 -2.866920 -2.872925 -2.840409 -2.753849 -2.606435 -2.368209 -2.006671 -1.352634 -1.817019 -1.888953 -1.990152 -2.103720 -2.215549 -2.321217 -2.426364 -2.527105 -2.621344 -2.706686 -2.774872 -2.824117 -2.848339 -2.837945 -2.792711 -2.696081 -2.542758 -2.305180 -1.961508 -1.352634 -2.178613 -2.204881 -2.260641 -2.330963 -2.403688 -2.473830 -2.544440 -2.614363 -2.678870 -2.736798 -2.780343 -2.807313 -2.812255 -2.785443 -2.727870 -2.624074 -2.468298 -2.236275 -1.914260 -1.352634 -2.578226 -2.551885 -2.557592 -2.580711 -2.609908 -2.638989 -2.669326 -2.701232 -2.731232 -2.755711 -2.771757 -2.774623 -2.759468 -2.716574 -2.646849 -2.538605 -2.383292 -2.162953 -1.865010 -1.352634 -3.078195 -2.985210 -2.929047 -2.892938 -2.866837 -2.843899 -2.823454 -2.808654 -2.798858 -2.783259 -2.765605 -2.738787 -2.701223 -2.639956 -2.555986 -2.443284 -2.291898 -2.086871 -1.814669 -1.352634 -3.956423 -3.757896 -3.603686 -3.473963 -3.360107 -3.254103 -3.153633 -3.062121 -2.989047 -2.910318 -2.832900 -2.762817 -2.690169 -2.600601 -2.492087 -2.370174 -2.209903 -2.017458 -1.768950 -1.352634 -18.45619 -17.97285 -17.42436 -16.81479 -16.14832 -15.42902 -14.66058 -13.84639 -12.98948 -12.09257 -11.15809 -10.18822 -9.184905 -8.149888 -7.084743 -5.990892 -4.869629 -3.722126 -2.549463 -1.352634 0.1235163 -0.2445288 -0.5578912 -0.9019005 -1.218399 -1.492653 -1.601539 -1.852043 -2.071685 -2.277272 -2.460415 -2.473653 -2.659347 -2.811987 -2.949261 -3.032750 -3.026134 -3.016181 -2.731236 -1.532598 0.4556082 8.2594052E-02 -0.2997121 -0.6819240 -1.047084 -1.349964 -1.514470 -1.791366 -2.038662 -2.276206 -2.479945 -2.479837 -2.681616 -2.841633 -2.986191 -3.054420 -3.030595 -3.010598 -2.708129 -1.532598 0.6317241 0.2280427 -0.1759869 -0.5673150 -0.9407834 -1.243604 -1.499808 -1.781037 -2.037242 -2.288999 -2.478010 -2.541800 -2.732804 -2.884337 -3.023045 -3.061021 -3.042575 -3.004399 -2.682917 -1.532598 0.6737590 0.2736205 -0.1318818 -0.5238632 -0.8848716 -1.207404 -1.501049 -1.786774 -2.054997 -2.307282 -2.489208 -2.620501 -2.790819 -2.932603 -3.058515 -3.068940 -3.059589 -2.996543 -2.655469 -1.532598 0.6418356 0.2479870 -0.1503397 -0.5292481 -0.8803625 -1.213652 -1.521816 -1.814473 -2.088837 -2.331435 -2.534003 -2.693123 -2.850163 -2.981125 -3.090381 -3.088484 -3.074996 -2.986250 -2.625651 -1.532598 0.5524925 0.1705311 -0.2142877 -0.5735317 -0.9181112 -1.251001 -1.564433 -1.865568 -2.139916 -2.376100 -2.594056 -2.766563 -2.909191 -3.028227 -3.116664 -3.113305 -3.089062 -2.972712 -2.593298 -1.532598 0.4189877 5.5103455E-02 -0.3076922 -0.6554723 -0.9909349 -1.316859 -1.634323 -1.933594 -2.194675 -2.441100 -2.663760 -2.833218 -2.968921 -3.071433 -3.138478 -3.137941 -3.097888 -2.955478 -2.558507 -1.532598 0.2503051 -8.9978799E-02 -0.4358605 -0.7688141 -1.093077 -1.414440 -1.724985 -2.007060 -2.270122 -2.518716 -2.731784 -2.896469 -3.022634 -3.110747 -3.163481 -3.161015 -3.101954 -2.933920 -2.522206 -1.532598 4.8618216E-02 -0.2682836 -0.5941159 -0.9125004 -1.224544 -1.535699 -1.822468 -2.100450 -2.362723 -2.599134 -2.796273 -2.951034 -3.068429 -3.145498 -3.188238 -3.178657 -3.100148 -2.907220 -2.484269 -1.532598 -0.1866659 -0.4759685 -0.7817253 -1.083557 -1.376657 -1.660212 -1.940498 -2.212550 -2.461303 -2.673328 -2.856606 -2.998108 -3.107484 -3.177102 -3.209103 -3.188213 -3.090613 -2.875042 -2.444480 -1.532598 -0.4518197 -0.7101185 -0.9955728 -1.270045 -1.539099 -1.809067 -2.078063 -2.326843 -2.551403 -2.746315 -2.907892 -3.040550 -3.140329 -3.203252 -3.223547 -3.188289 -3.072354 -2.836787 -2.402613 -1.532598 -0.7449098 -0.9687685 -1.222724 -1.475878 -1.727016 -1.976349 -2.211780 -2.435842 -2.636742 -2.807925 -2.955684 -3.078651 -3.168061 -3.221202 -3.228491 -3.177099 -3.044614 -2.791999 -2.358274 -1.532598 -1.063737 -1.254575 -1.478451 -1.705838 -1.922229 -2.136516 -2.346766 -2.537486 -2.711808 -2.867048 -3.001256 -3.111399 -3.188940 -3.227307 -3.220838 -3.152721 -3.005758 -2.739415 -2.312174 -1.532598 -1.418850 -1.566374 -1.747884 -1.938377 -2.122440 -2.299682 -2.471674 -2.635737 -2.788531 -2.924914 -3.040640 -3.134989 -3.197999 -3.219314 -3.197208 -3.113507 -2.954050 -2.678932 -2.263455 -1.532598 -1.796475 -1.898942 -2.036514 -2.181680 -2.323088 -2.464549 -2.604728 -2.739969 -2.865334 -2.977443 -3.070247 -3.144870 -3.190450 -3.193147 -3.154001 -3.056826 -2.888070 -2.610683 -2.211859 -1.532598 -2.209616 -2.258228 -2.345162 -2.443601 -2.542424 -2.641774 -2.743124 -2.843037 -2.938133 -3.020175 -3.085929 -3.136019 -3.160747 -3.144512 -3.088270 -2.981134 -2.807079 -2.533521 -2.157153 -1.532598 -2.670250 -2.657007 -2.685347 -2.728775 -2.777645 -2.830698 -2.888636 -2.945765 -3.003563 -3.048660 -3.081851 -3.103733 -3.105786 -3.070707 -2.998961 -2.885465 -2.711472 -2.450064 -2.099176 -1.532598 -3.229071 -3.141254 -3.101131 -3.076810 -3.061330 -3.055129 -3.057863 -3.062541 -3.071837 -3.074245 -3.067111 -3.056600 -3.031146 -2.976476 -2.890113 -2.770759 -2.602867 -2.360948 -2.037949 -1.532598 -4.185158 -3.969456 -3.821310 -3.696158 -3.580369 -3.477776 -3.391364 -3.313601 -3.247732 -3.182838 -3.111104 -3.047676 -2.980614 -2.898608 -2.790260 -2.664654 -2.495512 -2.274531 -1.976669 -1.532598 -21.99948 -21.44168 -20.79978 -20.07917 -19.28680 -18.42823 -17.50868 -16.53278 -15.50462 -14.42781 -13.30551 -12.14054 -10.93536 -9.692162 -8.412925 -7.099411 -5.753232 -4.375835 -2.968550 -1.532598 0.2368323 -0.2137459 -0.5521610 -0.9329879 -1.277230 -1.583060 -1.709833 -1.970243 -2.205636 -2.422674 -2.620224 -2.640990 -2.823337 -2.986300 -3.137675 -3.242904 -3.234532 -3.253332 -2.997462 -1.697697 0.6545547 0.1977580 -0.2229364 -0.6454241 -1.046147 -1.403195 -1.593204 -1.900682 -2.161732 -2.416875 -2.642917 -2.639090 -2.848766 -3.020694 -3.182625 -3.276106 -3.243880 -3.253225 -2.975950 -1.697697 0.8739359 0.3963733 -5.7468995E-02 -0.4916438 -0.9073467 -1.271705 -1.581626 -1.884745 -2.158971 -2.426606 -2.649602 -2.714150 -2.909013 -3.074042 -3.229576 -3.293224 -3.264512 -3.253367 -2.951972 -1.697697 0.9401958 0.4725908 1.0613542E-02 -0.4266863 -0.8435716 -1.235161 -1.574185 -1.882595 -2.173246 -2.444520 -2.659907 -2.800678 -2.979160 -3.134217 -3.275725 -3.305101 -3.291411 -3.252337 -2.925333 -1.697697 0.9159779 0.4597155 6.4026937E-03 -0.4276341 -0.8465665 -1.235420 -1.578384 -1.904728 -2.199997 -2.475966 -2.709511 -2.880618 -3.054591 -3.196411 -3.320140 -3.333520 -3.318800 -3.249376 -2.895834 -1.697697 0.8219097 0.3856325 -5.6212418E-02 -0.4812273 -0.8858638 -1.256986 -1.612591 -1.940889 -2.248738 -2.527950 -2.768591 -2.963089 -3.129743 -3.259332 -3.360795 -3.369657 -3.343321 -3.243302 -2.863272 -1.697697 0.6802914 0.2613857 -0.1632784 -0.5684566 -0.9488822 -1.318226 -1.668386 -2.002876 -2.312935 -2.590654 -2.838751 -3.044353 -3.202311 -3.317372 -3.396327 -3.407082 -3.365217 -3.233424 -2.827589 -1.697697 0.4953397 9.8054528E-02 -0.3005772 -0.6799863 -1.048678 -1.406772 -1.756429 -2.088080 -2.391047 -2.666082 -2.918373 -3.118083 -3.270238 -3.370525 -3.433824 -3.442409 -3.382763 -3.218810 -2.789979 -1.697697 0.2729820 -9.3267985E-02 -0.4652051 -0.8268613 -1.178661 -1.529149 -1.870175 -2.189122 -2.481856 -2.757983 -3.002418 -3.186610 -3.328668 -3.418047 -3.470603 -3.472018 -3.393043 -3.198435 -2.750459 -1.697697 1.9478237E-02 -0.3151894 -0.6636230 -1.005701 -1.342326 -1.677765 -1.996932 -2.300769 -2.592964 -2.859815 -3.077737 -3.251544 -3.378474 -3.461437 -3.503474 -3.493426 -3.393919 -3.171709 -2.708683 -1.697697 -0.2696842 -0.5695649 -0.8936576 -1.214102 -1.530388 -1.835337 -2.138480 -2.434570 -2.713490 -2.947975 -3.151311 -3.306365 -3.422336 -3.498623 -3.530217 -3.504774 -3.385062 -3.137660 -2.664343 -1.697697 -0.5899208 -0.8553829 -1.151237 -1.440454 -1.726071 -2.014565 -2.303880 -2.573576 -2.819848 -3.032026 -3.210056 -3.354759 -3.461686 -3.527588 -3.547390 -3.504516 -3.365429 -3.095375 -2.617093 -1.697697 -0.9418966 -1.167406 -1.425502 -1.687670 -1.950046 -2.211604 -2.462901 -2.705588 -2.918948 -3.101408 -3.263517 -3.397851 -3.493588 -3.545937 -3.551336 -3.490400 -3.333029 -3.043581 -2.566434 -1.697697 -1.327147 -1.510835 -1.733765 -1.956826 -2.178525 -2.404527 -2.619244 -2.821789 -3.005497 -3.168979 -3.313156 -3.431418 -3.513862 -3.550561 -3.538164 -3.459613 -3.285528 -2.981766 -2.513316 -1.697697 -1.751893 -1.881927 -2.055272 -2.236137 -2.413186 -2.591465 -2.767387 -2.937880 -3.094871 -3.233505 -3.354774 -3.451897 -3.517111 -3.535476 -3.503720 -3.408272 -3.220689 -2.910049 -2.456438 -1.697697 -2.216790 -2.287750 -2.402022 -2.527923 -2.656004 -2.790784 -2.926712 -3.058243 -3.181754 -3.289644 -3.382087 -3.453892 -3.496503 -3.493181 -3.443207 -3.332927 -3.137189 -2.827384 -2.395414 -1.697697 -2.734307 -2.736988 -2.786316 -2.850744 -2.922218 -3.004105 -3.091724 -3.178031 -3.259997 -3.330894 -3.386150 -3.427740 -3.442850 -3.418159 -3.352346 -3.230836 -3.034194 -2.733160 -2.329780 -1.697697 -3.351433 -3.266789 -3.240937 -3.234094 -3.236446 -3.249762 -3.274962 -3.304333 -3.333144 -3.356643 -3.368948 -3.373995 -3.356721 -3.309905 -3.230638 -3.101759 -2.911358 -2.629654 -2.259106 -1.697697 -4.377232 -4.155059 -4.008133 -3.884072 -3.772417 -3.680374 -3.608914 -3.550018 -3.497037 -3.445425 -3.392763 -3.340138 -3.270549 -3.195194 -3.097759 -2.963065 -2.782809 -2.521266 -2.184570 -1.697697 -25.68348 -25.04990 -24.31052 -23.47415 -22.54947 -21.54437 -20.46580 -19.31986 -18.11180 -16.84617 -15.52692 -14.15750 -12.74092 -11.27988 -9.776755 -8.233667 -6.652546 -5.035143 -3.383041 -1.697697 0.3545890 -0.1789188 -0.5522880 -0.9738308 -1.347772 -1.674163 -1.860912 -2.077883 -2.329219 -2.560973 -2.768518 -2.829644 -2.974764 -3.147448 -3.309818 -3.431476 -3.422370 -3.466349 -3.243032 -1.850200 0.8594161 0.3210880 -0.1569837 -0.6301571 -1.058757 -1.450267 -1.680535 -1.994964 -2.281108 -2.550666 -2.794680 -2.808235 -3.005185 -3.186624 -3.363239 -3.476768 -3.437021 -3.471990 -3.224123 -1.850200 1.117525 0.5641778 4.8988100E-02 -0.4316525 -0.8803249 -1.286928 -1.643505 -1.984690 -2.282251 -2.561668 -2.806385 -2.887267 -3.078184 -3.250097 -3.419902 -3.503887 -3.468213 -3.479229 -3.202412 -1.850200 1.205825 0.6636366 0.1446373 -0.3374268 -0.7967454 -1.231689 -1.633185 -1.985635 -2.290788 -2.583485 -2.816192 -2.982528 -3.161456 -3.323764 -3.477191 -3.521796 -3.505326 -3.486115 -3.177663 -1.850200 1.186213 0.6667769 0.1574134 -0.3263183 -0.7879738 -1.233241 -1.640053 -1.993020 -2.317555 -2.613014 -2.871111 -3.069934 -3.248159 -3.401538 -3.535959 -3.561832 -3.543925 -3.491826 -3.149587 -1.850200 1.092001 0.5954353 0.1010450 -0.3722651 -0.8310396 -1.266747 -1.660190 -2.022246 -2.357314 -2.664081 -2.937852 -3.152758 -3.334635 -3.477142 -3.591534 -3.610540 -3.581478 -3.494788 -3.117894 -1.850200 0.9403768 0.4687993 -6.8942788E-03 -0.4658141 -0.9092093 -1.321945 -1.710322 -2.076187 -2.416076 -2.732823 -3.006376 -3.235257 -3.421035 -3.549737 -3.640668 -3.660446 -3.616522 -3.493865 -3.082394 -1.850200 0.7431927 0.2964898 -0.1567356 -0.5934049 -1.007802 -1.407714 -1.791420 -2.154732 -2.499724 -2.813151 -3.085005 -3.320095 -3.497806 -3.617336 -3.690040 -3.706794 -3.646175 -3.487865 -3.044548 -1.850200 0.5039673 8.5758328E-02 -0.3374417 -0.7421711 -1.139001 -1.524813 -1.900104 -2.263050 -2.600644 -2.901965 -3.178617 -3.405740 -3.570350 -3.677960 -3.739065 -3.747227 -3.668110 -3.475721 -3.004511 -1.850200 0.2270329 -0.1524611 -0.5431228 -0.9266686 -1.302410 -1.675808 -2.041118 -2.389135 -2.707065 -3.011527 -3.280611 -3.484726 -3.634983 -3.732278 -3.784507 -3.781028 -3.680663 -3.456482 -2.961836 -1.850200 -8.2066230E-02 -0.4230877 -0.7863320 -1.144454 -1.500208 -1.857496 -2.197579 -2.524246 -2.840120 -3.131806 -3.368564 -3.558804 -3.690824 -3.780280 -3.823553 -3.805015 -3.683298 -3.428733 -2.916098 -1.850200 -0.4278195 -0.7317589 -1.062257 -1.393757 -1.722797 -2.046924 -2.368479 -2.686595 -2.981719 -3.233843 -3.450048 -3.618569 -3.739917 -3.821155 -3.852360 -3.817461 -3.674145 -3.391359 -2.866862 -1.850200 -0.8083463 -1.072385 -1.367071 -1.660808 -1.956732 -2.261616 -2.566321 -2.847282 -3.106989 -3.328225 -3.514486 -3.670044 -3.781650 -3.852515 -3.868414 -3.815342 -3.651081 -3.343054 -2.813678 -1.850200 -1.225169 -1.440008 -1.695178 -1.955698 -2.221388 -2.486289 -2.748092 -2.996279 -3.215080 -3.405062 -3.573795 -3.713233 -3.812542 -3.869770 -3.868062 -3.794868 -3.610744 -3.282638 -2.756161 -1.850200 -1.689653 -1.851606 -2.054327 -2.267414 -2.485534 -2.706275 -2.920840 -3.125214 -3.313905 -3.481512 -3.627055 -3.744922 -3.827336 -3.866410 -3.845717 -3.751233 -3.549788 -3.210044 -2.694762 -1.850200 -2.197788 -2.296055 -2.441609 -2.594932 -2.753469 -2.923460 -3.095184 -3.260740 -3.413835 -3.551304 -3.667912 -3.758798 -3.817192 -3.833873 -3.793690 -3.679753 -3.465492 -3.123828 -2.628199 -1.850200 -2.771219 -2.791223 -2.865799 -2.953013 -3.050046 -3.161820 -3.280516 -3.397095 -3.505649 -3.603063 -3.685572 -3.740979 -3.769724 -3.763088 -3.703899 -3.575416 -3.356217 -3.021876 -2.555757 -1.850200 -3.452271 -3.375357 -3.360312 -3.367463 -3.391536 -3.431579 -3.481627 -3.535652 -3.586387 -3.631058 -3.670048 -3.683439 -3.678842 -3.647758 -3.571136 -3.435322 -3.219198 -2.907021 -2.476834 -1.850200 -4.541509 -4.318401 -4.166962 -4.044132 -3.943698 -3.869203 -3.817104 -3.776020 -3.737565 -3.701698 -3.672530 -3.623708 -3.569359 -3.502584 -3.406251 -3.271088 -3.070136 -2.780775 -2.391655 -1.850200 -29.49723 -28.78657 -27.94648 -26.98909 -25.92598 -24.76757 -23.52276 -22.19913 -20.80326 -19.34067 -17.81612 -16.23376 -14.59716 -12.90950 -11.17360 -9.391960 -7.566847 -5.700306 -3.794187 -1.850200 0.4835611 -0.1307979 -0.5564945 -1.015255 -1.415479 -1.769425 -2.003691 -2.182587 -2.444137 -2.688404 -2.907836 -3.004896 -3.116155 -3.297296 -3.468608 -3.603714 -3.593648 -3.658736 -3.469679 -1.991894 1.074564 0.4427307 -9.2786521E-02 -0.6152515 -1.087802 -1.512821 -1.770014 -2.082297 -2.385999 -2.678341 -2.935948 -2.973092 -3.151781 -3.342662 -3.530299 -3.660601 -3.614597 -3.669996 -3.454247 -1.991894 1.362579 0.7367927 0.1515685 -0.3874265 -0.8808191 -1.312218 -1.697600 -2.061759 -2.395565 -2.695647 -2.954572 -3.054423 -3.240344 -3.417937 -3.598273 -3.698907 -3.655934 -3.684425 -3.435790 -1.991894 1.472178 0.8554298 0.2717203 -0.2686377 -0.7610359 -1.228923 -1.666769 -2.068323 -2.414946 -2.717782 -2.972895 -3.156106 -3.340868 -3.505544 -3.669028 -3.724624 -3.705567 -3.699666 -3.413991 -1.991894 1.457367 0.8694416 0.2987742 -0.2319249 -0.7339338 -1.216126 -1.673115 -2.086102 -2.434363 -2.753527 -3.025888 -3.248611 -3.437539 -3.596020 -3.741990 -3.775238 -3.757242 -3.714250 -3.388437 -1.991894 1.361613 0.8002004 0.2536720 -0.2686638 -0.7692287 -1.251728 -1.707641 -2.108107 -2.469517 -2.800040 -3.093853 -3.338886 -3.530509 -3.686795 -3.811395 -3.834815 -3.808255 -3.726479 -3.358742 -1.991894 1.201505 0.6727068 0.1455707 -0.3590337 -0.8494040 -1.322732 -1.757464 -2.152474 -2.525855 -2.864758 -3.170250 -3.419085 -3.622662 -3.772020 -3.874451 -3.895516 -3.855671 -3.735150 -3.324587 -1.991894 0.9902919 0.4918635 -7.4209464E-03 -0.4916049 -0.9652745 -1.412504 -1.828984 -2.229730 -2.600195 -2.949281 -3.252525 -3.506069 -3.714274 -3.852902 -3.936915 -3.954164 -3.897068 -3.738906 -3.287645 -1.991894 0.7347478 0.2709167 -0.1997543 -0.6599399 -1.101904 -1.527043 -1.936458 -2.328236 -2.703799 -3.048420 -3.344681 -3.602941 -3.797941 -3.928476 -3.998716 -4.008407 -3.931024 -3.736443 -3.248291 -1.991894 0.4388274 1.4380509E-02 -0.4238999 -0.8489875 -1.267238 -1.676181 -2.073762 -2.462345 -2.825665 -3.153049 -3.454319 -3.701159 -3.879736 -3.995087 -4.056096 -4.055545 -3.955724 -3.726113 -3.205912 -1.991894 0.1060364 -0.2752299 -0.6772963 -1.073975 -1.467165 -1.860941 -2.245983 -2.614925 -2.956173 -3.282884 -3.570246 -3.789901 -3.951633 -4.054428 -4.106312 -4.091699 -3.970139 -3.706156 -3.159878 -1.991894 -0.2606719 -0.6029189 -0.9695051 -1.334612 -1.704307 -2.079187 -2.431500 -2.780275 -3.115962 -3.420901 -3.669076 -3.868269 -4.011342 -4.107027 -4.146704 -4.115811 -3.972758 -3.675259 -3.109658 -1.991894 -0.6688662 -0.9660451 -1.296762 -1.630163 -1.961902 -2.300406 -2.638788 -2.974761 -3.274745 -3.540625 -3.757479 -3.930796 -4.063818 -4.149477 -4.175050 -4.125244 -3.960198 -3.631981 -3.054716 -1.991894 -1.115744 -1.363719 -1.650105 -1.940898 -2.241107 -2.555387 -2.859346 -3.149726 -3.415054 -3.639458 -3.827638 -3.985522 -4.106391 -4.177344 -4.186866 -4.116118 -3.928052 -3.574514 -2.994291 -1.991894 -1.610129 -1.801451 -2.040576 -2.286893 -2.539138 -2.804564 -3.065132 -3.307113 -3.525909 -3.724199 -3.891796 -4.029968 -4.133395 -4.185513 -4.175655 -4.082707 -3.872385 -3.502530 -2.928551 -1.991894 -2.164279 -2.286378 -2.462067 -2.647676 -2.842156 -3.047044 -3.254628 -3.453819 -3.637526 -3.803502 -3.945050 -4.056197 -4.136056 -4.165519 -4.131821 -4.017856 -3.789773 -3.414114 -2.856778 -1.991894 -2.789901 -2.827702 -2.923602 -3.036388 -3.165494 -3.308664 -3.458475 -3.606587 -3.743117 -3.866518 -3.974296 -4.049748 -4.099531 -4.104038 -4.045408 -3.914231 -3.677452 -3.306556 -2.777733 -1.991894 -3.531450 -3.466208 -3.464025 -3.487829 -3.534989 -3.601215 -3.679774 -3.760953 -3.833943 -3.901139 -3.962398 -3.994820 -4.009465 -3.987979 -3.907142 -3.765888 -3.530874 -3.181000 -2.690351 -1.991894 -4.687850 -4.458928 -4.307030 -4.189618 -4.104784 -4.050834 -4.019428 -3.997757 -3.976171 -3.956954 -3.943662 -3.916203 -3.880049 -3.822341 -3.719448 -3.578401 -3.361243 -3.039777 -2.593796 -1.991894 -33.43137 -32.64234 -31.69816 -30.61488 -29.40769 -28.08959 -26.67175 -25.16341 -23.57243 -21.90539 -20.16790 -18.36479 -16.50024 -14.57795 -12.60116 -10.57278 -8.495420 -6.371429 -4.202934 -1.991894 0.5332115 -2.1183604E-02 -0.5495393 -1.051410 -1.488534 -1.858760 -2.135329 -2.287239 -2.555541 -2.808274 -3.037317 -3.167092 -3.248573 -3.436978 -3.615340 -3.763072 -3.750754 -3.834172 -3.678687 -2.124210 1.296633 0.5881191 -1.7150059E-02 -0.6017733 -1.113025 -1.575628 -1.875574 -2.174704 -2.486272 -2.794482 -3.069957 -3.132191 -3.290421 -3.488862 -3.684632 -3.832191 -3.777985 -3.850930 -3.667480 -2.124210 1.618541 0.9137667 0.2515483 -0.3427809 -0.8823869 -1.366947 -1.764242 -2.141651 -2.493325 -2.822234 -3.098982 -3.217830 -3.397350 -3.578842 -3.764050 -3.882598 -3.829959 -3.872702 -3.653131 -2.124210 1.738806 1.046667 0.3981961 -0.1993304 -0.7501852 -1.243833 -1.703005 -2.134239 -2.522177 -2.859226 -3.124871 -3.323344 -3.513069 -3.680968 -3.849112 -3.917463 -3.892366 -3.896666 -3.635168 -2.124210 1.728306 1.070160 0.4388634 -0.1502548 -0.6924715 -1.204399 -1.693178 -2.152516 -2.556147 -2.892546 -3.184490 -3.419141 -3.622798 -3.783205 -3.936073 -3.977061 -3.958264 -3.920509 -3.613070 -2.124210 1.629543 1.002927 0.3990054 -0.1723851 -0.7119995 -1.230654 -1.728001 -2.192479 -2.587131 -2.938794 -3.249019 -3.511848 -3.722811 -3.884362 -4.018641 -4.048764 -4.022007 -3.942468 -3.586401 -2.124210 1.462197 0.8722492 0.2942168 -0.2564050 -0.7888615 -1.301911 -1.796729 -2.238092 -2.634022 -3.001773 -3.326570 -3.601669 -3.819329 -3.984339 -4.097806 -4.122370 -4.080952 -3.961057 -3.554611 -2.124210 1.236849 0.6846426 0.1377274 -0.3905938 -0.9071146 -1.408651 -1.875858 -2.301630 -2.710773 -3.080369 -3.415082 -3.690646 -3.917483 -4.078526 -4.175747 -4.193563 -4.133008 -3.974948 -3.519382 -2.124210 0.9644009 0.4515663 -6.2761754E-02 -0.5648819 -1.060501 -1.532771 -1.975442 -2.403446 -2.803116 -3.181958 -3.513304 -3.789976 -4.018085 -4.166616 -4.249658 -4.259189 -4.178026 -3.982235 -3.481572 -2.124210 0.6508731 0.1821451 -0.2987232 -0.7738963 -1.233799 -1.680245 -2.112082 -2.529434 -2.930226 -3.296758 -3.620275 -3.900705 -4.112357 -4.248185 -4.316407 -4.315737 -4.215324 -3.981355 -3.440192 -2.124210 0.3002601 -0.1265091 -0.5703633 -1.005306 -1.438969 -1.863606 -2.283654 -2.694194 -3.075754 -3.425679 -3.748559 -4.010328 -4.201166 -4.318870 -4.376623 -4.362161 -4.241810 -3.970384 -3.394540 -2.124210 -8.9969866E-02 -0.4697182 -0.8749310 -1.274868 -1.680491 -2.087475 -2.492944 -2.873455 -3.237836 -3.583051 -3.876920 -4.108397 -4.275514 -4.380687 -4.427636 -4.398002 -4.255490 -3.948026 -3.344092 -2.124210 -0.5211342 -0.8540348 -1.219808 -1.584683 -1.960738 -2.337088 -2.707279 -3.075543 -3.428434 -3.733915 -3.990161 -4.189878 -4.339818 -4.432969 -4.467018 -4.419452 -4.253264 -3.912135 -3.288181 -2.124210 -0.9988598 -1.279098 -1.600438 -1.923612 -2.256517 -2.602985 -2.956825 -3.291375 -3.594859 -3.863603 -4.076109 -4.254814 -4.394536 -4.472756 -4.490266 -4.422140 -4.230447 -3.860311 -3.226082 -2.124210 -1.524209 -1.744491 -2.011498 -2.292077 -2.587858 -2.888890 -3.194313 -3.481399 -3.734762 -3.959995 -4.150359 -4.311307 -4.434026 -4.494885 -4.490917 -4.399654 -4.182508 -3.791388 -3.156884 -2.124210 -2.122576 -2.267757 -2.467077 -2.686324 -2.921045 -3.166815 -3.409347 -3.640768 -3.855858 -4.050220 -4.216190 -4.352098 -4.450436 -4.488531 -4.458841 -4.344017 -4.104377 -3.702638 -3.080832 -2.124210 -2.792593 -2.852366 -2.968508 -3.106416 -3.269543 -3.448022 -3.630411 -3.808478 -3.975292 -4.126260 -4.257309 -4.361051 -4.427506 -4.437021 -4.381200 -4.245680 -3.991434 -3.591120 -2.996030 -2.124210 -3.595944 -3.538265 -3.552882 -3.597856 -3.670120 -3.763235 -3.869036 -3.977244 -4.078821 -4.171617 -4.252259 -4.314027 -4.343272 -4.321365 -4.242827 -4.094312 -3.837439 -3.454778 -2.901112 -2.124210 -4.817171 -4.583722 -4.431520 -4.326029 -4.257717 -4.224818 -4.212211 -4.208440 -4.209579 -4.214961 -4.219815 -4.219318 -4.197998 -4.139197 -4.038044 -3.887649 -3.647363 -3.297030 -2.794554 -2.124210 -37.47786 -36.60915 -35.55754 -34.34384 -32.98705 -31.50338 -29.90618 -28.20658 -26.41373 -24.53530 -22.57779 -20.54672 -18.44693 -16.28260 -14.05746 -11.77482 -9.437626 -7.048552 -4.610014 -2.124210 0.5845016 -8.0747493E-02 -0.5573010 -1.057112 -1.539283 -1.942282 -2.255286 -2.389513 -2.665352 -2.923725 -3.158669 -3.317034 -3.372782 -3.569019 -3.752892 -3.909683 -3.896576 -3.995136 -3.870945 -2.248313 1.494333 0.7433057 7.3709995E-02 -0.5589963 -1.138347 -1.631201 -1.975340 -2.280007 -2.589284 -2.904832 -3.192962 -3.287837 -3.424612 -3.628844 -3.830277 -3.990842 -3.929121 -4.017458 -3.864287 -2.248313 1.873099 1.102253 0.3785766 -0.2999578 -0.8858488 -1.409084 -1.854678 -2.234680 -2.592724 -2.934875 -3.235932 -3.376261 -3.552530 -3.734455 -3.920994 -4.053348 -3.993532 -4.046787 -3.854337 -2.248313 2.007632 1.246401 0.5236461 -0.1330907 -0.7328257 -1.280439 -1.758926 -2.203200 -2.614865 -2.986007 -3.276048 -3.488941 -3.681533 -3.853523 -4.017565 -4.098995 -4.070239 -4.079516 -3.840623 -2.248313 1.999590 1.266553 0.5774496 -6.5347627E-02 -0.6659949 -1.211646 -1.719204 -2.206729 -2.654232 -3.035234 -3.335801 -3.590058 -3.800693 -3.967635 -4.116911 -4.168946 -4.149442 -4.112914 -3.822580 -2.248313 1.895904 1.205046 0.5415903 -8.2083702E-02 -0.6659873 -1.214670 -1.743785 -2.246989 -2.703104 -3.078046 -3.406406 -3.681863 -3.911011 -4.079744 -4.216262 -4.254751 -4.225654 -4.144605 -3.799613 -2.248313 1.719918 1.071000 0.4387996 -0.1582303 -0.7313653 -1.280401 -1.810826 -2.314814 -2.749680 -3.137092 -3.481909 -3.777317 -4.014964 -4.188768 -4.309817 -4.342496 -4.295765 -4.173314 -3.771105 -2.248313 1.482076 0.8752947 0.2798065 -0.2921189 -0.8491543 -1.388093 -1.911811 -2.384398 -2.813583 -3.216738 -3.571235 -3.878202 -4.115935 -4.294152 -4.400373 -4.425159 -4.359983 -4.197532 -3.738787 -2.248313 1.193012 0.6310197 7.3114604E-02 -0.4719371 -1.006784 -1.529465 -2.021722 -2.474684 -2.910946 -3.311491 -3.676053 -3.976876 -4.222385 -4.393787 -4.486650 -4.499845 -4.417427 -4.215275 -3.703751 -2.248313 0.8618987 0.3493816 -0.1730664 -0.6894416 -1.199777 -1.687097 -2.154236 -2.603669 -3.031271 -3.434587 -3.787593 -4.090937 -4.335079 -4.486733 -4.564379 -4.565974 -4.465689 -4.224865 -3.664993 -2.248313 0.4943260 2.4215057E-02 -0.4606697 -0.9408178 -1.410764 -1.873052 -2.323786 -2.765267 -3.188999 -3.572123 -3.917026 -4.219290 -4.434858 -4.569780 -4.634800 -4.622825 -4.502850 -4.224217 -3.621605 -2.248313 8.0407351E-02 -0.3389537 -0.7796384 -1.217088 -1.657818 -2.096682 -2.536216 -2.965932 -3.358582 -3.729990 -4.067873 -4.336452 -4.529663 -4.641833 -4.696767 -4.669425 -4.527633 -4.211288 -3.572624 -2.248313 -0.3737342 -0.7405226 -1.138181 -1.538834 -1.947883 -2.365691 -2.777164 -3.172353 -3.556621 -3.915884 -4.205036 -4.443060 -4.606948 -4.706236 -4.748638 -4.702065 -4.536820 -4.183546 -3.517231 -2.248313 -0.8791750 -1.189739 -1.539701 -1.901890 -2.271450 -2.649298 -3.034678 -3.416092 -3.763855 -4.069939 -4.322129 -4.523393 -4.671221 -4.758885 -4.784200 -4.717216 -4.524423 -4.137926 -3.454438 -2.248313 -1.435145 -1.683588 -1.978010 -2.288490 -2.619025 -2.970249 -3.311589 -3.639252 -3.937141 -4.191443 -4.409528 -4.592645 -4.721897 -4.793945 -4.797100 -4.708500 -4.484905 -4.072561 -3.383143 -2.248313 -2.062697 -2.239203 -2.467987 -2.714798 -2.988062 -3.278805 -3.560673 -3.824369 -4.070484 -4.292387 -4.485534 -4.643402 -4.751116 -4.800934 -4.777541 -4.664253 -4.412644 -3.984114 -3.303514 -2.248313 -2.781826 -2.861285 -3.004251 -3.170357 -3.365297 -3.578560 -3.793759 -4.004073 -4.201995 -4.381842 -4.538679 -4.662543 -4.739957 -4.760998 -4.710702 -4.571517 -4.301982 -3.869190 -3.213809 -2.248313 -3.644460 -3.600716 -3.628999 -3.697462 -3.797760 -3.919107 -4.051684 -4.187545 -4.321091 -4.442372 -4.546525 -4.624379 -4.662426 -4.650577 -4.575680 -4.416964 -4.144168 -3.724275 -3.112224 -2.248313 -4.932983 -4.695552 -4.550303 -4.456405 -4.408839 -4.393013 -4.400507 -4.419575 -4.450398 -4.482103 -4.510242 -4.524077 -4.508157 -4.457266 -4.357919 -4.193296 -3.938732 -3.553943 -2.996197 -2.248313 -41.62963 -40.68000 -39.51798 -38.16915 -36.65767 -35.00276 -33.22034 -31.32333 -29.32231 -27.22604 -25.04190 -22.77620 -20.43438 -18.02117 -15.54101 -12.99714 -10.39286 -7.731661 -5.015991 -2.248313 0.6883435 -0.1361651 -0.7505332 -1.044212 -1.591257 -2.007946 -2.358940 -2.483690 -2.771103 -3.035310 -3.274388 -3.455032 -3.490579 -3.693758 -3.882199 -4.046271 -4.032784 -4.143284 -4.048245 -2.365163 1.687604 0.8519976 0.1653046 -0.5001355 -1.129518 -1.686976 -2.069118 -2.380071 -2.698535 -3.014199 -3.307761 -3.436985 -3.554968 -3.762460 -3.969234 -4.138740 -4.072437 -4.170678 -4.046310 -2.365163 2.116376 1.286398 0.5113139 -0.2082273 -0.8825829 -1.451915 -1.931993 -2.349358 -2.700685 -3.046883 -3.357977 -3.533172 -3.705690 -3.884233 -4.072605 -4.212255 -4.150327 -4.207280 -4.041022 -2.365163 2.273321 1.448490 0.6748818 -5.9347626E-02 -0.7158373 -1.306870 -1.835547 -2.290083 -2.709879 -3.097440 -3.417753 -3.651763 -3.847035 -4.017900 -4.183198 -4.269002 -4.241361 -4.248303 -4.031882 -2.365163 2.269657 1.470165 0.7174915 1.6499503E-02 -0.6352947 -1.232056 -1.768358 -2.265663 -2.738871 -3.159674 -3.490986 -3.757217 -3.973288 -4.148129 -4.296132 -4.348139 -4.332942 -4.290695 -4.018312 -2.365163 2.161412 1.402582 0.6834993 8.7302197E-03 -0.6283728 -1.215751 -1.764670 -2.295480 -2.792764 -3.218590 -3.558692 -3.853326 -4.091518 -4.272655 -4.407341 -4.448057 -4.420380 -4.332329 -3.999593 -2.365163 1.975746 1.267980 0.5818116 -6.4929411E-02 -0.6813771 -1.262518 -1.824816 -2.363291 -2.861138 -3.273933 -3.640428 -3.947378 -4.202594 -4.386586 -4.514836 -4.547894 -4.502930 -4.371975 -3.974848 -2.365163 1.725053 1.063754 0.4197196 -0.1984952 -0.7930191 -1.367993 -1.926604 -2.457853 -2.924957 -3.348686 -3.725703 -4.052871 -4.308869 -4.497546 -4.615564 -4.638975 -4.578797 -4.407390 -3.945854 -2.365163 1.420276 0.8088172 0.2065005 -0.3824939 -0.9535733 -1.514050 -2.058637 -2.554281 -3.016125 -3.444418 -3.832913 -4.165286 -4.416444 -4.610179 -4.713021 -4.724985 -4.647022 -4.436131 -3.914202 -2.365163 1.070995 0.5141969 -5.0292764E-02 -0.6077795 -1.154138 -1.692266 -2.199072 -2.678981 -3.137954 -3.566197 -3.955366 -4.277109 -4.536441 -4.714730 -4.802289 -4.804070 -4.705929 -4.456709 -3.878497 -2.365163 0.6848329 0.1728307 -0.3481203 -0.8686798 -1.387826 -1.883623 -2.370591 -2.838075 -3.294920 -3.716237 -4.085661 -4.410748 -4.658742 -4.813150 -4.884645 -4.872326 -4.754499 -4.467031 -3.837477 -2.365163 0.2519084 -0.2055703 -0.6858349 -1.162258 -1.639351 -2.112106 -2.578674 -3.041553 -3.484951 -3.876555 -4.245435 -4.554694 -4.767138 -4.898111 -4.958250 -4.931329 -4.790740 -4.464314 -3.790078 -2.365163 -0.2272520 -0.6261038 -1.057680 -1.493854 -1.935892 -2.385918 -2.837141 -3.270626 -3.681875 -4.072828 -4.417139 -4.677264 -4.860523 -4.972704 -5.019244 -4.976537 -4.811112 -4.445104 -3.735288 -2.365163 -0.7544653 -1.096529 -1.477437 -1.869983 -2.280512 -2.696644 -3.109831 -3.522293 -3.920956 -4.264767 -4.558358 -4.777680 -4.934906 -5.036149 -5.064300 -5.003510 -4.809515 -4.406013 -3.672027 -2.365163 -1.339722 -1.617343 -1.942033 -2.283238 -2.646492 -3.029457 -3.421487 -3.785948 -4.127546 -4.419388 -4.661407 -4.855397 -4.996762 -5.083208 -5.089042 -5.004722 -4.780475 -4.344413 -3.599160 -2.365163 -1.998256 -2.199693 -2.457040 -2.741845 -3.047897 -3.377222 -3.704098 -4.007679 -4.285657 -4.534946 -4.749934 -4.920960 -5.040061 -5.103304 -5.081845 -4.969251 -4.716369 -4.256883 -3.516006 -2.365163 -2.760225 -2.860606 -3.028989 -3.229568 -3.458117 -3.704916 -3.954730 -4.198652 -4.431532 -4.640185 -4.820564 -4.959719 -5.047355 -5.077219 -5.024929 -4.883512 -4.608405 -4.139877 -3.422123 -2.365163 -3.680362 -3.649439 -3.698924 -3.789051 -3.917673 -4.069846 -4.232055 -4.397532 -4.564847 -4.716782 -4.844567 -4.938377 -4.985022 -4.976857 -4.893346 -4.730122 -4.446111 -3.988304 -3.314841 -2.365163 -5.040728 -4.796666 -4.657362 -4.576797 -4.551140 -4.558691 -4.585246 -4.633240 -4.696243 -4.758454 -4.807207 -4.833964 -4.828538 -4.779060 -4.665303 -4.494703 -4.226285 -3.807304 -3.190902 -2.365163 -45.88049 -44.84866 -43.57263 -42.08488 -40.41378 -38.58239 -36.60921 -34.50904 -32.29393 -29.97376 -27.55686 -25.05027 -22.46010 -19.79163 -17.04954 -14.23795 -11.36057 -8.420688 -5.421311 -2.365163 0.7966000 -9.8926567E-02 -0.8443698 -1.387886 -1.585795 -2.070469 -2.466931 -2.569807 -2.871536 -3.142151 -3.385749 -3.583156 -3.602206 -3.811110 -4.003847 -4.175035 -4.159752 -4.281704 -4.213651 -2.475562 1.895696 0.9842646 0.1672101 -0.4658461 -1.082729 -1.695126 -2.151543 -2.473355 -2.806120 -3.124238 -3.420609 -3.579184 -3.682665 -3.889280 -4.099835 -4.279074 -4.206855 -4.314873 -4.216928 -2.475562 2.362332 1.449609 0.6363981 -0.1210311 -0.8289030 -1.490592 -2.004970 -2.446850 -2.822701 -3.160922 -3.474632 -3.681484 -3.854188 -4.027884 -4.218557 -4.364822 -4.298805 -4.359433 -4.217016 -2.475562 2.534694 1.647144 0.8221772 4.2738378E-02 -0.6891378 -1.333183 -1.897066 -2.396684 -2.815413 -3.208020 -3.547137 -3.811221 -4.008451 -4.178834 -4.345281 -4.433784 -4.402822 -4.409366 -4.213351 -2.475562 2.537240 1.674427 0.8718394 0.1019893 -0.6041027 -1.246215 -1.831232 -2.344853 -2.825121 -3.267959 -3.635659 -3.919478 -4.146039 -4.322916 -4.470817 -4.526563 -4.506934 -4.461739 -4.205038 -2.475562 2.425931 1.605731 0.8245504 9.6239172E-02 -0.5882570 -1.225297 -1.805463 -2.348099 -2.871676 -3.341262 -3.717351 -4.017295 -4.264431 -4.457133 -4.591503 -4.637332 -4.607753 -4.514319 -4.191332 -2.475562 2.229961 1.461165 0.7232453 2.4742249E-02 -0.6376724 -1.258009 -1.842367 -2.409161 -2.947120 -3.412457 -3.790729 -4.115807 -4.380281 -4.576993 -4.708673 -4.747734 -4.702116 -4.564547 -4.171171 -2.475562 1.965263 1.250232 0.5574335 -0.1104277 -0.7438325 -1.351737 -1.941809 -2.509569 -3.035250 -3.480279 -3.883485 -4.219683 -4.494754 -4.692346 -4.823856 -4.853044 -4.788697 -4.609968 -4.146162 -2.475562 1.644188 0.9834719 0.3367430 -0.2960355 -0.9054365 -1.499909 -2.080055 -2.631164 -3.123862 -3.578471 -3.984391 -4.336937 -4.606671 -4.813716 -4.932606 -4.950864 -4.866086 -4.648401 -4.118308 -2.475562 1.279542 0.6743409 7.0540294E-02 -0.5278693 -1.111046 -1.685933 -2.243724 -2.755624 -3.246984 -3.696018 -4.113780 -4.460284 -4.731115 -4.934944 -5.036325 -5.037996 -4.932592 -4.678423 -4.086003 -2.475562 0.8752771 0.3226829 -0.2390193 -0.7980912 -1.354115 -1.901192 -2.415784 -2.920485 -3.398201 -3.854099 -4.259169 -4.591244 -4.866209 -5.041175 -5.128384 -5.115798 -4.989037 -4.697412 -4.047851 -2.475562 0.4234847 -7.1158990E-02 -0.5882869 -1.110164 -1.622876 -2.130235 -2.628603 -3.117391 -3.592613 -4.029976 -4.413558 -4.744382 -4.992157 -5.141123 -5.207789 -5.182567 -5.034778 -4.703013 -4.002581 -2.475562 -7.8159504E-02 -0.5118338 -0.9791319 -1.449931 -1.925529 -2.405896 -2.889032 -3.366530 -3.808554 -4.225452 -4.601821 -4.892509 -5.107167 -5.225720 -5.276566 -5.235429 -5.065237 -4.692305 -3.948983 -2.475562 -0.6287069 -1.000214 -1.413082 -1.838375 -2.281018 -2.737034 -3.186276 -3.627617 -4.057016 -4.456090 -4.773209 -5.020877 -5.194715 -5.297369 -5.331422 -5.271633 -5.074158 -4.661572 -3.885798 -2.475562 -1.242375 -1.547346 -1.899770 -2.277581 -2.673459 -3.086883 -3.511239 -3.931880 -4.305740 -4.644328 -4.910677 -5.117074 -5.267957 -5.353669 -5.366838 -5.283361 -5.054791 -4.607453 -3.811826 -2.475562 -1.932078 -2.155965 -2.439263 -2.757093 -3.106970 -3.469946 -3.836925 -4.187951 -4.501957 -4.778925 -5.012153 -5.196332 -5.325062 -5.385932 -5.371348 -5.259542 -4.998188 -4.524309 -3.725403 -2.475562 -2.733806 -2.850981 -3.046112 -3.280491 -3.548878 -3.830487 -4.112650 -4.392617 -4.659878 -4.897495 -5.093954 -5.245869 -5.344295 -5.373002 -5.325683 -5.183283 -4.893950 -4.407064 -3.626840 -2.475562 -3.702289 -3.683488 -3.754795 -3.874153 -4.033240 -4.215873 -4.408248 -4.610760 -4.808760 -4.989206 -5.134118 -5.236676 -5.292407 -5.282966 -5.200979 -5.032382 -4.729245 -4.248870 -3.512945 -2.475562 -5.128791 -4.887155 -4.759655 -4.695940 -4.690753 -4.721393 -4.777515 -4.860538 -4.951145 -5.036756 -5.099455 -5.132735 -5.136650 -5.081741 -4.969267 -4.785985 -4.497767 -4.056820 -3.380622 -2.475562 -50.22493 -49.10967 -47.71679 -46.08607 -44.25046 -42.23758 -40.06838 -37.75964 -35.32486 -32.77512 -30.11991 -27.36634 -24.52190 -21.59220 -18.58240 -15.49705 -12.34047 -9.115559 -5.826340 -2.475562 0.9039733 -6.4396560E-02 -0.8692701 -1.476281 -2.019510 -2.114888 -2.551164 -2.640780 -2.959868 -3.242512 -3.494153 -3.703153 -3.707982 -3.922585 -4.118553 -4.296234 -4.279109 -4.411010 -4.366325 -2.580184 2.100889 1.119992 0.2413918 -0.5296299 -1.121549 -1.694398 -2.203681 -2.566506 -2.908193 -3.234782 -3.532543 -3.716513 -3.804661 -4.011568 -4.220564 -4.412094 -4.334158 -4.450312 -4.374683 -2.580184 2.606723 1.631265 0.7297769 -5.5848364E-02 -0.7799327 -1.468635 -2.081103 -2.543838 -2.939757 -3.280721 -3.592319 -3.819177 -3.999251 -4.169891 -4.350476 -4.510489 -4.439636 -4.502192 -4.379972 -2.580184 2.795801 1.841177 0.9589690 0.1415869 -0.6262698 -1.349328 -1.957450 -2.486208 -2.940355 -3.322390 -3.671339 -3.958320 -4.168850 -4.337983 -4.491606 -4.592207 -4.556184 -4.561855 -4.381462 -2.580184 2.803154 1.874020 1.022713 0.2054430 -0.5651273 -1.260297 -1.882290 -2.444222 -2.922591 -3.374639 -3.763180 -4.078473 -4.312409 -4.490796 -4.633692 -4.696259 -4.674261 -4.624912 -4.378428 -2.580184 2.687416 1.807290 0.9743925 0.1848345 -0.5496206 -1.230736 -1.858788 -2.418984 -2.950965 -3.445758 -3.862039 -4.175421 -4.434980 -4.629766 -4.766556 -4.819919 -4.787297 -4.687322 -4.369977 -2.580184 2.482291 1.656291 0.8618159 0.1109434 -0.5963519 -1.262766 -1.874951 -2.459081 -3.021610 -3.534991 -3.945827 -4.276467 -4.551126 -4.759675 -4.898011 -4.941788 -4.892270 -4.746364 -4.355278 -2.580184 2.203242 1.434169 0.6922073 -2.3158576E-02 -0.7028042 -1.344574 -1.958938 -2.557338 -3.125769 -3.619561 -4.030319 -4.384074 -4.672238 -4.881968 -5.024273 -5.056436 -4.988434 -4.801234 -4.335587 -2.580184 1.865683 1.159135 0.4643814 -0.2125199 -0.8612566 -1.488299 -2.098114 -2.691924 -3.236297 -3.708043 -4.140742 -4.501922 -4.795430 -5.007761 -5.144843 -5.163638 -5.075696 -4.849980 -4.313081 -2.580184 1.490337 0.8345272 0.1892780 -0.4516236 -1.072354 -1.677794 -2.274483 -2.840382 -3.352003 -3.838418 -4.260866 -4.632190 -4.918301 -5.134937 -5.253941 -5.260930 -5.154009 -4.890508 -4.286034 -2.580184 1.059819 0.4671811 -0.1322181 -0.7309955 -1.321047 -1.905429 -2.468300 -2.997781 -3.512439 -3.984195 -4.411481 -4.768069 -5.058280 -5.256843 -5.356093 -5.346124 -5.221578 -4.920679 -4.252963 -2.580184 0.5885561 5.8600225E-02 -0.4937063 -1.051639 -1.608923 -2.149884 -2.680658 -3.199922 -3.702267 -4.171430 -4.575977 -4.925777 -5.206790 -5.368818 -5.444790 -5.421443 -5.276896 -4.937609 -4.212074 -2.580184 6.9678314E-02 -0.3988721 -0.9036899 -1.408474 -1.918987 -2.430045 -2.940341 -3.452103 -3.941985 -4.376860 -4.773871 -5.104317 -5.334358 -5.465198 -5.522528 -5.483009 -5.317720 -4.936812 -4.161752 -2.580184 -0.5030382 -0.9049179 -1.348161 -1.807069 -2.282225 -2.767729 -3.262286 -3.736044 -4.193236 -4.623417 -4.981915 -5.253814 -5.440979 -5.544344 -5.587095 -5.529246 -5.336650 -4.913924 -4.100317 -2.580184 -1.143570 -1.474757 -1.854357 -2.265554 -2.700840 -3.145153 -3.599989 -4.055802 -4.484365 -4.850130 -5.146085 -5.365895 -5.524517 -5.610579 -5.633751 -5.552933 -5.326287 -4.865517 -4.026494 -2.580184 -1.863040 -2.109009 -2.419787 -2.768089 -3.151786 -3.562741 -3.964735 -4.360017 -4.717286 -5.018656 -5.262673 -5.454238 -5.590433 -5.655588 -5.651709 -5.540749 -5.278465 -4.786238 -3.938022 -2.580184 -2.703252 -2.837871 -3.056262 -3.324949 -3.633764 -3.957469 -4.276827 -4.596385 -4.891939 -5.151074 -5.359476 -5.517755 -5.624842 -5.658104 -5.620146 -5.474482 -5.181840 -4.670112 -3.835210 -2.580184 -3.715760 -3.707359 -3.803290 -3.953444 -4.145909 -4.360782 -4.590984 -4.830719 -5.058506 -5.260453 -5.417077 -5.523640 -5.589026 -5.581401 -5.505968 -5.329214 -5.019226 -4.508176 -3.714678 -2.580184 -5.207692 -4.966867 -4.855219 -4.812997 -4.829649 -4.886733 -4.973630 -5.088982 -5.207061 -5.317358 -5.390884 -5.426864 -5.432449 -5.382913 -5.273793 -5.076199 -4.777220 -4.305010 -3.572939 -2.580184 -54.65804 -53.45810 -51.94537 -50.16724 -48.16318 -45.96407 -43.59392 -41.07148 -38.41179 -35.62711 -32.72766 -29.72209 -26.61781 -23.42127 -20.13812 -16.77333 -13.33136 -9.816176 -6.231373 -2.580184 1.007202 -3.2817386E-02 -0.9014312 -1.527349 -2.107841 -2.581537 -2.542473 -2.719770 -3.060755 -3.335763 -3.597303 -3.816313 -3.808987 -4.028992 -4.228157 -4.410463 -4.390061 -4.533710 -4.508554 -2.679603 2.306895 1.248163 0.3028899 -0.5129858 -1.233675 -1.751997 -2.220044 -2.644145 -3.002544 -3.339222 -3.645054 -3.849438 -3.922935 -4.130768 -4.338212 -4.538692 -4.451900 -4.578359 -4.521613 -2.679603 2.846377 1.800144 0.8380384 -2.8593021E-02 -0.7617130 -1.451627 -2.085527 -2.629817 -3.043335 -3.401454 -3.711575 -3.950637 -4.139604 -4.309312 -4.477380 -4.649226 -4.569256 -4.638620 -4.531467 -2.679603 3.057547 2.034186 1.080222 0.2274786 -0.5553778 -1.322085 -2.013464 -2.569231 -3.049228 -3.445208 -3.792846 -4.094444 -4.326225 -4.490829 -4.634331 -4.745228 -4.701682 -4.707272 -4.537555 -2.679603 3.072367 2.068960 1.164524 0.3109123 -0.4971333 -1.269207 -1.931586 -2.523849 -3.040207 -3.482961 -3.883295 -4.224690 -4.469934 -4.652180 -4.788068 -4.859929 -4.834686 -4.779397 -4.539367 -2.679603 2.947619 2.004606 1.121539 0.2862451 -0.5105394 -1.238691 -1.900820 -2.510202 -3.038657 -3.546068 -3.986840 -4.333066 -4.595570 -4.800467 -4.936824 -4.993024 -4.960203 -4.851676 -4.535632 -2.679603 2.729952 1.848604 1.007125 0.1945803 -0.5578231 -1.264240 -1.923827 -2.521201 -3.096576 -3.635654 -4.089711 -4.431289 -4.717631 -4.939962 -5.074900 -5.124625 -5.076806 -4.922360 -4.525221 -2.679603 2.438892 1.615019 0.8233688 6.0426462E-02 -0.6622325 -1.348384 -1.985151 -2.606274 -3.201200 -3.745593 -4.177064 -4.543283 -4.839174 -5.071228 -5.208344 -5.249798 -5.184227 -4.988427 -4.509647 -2.679603 2.085486 1.332150 0.5890540 -0.1320462 -0.8221105 -1.479745 -2.118262 -2.742296 -3.337051 -3.843779 -4.281470 -4.658802 -4.965858 -5.195102 -5.337450 -5.368309 -5.281595 -5.047461 -4.491934 -2.679603 1.692560 0.9936687 0.3046900 -0.3770781 -1.033837 -1.672332 -2.297761 -2.912354 -3.466160 -3.960574 -4.405772 -4.796619 -5.098807 -5.325312 -5.456238 -5.475372 -5.367486 -5.097536 -4.469716 -2.679603 1.244342 0.6135162 -2.9597800E-02 -0.6665787 -1.288833 -1.905146 -2.510399 -3.081798 -3.619293 -4.114496 -4.561735 -4.946058 -5.238352 -5.459692 -5.569463 -5.570704 -5.444253 -5.136329 -4.440833 -2.679603 0.7539364 0.1879558 -0.4039668 -0.9955591 -1.585677 -2.173466 -2.732585 -3.287515 -3.812805 -4.308941 -4.743496 -5.102202 -5.394429 -5.582446 -5.670382 -5.656215 -5.509386 -5.161458 -4.403748 -2.679603 0.2159443 -0.2866308 -0.8239417 -1.369037 -1.913946 -2.456717 -2.998191 -3.537934 -4.058132 -4.527462 -4.937200 -5.292238 -5.541586 -5.695869 -5.757671 -5.728648 -5.559011 -5.168903 -4.356761 -2.679603 -0.3789476 -0.8116893 -1.285829 -1.777473 -2.284289 -2.799091 -3.324618 -3.849896 -4.329242 -4.777676 -5.172557 -5.466411 -5.669049 -5.787904 -5.832830 -5.785849 -5.587469 -5.153500 -4.297873 -2.679603 -1.044173 -1.398369 -1.808939 -2.249717 -2.720546 -3.204340 -3.690063 -4.179493 -4.648827 -5.045675 -5.365047 -5.606073 -5.766725 -5.867114 -5.891817 -5.820242 -5.588344 -5.110539 -4.225204 -2.679603 -1.788875 -2.061531 -2.399550 -2.777580 -3.193845 -3.641226 -4.094953 -4.529586 -4.929716 -5.252118 -5.504820 -5.706882 -5.848982 -5.927079 -5.923950 -5.818329 -5.550733 -5.033142 -4.136277 -2.679603 -2.659234 -2.820061 -3.065125 -3.363971 -3.713130 -4.080486 -4.444746 -4.798754 -5.122341 -5.401464 -5.618036 -5.787434 -5.899536 -5.947917 -5.908308 -5.761089 -5.459227 -4.915023 -4.030956 -2.679603 -3.724750 -3.727479 -3.843701 -4.025415 -4.252349 -4.505050 -4.772780 -5.046877 -5.304235 -5.524847 -5.692892 -5.817134 -5.882617 -5.889354 -5.807734 -5.620774 -5.295223 -4.747122 -3.907534 -2.679603 -5.279523 -5.040681 -4.939592 -4.926679 -4.970820 -5.054779 -5.172298 -5.314622 -5.464596 -5.588112 -5.677874 -5.733591 -5.742855 -5.699765 -5.578557 -5.365475 -5.042140 -4.533332 -3.761122 -2.679603 -59.17545 -57.88960 -56.25412 -54.32507 -52.14806 -49.75821 -47.18238 -44.44139 -41.55181 -38.52712 -35.37853 -32.11551 -28.74615 -25.27748 -21.71565 -18.06608 -14.33359 -10.52250 -6.636673 -2.679603 1.105619 -1.4837120E-02 -0.9307306 -1.575604 -2.181277 -2.684973 -3.045096 -2.659469 -3.144936 -3.437940 -3.691742 -3.922317 -3.905915 -4.129855 -4.333514 -4.519050 -4.495355 -4.649067 -4.643640 -2.774314 2.503875 1.367140 0.3697147 -0.4949133 -1.254607 -1.887135 -2.306703 -2.685123 -3.098914 -3.428626 -3.753132 -3.978224 -4.037868 -4.245544 -4.456701 -4.658417 -4.563338 -4.700058 -4.662244 -2.774314 3.086579 1.969585 0.9461226 2.8688632E-02 -0.7885725 -1.441785 -2.110336 -2.686227 -3.147465 -3.513252 -3.830743 -4.081641 -4.273715 -4.446099 -4.612145 -4.779957 -4.695175 -4.769572 -4.677894 -2.774314 3.320569 2.221023 1.209350 0.2950376 -0.5087696 -1.280413 -2.020322 -2.648723 -3.151214 -3.571597 -3.913784 -4.225819 -4.469936 -4.640983 -4.781613 -4.888141 -4.844635 -4.847986 -4.689995 -2.774314 3.339077 2.262980 1.294822 0.4074833 -0.4315780 -1.238613 -1.978065 -2.598215 -3.144244 -3.599412 -3.999911 -4.356451 -4.622343 -4.814738 -4.947553 -5.013685 -4.991163 -4.930414 -4.697754 -2.774314 3.204683 2.198018 1.267080 0.3880379 -0.4479225 -1.246381 -1.943952 -2.580422 -3.145457 -3.644796 -4.101413 -4.478727 -4.751717 -4.967827 -5.103015 -5.160003 -5.127997 -5.012402 -4.699984 -2.774314 2.975517 2.037916 1.147798 0.2918122 -0.5213915 -1.269149 -1.960552 -2.602746 -3.176983 -3.728508 -4.214632 -4.586784 -4.877557 -5.107275 -5.249968 -5.303287 -5.255383 -5.091698 -4.695130 -2.774314 2.669988 1.795573 0.9560343 0.1426385 -0.6260538 -1.348637 -2.028604 -2.660664 -3.275834 -3.842959 -4.319384 -4.691350 -4.999755 -5.240022 -5.388103 -5.438093 -5.371929 -5.166135 -4.684603 -2.774314 2.300499 1.495507 0.7136201 -5.6298800E-02 -0.7846273 -1.478976 -2.142010 -2.793230 -3.415096 -3.966366 -4.419033 -4.814369 -5.129439 -5.372670 -5.523550 -5.565873 -5.478064 -5.233082 -4.671913 -2.774314 1.888799 1.150607 0.4168185 -0.3063094 -0.9979413 -1.666404 -2.323009 -2.968039 -3.570361 -4.085744 -4.550800 -4.944892 -5.270297 -5.505228 -5.655894 -5.683933 -5.572016 -5.291005 -4.654724 -2.774314 1.431036 0.7576436 7.0486970E-02 -0.6026537 -1.258200 -1.904641 -2.545741 -3.165733 -3.725988 -4.248106 -4.701577 -5.102439 -5.412033 -5.646418 -5.778750 -5.788661 -5.653672 -5.337576 -4.630600 -2.774314 0.9182217 0.3146692 -0.3147004 -0.9392808 -1.563055 -2.183800 -2.792431 -3.371145 -3.930362 -4.434494 -4.890493 -5.269064 -5.571616 -5.787976 -5.892582 -5.882331 -5.723974 -5.370691 -4.597258 -2.774314 0.3597867 -0.1752768 -0.7448481 -1.324092 -1.912202 -2.484636 -3.060815 -3.628448 -4.174150 -4.670263 -5.096406 -5.462588 -5.743178 -5.918849 -5.988812 -5.961645 -5.782069 -5.387011 -4.552678 -2.774314 -0.2556260 -0.7191234 -1.225902 -1.749678 -2.288373 -2.833346 -3.391566 -3.949233 -4.465550 -4.926718 -5.338683 -5.666074 -5.894247 -6.028428 -6.073253 -6.025171 -5.819643 -5.380797 -4.495000 -2.774314 -0.9437791 -1.322564 -1.762362 -2.234242 -2.735604 -3.258202 -3.784933 -4.303158 -4.796671 -5.233657 -5.570763 -5.833120 -6.012236 -6.121220 -6.142894 -6.065898 -5.828789 -5.346480 -4.422154 -2.774314 -1.713472 -2.009366 -2.377286 -2.785994 -3.235279 -3.716160 -4.215768 -4.693467 -5.121448 -5.475998 -5.745474 -5.955725 -6.108885 -6.194250 -6.186131 -6.072985 -5.799424 -5.276087 -4.332097 -2.774314 -2.611140 -2.795113 -3.070176 -3.401861 -3.786062 -4.198975 -4.609999 -4.999326 -5.348340 -5.640057 -5.876321 -6.054638 -6.177091 -6.227276 -6.180706 -6.026320 -5.715336 -5.161320 -4.223205 -2.774314 -3.726482 -3.743920 -3.881127 -4.094547 -4.360333 -4.651258 -4.957025 -5.261747 -5.545503 -5.779750 -5.970357 -6.102118 -6.178802 -6.181963 -6.088519 -5.893202 -5.553842 -4.991783 -4.094641 -2.774314 -5.342651 -5.105443 -5.018075 -5.031427 -5.109307 -5.224528 -5.375717 -5.553235 -5.721126 -5.862110 -5.970232 -6.037704 -6.054250 -6.000972 -5.861079 -5.635346 -5.292093 -4.767626 -3.941073 -2.774314 -63.77322 -62.40026 -60.63921 -58.55555 -56.20155 -53.61666 -50.83067 -47.86650 -44.74229 -41.47278 -38.07018 -34.54478 -30.90538 -27.15958 -23.31404 -19.37463 -15.34655 -11.23444 -7.042445 -2.774314 1.197786 1.8623404E-03 -0.9573322 -1.630946 -2.246627 -2.764963 -3.188822 -2.786874 -3.216070 -3.530272 -3.787538 -4.023720 -3.998265 -4.225355 -4.433475 -4.622503 -4.596193 -4.756585 -4.769188 -2.864743 2.697511 1.489974 0.4291608 -0.4835730 -1.276726 -1.960439 -2.436057 -2.722569 -3.174183 -3.528773 -3.855111 -4.105330 -4.147434 -4.352228 -4.567159 -4.773433 -4.670468 -4.812330 -4.792758 -2.864743 3.326177 2.130929 1.045367 7.2800197E-02 -0.7838739 -1.516547 -2.090797 -2.731470 -3.243683 -3.616498 -3.949658 -4.208868 -4.402052 -4.572730 -4.739108 -4.906501 -4.820825 -4.889037 -4.813756 -2.864743 3.590514 2.396784 1.328878 0.3711671 -0.5136585 -1.246904 -2.023427 -2.698835 -3.246978 -3.680662 -4.038996 -4.348156 -4.605563 -4.784840 -4.923581 -5.029776 -4.984648 -4.976167 -4.831662 -2.864743 3.614232 2.452234 1.426022 0.4752675 -0.3724988 -1.208628 -1.986281 -2.670316 -3.236545 -3.725409 -4.115628 -4.478764 -4.770479 -4.964086 -5.101943 -5.167555 -5.142681 -5.067270 -4.845235 -2.864743 3.457870 2.389049 1.404149 0.4865002 -0.3873553 -1.219896 -1.983047 -2.650597 -3.247465 -3.749954 -4.210613 -4.606869 -4.907851 -5.122443 -5.269339 -5.321154 -5.289811 -5.158491 -4.853244 -2.864743 3.215853 2.223367 1.286816 0.3866913 -0.4707815 -1.270742 -1.999649 -2.672574 -3.270318 -3.818494 -4.323013 -4.728004 -5.027529 -5.264162 -5.425699 -5.473105 -5.424108 -5.247328 -4.854263 -2.864743 2.894712 1.971898 1.085837 0.2276268 -0.5914602 -1.351735 -2.065913 -2.729101 -3.348436 -3.931330 -4.447639 -4.836738 -5.156155 -5.402657 -5.571794 -5.617813 -5.546063 -5.331251 -4.849210 -2.864743 2.518579 1.661555 0.8325524 1.9301804E-02 -0.7512665 -1.482180 -2.176701 -2.843920 -3.486810 -4.075410 -4.559942 -4.957397 -5.283360 -5.543588 -5.712606 -5.750038 -5.658005 -5.408326 -4.842062 -2.864743 2.087257 1.301953 0.5242927 -0.2376136 -0.9658192 -1.665009 -2.350168 -3.022132 -3.661167 -4.218016 -4.683590 -5.091241 -5.428975 -5.680752 -5.850443 -5.875453 -5.758360 -5.476447 -4.830034 -2.864743 1.606419 0.8937953 0.1673923 -0.5400377 -1.228570 -1.907521 -2.577948 -3.239687 -3.838655 -4.367851 -4.841725 -5.251919 -5.582230 -5.826457 -5.981505 -5.986566 -5.850211 -5.531523 -4.810760 -2.864743 1.076839 0.4356520 -0.2288962 -0.8869802 -1.542691 -2.193173 -2.842649 -3.459667 -4.037921 -4.561706 -5.034284 -5.431350 -5.746847 -5.986204 -6.101466 -6.084939 -5.929727 -5.571860 -4.781855 -2.864743 0.5014979 -6.6089064E-02 -0.6685904 -1.282588 -1.901379 -2.517434 -3.123660 -3.725511 -4.285013 -4.803822 -5.253332 -5.627102 -5.939941 -6.130863 -6.206529 -6.171676 -5.995093 -5.595113 -4.741093 -2.864743 -0.1343203 -0.6259221 -1.166526 -1.724031 -2.293385 -2.871906 -3.461740 -4.047187 -4.598016 -5.076088 -5.502790 -5.861135 -6.112768 -6.256512 -6.297215 -6.243026 -6.040022 -5.596132 -4.685760 -2.864743 -0.8425280 -1.249489 -1.716553 -2.218454 -2.750111 -3.305362 -3.881932 -4.422070 -4.937375 -5.397331 -5.772494 -6.059017 -6.252742 -6.355286 -6.373793 -6.293248 -6.056182 -5.568364 -4.613934 -2.864743 -1.637404 -1.956141 -2.351303 -2.794025 -3.276714 -3.793262 -4.326462 -4.851507 -5.304393 -5.687140 -5.982479 -6.201443 -6.360591 -6.438275 -6.425769 -6.311359 -6.034356 -5.502695 -4.523287 -2.864743 -2.561676 -2.767985 -3.068345 -3.438306 -3.861991 -4.314628 -4.776992 -5.201058 -5.569289 -5.878753 -6.129919 -6.315745 -6.443147 -6.486722 -6.433894 -6.277516 -5.958117 -5.390207 -4.410469 -2.864743 -3.719648 -3.753390 -3.915675 -4.160992 -4.465293 -4.798630 -5.143455 -5.484230 -5.782065 -6.037662 -6.239729 -6.380353 -6.459429 -6.457770 -6.356964 -6.154658 -5.801184 -5.219309 -4.275374 -2.864743 -5.399585 -5.162612 -5.089581 -5.128537 -5.239305 -5.395132 -5.585083 -5.787706 -5.974543 -6.138240 -6.256539 -6.325729 -6.338011 -6.284263 -6.137866 -5.897927 -5.535199 -4.985603 -4.112879 -2.864743 -68.44775 -66.98673 -65.09707 -62.85530 -60.32043 -57.53639 -54.53596 -51.34418 -47.98087 -44.46197 -40.80072 -37.00827 -33.09410 -29.06643 -24.93241 -20.69838 -16.36989 -11.95190 -7.448840 -2.864743 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -1.236378 -1.259939 -1.279926 -1.296369 -1.308428 -1.315361 -1.327739 -1.335827 -1.339003 -1.336565 -1.327104 -1.310909 -1.286142 -1.254534 -1.218075 -1.169380 -1.104997 -1.019417 -0.8993821 -0.6128114 -1.248878 -1.269959 -1.288258 -1.302444 -1.311764 -1.316822 -1.327708 -1.334248 -1.335858 -1.331213 -1.320749 -1.303055 -1.276911 -1.244429 -1.207647 -1.158977 -1.095040 -1.010692 -0.8928956 -0.6128114 -1.260933 -1.280100 -1.295963 -1.307220 -1.314368 -1.317957 -1.327234 -1.332092 -1.332033 -1.325670 -1.313606 -1.294420 -1.266933 -1.233844 -1.196741 -1.148201 -1.084767 -1.001817 -0.8862467 -0.6128114 -1.273031 -1.289539 -1.302239 -1.311162 -1.316599 -1.318674 -1.326141 -1.329230 -1.326709 -1.319296 -1.305604 -1.284939 -1.256032 -1.222747 -1.185411 -1.137028 -1.074166 -0.9926014 -0.8794297 -0.6128114 -1.284296 -1.297322 -1.307678 -1.314633 -1.318456 -1.318764 -1.324286 -1.324785 -1.321122 -1.311990 -1.296673 -1.274542 -1.244832 -1.211112 -1.173583 -1.125301 -1.063214 -0.9831184 -0.8724172 -0.6128114 -1.293642 -1.304241 -1.312490 -1.317766 -1.319654 -1.318048 -1.321553 -1.320022 -1.314507 -1.303650 -1.286725 -1.262903 -1.233015 -1.198766 -1.161258 -1.113095 -1.051919 -0.9733486 -0.8651985 -0.6128114 -1.302288 -1.310464 -1.316908 -1.320185 -1.319993 -1.316349 -1.316913 -1.314114 -1.306745 -1.294178 -1.275131 -1.251003 -1.220545 -1.185941 -1.148395 -1.100407 -1.040279 -0.9632710 -0.8577529 -0.6128114 -1.310125 -1.316220 -1.320460 -1.321583 -1.318494 -1.312625 -1.311760 -1.306936 -1.297725 -1.283458 -1.263217 -1.238362 -1.207129 -1.172421 -1.134730 -1.087236 -1.028158 -0.9528590 -0.8500572 -0.6128114 -1.317345 -1.320966 -1.322835 -1.320932 -1.316286 -1.308212 -1.305164 -1.298360 -1.287304 -1.270913 -1.250465 -1.224928 -1.193210 -1.158292 -1.120348 -1.073507 -1.015847 -0.9420857 -0.8420746 -0.6128114 -1.323379 -1.323719 -1.323031 -1.319408 -1.312461 -1.302238 -1.297007 -1.288219 -1.274795 -1.258152 -1.236834 -1.210262 -1.178398 -1.143128 -1.105305 -1.059301 -1.002780 -0.9309137 -0.8337668 -0.6128114 -1.327223 -1.325491 -1.322192 -1.316130 -1.306904 -1.294559 -1.286247 -1.275816 -1.262092 -1.244447 -1.221784 -1.194927 -1.162903 -1.126991 -1.089633 -1.044569 -0.9891899 -0.9192998 -0.8250799 -0.6128114 -1.329848 -1.325386 -1.319527 -1.311061 -1.299497 -1.284248 -1.275148 -1.263282 -1.248416 -1.229176 -1.206054 -1.178845 -1.147643 -1.111976 -1.073352 -1.029485 -0.9750318 -0.9072653 -0.8159372 -0.6128114 -1.330559 -1.323470 -1.314989 -1.303327 -1.289724 -1.273725 -1.263135 -1.249093 -1.233090 -1.213299 -1.189578 -1.162463 -1.131501 -1.096506 -1.056760 -1.013217 -0.9602565 -0.8945727 -0.8062235 -0.6128114 -1.328667 -1.319112 -1.308352 -1.295514 -1.280035 -1.261653 -1.249558 -1.234510 -1.217301 -1.196650 -1.172531 -1.145439 -1.114929 -1.080335 -1.041206 -0.9962402 -0.9447991 -0.8812322 -0.7958107 -0.6128114 -1.327122 -1.315387 -1.301670 -1.286703 -1.268889 -1.249541 -1.235896 -1.219169 -1.200320 -1.178885 -1.154780 -1.127835 -1.098049 -1.063720 -1.024440 -0.9800154 -0.9289444 -0.8670990 -0.7839220 -0.6128114 -1.326155 -1.311687 -1.296202 -1.278831 -1.260195 -1.240889 -1.220037 -1.202496 -1.182821 -1.161376 -1.137318 -1.110870 -1.079847 -1.045348 -1.006801 -0.9636362 -0.9131301 -0.8521965 -0.7701823 -0.6128114 -1.328001 -1.311584 -1.294353 -1.276495 -1.257028 -1.237289 -1.216562 -1.193650 -1.170599 -1.144984 -1.119588 -1.091571 -1.060696 -1.026427 -0.9886685 -0.9452948 -0.8950543 -0.8345841 -0.7545363 -0.6128114 -1.340373 -1.319633 -1.301564 -1.282039 -1.261320 -1.239625 -1.216671 -1.192286 -1.166632 -1.139318 -1.110234 -1.080257 -1.046364 -1.010117 -0.9699863 -0.9250553 -0.8731025 -0.8092751 -0.7359160 -0.6128114 -1.396739 -1.372397 -1.347291 -1.322562 -1.295370 -1.267224 -1.238028 -1.208143 -1.176224 -1.142869 -1.107623 -1.070087 -1.029634 -0.9854765 -0.9370445 -0.8858490 -0.8321851 -0.7750077 -0.7115620 -0.6128114 -1.268719 -1.239622 -1.209886 -1.179519 -1.148526 -1.116913 -1.084932 -1.051856 -1.018419 -0.9843846 -0.9497650 -0.9145661 -0.8787942 -0.8424551 -0.8055548 -0.7680979 -0.7300811 -0.6915240 -0.6524323 -0.6128114 -1.272120 -1.341763 -1.404418 -1.482265 -1.553209 -1.618841 -1.676176 -1.724100 -1.758971 -1.794044 -1.831817 -1.858191 -1.869469 -1.862846 -1.831950 -1.788522 -1.720442 -1.609714 -1.432993 -1.004622 -1.292750 -1.358746 -1.421727 -1.498840 -1.570790 -1.635375 -1.690302 -1.734582 -1.764020 -1.798033 -1.834025 -1.857165 -1.865883 -1.855553 -1.820733 -1.775509 -1.706649 -1.596463 -1.422678 -1.004622 -1.316836 -1.381784 -1.446095 -1.521588 -1.591713 -1.652448 -1.704268 -1.743870 -1.770033 -1.802625 -1.836090 -1.855992 -1.860796 -1.846817 -1.808363 -1.761752 -1.692222 -1.582751 -1.412101 -1.004622 -1.347244 -1.410848 -1.473859 -1.547958 -1.612865 -1.670246 -1.717465 -1.751547 -1.777032 -1.807358 -1.836735 -1.853749 -1.854624 -1.836538 -1.795173 -1.747193 -1.677125 -1.568547 -1.401248 -1.004622 -1.383746 -1.446065 -1.506833 -1.574532 -1.635163 -1.687728 -1.728604 -1.760824 -1.784418 -1.811777 -1.837171 -1.850209 -1.846604 -1.824483 -1.781053 -1.731768 -1.661317 -1.553764 -1.390101 -1.004622 -1.426355 -1.485329 -1.539926 -1.601954 -1.657251 -1.703046 -1.740956 -1.770765 -1.791557 -1.814174 -1.836229 -1.844204 -1.836873 -1.810929 -1.765900 -1.715415 -1.644759 -1.538427 -1.378648 -1.004622 -1.471078 -1.524594 -1.573268 -1.629366 -1.677264 -1.719311 -1.754028 -1.780578 -1.796887 -1.816045 -1.832632 -1.836465 -1.825004 -1.796274 -1.749638 -1.698069 -1.627410 -1.522511 -1.366872 -1.004622 -1.517624 -1.563883 -1.606249 -1.654675 -1.698350 -1.736293 -1.767042 -1.788709 -1.801559 -1.816021 -1.827529 -1.826624 -1.811097 -1.780331 -1.732177 -1.679682 -1.609222 -1.505980 -1.354744 -1.004622 -1.564134 -1.602112 -1.637460 -1.681185 -1.719995 -1.753040 -1.778340 -1.795956 -1.804173 -1.812436 -1.819226 -1.813994 -1.795703 -1.762973 -1.713401 -1.660180 -1.590131 -1.488795 -1.342234 -1.004622 -1.608504 -1.640127 -1.670097 -1.707850 -1.741003 -1.767722 -1.788440 -1.801015 -1.803052 -1.806316 -1.808281 -1.799281 -1.778577 -1.744076 -1.693246 -1.639498 -1.569828 -1.470912 -1.329307 -1.004622 -1.653400 -1.678857 -1.702308 -1.732740 -1.759404 -1.780784 -1.795138 -1.802121 -1.798970 -1.797145 -1.794611 -1.782587 -1.759629 -1.723499 -1.671622 -1.617574 -1.548356 -1.452272 -1.315918 -1.004622 -1.697621 -1.715632 -1.732019 -1.755550 -1.775401 -1.789957 -1.798522 -1.799733 -1.791405 -1.784878 -1.778754 -1.763824 -1.738709 -1.701138 -1.648438 -1.594268 -1.525789 -1.432824 -1.302014 -1.004622 -1.738452 -1.749168 -1.757431 -1.773872 -1.786375 -1.795184 -1.797904 -1.793481 -1.780767 -1.770234 -1.760576 -1.742884 -1.715768 -1.676912 -1.623626 -1.568798 -1.502059 -1.412525 -1.287532 -1.004622 -1.773944 -1.777273 -1.778352 -1.787737 -1.793332 -1.795944 -1.793206 -1.784159 -1.767470 -1.753056 -1.740022 -1.719772 -1.690819 -1.650837 -1.597789 -1.541794 -1.477108 -1.391347 -1.272391 -1.004622 -1.805025 -1.800134 -1.793827 -1.796386 -1.795720 -1.793029 -1.785501 -1.772017 -1.751535 -1.733507 -1.717260 -1.694609 -1.664054 -1.623225 -1.572146 -1.513309 -1.450920 -1.369239 -1.256488 -1.004622 -1.832374 -1.819832 -1.806387 -1.802522 -1.796064 -1.788033 -1.775708 -1.757856 -1.733577 -1.712109 -1.692886 -1.667738 -1.635762 -1.595259 -1.545371 -1.484841 -1.423685 -1.346190 -1.239877 -1.004622 -1.862834 -1.842536 -1.821504 -1.811115 -1.798682 -1.784891 -1.767347 -1.744624 -1.715918 -1.689815 -1.666988 -1.639929 -1.607002 -1.566901 -1.518131 -1.460313 -1.395883 -1.322324 -1.221978 -1.004622 -1.910730 -1.881356 -1.851602 -1.833757 -1.814510 -1.793524 -1.770833 -1.744759 -1.714791 -1.681021 -1.644425 -1.615880 -1.581995 -1.541523 -1.494035 -1.438061 -1.372700 -1.298836 -1.202900 -1.004622 -2.028393 -1.995160 -1.961353 -1.926412 -1.891790 -1.854890 -1.820901 -1.789952 -1.755979 -1.718981 -1.678261 -1.633898 -1.585581 -1.534397 -1.484381 -1.427190 -1.359861 -1.281503 -1.182320 -1.004622 -2.506804 -2.447971 -2.386610 -2.322773 -2.256504 -2.187850 -2.116880 -2.043885 -1.968167 -1.890518 -1.810752 -1.728914 -1.645272 -1.559161 -1.471359 -1.381658 -1.290082 -1.196695 -1.101533 -1.004622 -1.189691 -1.323002 -1.444826 -1.548702 -1.644372 -1.758418 -1.864654 -1.959815 -2.041920 -2.103269 -2.158648 -2.228067 -2.280873 -2.313047 -2.314932 -2.278152 -2.225557 -2.107468 -1.885617 -1.332105 -1.191654 -1.328070 -1.451136 -1.550770 -1.652056 -1.770547 -1.878381 -1.974920 -2.054877 -2.109534 -2.164014 -2.232641 -2.283566 -2.312060 -2.308004 -2.265316 -2.210245 -2.090944 -1.871584 -1.332105 -1.214249 -1.347610 -1.464272 -1.566846 -1.672101 -1.791028 -1.898738 -1.992802 -2.067343 -2.116190 -2.172513 -2.239081 -2.286299 -2.309704 -2.298894 -2.251627 -2.193960 -2.073649 -1.857142 -1.332105 -1.250599 -1.374860 -1.490322 -1.595761 -1.701861 -1.818292 -1.923011 -2.011626 -2.077566 -2.127216 -2.182267 -2.245898 -2.287876 -2.305496 -2.287224 -2.236895 -2.176603 -2.055542 -1.842270 -1.332105 -1.293185 -1.415229 -1.529868 -1.634453 -1.738269 -1.850149 -1.948558 -2.028638 -2.090759 -2.140293 -2.193636 -2.251408 -2.288220 -2.298901 -2.273578 -2.220910 -2.158073 -2.036568 -1.826940 -1.332105 -1.348240 -1.468206 -1.578905 -1.680031 -1.779307 -1.883581 -1.973084 -2.046048 -2.107380 -2.155131 -2.204116 -2.255968 -2.286469 -2.289403 -2.258751 -2.203515 -2.138299 -2.016673 -1.811152 -1.332105 -1.417028 -1.529804 -1.634372 -1.730027 -1.821924 -1.916451 -1.996943 -2.067347 -2.125423 -2.170350 -2.213717 -2.258734 -2.281758 -2.276550 -2.242431 -2.184523 -2.117129 -1.995607 -1.794895 -1.332105 -1.492166 -1.597256 -1.694119 -1.781635 -1.863592 -1.948695 -2.024734 -2.090365 -2.144803 -2.183681 -2.220689 -2.258459 -2.273310 -2.261509 -2.224295 -2.163747 -2.094485 -1.973681 -1.778135 -1.332105 -1.574232 -1.668230 -1.755630 -1.832316 -1.905515 -1.984623 -2.054601 -2.114621 -2.162557 -2.195287 -2.225089 -2.254070 -2.260478 -2.244451 -2.204047 -2.141070 -2.070264 -1.950619 -1.760918 -1.332105 -1.658906 -1.740651 -1.816791 -1.884772 -1.950788 -2.022365 -2.085627 -2.137446 -2.178221 -2.204296 -2.225469 -2.244859 -2.244729 -2.224850 -2.181360 -2.116135 -2.044363 -1.926253 -1.743021 -1.332105 -1.744339 -1.815195 -1.881020 -1.939746 -1.997852 -2.060057 -2.114439 -2.158086 -2.190804 -2.208757 -2.220588 -2.231304 -2.226012 -2.202291 -2.155943 -2.088853 -2.016638 -1.900608 -1.724596 -1.332105 -1.833025 -1.891835 -1.946827 -1.996317 -2.043931 -2.095337 -2.140122 -2.174978 -2.198191 -2.206900 -2.210642 -2.214566 -2.203825 -2.176340 -2.127522 -2.059042 -1.986991 -1.873610 -1.705482 -1.332105 -1.923419 -1.969638 -2.012891 -2.051060 -2.087008 -2.127069 -2.161033 -2.185554 -2.198456 -2.199316 -2.196671 -2.194035 -2.177752 -2.146739 -2.095778 -2.026531 -1.955024 -1.845173 -1.685385 -1.332105 -2.012714 -2.046036 -2.076148 -2.101675 -2.125012 -2.152472 -2.174335 -2.188901 -2.193137 -2.186837 -2.177930 -2.169053 -2.147551 -2.113181 -2.060578 -1.991201 -1.920257 -1.815286 -1.664364 -1.332105 -2.097612 -2.117148 -2.132502 -2.144106 -2.154538 -2.170241 -2.181105 -2.186704 -2.182482 -2.168842 -2.153762 -2.139390 -2.113055 -2.075706 -2.021898 -1.952077 -1.883052 -1.783935 -1.642302 -1.332105 -2.171390 -2.176531 -2.178963 -2.178367 -2.177253 -2.182078 -2.182144 -2.178969 -2.166516 -2.145557 -2.124591 -2.105214 -2.074724 -2.034569 -1.979969 -1.909167 -1.843444 -1.750849 -1.619048 -1.332105 -2.239254 -2.230579 -2.219793 -2.206831 -2.194551 -2.189366 -2.179548 -2.167749 -2.147459 -2.119125 -2.092318 -2.068293 -2.033243 -1.990693 -1.938452 -1.870637 -1.801584 -1.715939 -1.594457 -1.332105 -2.317220 -2.293272 -2.268276 -2.241465 -2.216779 -2.201487 -2.182042 -2.161300 -2.132864 -2.096738 -2.059338 -2.030240 -1.993191 -1.949522 -1.898887 -1.834031 -1.759239 -1.679970 -1.568457 -1.332105 -2.465786 -2.423800 -2.383697 -2.342809 -2.300329 -2.257297 -2.227127 -2.195609 -2.162332 -2.123451 -2.077233 -2.024137 -1.977179 -1.930830 -1.876685 -1.812472 -1.734198 -1.647438 -1.542445 -1.332105 -3.835547 -3.746591 -3.651516 -3.551213 -3.445622 -3.334926 -3.219260 -3.098832 -2.973771 -2.844242 -2.710400 -2.572355 -2.430275 -2.284261 -2.134446 -1.980947 -1.823851 -1.663290 -1.499584 -1.332105 -1.068723 -1.261629 -1.439503 -1.599683 -1.730209 -1.852795 -1.998746 -2.132999 -2.253366 -2.353743 -2.414539 -2.509139 -2.596557 -2.663888 -2.700703 -2.679342 -2.650834 -2.540747 -2.286479 -1.613434 -1.023425 -1.228792 -1.417252 -1.580888 -1.707688 -1.842328 -1.999042 -2.140778 -2.265265 -2.363322 -2.414863 -2.514679 -2.603235 -2.669009 -2.700109 -2.668178 -2.636322 -2.522676 -2.268991 -1.613434 -1.023770 -1.231345 -1.418955 -1.575182 -1.709743 -1.855988 -2.016126 -2.158853 -2.281924 -2.370420 -2.424080 -2.525404 -2.612135 -2.673862 -2.697198 -2.656687 -2.620718 -2.503499 -2.250869 -1.613434 -1.054560 -1.255256 -1.434239 -1.592048 -1.737225 -1.886073 -2.043571 -2.183903 -2.298793 -2.378340 -2.439666 -2.539362 -2.622113 -2.677508 -2.691311 -2.644479 -2.603785 -2.483139 -2.232066 -1.613434 -1.105333 -1.293145 -1.470118 -1.634091 -1.779936 -1.925730 -2.078733 -2.210801 -2.312861 -2.394547 -2.459686 -2.554974 -2.631718 -2.679055 -2.681562 -2.631428 -2.585337 -2.461371 -2.212738 -1.613434 -1.171080 -1.352229 -1.527968 -1.690747 -1.833105 -1.974106 -2.117423 -2.235744 -2.332908 -2.416058 -2.481581 -2.570674 -2.639949 -2.677594 -2.669443 -2.616557 -2.565162 -2.438323 -2.192776 -1.613434 -1.257435 -1.431873 -1.600487 -1.755427 -1.894535 -2.026842 -2.154581 -2.263856 -2.359904 -2.441174 -2.503742 -2.585104 -2.645291 -2.671914 -2.656232 -2.599774 -2.543383 -2.413729 -2.172161 -1.613434 -1.361626 -1.524077 -1.680856 -1.828498 -1.958582 -2.077277 -2.193581 -2.298958 -2.391555 -2.467849 -2.525146 -2.597114 -2.646591 -2.661418 -2.641527 -2.580615 -2.519035 -2.387594 -2.150847 -1.613434 -1.473557 -1.624981 -1.770500 -1.904353 -2.020399 -2.129306 -2.239146 -2.338418 -2.424793 -2.494531 -2.544489 -2.605280 -2.642555 -2.648621 -2.624047 -2.558672 -2.492293 -2.359740 -2.128781 -1.613434 -1.596178 -1.732432 -1.861094 -1.980337 -2.085924 -2.187075 -2.288643 -2.379301 -2.457229 -2.519341 -2.560479 -2.608339 -2.633167 -2.633346 -2.603319 -2.533970 -2.463241 -2.330036 -2.105901 -1.613434 -1.722865 -1.839957 -1.953526 -2.061412 -2.157160 -2.247924 -2.338881 -2.419003 -2.487159 -2.539780 -2.571016 -2.604933 -2.620712 -2.614069 -2.578608 -2.504977 -2.430933 -2.298322 -2.082134 -1.613434 -1.851375 -1.952031 -2.052106 -2.147115 -2.230568 -2.308217 -2.387133 -2.455869 -2.512125 -2.553564 -2.573759 -2.597029 -2.604190 -2.590136 -2.549628 -2.471849 -2.395626 -2.264316 -2.057391 -1.613434 -1.987006 -2.070576 -2.153806 -2.233397 -2.302824 -2.366055 -2.431399 -2.486978 -2.529706 -2.558619 -2.569770 -2.583885 -2.581900 -2.560602 -2.514757 -2.434568 -2.356640 -2.227892 -2.031554 -1.613434 -2.125770 -2.189196 -2.254316 -2.317989 -2.371221 -2.418619 -2.468605 -2.509689 -2.538530 -2.556021 -2.558260 -2.563235 -2.552634 -2.524710 -2.474284 -2.391948 -2.313829 -2.189194 -2.004484 -1.613434 -2.262715 -2.305880 -2.352229 -2.396632 -2.431909 -2.462649 -2.496040 -2.522916 -2.538771 -2.544530 -2.537202 -2.533718 -2.515423 -2.481359 -2.427053 -2.343591 -2.266343 -2.148126 -1.975994 -1.613434 -2.394507 -2.416520 -2.442309 -2.466242 -2.482528 -2.496051 -2.512998 -2.526080 -2.529017 -2.522696 -2.505383 -2.493716 -2.469316 -2.429814 -2.372765 -2.289068 -2.214138 -2.104497 -1.945866 -1.613434 -2.514060 -2.514126 -2.520470 -2.525798 -2.523366 -2.519183 -2.519829 -2.518564 -2.508763 -2.490323 -2.463224 -2.444436 -2.414483 -2.370554 -2.311767 -2.233951 -2.157728 -2.058100 -1.913823 -1.613434 -2.628877 -2.606715 -2.594090 -2.581132 -2.560279 -2.538496 -2.523736 -2.508156 -2.485480 -2.454639 -2.416622 -2.389246 -2.354035 -2.307107 -2.249785 -2.176669 -2.098103 -2.009010 -1.879661 -1.613434 -2.807416 -2.760398 -2.723356 -2.684301 -2.639450 -2.594680 -2.564422 -2.533099 -2.497267 -2.454374 -2.406425 -2.352356 -2.313145 -2.262864 -2.200811 -2.130644 -2.042697 -1.960412 -1.844122 -1.613434 -5.247004 -5.126811 -4.996704 -4.857080 -4.708366 -4.550952 -4.385228 -4.211558 -4.030282 -3.841732 -3.646195 -3.443975 -3.235309 -3.020472 -2.799665 -2.573133 -2.341052 -2.103631 -1.861033 -1.613434 -0.9638299 -1.190328 -1.419107 -1.628552 -1.811016 -1.939563 -2.112472 -2.276880 -2.428436 -2.561980 -2.655654 -2.741087 -2.855362 -2.949762 -3.016893 -3.022820 -3.010115 -2.919878 -2.647290 -1.860027 -0.8518677 -1.101908 -1.348077 -1.573123 -1.762546 -1.895730 -2.087521 -2.267222 -2.431358 -2.570707 -2.651498 -2.743545 -2.863093 -2.959151 -3.022631 -3.014592 -2.997858 -2.901949 -2.627085 -1.860027 -0.8159386 -1.075232 -1.326000 -1.549684 -1.733576 -1.893598 -2.091851 -2.278505 -2.446921 -2.580874 -2.653308 -2.756491 -2.876343 -2.970192 -3.026527 -3.005244 -2.984814 -2.882614 -2.605997 -1.860027 -0.8299694 -1.089277 -1.334710 -1.548265 -1.742057 -1.914468 -2.116454 -2.304192 -2.468841 -2.587491 -2.669940 -2.777479 -2.893453 -2.981411 -3.027684 -2.996102 -2.970931 -2.861754 -2.583977 -1.860027 -0.8805569 -1.130642 -1.365773 -1.581518 -1.776313 -1.956573 -2.156449 -2.339756 -2.490292 -2.603975 -2.694958 -2.802347 -2.911920 -2.991732 -3.024712 -2.986653 -2.955050 -2.839196 -2.560961 -1.860027 -0.9561362 -1.194571 -1.425853 -1.637577 -1.834759 -2.015522 -2.209504 -2.376760 -2.514044 -2.631339 -2.725821 -2.828543 -2.929874 -2.999834 -3.016912 -2.976277 -2.937170 -2.814766 -2.536904 -1.860027 -1.055452 -1.283228 -1.506481 -1.715195 -1.910243 -2.087974 -2.263648 -2.415860 -2.549970 -2.666152 -2.759035 -2.854821 -2.946113 -3.003754 -3.008490 -2.964232 -2.916895 -2.788299 -2.511906 -1.860027 -1.174919 -1.392106 -1.607893 -1.810597 -1.997886 -2.159357 -2.319684 -2.464597 -2.592899 -2.704612 -2.793225 -2.879772 -2.959104 -3.001545 -2.999068 -2.950024 -2.894152 -2.759605 -2.486177 -1.860027 -1.316161 -1.520705 -1.725911 -1.915883 -2.084079 -2.234256 -2.382897 -2.517649 -2.638477 -2.744344 -2.826857 -2.902353 -2.967384 -2.995752 -2.987412 -2.931894 -2.867973 -2.728450 -2.459589 -1.860027 -1.476046 -1.664431 -1.848250 -2.020932 -2.177714 -2.314131 -2.448910 -2.572738 -2.685245 -2.782975 -2.857694 -2.920888 -2.969156 -2.987916 -2.972293 -2.909642 -2.837841 -2.694654 -2.431937 -1.860027 -1.644917 -1.808178 -1.974865 -2.132304 -2.272653 -2.395201 -2.517241 -2.629356 -2.731271 -2.818551 -2.883459 -2.932428 -2.967323 -2.976611 -2.952657 -2.882702 -2.803543 -2.657992 -2.403124 -1.860027 -1.820266 -1.960734 -2.105819 -2.243641 -2.368440 -2.477864 -2.586929 -2.685321 -2.773933 -2.848930 -2.900942 -2.937467 -2.961119 -2.960331 -2.926828 -2.849620 -2.764526 -2.618139 -2.373034 -1.860027 -2.000575 -2.115003 -2.238165 -2.357785 -2.466897 -2.560831 -2.654032 -2.737411 -2.810874 -2.871008 -2.910255 -2.935700 -2.948043 -2.936486 -2.894104 -2.809539 -2.720203 -2.574780 -2.341540 -1.860027 -2.183518 -2.274114 -2.375367 -2.474157 -2.563341 -2.639665 -2.715193 -2.781734 -2.838510 -2.884706 -2.910978 -2.924056 -2.925050 -2.903516 -2.852586 -2.761925 -2.670114 -2.527903 -2.308460 -1.860027 -2.372944 -2.435133 -2.511382 -2.587211 -2.654799 -2.710905 -2.765987 -2.815005 -2.855961 -2.886947 -2.899393 -2.899402 -2.889674 -2.858942 -2.800987 -2.705964 -2.613525 -2.477784 -2.273567 -1.860027 -2.558568 -2.592951 -2.642911 -2.693006 -2.736799 -2.771093 -2.804220 -2.833418 -2.857351 -2.873310 -2.872045 -2.859123 -2.839209 -2.801075 -2.738148 -2.640834 -2.549472 -2.423795 -2.236539 -1.860027 -2.738196 -2.743456 -2.764636 -2.787117 -2.804652 -2.814134 -2.824486 -2.833286 -2.839700 -2.840433 -2.826034 -2.800918 -2.772396 -2.728949 -2.663148 -2.566298 -2.477963 -2.365517 -2.196949 -1.860027 -2.903827 -2.878422 -2.873427 -2.869100 -2.859829 -2.843371 -2.829812 -2.817006 -2.805025 -2.790811 -2.763782 -2.727273 -2.690840 -2.642764 -2.577756 -2.489598 -2.399706 -2.302354 -2.154120 -1.860027 -3.112599 -3.051134 -3.016495 -2.983928 -2.947286 -2.901783 -2.859413 -2.821640 -2.788063 -2.754276 -2.714073 -2.659765 -2.613172 -2.562272 -2.498481 -2.416833 -2.319198 -2.235585 -2.108035 -1.860027 -6.733509 -6.581703 -6.414555 -6.232888 -6.037457 -5.829043 -5.608362 -5.376038 -5.132699 -4.878909 -4.615152 -4.341916 -4.059637 -3.768695 -3.469470 -3.162301 -2.847489 -2.525331 -2.196096 -1.860027 -0.8693606 -1.124623 -1.405526 -1.658810 -1.883790 -2.058863 -2.216474 -2.407744 -2.584162 -2.742474 -2.865564 -2.941436 -3.076638 -3.191844 -3.283511 -3.315793 -3.316430 -3.252310 -2.975372 -2.079525 -0.6902334 -0.9761983 -1.278918 -1.556572 -1.801513 -1.972271 -2.162793 -2.376153 -2.572053 -2.744269 -2.862169 -2.937033 -3.082536 -3.202917 -3.294544 -3.312195 -3.306916 -3.235898 -2.953178 -2.079525 -0.6146961 -0.9166292 -1.224593 -1.507006 -1.744364 -1.940735 -2.153747 -2.377814 -2.579626 -2.754895 -2.854511 -2.950951 -3.098898 -3.218253 -3.304699 -3.304093 -3.297739 -3.217952 -2.929820 -2.079525 -0.6064847 -0.9135236 -1.215986 -1.487062 -1.730012 -1.950759 -2.173980 -2.396242 -2.601006 -2.765998 -2.868213 -2.978731 -3.121634 -3.235765 -3.312798 -3.297790 -3.287491 -3.198228 -2.905221 -2.079525 -0.6478466 -0.9487663 -1.237503 -1.505510 -1.758886 -1.989724 -2.210866 -2.430894 -2.630534 -2.781289 -2.896529 -3.012836 -3.147331 -3.253695 -3.317000 -3.292888 -3.275996 -3.176461 -2.879300 -2.079525 -0.7248118 -1.013210 -1.295370 -1.562595 -1.816829 -2.045515 -2.264551 -2.479459 -2.663195 -2.813290 -2.936688 -3.049192 -3.174388 -3.270350 -3.314944 -3.288280 -3.263057 -3.152345 -2.851969 -2.079525 -0.8315160 -1.111212 -1.386744 -1.648769 -1.891283 -2.116901 -2.333077 -2.534572 -2.707781 -2.859187 -2.979872 -3.086930 -3.200968 -3.283636 -3.310922 -3.283053 -3.247054 -3.125621 -2.823343 -2.079525 -0.9697631 -1.238656 -1.505084 -1.749853 -1.983639 -2.205539 -2.410032 -2.596647 -2.764050 -2.910964 -3.025980 -3.125279 -3.226178 -3.291126 -3.307666 -3.275061 -3.228027 -3.096009 -2.793506 -2.079525 -1.134944 -1.387044 -1.634503 -1.870569 -2.096105 -2.306317 -2.492209 -2.667342 -2.826746 -2.962764 -3.072091 -3.162401 -3.248147 -3.293505 -3.303257 -3.263608 -3.204684 -3.063184 -2.762343 -2.079525 -1.316298 -1.549659 -1.784817 -2.008837 -2.220850 -2.409060 -2.582004 -2.743408 -2.888014 -3.013818 -3.115950 -3.196043 -3.263502 -3.295693 -3.296399 -3.247797 -3.176666 -3.026841 -2.729987 -2.079525 -1.519183 -1.732864 -1.951956 -2.153483 -2.343121 -2.519367 -2.673412 -2.816822 -2.948352 -3.063742 -3.155396 -3.222499 -3.273636 -3.295252 -3.284685 -3.225791 -3.143119 -2.986652 -2.696373 -2.079525 -1.742869 -1.926790 -2.117985 -2.301689 -2.472278 -2.624657 -2.760127 -2.889049 -3.007613 -3.110433 -3.187584 -3.240399 -3.279453 -3.289275 -3.266790 -3.196330 -3.103314 -2.942228 -2.661127 -2.079525 -1.968702 -2.126162 -2.291290 -2.448951 -2.594634 -2.726731 -2.845870 -2.959300 -3.062253 -3.149720 -3.211314 -3.251495 -3.277633 -3.274761 -3.239996 -3.158453 -3.056485 -2.893091 -2.624085 -2.079525 -2.204080 -2.325757 -2.460336 -2.592856 -2.717767 -2.829969 -2.928855 -3.022945 -3.108195 -3.179678 -3.226718 -3.252473 -3.264408 -3.247905 -3.201680 -3.110612 -3.001826 -2.839120 -2.585024 -2.079525 -2.438981 -2.528134 -2.633895 -2.739259 -2.838430 -2.927183 -3.003801 -3.076812 -3.143181 -3.197373 -3.228946 -3.238701 -3.235396 -3.205434 -3.149304 -3.051413 -2.938335 -2.780222 -2.543645 -2.079525 -2.680535 -2.732659 -2.805052 -2.879669 -2.950608 -3.013675 -3.066064 -3.116082 -3.160978 -3.195751 -3.210624 -3.204613 -3.186730 -3.144380 -3.080402 -2.979130 -2.865118 -2.716556 -2.499563 -2.079525 -2.918665 -2.933486 -2.969400 -3.009138 -3.048396 -3.081362 -3.106213 -3.131024 -3.152796 -3.167600 -3.165496 -3.144709 -3.114254 -3.061889 -2.992789 -2.891956 -2.780965 -2.646739 -2.452188 -2.079525 -3.147720 -3.121809 -3.118907 -3.120582 -3.124078 -3.124557 -3.119226 -3.117091 -3.114885 -3.109439 -3.090698 -3.056777 -3.016131 -2.956641 -2.884828 -2.791364 -2.685042 -2.569378 -2.400705 -2.079525 -3.406724 -3.331986 -3.288044 -3.251147 -3.217850 -3.179878 -3.136995 -3.101904 -3.070529 -3.040040 -3.003212 -2.952893 -2.903007 -2.842898 -2.771690 -2.685840 -2.577457 -2.484187 -2.344445 -2.079525 -8.288466 -8.104436 -7.898542 -7.672180 -7.426690 -7.163320 -6.883195 -6.587366 -6.276771 -5.952260 -5.614595 -5.264462 -4.902496 -4.529267 -4.145296 -3.751054 -3.346973 -2.933451 -2.510855 -2.079525 -0.7673845 -1.079935 -1.391034 -1.688027 -1.953869 -2.170742 -2.319227 -2.532612 -2.726796 -2.905172 -3.053149 -3.118611 -3.272062 -3.403743 -3.515000 -3.570498 -3.580806 -3.544749 -3.275522 -2.277299 -0.5202020 -0.8551785 -1.205910 -1.539078 -1.836218 -2.053066 -2.233741 -2.475049 -2.696779 -2.898373 -3.048833 -3.104514 -3.273652 -3.414847 -3.530189 -3.571805 -3.574132 -3.530750 -3.252143 -2.277299 -0.3965018 -0.7606007 -1.126414 -1.467874 -1.759887 -1.988750 -2.210784 -2.463089 -2.697380 -2.906490 -3.034822 -3.119526 -3.291198 -3.433136 -3.546027 -3.565837 -3.568232 -3.515238 -3.227284 -2.277299 -0.3704315 -0.7422484 -1.106784 -1.434070 -1.722436 -1.981350 -2.221817 -2.479337 -2.718781 -2.918188 -3.042565 -3.154504 -3.317794 -3.455899 -3.560883 -3.561490 -3.562703 -3.497841 -3.200847 -2.277299 -0.4081380 -0.7745829 -1.119280 -1.437154 -1.736783 -2.008376 -2.260645 -2.516888 -2.748031 -2.930290 -3.074112 -3.195991 -3.350485 -3.480383 -3.572503 -3.560925 -3.557149 -3.478147 -3.172719 -2.277299 -0.4884683 -0.8366939 -1.169309 -1.483948 -1.783771 -2.064022 -2.319187 -2.567177 -2.783575 -2.968115 -3.121460 -3.243351 -3.385675 -3.504970 -3.577700 -3.562279 -3.549583 -3.455785 -3.142776 -2.277299 -0.6003135 -0.9353437 -1.256264 -1.564631 -1.863097 -2.140810 -2.389750 -2.625203 -2.835851 -3.026170 -3.175044 -3.295091 -3.422958 -3.527631 -3.578486 -3.563995 -3.539143 -3.430375 -3.111070 -2.277299 -0.7482126 -1.068235 -1.376987 -1.676507 -1.966592 -2.232058 -2.469757 -2.698217 -2.908849 -3.088054 -3.235180 -3.347224 -3.460696 -3.545646 -3.582048 -3.563886 -3.525287 -3.401521 -3.077868 -2.277299 -0.9284618 -1.231922 -1.527284 -1.814235 -2.082475 -2.336274 -2.568617 -2.791997 -2.986122 -3.155526 -3.293406 -3.397372 -3.495335 -3.557931 -3.586599 -3.561192 -3.506939 -3.368734 -3.043053 -2.277299 -1.137299 -1.422288 -1.697947 -1.959973 -2.216214 -2.462485 -2.687212 -2.887045 -3.068262 -3.222628 -3.348828 -3.443581 -3.522927 -3.570164 -3.589355 -3.553637 -3.483176 -3.331583 -3.006471 -2.277299 -1.369763 -1.626312 -1.881741 -2.129915 -2.374075 -2.601979 -2.799680 -2.986182 -3.147646 -3.286690 -3.400985 -3.483134 -3.543272 -3.580076 -3.588130 -3.539436 -3.453165 -3.289596 -2.967909 -2.277299 -1.618876 -1.852224 -2.089682 -2.319394 -2.534302 -2.736926 -2.915695 -3.077553 -3.221256 -3.347570 -3.447678 -3.514309 -3.560592 -3.584401 -3.579616 -3.517260 -3.415901 -3.242227 -2.927859 -2.277299 -1.895348 -2.097928 -2.301881 -2.501838 -2.695060 -2.868575 -3.020572 -3.162638 -3.291274 -3.401948 -3.486254 -3.540458 -3.571784 -3.580173 -3.560741 -3.485067 -3.370136 -3.188731 -2.885548 -2.277299 -2.176816 -2.343862 -2.515793 -2.683013 -2.842224 -2.990544 -3.122151 -3.244520 -3.354041 -3.446832 -3.516768 -3.556756 -3.572207 -3.562694 -3.528476 -3.440581 -3.314476 -3.128894 -2.840708 -2.277299 -2.466090 -2.588147 -2.722370 -2.857399 -2.989099 -3.111165 -3.218156 -3.317820 -3.406635 -3.480192 -3.532885 -3.556717 -3.555304 -3.527803 -3.479261 -3.381230 -3.247306 -3.062752 -2.793004 -2.277299 -2.758981 -2.838583 -2.933730 -3.032274 -3.130879 -3.222668 -3.302670 -3.377020 -3.441731 -3.493712 -3.526386 -3.532075 -3.513982 -3.470343 -3.409242 -3.304155 -3.167120 -2.989535 -2.741954 -2.277299 -3.055800 -3.089185 -3.140556 -3.198452 -3.259859 -3.317012 -3.365119 -3.409745 -3.447296 -3.475195 -3.486885 -3.474196 -3.440492 -3.384650 -3.314249 -3.206592 -3.072822 -2.908973 -2.686849 -2.277299 -3.350394 -3.332597 -3.334489 -3.344882 -3.362733 -3.379668 -3.390811 -3.402753 -3.411571 -3.414253 -3.405199 -3.375112 -3.328218 -3.264924 -3.190687 -3.087132 -2.962924 -2.818813 -2.626647 -2.277299 -3.663692 -3.589359 -3.538151 -3.497152 -3.465152 -3.433554 -3.398946 -3.370712 -3.345824 -3.319870 -3.286672 -3.240268 -3.183421 -3.115954 -3.039376 -2.950463 -2.834816 -2.717735 -2.560013 -2.277299 -9.906311 -9.689448 -9.443147 -9.169597 -8.870865 -8.548840 -8.205210 -7.841475 -7.458972 -7.058885 -6.642272 -6.210076 -5.763140 -5.302222 -4.828006 -4.341109 -3.842098 -3.331484 -2.809739 -2.277299 -0.6609513 -1.050604 -1.382486 -1.716961 -2.015993 -2.271115 -2.418555 -2.653079 -2.862776 -3.055550 -3.222678 -3.279565 -3.448095 -3.593774 -3.720578 -3.796136 -3.812980 -3.803692 -3.551193 -2.457263 -0.3373270 -0.7468143 -1.132115 -1.509536 -1.854628 -2.131837 -2.304215 -2.571658 -2.813706 -3.036737 -3.217547 -3.254208 -3.444121 -3.603808 -3.739160 -3.802563 -3.807754 -3.792583 -3.527457 -2.457263 -0.1735603 -0.6127543 -1.018728 -1.411712 -1.769191 -2.041301 -2.272355 -2.549256 -2.804324 -3.041859 -3.205446 -3.269058 -3.462307 -3.624556 -3.760171 -3.799911 -3.805457 -3.780205 -3.501915 -2.457263 -0.1291267 -0.5695693 -0.9827422 -1.378359 -1.722389 -2.017510 -2.279131 -2.558060 -2.820947 -3.057259 -3.203665 -3.308460 -3.493233 -3.652389 -3.781569 -3.796362 -3.805276 -3.766034 -3.474436 -2.457263 -0.1561258 -0.5893479 -1.000915 -1.379604 -1.722704 -2.035319 -2.312051 -2.592509 -2.855689 -3.072132 -3.234717 -3.358702 -3.531996 -3.684023 -3.800459 -3.799533 -3.804622 -3.749574 -3.444869 -2.457263 -0.2393193 -0.6604572 -1.054891 -1.416949 -1.762522 -2.080643 -2.365364 -2.647835 -2.901387 -3.108020 -3.286651 -3.419179 -3.576608 -3.717440 -3.813382 -3.806904 -3.803309 -3.730275 -3.413052 -2.457263 -0.3656639 -0.7659673 -1.137265 -1.493083 -1.833232 -2.150684 -2.441269 -2.716498 -2.951046 -3.167447 -3.352526 -3.483030 -3.625677 -3.749907 -3.819916 -3.815512 -3.799457 -3.707688 -3.378945 -2.457263 -0.5244179 -0.9009997 -1.258004 -1.599240 -1.932469 -2.248811 -2.534244 -2.789720 -3.025915 -3.242741 -3.422723 -3.548756 -3.674124 -3.779023 -3.830614 -3.824528 -3.792511 -3.681249 -3.343005 -2.457263 -0.7169076 -1.071674 -1.408896 -1.738129 -2.060777 -2.367740 -2.632939 -2.886577 -3.120106 -3.326715 -3.494457 -3.610863 -3.718388 -3.801013 -3.844028 -3.831050 -3.781350 -3.650269 -3.305125 -2.457263 -0.9428841 -1.273760 -1.592947 -1.906146 -2.210001 -2.492337 -2.755870 -3.003971 -3.223600 -3.410463 -3.566135 -3.668565 -3.756924 -3.822468 -3.856770 -3.832919 -3.764590 -3.614218 -3.265123 -2.457263 -1.200150 -1.506059 -1.805481 -2.089961 -2.372330 -2.646463 -2.900712 -3.126298 -3.323156 -3.494175 -3.631367 -3.721840 -3.789626 -3.843408 -3.865996 -3.828425 -3.740958 -3.572406 -3.222787 -2.457263 -1.484393 -1.757621 -2.027842 -2.295674 -2.563190 -2.820036 -3.042069 -3.244894 -3.419223 -3.567805 -3.690382 -3.768145 -3.820801 -3.860505 -3.868314 -3.815106 -3.708969 -3.524080 -3.177789 -2.457263 -1.785287 -2.031858 -2.279557 -2.524388 -2.757130 -2.980358 -3.180248 -3.353119 -3.503550 -3.635053 -3.742429 -3.808516 -3.846950 -3.869290 -3.860281 -3.790338 -3.666769 -3.468104 -3.130568 -2.457263 -2.119125 -2.325889 -2.534451 -2.743023 -2.945306 -3.132804 -3.299729 -3.449581 -3.581577 -3.695465 -3.786821 -3.838281 -3.861552 -3.864770 -3.837973 -3.751369 -3.612263 -3.404077 -3.080320 -2.457263 -2.456809 -2.620220 -2.788253 -2.953587 -3.116597 -3.272288 -3.414131 -3.540515 -3.650675 -3.744918 -3.817885 -3.851895 -3.857085 -3.841032 -3.796470 -3.694618 -3.543191 -3.332066 -3.026570 -2.457263 -2.801869 -2.912375 -3.035310 -3.161659 -3.287521 -3.408047 -3.519254 -3.618303 -3.703349 -3.774410 -3.826085 -3.840555 -3.825344 -3.790671 -3.729968 -3.616247 -3.457321 -3.250618 -2.968741 -2.457263 -3.157475 -3.212277 -3.284222 -3.363935 -3.447029 -3.528732 -3.603816 -3.669727 -3.725304 -3.769255 -3.796549 -3.790730 -3.755682 -3.704633 -3.631716 -3.511921 -3.353492 -3.160249 -2.905979 -2.457263 -3.514343 -3.510378 -3.522581 -3.545863 -3.578524 -3.614722 -3.647619 -3.674453 -3.696048 -3.710920 -3.712799 -3.687368 -3.635808 -3.573125 -3.495229 -3.377455 -3.229661 -3.058155 -2.836798 -2.457263 -3.888507 -3.817537 -3.760746 -3.719359 -3.691180 -3.670797 -3.651787 -3.631779 -3.612999 -3.595518 -3.570882 -3.523398 -3.461081 -3.391387 -3.315996 -3.215555 -3.082556 -2.942444 -2.758699 -2.457263 -11.58230 -11.33200 -11.04391 -10.72052 -10.36558 -9.981492 -9.570606 -9.134963 -8.676349 -8.196331 -7.696281 -7.177416 -6.640808 -6.087412 -5.518089 -4.933609 -4.334677 -3.721928 -3.095944 -2.457263 -0.5604886 -1.021439 -1.383745 -1.753075 -2.079282 -2.362973 -2.521814 -2.767608 -2.992368 -3.197199 -3.378694 -3.438578 -3.609863 -3.766421 -3.906014 -3.998956 -4.018732 -4.034547 -3.804912 -2.622362 -0.1561750 -0.6409031 -1.068289 -1.485188 -1.866817 -2.190617 -2.372590 -2.664663 -2.924652 -3.167102 -3.370758 -3.398493 -3.599818 -3.774808 -3.927381 -4.010703 -4.014693 -4.026441 -3.781599 -2.622362 5.0392143E-02 -0.4634983 -0.9179833 -1.354533 -1.755906 -2.078238 -2.338954 -2.634958 -2.909217 -3.167675 -3.361646 -3.413623 -3.617914 -3.798115 -3.953224 -4.012506 -4.015536 -4.017474 -3.756173 -2.622362 0.1166771 -0.3984773 -0.8620049 -1.303181 -1.702357 -2.054612 -2.345813 -2.640983 -2.923869 -3.183213 -3.354223 -3.456534 -3.653409 -3.830651 -3.980696 -4.009099 -4.019714 -4.006976 -3.728453 -2.622362 9.7522549E-02 -0.4088478 -0.8693156 -1.303235 -1.710638 -2.070317 -2.373052 -2.675166 -2.956879 -3.203904 -3.387911 -3.513098 -3.700646 -3.869202 -4.006962 -4.015658 -4.024822 -3.994428 -3.698230 -2.622362 1.2582560E-02 -0.4736182 -0.9228781 -1.353533 -1.751999 -2.104268 -2.424025 -2.724449 -3.004905 -3.244738 -3.441997 -3.581918 -3.755322 -3.911859 -4.028437 -4.028745 -4.029415 -3.979102 -3.665298 -2.622362 -0.1190867 -0.5842764 -1.020766 -1.431062 -1.812256 -2.171188 -2.491704 -2.793299 -3.063912 -3.305602 -3.510356 -3.656583 -3.813074 -3.954504 -4.041802 -4.045081 -4.032847 -3.960396 -3.629518 -2.622362 -0.2944171 -0.7362345 -1.145204 -1.532976 -1.908930 -2.259651 -2.583450 -2.878001 -3.143600 -3.382380 -3.589878 -3.731085 -3.872305 -3.994313 -4.059549 -4.062419 -4.033782 -3.937556 -3.591506 -2.622362 -0.5054499 -0.9134806 -1.297588 -1.670950 -2.031354 -2.378677 -2.695269 -2.980640 -3.237775 -3.476099 -3.676953 -3.805788 -3.928701 -4.026555 -4.081134 -4.077884 -4.030349 -3.909743 -3.551223 -2.622362 -0.7453223 -1.125115 -1.484651 -1.839030 -2.189378 -2.523013 -2.823371 -3.097471 -3.351969 -3.580870 -3.761148 -3.880373 -3.980768 -4.058407 -4.103309 -4.089193 -4.020938 -3.876182 -3.508427 -2.622362 -1.021408 -1.369556 -1.707259 -2.042413 -2.372347 -2.680030 -2.970817 -3.238124 -3.478122 -3.678500 -3.844810 -3.947107 -4.026354 -4.091080 -4.122959 -4.094220 -4.004253 -3.835897 -3.462864 -2.622362 -1.329846 -1.648042 -1.962275 -2.264975 -2.566823 -2.864556 -3.143676 -3.384737 -3.594725 -3.774618 -3.917409 -4.004652 -4.070295 -4.120265 -4.136584 -4.090495 -3.978487 -3.787778 -3.414209 -2.622362 -1.666419 -1.949369 -2.229347 -2.511008 -2.794790 -3.066456 -3.308525 -3.523020 -3.703443 -3.856793 -3.982213 -4.057270 -4.108656 -4.141583 -4.139870 -4.075250 -3.941250 -3.730538 -3.362019 -2.622362 -2.028710 -2.278223 -2.530457 -2.775796 -3.018508 -3.254296 -3.462392 -3.640639 -3.795344 -3.930299 -4.040486 -4.101842 -4.135810 -4.149964 -4.128159 -4.044654 -3.889918 -3.663424 -3.306843 -2.622362 -2.419930 -2.619174 -2.825931 -3.030120 -3.229859 -3.420173 -3.594066 -3.746569 -3.880351 -3.994561 -4.085379 -4.131212 -4.144765 -4.138616 -4.095897 -3.993886 -3.821226 -3.586645 -3.247463 -2.622362 -2.819856 -2.961840 -3.112877 -3.267540 -3.423958 -3.577904 -3.719708 -3.842614 -3.949927 -4.040267 -4.107897 -4.134597 -4.125823 -4.097998 -4.035608 -3.917304 -3.732362 -3.498670 -3.183198 -2.622362 -3.230958 -3.308757 -3.403205 -3.505157 -3.612768 -3.723011 -3.826086 -3.913627 -3.988715 -4.051127 -4.091783 -4.095482 -4.064852 -4.015666 -3.937892 -3.808770 -3.621580 -3.397573 -3.113042 -2.622362 -3.649539 -3.658123 -3.686115 -3.726068 -3.777019 -3.833779 -3.889162 -3.933800 -3.970349 -3.999613 -4.012116 -3.992447 -3.942835 -3.876979 -3.792413 -3.662720 -3.485295 -3.282058 -3.035286 -2.622362 -4.086494 -4.017763 -3.964262 -3.926071 -3.905763 -3.897636 -3.892802 -3.884406 -3.875229 -3.866547 -3.850079 -3.807758 -3.742306 -3.669415 -3.590223 -3.475401 -3.322505 -3.149025 -2.946643 -2.622362 -13.31235 -13.02802 -12.69606 -12.32105 -11.90708 -11.45775 -10.97614 -10.46492 -9.926380 -9.362480 -8.774938 -8.165252 -7.534739 -6.884567 -6.215779 -5.529305 -4.825993 -4.106610 -3.371852 -2.622362 -0.4625386 -0.9943948 -1.389358 -1.794247 -2.148393 -2.453205 -2.649416 -2.874362 -3.113363 -3.330995 -3.523411 -3.606298 -3.759450 -3.925628 -4.075314 -4.182751 -4.204205 -4.242383 -4.038789 -2.774865 2.0559302E-02 -0.5437172 -1.014609 -1.475840 -1.886360 -2.244543 -2.450746 -2.746373 -3.029253 -3.289016 -3.512218 -3.547185 -3.743524 -3.931790 -4.099186 -4.200078 -4.200954 -4.237267 -4.016602 -2.774865 0.2627089 -0.3215738 -0.8361748 -1.312300 -1.746510 -2.107615 -2.399651 -2.715102 -3.011321 -3.286822 -3.504926 -3.558685 -3.763393 -3.956961 -4.129245 -4.206310 -4.205207 -4.231920 -3.992016 -2.774865 0.3549244 -0.2310455 -0.7522644 -1.236137 -1.676767 -2.068983 -2.407008 -2.726621 -3.024169 -3.304786 -3.492224 -3.606169 -3.804416 -3.994848 -4.162574 -4.203285 -4.213436 -4.225480 -3.964793 -2.774865 0.3463686 -0.2280491 -0.7430105 -1.224509 -1.674128 -2.087101 -2.441171 -2.756837 -3.059835 -3.328400 -3.528462 -3.669838 -3.858227 -4.041333 -4.196755 -4.213496 -4.223774 -4.217399 -3.934673 -2.774865 0.2635561 -0.2880052 -0.7921648 -1.269190 -1.722884 -2.133847 -2.485519 -2.806055 -3.107907 -3.368674 -3.588882 -3.742379 -3.920736 -4.091668 -4.226991 -4.232429 -4.234881 -4.206838 -3.901367 -2.774865 0.1256981 -0.4005678 -0.8882531 -1.357553 -1.798746 -2.194152 -2.549888 -2.873663 -3.168123 -3.436661 -3.659356 -3.820526 -3.989588 -4.144168 -4.247226 -4.256154 -4.245379 -4.192955 -3.864645 -2.774865 -5.8669887E-02 -0.5569670 -1.026690 -1.475006 -1.888988 -2.279932 -2.636589 -2.955921 -3.253570 -3.521106 -3.741814 -3.904638 -4.058656 -4.194778 -4.271255 -4.280939 -4.253433 -4.174853 -3.825261 -2.774865 -0.2852170 -0.7538276 -1.191626 -1.607284 -2.012876 -2.392979 -2.743964 -3.064531 -3.356827 -3.613849 -3.836168 -3.992959 -4.128562 -4.238122 -4.301289 -4.304503 -4.257619 -4.151571 -3.783288 -2.774865 -0.5488706 -0.9758861 -1.381349 -1.779819 -2.164802 -2.536634 -2.881742 -3.191262 -3.468270 -3.723812 -3.937660 -4.078549 -4.193799 -4.279932 -4.333658 -4.325201 -4.255977 -4.122058 -3.738419 -2.774865 -0.8409199 -1.230670 -1.610085 -1.984139 -2.354437 -2.712612 -3.036548 -3.330123 -3.603415 -3.846255 -4.033039 -4.159903 -4.251213 -4.323363 -4.364253 -4.340445 -4.247343 -4.085015 -3.690334 -2.774865 -1.170372 -1.524479 -1.877921 -2.227453 -2.571976 -2.900696 -3.212328 -3.497026 -3.748845 -3.958211 -4.126579 -4.229930 -4.306590 -4.364055 -4.388258 -4.347471 -4.229211 -4.039069 -3.638649 -2.774865 -1.535173 -1.856490 -2.176265 -2.489573 -2.807212 -3.121142 -3.416730 -3.663833 -3.882813 -4.063543 -4.205431 -4.294904 -4.356362 -4.397675 -4.402048 -4.342330 -4.198835 -3.982703 -3.582920 -2.774865 -1.930771 -2.209771 -2.495208 -2.783387 -3.076222 -3.348438 -3.599849 -3.816284 -3.998209 -4.151222 -4.275804 -4.352687 -4.395317 -4.418790 -4.401668 -4.320649 -4.152703 -3.914706 -3.522795 -2.774865 -2.362657 -2.599627 -2.838494 -3.079455 -3.325319 -3.555152 -3.762182 -3.939336 -4.096269 -4.229843 -4.335822 -4.395952 -4.418126 -4.420063 -4.380548 -4.276977 -4.086753 -3.835263 -3.458313 -2.774865 -2.812749 -2.988242 -3.174101 -3.359179 -3.547621 -3.732777 -3.904530 -4.052486 -4.181389 -4.290920 -4.374638 -4.414010 -4.414017 -4.390615 -4.328943 -4.205113 -3.996944 -3.742423 -3.388074 -2.774865 -3.277910 -3.380694 -3.502716 -3.630149 -3.765149 -3.902456 -4.031195 -4.142251 -4.237721 -4.317317 -4.373079 -4.388336 -4.364974 -4.315647 -4.234603 -4.096069 -3.880474 -3.633168 -3.310899 -2.774865 -3.761291 -3.783027 -3.829177 -3.888051 -3.960061 -4.039898 -4.115284 -4.179634 -4.233699 -4.277064 -4.300366 -4.290187 -4.245099 -4.175498 -4.083148 -3.941453 -3.731398 -3.505502 -3.224840 -2.774865 -4.260666 -4.193597 -4.146253 -4.117320 -4.108078 -4.113481 -4.121720 -4.126776 -4.130475 -4.132648 -4.122737 -4.087712 -4.026044 -3.947820 -3.858261 -3.733808 -3.549900 -3.354233 -3.125927 -2.774865 -15.09291 -14.77395 -14.39686 -13.96776 -13.49210 -12.97455 -12.41904 -11.82887 -11.20689 -10.55550 -9.876757 -9.172474 -8.444216 -7.693366 -6.921161 -6.128703 -5.316983 -4.486903 -3.639279 -2.774865 -0.3636436 -0.9610186 -1.395384 -1.835007 -2.214450 -2.543197 -2.771305 -2.977319 -3.227500 -3.455767 -3.659004 -3.763886 -3.899019 -4.073576 -4.231383 -4.351038 -4.373493 -4.430871 -4.254673 -2.916559 0.1986274 -0.4487142 -0.9631214 -1.464890 -1.913756 -2.303486 -2.529287 -2.822391 -3.123409 -3.403244 -3.643174 -3.690182 -3.876598 -4.077690 -4.257233 -4.373753 -4.371026 -4.428582 -4.234190 -2.916559 0.4738178 -0.1880073 -0.7583463 -1.283436 -1.756971 -2.143249 -2.456041 -2.782303 -3.103899 -3.400273 -3.638539 -3.697498 -3.899673 -4.105309 -4.291735 -4.384924 -4.378282 -4.426793 -4.211076 -2.916559 0.5925842 -7.2752140E-02 -0.6563233 -1.192481 -1.662210 -2.083801 -2.452258 -2.797957 -3.123666 -3.419056 -3.626368 -3.748966 -3.948499 -4.148499 -4.331458 -4.382314 -4.391430 -4.424562 -4.185027 -2.916559 0.5913739 -5.3383157E-02 -0.6311952 -1.155836 -1.641827 -2.090453 -2.486855 -2.839096 -3.160069 -3.449555 -3.660547 -3.818758 -4.009116 -4.201204 -4.372964 -4.394910 -4.408004 -4.421139 -4.155706 -2.916559 0.5115768 -0.1067602 -0.6653934 -1.188045 -1.682134 -2.140449 -2.545244 -2.890865 -3.211375 -3.489469 -3.722623 -3.899429 -4.077646 -4.260410 -4.411036 -4.418339 -4.426282 -4.415581 -4.122736 -2.916559 0.3683447 -0.2178513 -0.7591504 -1.273188 -1.764124 -2.217772 -2.610883 -2.955275 -3.274459 -3.558888 -3.801931 -3.980916 -4.153694 -4.321963 -4.438877 -4.448107 -4.444194 -4.407001 -4.085771 -2.916559 0.1752114 -0.3796301 -0.8980066 -1.397644 -1.873868 -2.304813 -2.689922 -3.039791 -3.356743 -3.648576 -3.890125 -4.069056 -4.234990 -4.383198 -4.470600 -4.481792 -4.459946 -4.394379 -4.045701 -2.916559 -6.4166717E-02 -0.5840035 -1.075504 -1.549990 -1.996623 -2.413592 -2.797620 -3.142313 -3.464387 -3.751286 -3.983964 -4.165342 -4.315338 -4.438636 -4.510030 -4.515237 -4.472292 -4.376600 -4.002752 -2.916559 -0.3450687 -0.8263526 -1.282745 -1.721979 -2.149642 -2.553768 -2.929389 -3.274611 -3.587681 -3.859360 -4.091394 -4.264129 -4.394303 -4.490641 -4.551711 -4.545527 -4.479045 -4.352304 -3.956545 -2.916559 -0.6611086 -1.093281 -1.517114 -1.932308 -2.335830 -2.728943 -3.095231 -3.424030 -3.719249 -3.987895 -4.207973 -4.356863 -4.465551 -4.544711 -4.591374 -4.569716 -4.478666 -4.319921 -3.906644 -2.916559 -1.006447 -1.400280 -1.792449 -2.179478 -2.564695 -2.940253 -3.277438 -3.590631 -3.879057 -4.125910 -4.316428 -4.443741 -4.531082 -4.596802 -4.625680 -4.585690 -4.468828 -4.277851 -3.852594 -2.916559 -1.395630 -1.751013 -2.109885 -2.469636 -2.819210 -3.162251 -3.489429 -3.788356 -4.040544 -4.253695 -4.416486 -4.521559 -4.591644 -4.641639 -4.651328 -4.590395 -4.446131 -4.224209 -3.793872 -2.916559 -1.824167 -2.137715 -2.455112 -2.774028 -3.101857 -3.426182 -3.716050 -3.968767 -4.186093 -4.362608 -4.500832 -4.591124 -4.644109 -4.674127 -4.662810 -4.579826 -4.406636 -4.157293 -3.729790 -2.916559 -2.286098 -2.552578 -2.834478 -3.115696 -3.396228 -3.670691 -3.916501 -4.123397 -4.301337 -4.453411 -4.573412 -4.646056 -4.681731 -4.687946 -4.652841 -4.546738 -4.345583 -4.077097 -3.660388 -2.916559 -2.785822 -2.992022 -3.216491 -3.438187 -3.663376 -3.879775 -4.077449 -4.251276 -4.402237 -4.529245 -4.625355 -4.676910 -4.691432 -4.672723 -4.611172 -4.481479 -4.257730 -3.981205 -3.584560 -2.916559 -3.306542 -3.432583 -3.581599 -3.740582 -3.905675 -4.071370 -4.224077 -4.359081 -4.475551 -4.571863 -4.638795 -4.665184 -4.653369 -4.610830 -4.523913 -4.372875 -4.138827 -3.866073 -3.500682 -2.916559 -3.852562 -3.888734 -3.953909 -4.034455 -4.130280 -4.233405 -4.330672 -4.414877 -4.487848 -4.546048 -4.577761 -4.575681 -4.537045 -4.475668 -4.371644 -4.210774 -3.981171 -3.727981 -3.406525 -2.916559 -4.415510 -4.351589 -4.311845 -4.294902 -4.302150 -4.321664 -4.344986 -4.363757 -4.382140 -4.394979 -4.390188 -4.360885 -4.302810 -4.233609 -4.130172 -3.984416 -3.781282 -3.560355 -3.297468 -2.916559 -16.92084 -16.56669 -16.14295 -15.65765 -15.11781 -14.52925 -13.89684 -13.22461 -12.51596 -11.77374 -11.00041 -10.19806 -9.368533 -8.513438 -7.634208 -6.732120 -5.808321 -4.863848 -3.899639 -2.916559 -0.2683443 -0.9253113 -1.395625 -1.872833 -2.279460 -2.627161 -2.886511 -3.077879 -3.337145 -3.573734 -3.785766 -3.911709 -4.029979 -4.211601 -4.376009 -4.506877 -4.529291 -4.603106 -4.454345 -3.048875 0.3772374 -0.3350341 -0.9055464 -1.455801 -1.936210 -2.358990 -2.613834 -2.898395 -3.212487 -3.508030 -3.765754 -3.827098 -4.001141 -4.213398 -4.403222 -4.535400 -4.527322 -4.603413 -4.436062 -3.048875 0.6892191 -4.9185712E-02 -0.6834406 -1.251871 -1.764809 -2.194784 -2.518717 -2.850908 -3.186941 -3.504566 -3.765050 -3.830909 -4.028814 -4.244339 -4.441309 -4.552171 -4.537716 -4.605074 -4.414983 -3.048875 0.8257993 8.2334325E-02 -0.5620275 -1.146793 -1.668821 -2.111027 -2.498884 -2.861081 -3.210428 -3.530946 -3.754221 -3.885290 -4.084793 -4.292519 -4.486962 -4.551205 -4.556126 -4.607045 -4.390718 -3.048875 0.8384521 0.1156628 -0.5222051 -1.107262 -1.625075 -2.098108 -2.522457 -2.905222 -3.258116 -3.564806 -3.789679 -3.960306 -4.154047 -4.350867 -4.535510 -4.565933 -4.579500 -4.608301 -4.362839 -3.048875 0.7571089 7.0895612E-02 -0.5516477 -1.118410 -1.646687 -2.139034 -2.580882 -2.972753 -3.315596 -3.608635 -3.853592 -4.045710 -4.230582 -4.416915 -4.581288 -4.594628 -4.604804 -4.607881 -4.330884 -3.048875 0.6092464 -3.9808009E-02 -0.6341703 -1.193532 -1.723056 -2.217634 -2.664819 -3.043621 -3.378270 -3.680219 -3.936216 -4.135784 -4.312818 -4.488774 -4.618472 -4.632021 -4.630182 -4.604812 -4.294357 -3.048875 0.4065879 -0.2020531 -0.7735451 -1.316058 -1.838964 -2.325055 -2.750798 -3.121263 -3.465379 -3.768919 -4.029733 -4.227904 -4.400503 -4.559873 -4.659217 -4.674134 -4.653760 -4.598020 -4.254224 -3.048875 0.1555073 -0.4149220 -0.9539793 -1.478504 -1.981583 -2.438770 -2.849830 -3.228284 -3.567506 -3.876316 -4.130424 -4.327298 -4.493159 -4.625882 -4.707640 -4.715799 -4.674133 -4.586130 -4.210969 -3.048875 -0.1403842 -0.6682133 -1.174922 -1.673075 -2.135738 -2.575840 -2.982485 -3.353998 -3.695417 -3.995711 -4.239305 -4.433872 -4.583005 -4.691011 -4.758179 -4.754104 -4.689986 -4.567740 -4.164060 -3.048875 -0.4733850 -0.9570771 -1.425992 -1.882730 -2.326738 -2.747165 -3.145042 -3.511876 -3.838592 -4.124519 -4.365039 -4.541936 -4.668528 -4.756368 -4.807723 -4.787627 -4.698547 -4.540955 -4.112976 -3.048875 -0.8419347 -1.278830 -1.708966 -2.134879 -2.553185 -2.961441 -3.345100 -3.684707 -3.997324 -4.276423 -4.493443 -4.644713 -4.747433 -4.817770 -4.852450 -4.814010 -4.696997 -4.503917 -4.057178 -3.048875 -1.252766 -1.645210 -2.037204 -2.432465 -2.827753 -3.204470 -3.557508 -3.887233 -4.184873 -4.426610 -4.612781 -4.736837 -4.820293 -4.873145 -4.888428 -4.829457 -4.682228 -4.454241 -3.996044 -3.048875 -1.707887 -2.055145 -2.413132 -2.764458 -3.122219 -3.477180 -3.813406 -4.105929 -4.355358 -4.560884 -4.713003 -4.815299 -4.885452 -4.918343 -4.911210 -4.828278 -4.650319 -4.389634 -3.928871 -3.048875 -2.204532 -2.498276 -2.809204 -3.130294 -3.460420 -3.768138 -4.051845 -4.295783 -4.500037 -4.666526 -4.797578 -4.881837 -4.933265 -4.946354 -4.913544 -4.803171 -4.596293 -4.309741 -3.854851 -3.048875 -2.750060 -2.982634 -3.235943 -3.500274 -3.767261 -4.019828 -4.244534 -4.442091 -4.615024 -4.757060 -4.863743 -4.926921 -4.953639 -4.944945 -4.884155 -4.745278 -4.513040 -4.211593 -3.773823 -3.048875 -3.321262 -3.472404 -3.648511 -3.838545 -4.036553 -4.231019 -4.410541 -4.567587 -4.705005 -4.816018 -4.893120 -4.930327 -4.929126 -4.893703 -4.805671 -4.642229 -4.394329 -4.091067 -3.683549 -3.048875 -3.926556 -3.976832 -4.063354 -4.168804 -4.290357 -4.418430 -4.538064 -4.643384 -4.735434 -4.805836 -4.846390 -4.852691 -4.822267 -4.761825 -4.653452 -4.478495 -4.230097 -3.943056 -3.581545 -3.048875 -4.552560 -4.491610 -4.464508 -4.462630 -4.485206 -4.523855 -4.561433 -4.597011 -4.630285 -4.653497 -4.654094 -4.630639 -4.579490 -4.506708 -4.395646 -4.235466 -4.010543 -3.760683 -3.462585 -3.048875 -18.79339 -18.40347 -17.93162 -17.38812 -16.78170 -16.11952 -15.40742 -14.65022 -13.85190 -13.01578 -12.14470 -11.24108 -10.30704 -9.344409 -8.354836 -7.339768 -6.300516 -5.238254 -4.154050 -3.048875 -0.1785333 -0.8989535 -1.423219 -1.903520 -2.337907 -2.707982 -2.992546 -3.174615 -3.443046 -3.686462 -3.905147 -4.050367 -4.153224 -4.341491 -4.511415 -4.651414 -4.673621 -4.761815 -4.639221 -3.172978 0.5554594 -0.2209594 -0.8389435 -1.428386 -1.958731 -2.407463 -2.693328 -2.977361 -3.299678 -3.606715 -3.878889 -3.959610 -4.119222 -4.341015 -4.540000 -4.685978 -4.671530 -4.764590 -4.623480 -3.172978 0.9073867 0.1046782 -0.5899662 -1.224306 -1.770549 -2.236037 -2.592068 -2.924795 -3.268808 -3.598893 -3.882539 -3.959759 -4.152682 -4.375104 -4.581460 -4.708809 -4.685579 -4.769661 -4.604808 -3.172978 1.061577 0.2484958 -0.4707815 -1.101584 -1.665819 -2.151690 -2.556818 -2.926944 -3.289511 -3.629836 -3.878389 -4.019107 -4.215402 -4.429932 -4.631544 -4.710561 -4.709566 -4.775816 -4.582758 -3.172978 1.080952 0.2839580 -0.4154647 -1.052218 -1.622217 -2.122275 -2.561838 -2.965677 -3.341653 -3.675992 -3.914041 -4.099421 -4.293223 -4.494900 -4.685833 -4.727816 -4.739174 -4.781898 -4.556812 -3.172978 1.001423 0.2458872 -0.4360003 -1.062657 -1.627776 -2.141349 -2.610370 -3.033259 -3.413440 -3.724603 -3.982806 -4.187474 -4.379793 -4.568347 -4.740995 -4.763191 -4.771323 -4.786794 -4.526406 -3.172978 0.8479517 0.1372826 -0.5178472 -1.124319 -1.686328 -2.212813 -2.692964 -3.123018 -3.484711 -3.797201 -4.067112 -4.283298 -4.469365 -4.647023 -4.787276 -4.808864 -4.803823 -4.789504 -4.490926 -3.172978 0.6363918 -2.8603693E-02 -0.6517376 -1.239005 -1.799955 -2.322382 -2.802302 -3.210355 -3.567665 -3.888994 -4.162857 -4.385054 -4.563186 -4.727648 -4.836535 -4.858591 -4.835267 -4.788868 -4.451371 -3.172978 0.3726050 -0.2453690 -0.8349572 -1.405371 -1.949308 -2.459166 -2.908798 -3.309524 -3.674633 -3.996607 -4.271088 -4.485751 -4.662776 -4.806232 -4.895827 -4.907327 -4.863894 -4.783362 -4.408472 -3.172978 6.2124692E-02 -0.5090171 -1.062382 -1.609674 -2.125803 -2.599807 -3.036143 -3.438190 -3.799942 -4.123649 -4.386383 -4.595489 -4.766451 -4.882603 -4.956282 -4.953997 -4.887741 -4.771279 -4.361647 -3.172978 -0.2882066 -0.8145303 -1.332263 -1.839880 -2.315478 -2.773692 -3.196681 -3.593006 -3.951455 -4.259928 -4.512671 -4.716543 -4.862834 -4.959394 -5.013932 -4.996448 -4.904380 -4.750573 -4.310240 -3.172978 -0.6793697 -1.159893 -1.628282 -2.094864 -2.546616 -2.982887 -3.398392 -3.781625 -4.114878 -4.412049 -4.655422 -4.831610 -4.958878 -5.031843 -5.067439 -5.031282 -4.911603 -4.719139 -4.253487 -3.172978 -1.110283 -1.537140 -1.966953 -2.396170 -2.825736 -3.242335 -3.628566 -3.983057 -4.307311 -4.587329 -4.791317 -4.940308 -5.044282 -5.098485 -5.113667 -5.054955 -4.906487 -4.674029 -4.190666 -3.172978 -1.590531 -1.966128 -2.355592 -2.752406 -3.143862 -3.524210 -3.889254 -4.227217 -4.511885 -4.741689 -4.914433 -5.032144 -5.117354 -5.154189 -5.147471 -5.063221 -4.884470 -4.612324 -4.120929 -3.172978 -2.120760 -2.441955 -2.780438 -3.132686 -3.497247 -3.855513 -4.170627 -4.452469 -4.687764 -4.871868 -5.013179 -5.110738 -5.175604 -5.192651 -5.161330 -5.050066 -4.838803 -4.533416 -4.043164 -3.172978 -2.696805 -2.960730 -3.248347 -3.546817 -3.854932 -4.148957 -4.406173 -4.629133 -4.819869 -4.976108 -5.093092 -5.169546 -5.210546 -5.203392 -5.143460 -5.003341 -4.761144 -4.433823 -3.957371 -3.172978 -3.322366 -3.499064 -3.706961 -3.928595 -4.159039 -4.384360 -4.588002 -4.769834 -4.925629 -5.050443 -5.137521 -5.187556 -5.200872 -5.164840 -5.074602 -4.906880 -4.643533 -4.308942 -3.861315 -3.172978 -3.986241 -4.052672 -4.160664 -4.291305 -4.441304 -4.593432 -4.732363 -4.861367 -4.972427 -5.058186 -5.106810 -5.121759 -5.106036 -5.040921 -4.925270 -4.740886 -4.474186 -4.152251 -3.752021 -3.172978 -4.680778 -4.619107 -4.604083 -4.618874 -4.662462 -4.714397 -4.767304 -4.823168 -4.871959 -4.910263 -4.915802 -4.897450 -4.859266 -4.777354 -4.655198 -4.481391 -4.238599 -3.955943 -3.623348 -3.172978 -20.70810 -20.28184 -19.76070 -19.15682 -18.48157 -17.74329 -16.94890 -16.10401 -15.21321 -14.28032 -13.30856 -12.30070 -11.25912 -10.18591 -9.083157 -7.952014 -6.793946 -5.610763 -4.403410 -3.172978 -0.1060836 -0.8898316 -1.462834 -1.940890 -2.392530 -2.781138 -3.091905 -3.266361 -3.544818 -3.794656 -4.018649 -4.180364 -4.269853 -4.464224 -4.638876 -4.786247 -4.808259 -4.908682 -4.810464 -3.289828 0.7206845 -0.1285637 -0.7840526 -1.394063 -1.957188 -2.454252 -2.768252 -3.051377 -3.386875 -3.701757 -3.984761 -4.086842 -4.231328 -4.461875 -4.669383 -4.826397 -4.806448 -4.913659 -4.797392 -3.289828 1.120197 0.2518027 -0.4885305 -1.162440 -1.773392 -2.274420 -2.655832 -3.006158 -3.352242 -3.690382 -3.988823 -4.085533 -4.271512 -4.500069 -4.714932 -4.854636 -4.824439 -4.921975 -4.781310 -3.289828 1.297575 0.4205306 -0.3522058 -1.054305 -1.662029 -2.181152 -2.623544 -3.001175 -3.368926 -3.719867 -3.993572 -4.150081 -4.341900 -4.561326 -4.769523 -4.858923 -4.854136 -4.932020 -4.761689 -3.289828 1.327135 0.4629709 -0.3098106 -0.9976884 -1.611156 -2.154214 -2.616439 -3.028724 -3.418490 -3.774353 -4.036254 -4.235596 -4.428481 -4.634781 -4.830144 -4.878093 -4.890145 -4.942656 -4.737946 -3.289828 1.246459 0.4188929 -0.3209096 -1.002554 -1.616709 -2.160241 -2.644197 -3.089788 -3.493726 -3.835891 -4.106293 -4.328662 -4.522530 -4.716505 -4.892938 -4.919907 -4.929242 -4.952750 -4.709373 -3.289828 1.085501 0.3119339 -0.3995393 -1.063459 -1.664054 -2.211102 -2.719348 -3.179083 -3.581891 -3.912807 -4.195580 -4.426569 -4.621533 -4.801788 -4.949512 -4.972136 -4.969659 -4.961105 -4.675202 -3.289828 0.8642184 0.1430988 -0.5365373 -1.169314 -1.762751 -2.316843 -2.829319 -3.288781 -3.672373 -4.006361 -4.291975 -4.532048 -4.723592 -4.891082 -5.005881 -5.027287 -5.008887 -4.966529 -4.636448 -3.289828 0.5872376 -8.1310011E-02 -0.7179524 -1.334579 -1.912645 -2.460163 -2.961570 -3.394706 -3.777695 -4.117262 -4.404432 -4.643577 -4.828249 -4.981484 -5.072507 -5.084494 -5.044838 -4.967297 -4.594272 -3.289828 0.2617770 -0.3529171 -0.9532738 -1.542528 -2.100590 -2.625363 -3.091755 -3.519565 -3.905006 -4.244305 -4.528379 -4.756565 -4.939559 -5.066789 -5.140924 -5.141435 -5.075930 -4.961524 -4.547864 -3.289828 -0.1043998 -0.6739097 -1.233354 -1.788574 -2.313221 -2.796734 -3.255194 -3.673425 -4.056441 -4.390800 -4.657156 -4.881653 -5.050912 -5.154663 -5.208767 -5.192190 -5.101194 -4.947361 -4.496409 -3.289828 -0.5136934 -1.036760 -1.552956 -2.054867 -2.543271 -3.011369 -3.450267 -3.865188 -4.236074 -4.544374 -4.803676 -5.012382 -5.155458 -5.237898 -5.273335 -5.235485 -5.118150 -4.922188 -4.439117 -3.289828 -0.9670206 -1.431771 -1.899413 -2.363227 -2.822952 -3.271167 -3.694751 -4.081264 -4.425287 -4.725862 -4.962181 -5.134285 -5.253016 -5.313658 -5.329937 -5.269195 -5.122623 -4.882807 -4.375139 -3.289828 -1.469137 -1.877633 -2.297489 -2.726876 -3.160289 -3.572719 -3.963114 -4.330167 -4.655112 -4.909196 -5.106220 -5.244360 -5.337456 -5.379659 -5.373727 -5.288445 -5.109292 -4.825833 -4.303480 -3.289828 -2.028104 -2.381518 -2.750468 -3.133240 -3.526730 -3.915581 -4.283328 -4.594983 -4.860435 -5.066853 -5.221662 -5.335865 -5.408703 -5.429393 -5.398272 -5.285244 -5.071334 -4.750557 -4.222928 -3.289828 -2.638736 -2.925975 -3.245064 -3.587592 -3.929000 -4.259610 -4.556623 -4.808021 -5.018073 -5.187227 -5.314615 -5.406203 -5.456582 -5.451754 -5.391474 -5.247842 -4.999446 -4.652633 -4.132697 -3.289828 -3.310131 -3.514205 -3.753515 -4.012052 -4.277602 -4.528616 -4.757904 -4.963259 -5.139719 -5.277803 -5.375038 -5.438091 -5.460204 -5.425147 -5.333295 -5.159269 -4.884067 -4.526134 -4.031495 -3.289828 -4.034728 -4.115715 -4.247129 -4.405037 -4.584938 -4.760078 -4.925185 -5.074899 -5.204633 -5.302719 -5.360736 -5.389638 -5.377130 -5.309953 -5.190152 -4.995804 -4.711155 -4.363125 -3.915639 -3.289828 -4.799911 -4.735894 -4.732769 -4.766850 -4.831184 -4.901478 -4.977622 -5.050504 -5.114491 -5.159982 -5.173378 -5.166778 -5.127746 -5.041602 -4.912776 -4.723922 -4.462664 -4.154583 -3.778707 -3.289828 -22.66275 -22.19959 -21.62731 -20.96165 -20.21541 -19.39871 -18.51958 -17.58445 -16.59854 -15.56618 -14.49100 -13.37612 -12.22419 -11.03756 -9.818288 -8.568188 -7.288898 -5.981876 -4.648451 -3.289828 -4.3046687E-02 -0.8879839 -1.509644 -1.994184 -2.450714 -2.850949 -3.182249 -3.354073 -3.641533 -3.898423 -4.127196 -4.302667 -4.380337 -4.580380 -4.759247 -4.913055 -4.934330 -5.045618 -4.970347 -3.400226 0.8719314 -4.7522619E-02 -0.7668800 -1.378576 -1.953348 -2.475956 -2.841948 -3.121811 -3.470336 -3.794359 -4.086182 -4.209146 -4.338398 -4.576635 -4.791485 -4.958938 -4.932719 -5.052826 -4.960230 -3.400226 1.321276 0.3762749 -0.4023373 -1.101192 -1.744176 -2.306957 -2.716251 -3.079134 -3.439541 -3.780434 -4.088722 -4.205148 -4.385497 -4.619620 -4.841845 -4.993345 -4.954861 -5.064362 -4.947121 -3.400226 1.522694 0.5823356 -0.2339202 -0.9780135 -1.650583 -2.206914 -2.678531 -3.082754 -3.452014 -3.807976 -4.099224 -4.278934 -4.465322 -4.687544 -4.902486 -5.001261 -4.990256 -5.078233 -4.930426 -3.400226 1.565640 0.6415638 -0.1855154 -0.9389692 -1.597641 -2.175002 -2.676060 -3.100677 -3.495087 -3.863714 -4.148555 -4.369856 -4.561511 -4.768142 -4.970364 -5.023601 -5.032889 -5.093320 -4.909388 -3.400226 1.491181 0.5998099 -0.2060290 -0.9414123 -1.598531 -2.184689 -2.693254 -3.147540 -3.566965 -3.934835 -4.230464 -4.467308 -4.661036 -4.858669 -5.040193 -5.069990 -5.079508 -5.108534 -4.883233 -3.400226 1.322357 0.4831071 -0.2836230 -0.9965545 -1.647895 -2.224662 -2.748444 -3.230931 -3.661497 -4.026256 -4.318034 -4.569500 -4.767527 -4.952060 -5.103952 -5.128589 -5.127455 -5.122420 -4.851039 -3.400226 1.089598 0.3116073 -0.4202587 -1.108108 -1.734979 -2.313072 -2.853719 -3.344948 -3.770934 -4.122171 -4.421001 -4.676314 -4.877599 -5.047693 -5.168835 -5.192727 -5.173694 -5.133688 -4.813767 -3.400226 0.7972401 8.0084555E-02 -0.6083297 -1.266549 -1.877696 -2.455839 -2.993700 -3.473805 -3.879670 -4.234086 -4.532767 -4.794785 -4.988560 -5.144986 -5.243810 -5.258502 -5.217373 -5.140920 -4.773040 -3.400226 0.4631744 -0.2024058 -0.8461583 -1.477565 -2.069022 -2.634892 -3.149039 -3.599565 -4.008051 -4.359800 -4.662441 -4.917413 -5.103269 -5.242320 -5.324389 -5.321369 -5.257439 -5.142311 -4.727903 -3.400226 7.8703001E-02 -0.5365402 -1.136193 -1.729378 -2.299144 -2.829583 -3.308148 -3.759185 -4.156579 -4.511356 -4.803276 -5.041914 -5.222012 -5.339669 -5.402081 -5.379865 -5.291547 -5.135641 -4.677401 -3.400226 -0.3521952 -0.9123555 -1.469389 -2.018499 -2.540627 -3.039529 -3.509688 -3.945093 -4.339855 -4.677135 -4.950765 -5.181878 -5.339504 -5.436487 -5.473239 -5.432476 -5.317187 -5.117852 -4.620574 -3.400226 -0.8262596 -1.330172 -1.832395 -2.332244 -2.825640 -3.298387 -3.755971 -4.177008 -4.541851 -4.858135 -5.123531 -5.321660 -5.453461 -5.522086 -5.536253 -5.476430 -5.330482 -5.085385 -4.556288 -3.400226 -1.350157 -1.790383 -2.240650 -2.702394 -3.166974 -3.618850 -4.039475 -4.428257 -4.777298 -5.068821 -5.284757 -5.449921 -5.548856 -5.596293 -5.589128 -5.507353 -5.326576 -5.034299 -4.483351 -3.400226 -1.934275 -2.314105 -2.714689 -3.134939 -3.555268 -3.969782 -4.366742 -4.727363 -5.018690 -5.252817 -5.423871 -5.552637 -5.628823 -5.655827 -5.624194 -5.515823 -5.298456 -4.963037 -4.400387 -3.400226 -2.577985 -2.888107 -3.232343 -3.607904 -3.998949 -4.358057 -4.690784 -4.976768 -5.211169 -5.391577 -5.530105 -5.636803 -5.687326 -5.690647 -5.629405 -5.489736 -5.235634 -4.866038 -4.305789 -3.400226 -3.293519 -3.516347 -3.788712 -4.086460 -4.390604 -4.671763 -4.928513 -5.153515 -5.347343 -5.497298 -5.604430 -5.683738 -5.705504 -5.679285 -5.583903 -5.409796 -5.125851 -4.736710 -4.198989 -3.400226 -4.069460 -4.167716 -4.324101 -4.513527 -4.720791 -4.924004 -5.115722 -5.285238 -5.429017 -5.538550 -5.606519 -5.649312 -5.637414 -5.577477 -5.450099 -5.248131 -4.950914 -4.566190 -4.075695 -3.400226 -4.905341 -4.846927 -4.853115 -4.909341 -4.990619 -5.084042 -5.183715 -5.275851 -5.353107 -5.404809 -5.430223 -5.435265 -5.391675 -5.307803 -5.168357 -4.964612 -4.687173 -4.346396 -3.928968 -3.400226 -24.65536 -24.15474 -23.53021 -22.80100 -21.98149 -21.08415 -20.11794 -19.09016 -18.00666 -16.87231 -15.69140 -14.46663 -13.20173 -11.89903 -10.56079 -9.189045 -7.785823 -6.352006 -4.889780 -3.400226 1.5787138E-02 -0.8902457 -1.555711 -2.049603 -2.523172 -2.923378 -3.266619 -3.436996 -3.734244 -3.996971 -4.231318 -4.418148 -4.485316 -4.690703 -4.873078 -5.032655 -5.052823 -5.173951 -5.119464 -3.504848 1.014591 2.7050268E-02 -0.7360695 -1.393308 -1.966523 -2.496434 -2.899310 -3.190740 -3.548822 -3.884690 -4.184434 -4.327541 -4.440142 -4.685564 -4.905499 -5.084607 -5.051274 -5.183518 -5.112392 -3.504848 1.512298 0.5013207 -0.3498257 -1.061167 -1.715003 -2.308671 -2.775656 -3.149718 -3.521308 -3.870244 -4.186412 -4.319408 -4.495952 -4.733255 -4.958347 -5.125957 -5.077717 -5.198022 -5.102408 -3.504848 1.744162 0.7300862 -0.1317311 -0.9033366 -1.609599 -2.226522 -2.730515 -3.153541 -3.541709 -3.896476 -4.200799 -4.401065 -4.586346 -4.807216 -5.024103 -5.139355 -5.118791 -5.216046 -5.088770 -3.504848 1.800854 0.8110224 -6.0246103E-02 -0.8569245 -1.578159 -2.192058 -2.722973 -3.180062 -3.576247 -3.950421 -4.253822 -4.501025 -4.690894 -4.895909 -5.098615 -5.165113 -5.168887 -5.236335 -5.070714 -3.504848 1.728725 0.7776179 -7.9006478E-02 -0.8780404 -1.578393 -2.198545 -2.746825 -3.214238 -3.639262 -4.024336 -4.344865 -4.602550 -4.798634 -4.993313 -5.173854 -5.217927 -5.223119 -5.257047 -5.047356 -3.504848 1.561855 0.6571602 -0.1727117 -0.9307752 -1.623819 -2.245256 -2.789531 -3.283377 -3.732951 -4.127392 -4.441958 -4.707249 -4.908859 -5.095328 -5.247714 -5.284535 -5.277888 -5.276805 -5.017765 -3.504848 1.312188 0.4767458 -0.3070987 -1.043851 -1.718252 -2.321379 -2.878529 -3.393774 -3.852593 -4.236459 -4.544383 -4.818473 -5.025708 -5.196194 -5.321316 -5.357409 -5.332510 -5.294539 -4.982673 -3.504848 1.008931 0.2382820 -0.4997148 -1.207255 -1.849445 -2.453205 -3.017797 -3.534947 -3.979137 -4.345296 -4.662918 -4.936869 -5.144729 -5.299850 -5.407911 -5.430344 -5.385194 -5.308377 -4.944053 -3.504848 0.6622808 -5.6434255E-02 -0.7445908 -1.412566 -2.039571 -2.634600 -3.190944 -3.683766 -4.103646 -4.479298 -4.790771 -5.063313 -5.261105 -5.407759 -5.495608 -5.500453 -5.434113 -5.316402 -4.900819 -3.504848 0.2591357 -0.4012063 -1.041528 -1.671583 -2.274588 -2.850032 -3.368896 -3.835781 -4.260614 -4.626839 -4.938544 -5.195974 -5.386153 -5.517058 -5.582875 -5.567893 -5.476827 -5.316426 -4.851921 -3.504848 -0.1896661 -0.7870834 -1.384194 -1.973204 -2.543129 -3.068740 -3.568913 -4.027735 -4.441131 -4.801346 -5.095915 -5.340802 -5.518428 -5.620939 -5.665027 -5.629744 -5.511154 -5.305613 -4.796104 -3.504848 -0.6858158 -1.223737 -1.767928 -2.303088 -2.828090 -3.333471 -3.812149 -4.261997 -4.659635 -4.989071 -5.270905 -5.497809 -5.638570 -5.716948 -5.740638 -5.680714 -5.534642 -5.279840 -4.732057 -3.504848 -1.233422 -1.702230 -2.186868 -2.681031 -3.172615 -3.654716 -4.114679 -4.525687 -4.895041 -5.212358 -5.456327 -5.639363 -5.748030 -5.801468 -5.803308 -5.717021 -5.541483 -5.234590 -4.658364 -3.504848 -1.839843 -2.245050 -2.675081 -3.128093 -3.585436 -4.024791 -4.448603 -4.836866 -5.170049 -5.423990 -5.617414 -5.758902 -5.840267 -5.873450 -5.847611 -5.734122 -5.522891 -5.168092 -4.573573 -3.504848 -2.516768 -2.847996 -3.218106 -3.622791 -4.045254 -4.455014 -4.817985 -5.135002 -5.392069 -5.591444 -5.739654 -5.855270 -5.912650 -5.922024 -5.864087 -5.719084 -5.466572 -5.074483 -4.475528 -3.504848 -3.270955 -3.514677 -3.813869 -4.151606 -4.494841 -4.812931 -5.096686 -5.341807 -5.546849 -5.711942 -5.832353 -5.918896 -5.947009 -5.922496 -5.830605 -5.650956 -5.359794 -4.945655 -4.364144 -3.504848 -4.096263 -4.212658 -4.394435 -4.616301 -4.851443 -5.084620 -5.302471 -5.492033 -5.648737 -5.771276 -5.856764 -5.904159 -5.894228 -5.830671 -5.704380 -5.496155 -5.183388 -4.770967 -4.234613 -3.504848 -5.005040 -4.949716 -4.969819 -5.045370 -5.148121 -5.269673 -5.390311 -5.498945 -5.588433 -5.654679 -5.693112 -5.697269 -5.652865 -5.561686 -5.417764 -5.205120 -4.909616 -4.539402 -4.079361 -3.504848 -26.68411 -26.14548 -25.46739 -24.67242 -23.77816 -22.79810 -21.74262 -20.61990 -19.43649 -18.19776 -16.90819 -15.57159 -14.19124 -12.76996 -11.31026 -9.814337 -8.284158 -6.721483 -5.127902 -3.504848 7.3977172E-02 -0.8930493 -1.608613 -2.105844 -2.590258 -3.002588 -3.350818 -3.515842 -3.823269 -4.091267 -4.331140 -4.527488 -4.585611 -4.795794 -4.981299 -5.145773 -5.163761 -5.295079 -5.258701 -3.604268 1.154138 9.6081078E-02 -0.7237255 -1.402855 -2.008464 -2.527463 -2.952830 -3.251743 -3.624108 -3.968869 -4.280679 -4.442833 -4.537670 -4.790040 -5.014178 -5.203984 -5.161860 -5.306594 -5.254471 -3.604268 1.692674 0.6095976 -0.2907103 -1.060646 -1.707779 -2.309913 -2.807996 -3.218791 -3.598715 -3.958494 -4.283342 -4.430176 -4.602307 -4.842827 -5.068100 -5.252740 -5.191654 -5.324575 -5.247263 -3.604268 1.957531 0.8715322 -5.9345603E-02 -0.8483139 -1.566975 -2.216684 -2.780595 -3.221200 -3.622820 -3.985979 -4.301699 -4.516471 -4.704531 -4.924056 -5.137877 -5.272541 -5.239419 -5.347070 -5.236378 -3.604268 2.031778 0.9686516 5.2196309E-02 -0.7743734 -1.532772 -2.205415 -2.766228 -3.245603 -3.665013 -4.037735 -4.356351 -4.623646 -4.815747 -5.021796 -5.214429 -5.302135 -5.297147 -5.371935 -5.221032 -3.604268 1.957132 0.9479517 4.4389576E-02 -0.7951178 -1.556361 -2.209420 -2.785440 -3.290821 -3.715424 -4.110496 -4.449832 -4.732578 -4.930023 -5.124815 -5.299869 -5.362516 -5.359477 -5.398025 -5.200062 -3.604268 1.793957 0.8281511 -5.2219052E-02 -0.8704125 -1.600854 -2.253917 -2.839507 -3.342762 -3.802036 -4.214872 -4.558305 -4.838743 -5.047635 -5.232850 -5.381319 -5.438218 -5.423740 -5.423542 -5.172183 -3.604268 1.536293 0.6391302 -0.1966971 -0.9814885 -1.693584 -2.341935 -2.911027 -3.440773 -3.920673 -4.337767 -4.666228 -4.952969 -5.166923 -5.344888 -5.463598 -5.518450 -5.487312 -5.446723 -5.138321 -3.604268 1.221006 0.3942291 -0.3940154 -1.144882 -1.833047 -2.455740 -3.041526 -3.582783 -4.063938 -4.458703 -4.783365 -5.070336 -5.289729 -5.456865 -5.558583 -5.600060 -5.548338 -5.466566 -5.101184 -3.604268 0.8573256 8.8037737E-02 -0.6468885 -1.354779 -2.011764 -2.635386 -3.217996 -3.752775 -4.202291 -4.589385 -4.914683 -5.203696 -5.416339 -5.569566 -5.657799 -5.679726 -5.605017 -5.481257 -5.059503 -3.604268 0.4372394 -0.2638207 -0.9497840 -1.615851 -2.250908 -2.857836 -3.420948 -3.915291 -4.354975 -4.741966 -5.068063 -5.346190 -5.544661 -5.688034 -5.756521 -5.753738 -5.656687 -5.488177 -5.011892 -3.604268 -2.8010400E-02 -0.6660955 -1.301840 -1.924714 -2.534605 -3.105309 -3.623588 -4.111486 -4.539206 -4.922155 -5.236918 -5.489893 -5.682439 -5.801166 -5.848258 -5.820615 -5.700320 -5.484389 -4.957068 -3.604268 -0.5455157 -1.119337 -1.699178 -2.279389 -2.832038 -3.367049 -3.873071 -4.342754 -4.762385 -5.123106 -5.412858 -5.655783 -5.820253 -5.910652 -5.929552 -5.880476 -5.731606 -5.465948 -4.893588 -3.604268 -1.116183 -1.618714 -2.135370 -2.662321 -3.182147 -3.689940 -4.178638 -4.626843 -5.011140 -5.346818 -5.618654 -5.816891 -5.946495 -6.007376 -6.000483 -5.928347 -5.744711 -5.427376 -4.819706 -3.604268 -1.746066 -2.177639 -2.635451 -3.117757 -3.607597 -4.083301 -4.530572 -4.941463 -5.305363 -5.588479 -5.806487 -5.957584 -6.050139 -6.087313 -6.056207 -5.955582 -5.733860 -5.366510 -4.733612 -3.604268 -2.448651 -2.808354 -3.204480 -3.636614 -4.085257 -4.531116 -4.938996 -5.280491 -5.567099 -5.784001 -5.950599 -6.066535 -6.134616 -6.141670 -6.086029 -5.949123 -5.687472 -5.276206 -4.632976 -3.604268 -3.236292 -3.508466 -3.836518 -4.206547 -4.589471 -4.946728 -5.261288 -5.524906 -5.744534 -5.921539 -6.057666 -6.141740 -6.180303 -6.154856 -6.066706 -5.887744 -5.588606 -5.146937 -4.517179 -3.604268 -4.117521 -4.251654 -4.460009 -4.713277 -4.980501 -5.245190 -5.484497 -5.694790 -5.866203 -6.000462 -6.096339 -6.141942 -6.142814 -6.078581 -5.953689 -5.734736 -5.413244 -4.966855 -4.382572 -3.604268 -5.097903 -5.044709 -5.080355 -5.174148 -5.303268 -5.450521 -5.590774 -5.719155 -5.825971 -5.898484 -5.945284 -5.946699 -5.908908 -5.811815 -5.668766 -5.435538 -5.128992 -4.724367 -4.220731 -3.604268 -28.74740 -28.17021 -27.43730 -26.57515 -25.60403 -24.53923 -23.39239 -22.17258 -20.88703 -19.54166 -18.14140 -16.69041 -15.19226 -13.65007 -12.06653 -10.44405 -8.784773 -7.090600 -5.363248 -3.604268 0.1278140 -0.9056426 -1.656793 -2.160195 -2.661508 -3.081405 -3.435798 -3.592712 -3.907417 -4.181900 -4.426517 -4.631278 -4.681543 -4.896067 -5.085025 -5.253166 -5.269063 -5.409539 -5.390440 -3.698979 1.290499 0.1574929 -0.7068151 -1.416442 -2.040418 -2.581414 -3.010888 -3.308128 -3.697002 -4.048574 -4.373490 -4.555451 -4.631039 -4.890321 -5.121352 -5.317599 -5.266296 -5.423419 -5.389426 -3.698979 1.868521 0.7285821 -0.2338811 -1.042434 -1.736514 -2.321823 -2.837784 -3.274986 -3.673744 -4.039855 -4.379946 -4.538355 -4.704670 -4.949906 -5.181245 -5.373347 -5.300793 -5.445129 -5.385610 -3.698979 2.166951 1.011814 2.3805978E-02 -0.8234829 -1.541644 -2.204901 -2.800577 -3.286273 -3.698492 -4.075213 -4.402020 -4.628293 -4.816486 -5.039993 -5.256451 -5.399371 -5.356138 -5.471967 -5.378197 -3.698979 2.245220 1.125150 0.1404221 -0.7052738 -1.483019 -2.189625 -2.806557 -3.306856 -3.744335 -4.126977 -4.456584 -4.738036 -4.937313 -5.144240 -5.341677 -5.431604 -5.421880 -5.502015 -5.366230 -3.698979 2.168708 1.108908 0.1589362 -0.7127354 -1.511002 -2.221166 -2.821214 -3.350046 -3.800937 -4.196116 -4.550290 -4.852934 -5.057401 -5.254658 -5.433627 -5.498888 -5.492378 -5.533030 -5.348511 -3.698979 2.014787 0.9934288 6.7414790E-02 -0.7952139 -1.578299 -2.261585 -2.872698 -3.411356 -3.873772 -4.297892 -4.665474 -4.967273 -5.179846 -5.371885 -5.524356 -5.581009 -5.564356 -5.564099 -5.323594 -3.698979 1.759107 0.8003695 -8.5616022E-02 -0.9183037 -1.669751 -2.347495 -2.956492 -3.490248 -3.986499 -4.423378 -4.783900 -5.079004 -5.302460 -5.492605 -5.613511 -5.668231 -5.635363 -5.593787 -5.292275 -3.698979 1.434249 0.5430753 -0.2894930 -1.083873 -1.809921 -2.470095 -3.067636 -3.627062 -4.132175 -4.562091 -4.903084 -5.202684 -5.429221 -5.611989 -5.715305 -5.756896 -5.703964 -5.620086 -5.257822 -3.698979 1.049339 0.2314572 -0.5496684 -1.301880 -1.991679 -2.635864 -3.242831 -3.802065 -4.291565 -4.696571 -5.041418 -5.333025 -5.562353 -5.729038 -5.822304 -5.842926 -5.768544 -5.641343 -5.218870 -3.698979 0.6102124 -0.1313431 -0.8626316 -1.563055 -2.229817 -2.862692 -3.458855 -3.992687 -4.448140 -4.853340 -5.190958 -5.479307 -5.695914 -5.852706 -5.927619 -5.923496 -5.826893 -5.654820 -5.173819 -3.698979 0.1260709 -0.5485445 -1.221403 -1.879135 -2.518275 -3.128445 -3.683802 -4.186539 -4.640639 -5.031769 -5.365273 -5.633532 -5.842339 -5.978821 -6.030407 -5.998920 -5.877274 -5.657837 -5.121040 -3.698979 -0.4123222 -1.016336 -1.631638 -2.246981 -2.842545 -3.399736 -3.935426 -4.423757 -4.865404 -5.246697 -5.553322 -5.806541 -5.991711 -6.097681 -6.121658 -6.065342 -5.917258 -5.646336 -5.058786 -3.698979 -0.9991187 -1.537482 -2.087555 -2.643181 -3.195289 -3.728935 -4.242811 -4.714434 -5.127605 -5.477084 -5.769746 -5.985909 -6.129332 -6.201092 -6.201753 -6.119846 -5.940486 -5.615104 -4.985357 -3.698979 -1.651496 -2.111531 -2.597579 -3.106161 -3.624947 -4.137913 -4.613394 -5.044225 -5.427928 -5.745841 -5.980945 -6.144658 -6.246023 -6.291193 -6.265196 -6.156001 -5.938613 -5.561110 -4.898355 -3.698979 -2.381075 -2.762606 -3.192192 -3.650119 -4.124271 -4.599896 -5.043591 -5.421328 -5.727612 -5.969406 -6.148064 -6.266669 -6.338320 -6.361572 -6.304129 -6.160669 -5.899782 -5.476188 -4.795552 -3.698979 -3.198316 -3.490673 -3.854990 -4.258435 -4.674825 -5.074401 -5.417248 -5.706673 -5.938193 -6.126288 -6.267720 -6.355835 -6.395915 -6.386795 -6.297865 -6.112123 -5.807107 -5.349641 -4.674917 -3.698979 -4.131660 -4.286317 -4.522147 -4.805919 -5.107355 -5.401724 -5.665852 -5.889956 -6.079598 -6.222172 -6.323720 -6.373863 -6.373835 -6.322122 -6.195308 -5.969796 -5.633857 -5.167732 -4.533107 -3.698979 -5.183579 -5.134139 -5.184188 -5.299388 -5.458232 -5.629067 -5.791018 -5.932457 -6.051516 -6.136710 -6.189061 -6.191705 -6.147529 -6.064202 -5.906665 -5.667368 -5.341010 -4.913303 -4.360812 -3.698979 -30.84375 -30.22746 -29.43848 -28.50754 -27.45778 -26.30634 -25.06614 -23.74718 -22.35739 -20.90325 -19.39012 -17.82254 -16.20440 -14.53906 -12.82945 -11.07817 -9.287535 -7.459592 -5.596184 -3.698979 0.1708967 -0.9208483 -1.699969 -2.218245 -2.727041 -3.155575 -3.519272 -3.668509 -3.989305 -4.269124 -4.517990 -4.729899 -4.773070 -4.991727 -5.184124 -5.355341 -5.369871 -5.517076 -5.514493 -3.789407 1.420124 0.2291837 -0.6947657 -1.438634 -2.076374 -2.634708 -3.080177 -3.364866 -3.759926 -4.125915 -4.461530 -4.665489 -4.720136 -4.985114 -5.223361 -5.425740 -5.366781 -5.532525 -5.516654 -3.789407 2.049122 0.8496335 -0.1874501 -1.042754 -1.752950 -2.362936 -2.873389 -3.322720 -3.747250 -4.118869 -4.473537 -4.643436 -4.803749 -5.052371 -5.290237 -5.488221 -5.407964 -5.557006 -5.516235 -3.789407 2.371704 1.159138 8.9540437E-02 -0.7868336 -1.558230 -2.203879 -2.814491 -3.337661 -3.771994 -4.158341 -4.501716 -4.735970 -4.924373 -5.150819 -5.373012 -5.521385 -5.470634 -5.587280 -5.512445 -3.789407 2.444610 1.280164 0.2332841 -0.6688997 -1.445653 -2.169202 -2.822074 -3.364341 -3.818048 -4.218788 -4.554599 -4.846606 -5.055165 -5.262050 -5.466554 -5.557704 -5.543461 -5.621402 -5.504131 -3.789407 2.358057 1.268524 0.2570578 -0.6389957 -1.459837 -2.205063 -2.852842 -3.403252 -3.881988 -4.283485 -4.647423 -4.964324 -5.185544 -5.382303 -5.565434 -5.629808 -5.621059 -5.657418 -5.489996 -3.789407 2.215254 1.151804 0.1824242 -0.7163312 -1.538121 -2.267006 -2.903168 -3.466704 -3.951696 -4.378214 -4.762008 -5.084717 -5.312077 -5.504550 -5.663817 -5.717450 -5.700157 -5.693747 -5.468516 -3.789407 1.977089 0.9575438 2.7780397E-02 -0.8524865 -1.643526 -2.353876 -2.989418 -3.548946 -4.051871 -4.502689 -4.892211 -5.201090 -5.439911 -5.628769 -5.757985 -5.812869 -5.777977 -5.728841 -5.440225 -3.789407 1.641769 0.6927260 -0.1894111 -1.024132 -1.785364 -2.482619 -3.102401 -3.670359 -4.196040 -4.651682 -5.022466 -5.324795 -5.567322 -5.754601 -5.866047 -5.908481 -5.853490 -5.760973 -5.409019 -3.789407 1.235624 0.3690195 -0.4557472 -1.245963 -1.979337 -2.643565 -3.266337 -3.847248 -4.369036 -4.802961 -5.155433 -5.459624 -5.706380 -5.879543 -5.981019 -6.003027 -5.925601 -5.788873 -5.373309 -3.789407 0.7804207 -5.8240285E-03 -0.7784906 -1.517343 -2.209575 -2.868261 -3.486729 -4.058567 -4.545103 -4.955313 -5.311324 -5.611269 -5.849797 -6.010871 -6.093674 -6.091557 -5.991594 -5.810118 -5.331350 -3.789407 0.2778268 -0.4356065 -1.144120 -1.836611 -2.503379 -3.142498 -3.736771 -4.262919 -4.733846 -5.140995 -5.491725 -5.778520 -5.993525 -6.147215 -6.200905 -6.173810 -6.048318 -5.821407 -5.281322 -3.789407 -0.2792449 -0.9187661 -1.567679 -2.212920 -2.843635 -3.438484 -3.992421 -4.509712 -4.961692 -5.362483 -5.690987 -5.952282 -6.154235 -6.275568 -6.300513 -6.248235 -6.094289 -5.818134 -5.221477 -3.789407 -0.8847810 -1.454433 -2.038580 -2.628275 -3.205237 -3.772832 -4.306310 -4.803094 -5.239678 -5.603699 -5.908361 -6.150393 -6.304284 -6.395205 -6.390840 -6.311758 -6.126053 -5.794353 -5.149032 -3.789407 -1.557107 -2.045970 -2.561895 -3.097332 -3.640946 -4.183250 -4.696653 -5.147814 -5.545161 -5.885801 -6.143583 -6.324783 -6.433035 -6.493270 -6.467366 -6.356301 -6.134893 -5.746214 -5.061914 -3.789407 -2.313357 -2.717619 -3.171983 -3.664342 -4.164742 -4.666406 -5.137613 -5.558550 -5.880798 -6.144725 -6.335537 -6.461895 -6.540994 -6.568333 -6.514163 -6.368851 -6.107270 -5.665043 -4.957815 -3.789407 -3.158248 -3.471312 -3.860396 -4.305501 -4.757213 -5.188677 -5.573088 -5.878852 -6.124507 -6.323077 -6.470420 -6.565441 -6.612142 -6.606028 -6.512456 -6.327168 -6.023149 -5.539619 -4.833102 -3.789407 -4.139526 -4.314674 -4.581347 -4.897404 -5.232913 -5.557087 -5.840952 -6.082235 -6.277498 -6.437020 -6.542746 -6.597314 -6.602043 -6.559191 -6.418587 -6.190766 -5.851659 -5.354504 -4.684829 -3.789407 -5.261794 -5.217620 -5.282092 -5.421556 -5.607571 -5.806251 -5.988820 -6.150245 -6.268785 -6.370532 -6.425093 -6.427013 -6.390313 -6.306036 -6.133114 -5.886793 -5.548490 -5.090947 -4.503202 -3.789407 -32.97178 -32.31612 -31.46960 -30.46834 -29.33821 -28.09830 -26.76284 -25.34276 -23.84674 -22.28179 -20.65374 -18.96750 -17.22726 -15.43666 -13.59885 -11.71665 -9.792514 -7.828644 -5.827012 -3.789407 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -1.582758 -1.596172 -1.606549 -1.613965 -1.617790 -1.617586 -1.623672 -1.626542 -1.625779 -1.620914 -1.610748 -1.595982 -1.575059 -1.550020 -1.522920 -1.486725 -1.438323 -1.372550 -1.276455 -1.018276 -1.589173 -1.600744 -1.610106 -1.616068 -1.618109 -1.616879 -1.622210 -1.624293 -1.622739 -1.616397 -1.606019 -1.590440 -1.568729 -1.543206 -1.515943 -1.479711 -1.431424 -1.366232 -1.271369 -1.018276 -1.595275 -1.605637 -1.613382 -1.617396 -1.618154 -1.616198 -1.620688 -1.621872 -1.619444 -1.612160 -1.600910 -1.584491 -1.561979 -1.536148 -1.508675 -1.472452 -1.424288 -1.359800 -1.266129 -1.018276 -1.601656 -1.610213 -1.615807 -1.618402 -1.618234 -1.615511 -1.618997 -1.619220 -1.615073 -1.607554 -1.595378 -1.578092 -1.554634 -1.528823 -1.501168 -1.464926 -1.416900 -1.353065 -1.260730 -1.018276 -1.607657 -1.613794 -1.617947 -1.619411 -1.618388 -1.614699 -1.617074 -1.615460 -1.611020 -1.602522 -1.589385 -1.571197 -1.547286 -1.521214 -1.493355 -1.456981 -1.409240 -1.346099 -1.255146 -1.018276 -1.612507 -1.617129 -1.620025 -1.620576 -1.618445 -1.613674 -1.614876 -1.612047 -1.606522 -1.597001 -1.582873 -1.563491 -1.539644 -1.513168 -1.485240 -1.448691 -1.401315 -1.338883 -1.249365 -1.018276 -1.617316 -1.620420 -1.622287 -1.621665 -1.618316 -1.612358 -1.611398 -1.608163 -1.601514 -1.590936 -1.575273 -1.555900 -1.531685 -1.504898 -1.476786 -1.440053 -1.393122 -1.331395 -1.243365 -1.018276 -1.622077 -1.623930 -1.624449 -1.622530 -1.617092 -1.609757 -1.608250 -1.603750 -1.595939 -1.584256 -1.567823 -1.547991 -1.523157 -1.496216 -1.467737 -1.431066 -1.384532 -1.323610 -1.237126 -1.018276 -1.627048 -1.627338 -1.626377 -1.622243 -1.616153 -1.607443 -1.604532 -1.598749 -1.589712 -1.576417 -1.560054 -1.539729 -1.514459 -1.487198 -1.458174 -1.421660 -1.375825 -1.315499 -1.230608 -1.018276 -1.631924 -1.629805 -1.627174 -1.622234 -1.614667 -1.604577 -1.600204 -1.593069 -1.582199 -1.568952 -1.551951 -1.530735 -1.505257 -1.477441 -1.448159 -1.411910 -1.366448 -1.307026 -1.223776 -1.018276 -1.635867 -1.632647 -1.628281 -1.621720 -1.612631 -1.601117 -1.594354 -1.586067 -1.575202 -1.561204 -1.543049 -1.521527 -1.495748 -1.466996 -1.437718 -1.401770 -1.356628 -1.298146 -1.216573 -1.018276 -1.640213 -1.635132 -1.629007 -1.620779 -1.610047 -1.596264 -1.589137 -1.579784 -1.568025 -1.552642 -1.534034 -1.512048 -1.486831 -1.457934 -1.426874 -1.391415 -1.346319 -1.288878 -1.208925 -1.018276 -1.644426 -1.637486 -1.629465 -1.618713 -1.606481 -1.592336 -1.584056 -1.572857 -1.560097 -1.544164 -1.524871 -1.502754 -1.477426 -1.448702 -1.415921 -1.380024 -1.335471 -1.278992 -1.200717 -1.018276 -1.648072 -1.639291 -1.629540 -1.618043 -1.604333 -1.588184 -1.578603 -1.566490 -1.552548 -1.535639 -1.515727 -1.493297 -1.467955 -1.439069 -1.406199 -1.368060 -1.324018 -1.268493 -1.191821 -1.018276 -1.654107 -1.643586 -1.631348 -1.618058 -1.602316 -1.585293 -1.574230 -1.560382 -1.544679 -1.526738 -1.506487 -1.483760 -1.458577 -1.429289 -1.395479 -1.356957 -1.312234 -1.257237 -1.181471 -1.018276 -1.662994 -1.650066 -1.636243 -1.620753 -1.604229 -1.587197 -1.568865 -1.553963 -1.537168 -1.518819 -1.498141 -1.475351 -1.448296 -1.418065 -1.384093 -1.345811 -1.300555 -1.245243 -1.169291 -1.018276 -1.677185 -1.662338 -1.646781 -1.630689 -1.613164 -1.595445 -1.576895 -1.556335 -1.535763 -1.512804 -1.490201 -1.465164 -1.437462 -1.406577 -1.372401 -1.332866 -1.286715 -1.230601 -1.155216 -1.018276 -1.704317 -1.685012 -1.668360 -1.650305 -1.631135 -1.611057 -1.589807 -1.567217 -1.543441 -1.518108 -1.491112 -1.463290 -1.431733 -1.397927 -1.360383 -1.318181 -1.269120 -1.208383 -1.138179 -1.018276 -1.777587 -1.754200 -1.730073 -1.706303 -1.680162 -1.653096 -1.625012 -1.596256 -1.565532 -1.533409 -1.499445 -1.463243 -1.424187 -1.381494 -1.334594 -1.284957 -1.232865 -1.177271 -1.115420 -1.018276 -1.674184 -1.645087 -1.615351 -1.584984 -1.553991 -1.522378 -1.490397 -1.457321 -1.423884 -1.389850 -1.355230 -1.320031 -1.284259 -1.247920 -1.211020 -1.173563 -1.135546 -1.096989 -1.057897 -1.018276 -1.720949 -1.774697 -1.821836 -1.882651 -1.935711 -1.982601 -2.020605 -2.048982 -2.065134 -2.082575 -2.103314 -2.114333 -2.113117 -2.098415 -2.066166 -2.030405 -1.980496 -1.901213 -1.772134 -1.410087 -1.734780 -1.785305 -1.832415 -1.891741 -1.945108 -1.990622 -2.026411 -2.051891 -2.063962 -2.081233 -2.101072 -2.110159 -2.107971 -2.091482 -2.057354 -2.021185 -1.971293 -1.892459 -1.764915 -1.410087 -1.751498 -1.800715 -1.848268 -1.905460 -1.956746 -1.998713 -2.031943 -2.053954 -2.063901 -2.080451 -2.098908 -2.106236 -2.101985 -2.083790 -2.047980 -2.011645 -1.961756 -1.883404 -1.757478 -1.410087 -1.773189 -1.820331 -1.865958 -1.921608 -1.968116 -2.007216 -2.036848 -2.054672 -2.064680 -2.079944 -2.095738 -2.101810 -2.095554 -2.075305 -2.038320 -2.001748 -1.951859 -1.874020 -1.749809 -1.410087 -1.799074 -1.844466 -1.887581 -1.937413 -1.980174 -2.015376 -2.040065 -2.056972 -2.065924 -2.079464 -2.092879 -2.096799 -2.088152 -2.065897 -2.028314 -1.991456 -1.941569 -1.864225 -1.741890 -1.410087 -1.829363 -1.871319 -1.908747 -1.953570 -1.991898 -2.021753 -2.044576 -2.059960 -2.067255 -2.077577 -2.089393 -2.090356 -2.079942 -2.055818 -2.017905 -1.980728 -1.930859 -1.854041 -1.733710 -1.410087 -1.860672 -1.897521 -1.929709 -1.969521 -2.001916 -2.029208 -2.049843 -2.063145 -2.067398 -2.075951 -2.084383 -2.083203 -2.070674 -2.045408 -2.007059 -1.969523 -1.919692 -1.843444 -1.725250 -1.410087 -1.892799 -1.923313 -1.950189 -1.983732 -2.013112 -2.037448 -2.055403 -2.065314 -2.067752 -2.073501 -2.078925 -2.075119 -2.060496 -2.034566 -1.995726 -1.957813 -1.908032 -1.832403 -1.716481 -1.410087 -1.924388 -1.947944 -1.969188 -1.999257 -2.025032 -2.045918 -2.059999 -2.067587 -2.067263 -2.069039 -2.071837 -2.065694 -2.049889 -2.023232 -1.983837 -1.945545 -1.895825 -1.820876 -1.707375 -1.410087 -1.954022 -1.972601 -1.989692 -2.015292 -2.036973 -2.053290 -2.064581 -2.069062 -2.064783 -2.063670 -2.063692 -2.055575 -2.038739 -2.011360 -1.971367 -1.932675 -1.882771 -1.808822 -1.697894 -1.410087 -1.984354 -1.998203 -2.010406 -2.030520 -2.047592 -2.060522 -2.067602 -2.068593 -2.061271 -2.057142 -2.054581 -2.044947 -2.027049 -1.998884 -1.958265 -1.919157 -1.868901 -1.796183 -1.687994 -1.410087 -2.014875 -2.023022 -2.030043 -2.045388 -2.057762 -2.066120 -2.069582 -2.066982 -2.056566 -2.049654 -2.045084 -2.033857 -2.014788 -1.985771 -1.944481 -1.904888 -1.854305 -1.782906 -1.677623 -1.410087 -2.044041 -2.046944 -2.048091 -2.058565 -2.065935 -2.070668 -2.070432 -2.064302 -2.051308 -2.042009 -2.035280 -2.022361 -2.002006 -1.972002 -1.929988 -1.889064 -1.838916 -1.768948 -1.666715 -1.410087 -2.071499 -2.069183 -2.065375 -2.071030 -2.073750 -2.074405 -2.070659 -2.061624 -2.046175 -2.034360 -2.025349 -2.010620 -1.988809 -1.957661 -1.915448 -1.872335 -1.822679 -1.754277 -1.655192 -1.410087 -2.099460 -2.091284 -2.082288 -2.083235 -2.081663 -2.078725 -2.071749 -2.059680 -2.041615 -2.027183 -2.015685 -1.998908 -1.975492 -1.943154 -1.902035 -1.854772 -1.805577 -1.738842 -1.642950 -1.410087 -2.130253 -2.116489 -2.102291 -2.098582 -2.092788 -2.085879 -2.075278 -2.059809 -2.038688 -2.021344 -2.007114 -1.987783 -1.962468 -1.929611 -1.888475 -1.837868 -1.787789 -1.722628 -1.630037 -1.410087 -2.171871 -2.152009 -2.131789 -2.122870 -2.112201 -2.100428 -2.085275 -2.065402 -2.040126 -2.018143 -1.999919 -1.977969 -1.950759 -1.917059 -1.875423 -1.825512 -1.769786 -1.705754 -1.615878 -1.410087 -2.240330 -2.212508 -2.184530 -2.168813 -2.151693 -2.132939 -2.112662 -2.089247 -2.062241 -2.031763 -1.998808 -1.974196 -1.944591 -1.908800 -1.866425 -1.816023 -1.756719 -1.689401 -1.600577 -1.410087 -2.389992 -2.358248 -2.325925 -2.292493 -2.259354 -2.224026 -2.191677 -2.162425 -2.130264 -2.095206 -2.056571 -2.014450 -1.968548 -1.919953 -1.872678 -1.818429 -1.754275 -1.679319 -1.583810 -1.410087 -2.912270 -2.853436 -2.792075 -2.728238 -2.661969 -2.593315 -2.522345 -2.449350 -2.373632 -2.295983 -2.216218 -2.134379 -2.050737 -1.964626 -1.876824 -1.787123 -1.695547 -1.602160 -1.506998 -1.410087 -1.670453 -1.789460 -1.896794 -1.986376 -2.068846 -2.166665 -2.254628 -2.329189 -2.388242 -2.425861 -2.458747 -2.502625 -2.528899 -2.535658 -2.516987 -2.471598 -2.426032 -2.338625 -2.181894 -1.737570 -1.672283 -1.793073 -1.900917 -1.987349 -2.074133 -2.174250 -2.262070 -2.336496 -2.392866 -2.425192 -2.457377 -2.500122 -2.525100 -2.529767 -2.508039 -2.460276 -2.414700 -2.327642 -2.172609 -1.737570 -1.691716 -1.809110 -1.911505 -1.999962 -2.088489 -2.187796 -2.274164 -2.345300 -2.396773 -2.424875 -2.458039 -2.498928 -2.521288 -2.523007 -2.497837 -2.448691 -2.402954 -2.316247 -2.163026 -1.737570 -1.723031 -1.832461 -1.933072 -2.022227 -2.110274 -2.206099 -2.288618 -2.354348 -2.398996 -2.427530 -2.459146 -2.497799 -2.516668 -2.515126 -2.486202 -2.436743 -2.390737 -2.304407 -2.153126 -1.737570 -1.760135 -1.866860 -1.964936 -2.052011 -2.136766 -2.227243 -2.303385 -2.361845 -2.403290 -2.431166 -2.461339 -2.495553 -2.511258 -2.505839 -2.473617 -2.424317 -2.377987 -2.292084 -2.142882 -1.737570 -1.807424 -1.910852 -2.004028 -2.086691 -2.166014 -2.248829 -2.316976 -2.369544 -2.409787 -2.435891 -2.462647 -2.492725 -2.504581 -2.494921 -2.460707 -2.411343 -2.364679 -2.279234 -2.132292 -1.737570 -1.865582 -1.961282 -2.047586 -2.123952 -2.195606 -2.269437 -2.329913 -2.379721 -2.416799 -2.440701 -2.463287 -2.488777 -2.496150 -2.482207 -2.447316 -2.397729 -2.350689 -2.265623 -2.121342 -1.737570 -1.928099 -2.015385 -2.093467 -2.161510 -2.223835 -2.289265 -2.345377 -2.390643 -2.424665 -2.443969 -2.462227 -2.483017 -2.485628 -2.468640 -2.433295 -2.383378 -2.335986 -2.251555 -2.110000 -1.737570 -1.994942 -2.070950 -2.139612 -2.197605 -2.251771 -2.311377 -2.361792 -2.402308 -2.431146 -2.446185 -2.459681 -2.474887 -2.472781 -2.454460 -2.418509 -2.368272 -2.320502 -2.236780 -2.098310 -1.737570 -2.062259 -2.126453 -2.184609 -2.234290 -2.281527 -2.334210 -2.378788 -2.412754 -2.436323 -2.446933 -2.454903 -2.464246 -2.458891 -2.439426 -2.402807 -2.352122 -2.304166 -2.221138 -2.086054 -1.737570 -2.128747 -2.182703 -2.230978 -2.271969 -2.312078 -2.356675 -2.393994 -2.421911 -2.439827 -2.445183 -2.447399 -2.451752 -2.444120 -2.423393 -2.386064 -2.334939 -2.286877 -2.204641 -2.073382 -1.737570 -2.196313 -2.239000 -2.277375 -2.310312 -2.341591 -2.377458 -2.407411 -2.429134 -2.440639 -2.440192 -2.437833 -2.438576 -2.428336 -2.406206 -2.368178 -2.316622 -2.268563 -2.187226 -2.060137 -1.737570 -2.263523 -2.295198 -2.323596 -2.347271 -2.369277 -2.396504 -2.418567 -2.433309 -2.438110 -2.433114 -2.427413 -2.424638 -2.411513 -2.387858 -2.348977 -2.297080 -2.248891 -2.168811 -2.046014 -1.737570 -2.329334 -2.350416 -2.368322 -2.382164 -2.394729 -2.412895 -2.426546 -2.434868 -2.434360 -2.425254 -2.416156 -2.409869 -2.393789 -2.368283 -2.328479 -2.276274 -2.227310 -2.149373 -2.031080 -1.737570 -2.393331 -2.403592 -2.410239 -2.413790 -2.417211 -2.427400 -2.433679 -2.436347 -2.430584 -2.416993 -2.404231 -2.394613 -2.375363 -2.347759 -2.306811 -2.253327 -2.204244 -2.128899 -2.015214 -1.737570 -2.453681 -2.453147 -2.450464 -2.445329 -2.440737 -2.443553 -2.442454 -2.439354 -2.428150 -2.409591 -2.392811 -2.379603 -2.357057 -2.326788 -2.284383 -2.228137 -2.179723 -2.107114 -1.998267 -1.737570 -2.520516 -2.509640 -2.497145 -2.482785 -2.469953 -2.465558 -2.457223 -2.447745 -2.430621 -2.406204 -2.384547 -2.367152 -2.340072 -2.306497 -2.264709 -2.209008 -2.153873 -2.083925 -1.980090 -1.737570 -2.615142 -2.591925 -2.567886 -2.542002 -2.518741 -2.505819 -2.489192 -2.471771 -2.447139 -2.415296 -2.382686 -2.359359 -2.328753 -2.292196 -2.249406 -2.193364 -2.128443 -2.060090 -1.960605 -1.737570 -2.805009 -2.764897 -2.726592 -2.687441 -2.646745 -2.605729 -2.577852 -2.548716 -2.517996 -2.481897 -2.438736 -2.389006 -2.345803 -2.303502 -2.253725 -2.194263 -2.121181 -2.040071 -1.941199 -1.737570 -4.241012 -4.152056 -4.056981 -3.956678 -3.851087 -3.740391 -3.624726 -3.504297 -3.379236 -3.249707 -3.115865 -2.977820 -2.835740 -2.689727 -2.539911 -2.386412 -2.229317 -2.068755 -1.905049 -1.737570 -1.540262 -1.721239 -1.887253 -2.034842 -2.153334 -2.267535 -2.401345 -2.520943 -2.622767 -2.700808 -2.740472 -2.811264 -2.868807 -2.901866 -2.902556 -2.853271 -2.813135 -2.720715 -2.538785 -2.018899 -1.503062 -1.694601 -1.869448 -2.019157 -2.136611 -2.260600 -2.402062 -2.525933 -2.628934 -2.703677 -2.737146 -2.810467 -2.867427 -2.898512 -2.895206 -2.840396 -2.800271 -2.707886 -2.527389 -2.018899 -1.505624 -1.698716 -1.871813 -2.016721 -2.141032 -2.273442 -2.415857 -2.538152 -2.638115 -2.704881 -2.739965 -2.812807 -2.867131 -2.894564 -2.886198 -2.827572 -2.786989 -2.694536 -2.515578 -2.018899 -1.535488 -1.721293 -1.887649 -2.034349 -2.166494 -2.299365 -2.436933 -2.555032 -2.647056 -2.707031 -2.746787 -2.816799 -2.867019 -2.889422 -2.875256 -2.814579 -2.773156 -2.680617 -2.503312 -2.018899 -1.583116 -1.757776 -1.922138 -2.072851 -2.204211 -2.331831 -2.463292 -2.572780 -2.654114 -2.714759 -2.756154 -2.821240 -2.866059 -2.882590 -2.861956 -2.801589 -2.758692 -2.665962 -2.490747 -2.018899 -1.645669 -1.813435 -1.975237 -2.123119 -2.248929 -2.370375 -2.491604 -2.588898 -2.665378 -2.725546 -2.765993 -2.824999 -2.863650 -2.873662 -2.847435 -2.787610 -2.743499 -2.650693 -2.477767 -2.018899 -1.726609 -1.886723 -2.040157 -2.178540 -2.299232 -2.411325 -2.518313 -2.607119 -2.680962 -2.738132 -2.775098 -2.827206 -2.858891 -2.862005 -2.832645 -2.772877 -2.727794 -2.634605 -2.464346 -2.018899 -1.822840 -1.969915 -2.110150 -2.239753 -2.350599 -2.449743 -2.545923 -2.629604 -2.698897 -2.750836 -2.782828 -2.827199 -2.851270 -2.847525 -2.817601 -2.757157 -2.710748 -2.617712 -2.450440 -2.018899 -1.924117 -2.058818 -2.186497 -2.302178 -2.399454 -2.488591 -2.577315 -2.654096 -2.716786 -2.762468 -2.788381 -2.824222 -2.840256 -2.832111 -2.801238 -2.740273 -2.692622 -2.599878 -2.435995 -2.018899 -2.032840 -2.151601 -2.262427 -2.363655 -2.450016 -2.530352 -2.610205 -2.678309 -2.732865 -2.771877 -2.791113 -2.817850 -2.826284 -2.816028 -2.783584 -2.722483 -2.673550 -2.580997 -2.420955 -2.018899 -2.143189 -2.242817 -2.338332 -2.427369 -2.503131 -2.572690 -2.642016 -2.700281 -2.746229 -2.777626 -2.789990 -2.807687 -2.811233 -2.798203 -2.764338 -2.702535 -2.652807 -2.560941 -2.405247 -2.018899 -2.252426 -2.335247 -2.416702 -2.492425 -2.555839 -2.612737 -2.670878 -2.719317 -2.755661 -2.778814 -2.784153 -2.795624 -2.794922 -2.778672 -2.743638 -2.680796 -2.630655 -2.539479 -2.388783 -2.018899 -2.364005 -2.429781 -2.494759 -2.555604 -2.605744 -2.649637 -2.696125 -2.734100 -2.760375 -2.775023 -2.775147 -2.781842 -2.776492 -2.757151 -2.720324 -2.657423 -2.606587 -2.516430 -2.371446 -2.018899 -2.474375 -2.520990 -2.569254 -2.615741 -2.651670 -2.682403 -2.716762 -2.744131 -2.760824 -2.768193 -2.763456 -2.765387 -2.755803 -2.733610 -2.695025 -2.631553 -2.580509 -2.491939 -2.353100 -2.018899 -2.579855 -2.608544 -2.640906 -2.671360 -2.692783 -2.710760 -2.732955 -2.750560 -2.758817 -2.758896 -2.748811 -2.746432 -2.732954 -2.707610 -2.667090 -2.603005 -2.551687 -2.465924 -2.333558 -2.018899 -2.681564 -2.692898 -2.709073 -2.723747 -2.730980 -2.736500 -2.747240 -2.755733 -2.755752 -2.748217 -2.732078 -2.724910 -2.708030 -2.679173 -2.636603 -2.571571 -2.519911 -2.438196 -2.312598 -2.018899 -2.781296 -2.775635 -2.777378 -2.778554 -2.772213 -2.765115 -2.764600 -2.763268 -2.754639 -2.738662 -2.715619 -2.703406 -2.682260 -2.649393 -2.604304 -2.542674 -2.485794 -2.408551 -2.289943 -2.018899 -2.899907 -2.877066 -2.864264 -2.851380 -2.830743 -2.810014 -2.797749 -2.785204 -2.766258 -2.739947 -2.707231 -2.686910 -2.659769 -2.622174 -2.575615 -2.514791 -2.450303 -2.377065 -2.265381 -2.018899 -3.121695 -3.077222 -3.042571 -3.005988 -2.962964 -2.920161 -2.892669 -2.864377 -2.831941 -2.792803 -2.748860 -2.699121 -2.665045 -2.620414 -2.564595 -2.501261 -2.420839 -2.346874 -2.239642 -2.018899 -5.652469 -5.532276 -5.402169 -5.262545 -5.113832 -4.956417 -4.790693 -4.617023 -4.435747 -4.247197 -4.051660 -3.849440 -3.640774 -3.425937 -3.205130 -2.978598 -2.746516 -2.509095 -2.266498 -2.018899 -1.410123 -1.626102 -1.843682 -2.042162 -2.213952 -2.338278 -2.506277 -2.662110 -2.802201 -2.919383 -2.993169 -3.062711 -3.151148 -3.211635 -3.235693 -3.197441 -3.154919 -3.061459 -2.857047 -2.265492 -1.315116 -1.552175 -1.784705 -1.995934 -2.174653 -2.307509 -2.489186 -2.656218 -2.804545 -2.924170 -2.988376 -3.062849 -3.152659 -3.212010 -3.231672 -3.184400 -3.141302 -3.047256 -2.843828 -2.265492 -1.286176 -1.531832 -1.768211 -1.978903 -2.156500 -2.310626 -2.495952 -2.667047 -2.816644 -2.929745 -2.988930 -3.069844 -3.157312 -3.212672 -3.225777 -3.170955 -3.127411 -3.032415 -2.830086 -2.265492 -1.302726 -1.548136 -1.780137 -1.984804 -2.170074 -2.332818 -2.519527 -2.689240 -2.833034 -2.933702 -3.000164 -3.081852 -3.163741 -3.212527 -3.217590 -3.157544 -3.113375 -3.016881 -2.815780 -2.265492 -1.352903 -1.590127 -1.814908 -2.020687 -2.205026 -2.372875 -2.555618 -2.718869 -2.848698 -2.945300 -3.016484 -3.095486 -3.169937 -3.210873 -3.206422 -3.144098 -3.098257 -3.000559 -2.800857 -2.265492 -1.427156 -1.654854 -1.875087 -2.075497 -2.260263 -2.426683 -2.601660 -2.748312 -2.866820 -2.964323 -3.036061 -3.108825 -3.174539 -3.206936 -3.192155 -3.130296 -3.082251 -2.983349 -2.785275 -2.265492 -1.525125 -1.741309 -1.952648 -2.148875 -2.329487 -2.490812 -2.646635 -2.779421 -2.893376 -2.987614 -3.055869 -3.120823 -3.176835 -3.199543 -3.177725 -3.115743 -3.065169 -2.965160 -2.769113 -2.265492 -1.640584 -1.845335 -2.048195 -2.236991 -2.408070 -2.551705 -2.692596 -2.816981 -2.923692 -3.011952 -3.074718 -3.130365 -3.175871 -3.187842 -3.162750 -3.100354 -3.047072 -2.945878 -2.752573 -2.265492 -1.775643 -1.966543 -2.157429 -2.331757 -2.482836 -2.614579 -2.743021 -2.856239 -2.954264 -3.035328 -3.091289 -3.136834 -3.170974 -3.174006 -3.146717 -3.082846 -3.027328 -2.925338 -2.735528 -2.265492 -1.926815 -2.100010 -2.268036 -2.423879 -2.562497 -2.679818 -2.793813 -2.895177 -2.983588 -3.055861 -3.104036 -3.139319 -3.161461 -3.159032 -3.129060 -3.063444 -3.005710 -2.903429 -2.717782 -2.265492 -2.083804 -2.230463 -2.380047 -2.519531 -2.641163 -2.743693 -2.844063 -2.932872 -3.010132 -3.072215 -3.111701 -3.136263 -3.149763 -3.142420 -3.109437 -3.041990 -2.982166 -2.879996 -2.699245 -2.265492 -2.243334 -2.366146 -2.493421 -2.612644 -2.717700 -2.805943 -2.892403 -2.967489 -3.031985 -3.083268 -3.112727 -3.128837 -3.135705 -3.123673 -3.086937 -3.017672 -2.956384 -2.854783 -2.679805 -2.265492 -2.403620 -2.499817 -2.604438 -2.704498 -2.792815 -2.865142 -2.935769 -2.996746 -3.048153 -3.087802 -3.108295 -3.117468 -3.118372 -3.101455 -3.061640 -2.990163 -2.928005 -2.827540 -2.659336 -2.265492 -2.560690 -2.632453 -2.714770 -2.793950 -2.862661 -2.918028 -2.972417 -3.019029 -3.057465 -3.087131 -3.099251 -3.101259 -3.096553 -3.075561 -3.032651 -2.959331 -2.896775 -2.798241 -2.637661 -2.265492 -2.716598 -2.760897 -2.819463 -2.877094 -2.926130 -2.963869 -3.001308 -3.034204 -3.061253 -3.080914 -3.084833 -3.079555 -3.069852 -3.045084 -2.999625 -2.924833 -2.862174 -2.767043 -2.614554 -2.265492 -2.863262 -2.882576 -2.918314 -2.953999 -2.983411 -3.003788 -3.024376 -3.042903 -3.058588 -3.069063 -3.065153 -3.052643 -3.037854 -3.009860 -2.962285 -2.886297 -2.823396 -2.733433 -2.589695 -2.265492 -3.006155 -3.001374 -3.014071 -3.028289 -3.037814 -3.039775 -3.044012 -3.048437 -3.052604 -3.053499 -3.041579 -3.021451 -3.001506 -2.970352 -2.920590 -2.843963 -2.780125 -2.697000 -2.562653 -2.265492 -3.156354 -3.127549 -3.120579 -3.114755 -3.104378 -3.086999 -3.073500 -3.061918 -3.052534 -3.042389 -3.020866 -2.991503 -2.964562 -2.928297 -2.876880 -2.804696 -2.733315 -2.657157 -2.532748 -2.265492 -3.402270 -3.342935 -3.310608 -3.280453 -3.246371 -3.203426 -3.164495 -3.130330 -3.100449 -3.070876 -3.035486 -2.986576 -2.946404 -2.902835 -2.847297 -2.774871 -2.687447 -2.615154 -2.499944 -2.265492 -7.138974 -6.987168 -6.820020 -6.638353 -6.442922 -6.234509 -6.013827 -5.781503 -5.538165 -5.284374 -5.020617 -4.747381 -4.465102 -4.174160 -3.874935 -3.567766 -3.252954 -2.930796 -2.601561 -2.265492 -1.286474 -1.532018 -1.802830 -2.047139 -2.262504 -2.430333 -2.589641 -2.777930 -2.950317 -3.098944 -3.205011 -3.271444 -3.387436 -3.473825 -3.523799 -3.503388 -3.460087 -3.368864 -3.145835 -2.484990 -1.132352 -1.407320 -1.696060 -1.959686 -2.192225 -2.362722 -2.550826 -2.756875 -2.943283 -3.100437 -3.201852 -3.270186 -3.390646 -3.477598 -3.524207 -3.492420 -3.446588 -3.353863 -3.130985 -2.484990 -1.068916 -1.357663 -1.650280 -1.918609 -2.147864 -2.342622 -2.549411 -2.763637 -2.951764 -3.108981 -3.198499 -3.281897 -3.400812 -3.483442 -3.522876 -3.478583 -3.433480 -3.338152 -3.115494 -2.484990 -1.065429 -1.358171 -1.646515 -1.906926 -2.143369 -2.358749 -2.573796 -2.783096 -2.971262 -3.119195 -3.211575 -3.303087 -3.414573 -3.489575 -3.519137 -3.465831 -3.419633 -3.321617 -3.099309 -2.484990 -1.107341 -1.395304 -1.672966 -1.931978 -2.177106 -2.400848 -2.611402 -2.816183 -2.997604 -3.134718 -3.234583 -3.327653 -3.429018 -3.494511 -3.511951 -3.453875 -3.405161 -3.304124 -3.082366 -2.484990 -1.184176 -1.462066 -1.734210 -1.992198 -2.237502 -2.456776 -2.662552 -2.860361 -3.027881 -3.161813 -3.265352 -3.352494 -3.442843 -3.497040 -3.500281 -3.442014 -3.390059 -3.285514 -3.064592 -2.484990 -1.291154 -1.560873 -1.826550 -2.079387 -2.311626 -2.525195 -2.725651 -2.910214 -3.066316 -3.198011 -3.296844 -3.376554 -3.454566 -3.496011 -3.487160 -3.429819 -3.373282 -3.265664 -3.046077 -2.484990 -1.428182 -1.687238 -1.944014 -2.178304 -2.400335 -2.607787 -2.795726 -2.964380 -3.111904 -3.236767 -3.328371 -3.398901 -3.463495 -3.490130 -3.474304 -3.415716 -3.355024 -3.244437 -3.026882 -2.484990 -1.591143 -1.832609 -2.069236 -2.293436 -2.505455 -2.700036 -2.867995 -3.022779 -3.160293 -3.273352 -3.357307 -3.417803 -3.468313 -3.480287 -3.460502 -3.399659 -3.334570 -3.221636 -3.006911 -2.484990 -1.768196 -1.989497 -2.212392 -2.422944 -2.619769 -2.790444 -2.943194 -3.083027 -3.205224 -3.306881 -3.381722 -3.431706 -3.467168 -3.469764 -3.445254 -3.381336 -3.311874 -3.197097 -2.986299 -2.484990 -1.964050 -2.164169 -2.369156 -2.555299 -2.727527 -2.883626 -3.016912 -3.138561 -3.246594 -3.336477 -3.400127 -3.438390 -3.461420 -3.457217 -3.427092 -3.359763 -3.286526 -3.170625 -2.964975 -2.484990 -2.177372 -2.345773 -2.520466 -2.686271 -2.837814 -2.969896 -3.083895 -3.189768 -3.283608 -3.360501 -3.410891 -3.437684 -3.452144 -3.441151 -3.405756 -3.334522 -3.258214 -3.141970 -2.942592 -2.484990 -2.387560 -2.526989 -2.674121 -2.812988 -2.939110 -3.050041 -3.146098 -3.235350 -3.313540 -3.376334 -3.414078 -3.431500 -3.437825 -3.420223 -3.379973 -3.305419 -3.226586 -3.110781 -2.918995 -2.484990 -2.601038 -2.703967 -2.819685 -2.932256 -3.035964 -3.126039 -3.201617 -3.272148 -3.334293 -3.383772 -3.410818 -3.418794 -3.417066 -3.392971 -3.348796 -3.271832 -3.191243 -3.076966 -2.893963 -2.484990 -2.806432 -2.876110 -2.962125 -3.046999 -3.125012 -3.192344 -3.247356 -3.299437 -3.346080 -3.382706 -3.399685 -3.398286 -3.388638 -3.358578 -3.311412 -3.233282 -3.151596 -3.040457 -2.867209 -2.484990 -3.007567 -3.041402 -3.095543 -3.151392 -3.203730 -3.248520 -3.283282 -3.317210 -3.348049 -3.371657 -3.378787 -3.368980 -3.352238 -3.316674 -3.267100 -3.189002 -3.107085 -3.001310 -2.838347 -2.484990 -3.198882 -3.199420 -3.221912 -3.248257 -3.274800 -3.295638 -3.309405 -3.325225 -3.340434 -3.351473 -3.348791 -3.331014 -3.307839 -3.267161 -3.215365 -3.138094 -3.056537 -2.958290 -2.806789 -2.484990 -3.393662 -3.360319 -3.352061 -3.349014 -3.348553 -3.345078 -3.336600 -3.333075 -3.331530 -3.328694 -3.314834 -3.288154 -3.257829 -3.211432 -3.156181 -3.082337 -2.999016 -2.910037 -2.771714 -2.484990 -3.677382 -3.601948 -3.559272 -3.524376 -3.493711 -3.458095 -3.417729 -3.386013 -3.359111 -3.333591 -3.302093 -3.258119 -3.216050 -3.164992 -3.104194 -3.030156 -2.934945 -2.856272 -2.732443 -2.484990 -8.693932 -8.509901 -8.304007 -8.077645 -7.832155 -7.568785 -7.288660 -6.992831 -6.682236 -6.357724 -6.020060 -5.669927 -5.307961 -4.934732 -4.550761 -4.156519 -3.752438 -3.338916 -2.916320 -2.484990 -1.157083 -1.456595 -1.758824 -2.049242 -2.309969 -2.519052 -2.671353 -2.884123 -3.077899 -3.253354 -3.389157 -3.448267 -3.588857 -3.699076 -3.775067 -3.775395 -3.733485 -3.648399 -3.411116 -2.682764 -0.9417044 -1.265652 -1.603005 -1.923970 -2.209386 -2.421257 -2.606774 -2.841752 -3.057898 -3.250445 -3.385400 -3.443147 -3.591941 -3.705709 -3.780422 -3.767837 -3.721162 -3.633192 -3.394874 -2.682764 -0.8343766 -1.184504 -1.536042 -1.864006 -2.144438 -2.373453 -2.593119 -2.837651 -3.063614 -3.259158 -3.378387 -3.459942 -3.606524 -3.716614 -3.784837 -3.755522 -3.709012 -3.617219 -3.377859 -2.682764 -0.8145277 -1.172099 -1.522950 -1.837138 -2.119147 -2.374137 -2.609658 -2.858470 -3.087155 -3.271355 -3.390786 -3.491199 -3.626847 -3.729620 -3.787166 -3.744147 -3.696993 -3.600298 -3.360008 -2.682764 -0.8542634 -1.207641 -1.539383 -1.847789 -2.139859 -2.405554 -2.651536 -2.898572 -3.116096 -3.287586 -3.421082 -3.526100 -3.650492 -3.742009 -3.785944 -3.734876 -3.684939 -3.582216 -3.341242 -2.682764 -0.9352175 -1.271264 -1.593411 -1.899239 -2.190947 -2.464013 -2.711857 -2.948416 -3.151865 -3.324574 -3.462496 -3.564073 -3.674257 -3.752521 -3.779526 -3.726414 -3.671415 -3.562811 -3.321473 -2.682764 -1.046945 -1.371552 -1.683089 -1.982731 -2.272814 -2.542970 -2.782156 -3.004707 -3.202357 -3.376271 -3.506502 -3.603180 -3.697406 -3.759938 -3.769845 -3.717791 -3.656126 -3.541924 -3.300739 -2.682764 -1.194778 -1.505280 -1.805277 -2.096040 -2.377807 -2.633801 -2.859663 -3.074349 -3.268267 -3.427819 -3.553040 -3.639803 -3.718285 -3.762360 -3.761276 -3.707390 -3.638869 -3.519385 -3.279243 -2.682764 -1.374527 -1.668681 -1.955501 -2.233973 -2.492179 -2.734443 -2.953007 -3.159354 -3.333942 -3.481315 -3.595310 -3.672024 -3.734091 -3.759679 -3.752605 -3.695083 -3.619131 -3.494935 -3.256890 -2.682764 -1.581866 -1.857674 -2.124186 -2.376139 -2.620908 -2.852977 -3.060573 -3.240808 -3.400086 -3.531547 -3.632374 -3.697928 -3.742524 -3.755545 -3.741834 -3.679519 -3.596569 -3.468381 -3.233556 -2.682764 -1.811632 -2.057697 -2.302303 -2.538675 -2.768718 -2.979295 -3.157179 -3.321541 -3.460699 -3.575984 -3.663322 -3.715793 -3.744044 -3.748446 -3.727917 -3.659958 -3.570900 -3.439488 -3.209070 -2.682764 -2.054925 -2.276150 -2.500349 -2.715297 -2.913036 -3.095585 -3.252727 -3.392455 -3.513026 -3.613721 -3.686399 -3.724957 -3.741529 -3.736456 -3.709134 -3.636043 -3.541769 -3.407943 -3.183857 -2.682764 -2.321509 -2.509175 -2.696740 -2.878755 -3.052019 -3.205022 -3.335457 -3.454225 -3.557770 -3.642111 -3.700125 -3.727912 -3.733410 -3.718502 -3.684246 -3.607030 -3.508647 -3.373257 -3.157222 -2.682764 -2.586072 -2.734985 -2.888503 -3.036361 -3.175411 -3.301879 -3.410084 -3.507872 -3.592079 -3.659591 -3.705094 -3.722205 -3.717481 -3.692603 -3.652324 -3.572130 -3.470907 -3.335319 -3.128908 -2.682764 -2.850319 -2.953405 -3.067834 -3.181903 -3.291620 -3.390622 -3.473883 -3.549624 -3.614769 -3.666038 -3.698581 -3.705284 -3.691301 -3.657743 -3.612363 -3.530403 -3.427711 -3.294187 -3.098593 -2.682764 -3.106392 -3.166386 -3.241199 -3.318536 -3.395707 -3.465781 -3.524193 -3.577907 -3.623608 -3.659032 -3.678560 -3.675047 -3.653123 -3.612856 -3.563334 -3.480700 -3.378229 -3.249217 -3.065801 -2.682764 -3.351913 -3.368242 -3.402415 -3.442738 -3.487121 -3.527694 -3.560020 -3.590809 -3.617166 -3.636857 -3.644128 -3.630961 -3.601827 -3.556942 -3.504084 -3.421851 -3.321836 -3.200060 -3.029828 -2.682764 -3.596061 -3.568377 -3.561251 -3.563100 -3.572968 -3.582411 -3.586918 -3.594208 -3.600943 -3.604184 -3.598731 -3.575099 -3.538207 -3.489351 -3.433931 -3.353564 -3.256712 -3.144715 -2.989629 -2.682764 -3.916907 -3.840828 -3.789397 -3.749492 -3.719333 -3.689381 -3.656224 -3.630455 -3.609467 -3.588856 -3.562675 -3.523357 -3.475312 -3.418623 -3.354694 -3.280317 -3.180935 -3.081880 -2.943858 -2.682764 -10.31178 -10.09491 -9.848612 -9.575062 -9.276330 -8.954305 -8.610675 -8.246941 -7.864437 -7.464350 -7.047738 -6.615541 -6.168605 -5.707687 -5.233471 -4.746574 -4.247563 -3.736949 -3.215204 -2.682764 -1.024934 -1.396761 -1.722677 -2.050676 -2.347003 -2.597514 -2.751961 -2.987219 -3.198571 -3.392384 -3.551835 -3.603560 -3.764726 -3.896535 -3.996021 -4.018272 -3.979826 -3.904532 -3.657126 -2.862728 -0.7422237 -1.138194 -1.510815 -1.875191 -2.209964 -2.480312 -2.665163 -2.925343 -3.163376 -3.380381 -3.548139 -3.592759 -3.766371 -3.905517 -4.006626 -4.015080 -3.968445 -3.889763 -3.639784 -2.862728 -0.5980461 -1.020834 -1.412793 -1.792129 -2.138381 -2.411362 -2.642632 -2.912406 -3.160879 -3.388238 -3.543478 -3.612556 -3.785124 -3.921743 -4.017403 -4.005863 -3.958641 -3.874243 -3.621523 -2.862728 -0.5600177 -0.9848785 -1.384454 -1.767036 -2.104818 -2.395930 -2.654820 -2.926760 -3.181121 -3.405903 -3.550941 -3.651289 -3.812807 -3.942076 -4.026824 -3.996178 -3.949874 -3.857698 -3.602270 -2.862728 -0.5893879 -1.008662 -1.407139 -1.776446 -2.111610 -2.418330 -2.691073 -2.964284 -3.217943 -3.426912 -3.584250 -3.698043 -3.845051 -3.963360 -4.032786 -3.990505 -3.940361 -3.839869 -3.581930 -2.862728 -0.6732416 -1.081602 -1.465708 -1.818128 -2.155582 -2.467628 -2.746835 -3.021299 -3.266192 -3.465481 -3.633642 -3.751251 -3.880230 -3.983899 -4.033359 -3.987004 -3.930015 -3.820505 -3.560402 -2.862728 -0.7998949 -1.189283 -1.550423 -1.897160 -2.229846 -2.540627 -2.824641 -3.091928 -3.318149 -3.522578 -3.692859 -3.804211 -3.916211 -4.001498 -4.029210 -3.983188 -3.917728 -3.799454 -3.537666 -2.862728 -0.9589850 -1.325173 -1.672959 -2.006183 -2.331728 -2.640836 -2.919494 -3.166336 -3.390433 -3.591561 -3.752559 -3.855661 -3.948681 -4.014362 -4.026788 -3.978717 -3.903271 -3.776482 -3.514061 -2.862728 -1.151160 -1.496675 -1.825691 -2.147053 -2.462143 -2.761672 -3.017981 -3.259315 -3.477172 -3.664494 -3.810078 -3.901366 -3.975235 -4.020492 -4.024787 -3.971558 -3.886131 -3.751245 -3.489507 -2.862728 -1.377057 -1.699233 -2.010624 -2.316147 -2.611987 -2.884448 -3.135460 -3.367398 -3.567714 -3.732540 -3.863914 -3.940249 -3.994597 -4.024302 -4.020603 -3.960536 -3.865679 -3.723568 -3.463870 -2.862728 -1.633510 -1.930994 -2.222553 -2.498042 -2.769825 -3.030875 -3.268686 -3.474590 -3.649274 -3.796386 -3.908807 -3.971717 -4.007161 -4.025397 -4.012556 -3.944917 -3.841454 -3.693120 -3.436982 -2.862728 -1.915827 -2.179693 -2.439800 -2.696324 -2.950057 -3.189685 -3.391932 -3.572221 -3.723499 -3.848099 -3.944479 -3.994096 -4.015399 -4.021427 -3.998750 -3.923640 -3.812923 -3.659538 -3.408579 -2.862728 -2.211375 -2.446394 -2.681195 -2.911053 -3.126053 -3.328420 -3.506104 -3.656579 -3.783664 -3.889777 -3.970115 -4.007771 -4.016721 -4.009968 -3.977694 -3.895772 -3.779332 -3.622139 -3.379028 -2.862728 -2.534909 -2.726225 -2.918018 -3.107642 -3.289345 -3.455271 -3.600123 -3.726053 -3.832752 -3.920463 -3.985036 -4.009961 -4.007497 -3.988769 -3.948037 -3.860554 -3.739786 -3.580776 -3.347606 -2.862728 -2.852192 -2.997078 -3.145928 -3.291213 -3.432663 -3.565199 -3.682591 -3.783641 -3.868304 -3.937367 -3.986219 -3.998472 -3.984617 -3.955918 -3.908241 -3.816742 -3.693296 -3.535556 -3.313875 -2.862728 -3.165697 -3.256436 -3.358270 -3.462459 -3.565377 -3.662400 -3.749382 -3.824308 -3.886593 -3.936800 -3.970289 -3.970769 -3.946109 -3.909511 -3.856706 -3.763078 -3.638803 -3.485410 -3.277271 -2.862728 -3.470109 -3.506370 -3.557973 -3.616935 -3.679690 -3.741590 -3.797065 -3.844550 -3.884209 -3.915557 -3.934008 -3.924085 -3.890261 -3.847521 -3.791481 -3.697905 -3.575823 -3.430644 -3.236948 -2.862728 -3.764766 -3.748798 -3.748072 -3.758878 -3.779660 -3.804964 -3.827815 -3.846462 -3.862514 -3.875304 -3.878636 -3.858212 -3.816150 -3.768243 -3.710918 -3.619403 -3.502875 -3.368873 -3.191424 -2.862728 -4.127707 -4.054339 -3.995514 -3.953510 -3.925435 -3.905467 -3.886805 -3.868289 -3.852645 -3.840268 -3.822557 -3.783722 -3.731375 -3.674117 -3.613704 -3.530481 -3.416835 -3.298306 -3.138190 -2.862728 -11.98777 -11.73747 -11.44937 -11.12599 -10.77104 -10.38696 -9.976071 -9.540428 -9.081814 -8.601795 -8.101747 -7.582881 -7.046273 -6.492877 -5.923554 -5.339074 -4.740142 -4.127393 -3.501409 -2.862728 -0.9009501 -1.341088 -1.700485 -2.063507 -2.387807 -2.668736 -2.833556 -3.085431 -3.314576 -3.522998 -3.700408 -3.751943 -3.923021 -4.071756 -4.192059 -4.236228 -4.200810 -4.139637 -3.886728 -3.027827 -0.5473614 -1.015065 -1.431197 -1.834748 -2.205939 -2.520656 -2.720749 -3.007706 -3.264066 -3.502622 -3.694192 -3.732581 -3.922618 -4.082524 -4.207782 -4.238084 -4.191056 -4.125838 -3.868601 -3.027827 -0.3624111 -0.8577496 -1.298371 -1.720957 -2.110457 -2.433022 -2.698737 -2.988353 -3.256827 -3.507060 -3.690493 -3.755995 -3.944158 -4.104201 -4.225227 -4.233229 -4.184011 -4.111352 -3.849406 -3.027827 -0.3034023 -0.8014125 -1.250962 -1.678585 -2.070485 -2.420370 -2.710968 -2.999641 -3.275869 -3.524882 -3.696362 -3.800366 -3.978872 -4.131764 -4.242035 -4.225573 -4.178677 -4.095793 -3.829050 -3.027827 -0.3254067 -0.8157672 -1.262862 -1.686581 -2.086910 -2.441505 -2.740537 -3.036841 -3.310887 -3.551253 -3.735391 -3.855398 -4.021994 -4.162148 -4.256011 -4.224183 -4.173287 -4.078920 -3.807420 -3.027827 -0.4101143 -0.8826023 -1.320805 -1.741907 -2.132897 -2.478803 -2.794007 -3.088327 -3.361244 -3.597894 -3.789291 -3.918907 -4.069241 -4.193601 -4.265079 -4.226231 -4.166791 -4.060369 -3.784399 -3.027827 -0.5418037 -0.9951826 -1.421488 -1.823074 -2.196164 -2.548792 -2.864327 -3.159396 -3.425262 -3.660099 -3.854195 -3.985537 -4.116210 -4.222529 -4.268089 -4.229057 -4.158814 -4.039904 -3.759917 -3.027827 -0.7173519 -1.148660 -1.547941 -1.927362 -2.296029 -2.640450 -2.958372 -3.247770 -3.506616 -3.734377 -3.926957 -4.049243 -4.161494 -4.246668 -4.272842 -4.231059 -4.148550 -4.017204 -3.734420 -3.027827 -0.9288093 -1.326826 -1.702203 -2.068006 -2.421596 -2.762187 -3.073471 -3.351693 -3.597881 -3.820918 -4.002845 -4.109632 -4.201556 -4.263357 -4.278281 -4.230126 -4.134889 -3.991893 -3.707892 -3.027827 -1.168593 -1.539353 -1.891445 -2.238648 -2.581836 -2.909359 -3.202083 -3.464732 -3.703963 -3.913305 -4.071324 -4.165774 -4.234812 -4.277399 -4.281814 -4.224869 -4.117159 -3.963686 -3.680168 -3.027827 -1.444814 -1.785002 -2.115494 -2.443589 -2.766288 -3.064904 -3.343745 -3.595246 -3.815540 -3.993307 -4.134857 -4.211408 -4.259979 -4.288696 -4.281104 -4.214173 -4.094972 -3.932167 -3.651062 -3.027827 -1.752945 -2.063719 -2.370538 -2.664430 -2.956045 -3.240653 -3.503223 -3.724220 -3.911174 -4.066955 -4.185012 -4.245688 -4.279631 -4.293943 -4.273947 -4.196929 -4.067649 -3.896822 -3.620323 -3.027827 -2.088281 -2.361920 -2.632018 -2.902149 -3.171600 -3.425279 -3.646468 -3.837468 -3.994694 -4.124197 -4.223640 -4.270949 -4.290368 -4.290307 -4.258123 -4.172193 -4.034232 -3.857016 -3.587597 -3.027827 -2.444777 -2.682013 -2.920737 -3.149829 -3.373282 -3.586947 -3.772750 -3.928026 -4.058890 -4.168045 -4.250573 -4.284410 -4.288788 -4.275200 -4.231812 -4.138595 -3.993793 -3.812455 -3.553299 -3.027827 -2.822220 -3.004701 -3.193043 -3.377218 -3.555449 -3.723751 -3.874181 -4.001478 -4.109149 -4.196970 -4.260902 -4.281812 -4.271616 -4.246044 -4.193349 -4.094534 -3.944973 -3.763434 -3.516379 -3.027827 -3.195132 -3.317781 -3.448553 -3.581211 -3.714107 -3.843526 -3.960019 -4.057070 -4.138915 -4.205383 -4.250836 -4.258858 -4.235883 -4.199923 -4.140626 -4.038169 -3.886707 -3.708922 -3.476183 -3.027827 -3.559050 -3.617174 -3.690120 -3.769487 -3.854326 -3.941548 -4.021767 -4.087443 -4.142593 -4.188152 -4.215890 -4.211311 -4.178429 -4.133761 -4.071051 -3.967404 -3.818453 -3.647310 -3.431722 -3.027827 -3.907773 -3.902404 -3.914585 -3.938463 -3.974117 -4.016261 -4.057791 -4.090694 -4.118334 -4.142262 -4.153726 -4.137240 -4.096251 -4.044703 -3.981793 -3.880275 -3.738093 -3.577338 -3.381299 -3.027827 -4.313540 -4.242121 -4.185429 -4.144608 -4.122200 -4.112543 -4.106778 -4.098696 -4.091848 -4.087627 -4.077903 -4.044470 -3.991117 -3.932179 -3.870188 -3.775126 -3.644685 -3.496305 -3.321613 -3.027827 -13.71782 -13.43348 -13.10153 -12.72651 -12.31254 -11.86322 -11.38161 -10.87039 -10.33185 -9.767945 -9.180404 -8.570717 -7.940204 -7.290032 -6.621244 -5.934771 -5.231458 -4.512074 -3.777317 -3.027827 -0.7797417 -1.290898 -1.684702 -2.085177 -2.440284 -2.742867 -2.937640 -3.175094 -3.421417 -3.646691 -3.837665 -3.907028 -4.066805 -4.230352 -4.367942 -4.432405 -4.400618 -4.356898 -4.102078 -3.180330 -0.3577956 -0.9026354 -1.364661 -1.813700 -2.213432 -2.560534 -2.783625 -3.077949 -3.359840 -3.616864 -3.829220 -3.873617 -4.064604 -4.241908 -4.388586 -4.439911 -4.392815 -4.344672 -4.083503 -3.180330 -0.1385867 -0.7036978 -1.204399 -1.667144 -2.089419 -2.448307 -2.746764 -3.059620 -3.351544 -3.619692 -3.825702 -3.896041 -4.090160 -4.267907 -4.412243 -4.439594 -4.389547 -4.331965 -4.063697 -3.180330 -5.5231065E-02 -0.6229225 -1.129565 -1.600294 -2.032229 -2.421904 -2.760836 -3.076807 -3.368329 -3.640256 -3.827324 -3.946986 -4.132139 -4.303108 -4.436582 -4.434376 -4.388149 -4.318230 -4.042554 -3.180330 -6.6690736E-02 -0.6240957 -1.125539 -1.596030 -2.038202 -2.446522 -2.798274 -3.109215 -3.406128 -3.667726 -3.869673 -4.010603 -4.183650 -4.343680 -4.459446 -4.437963 -4.387275 -4.303225 -4.019944 -3.180330 -0.1494961 -0.6865389 -1.178715 -1.645684 -2.091919 -2.497481 -2.844970 -3.160622 -3.456197 -3.714427 -3.932252 -4.079971 -4.241096 -4.384869 -4.477710 -4.446275 -4.385835 -4.286497 -3.995721 -3.180330 -0.2870383 -0.8005762 -1.277638 -1.737861 -2.171556 -2.560817 -2.911618 -3.230428 -3.520633 -3.785650 -4.002548 -4.153049 -4.301770 -4.425210 -4.488428 -4.456442 -4.382842 -4.267627 -3.969774 -3.180330 -0.4712055 -0.9584118 -1.418226 -1.858327 -2.265021 -2.649584 -3.001082 -3.315948 -3.609261 -3.870880 -4.081286 -4.229531 -4.359213 -4.461274 -4.500656 -4.465361 -4.377050 -4.246219 -3.942652 -3.180330 -0.6980019 -1.156293 -1.585606 -1.993310 -2.391760 -2.766009 -3.111995 -3.427775 -3.714258 -3.960609 -4.167877 -4.305960 -4.413951 -4.489710 -4.514886 -4.471274 -4.367723 -4.221883 -3.914424 -3.180330 -0.9622738 -1.379497 -1.777395 -2.168669 -2.546969 -2.913094 -3.253085 -3.556306 -3.822706 -4.062805 -4.257226 -4.375196 -4.461230 -4.514500 -4.527769 -4.472934 -4.353747 -4.194207 -3.884900 -3.180330 -1.254399 -1.636080 -2.008508 -2.375679 -2.739593 -3.091982 -3.408573 -3.690937 -3.948448 -4.171083 -4.335131 -4.436407 -4.498987 -4.536536 -4.535983 -4.468773 -4.334908 -4.162649 -3.853863 -3.180330 -1.584573 -1.931617 -2.278044 -2.620918 -2.958559 -3.277970 -3.577336 -3.845565 -4.076624 -4.262407 -4.405917 -4.484317 -4.530266 -4.552102 -4.536164 -4.457380 -4.310012 -4.126658 -3.821038 -3.180330 -1.949857 -2.263917 -2.575878 -2.880302 -3.187212 -3.487209 -3.764884 -3.990506 -4.185264 -4.341949 -4.459370 -4.522344 -4.551501 -4.557763 -4.526414 -4.436763 -4.278073 -4.085597 -3.786089 -3.180330 -2.343398 -2.612678 -2.887428 -3.162823 -3.439461 -3.692043 -3.920884 -4.113298 -4.271795 -4.400866 -4.498937 -4.547582 -4.558976 -4.550259 -4.505104 -4.405549 -4.237803 -4.038997 -3.748727 -3.180330 -2.767169 -2.990418 -3.213361 -3.435790 -3.659580 -3.867250 -4.051286 -4.204725 -4.336114 -4.443280 -4.521783 -4.554636 -4.549789 -4.526301 -4.469840 -4.361991 -4.187706 -3.987268 -3.708912 -3.180330 -3.196005 -3.352880 -3.518973 -3.682731 -3.848305 -4.009017 -4.154851 -4.276477 -4.378757 -4.462242 -4.520932 -4.538217 -4.519567 -4.482146 -4.417463 -4.304506 -4.126327 -3.929220 -3.665416 -3.180330 -3.619834 -3.702133 -3.802006 -3.905975 -4.016582 -4.128850 -4.232193 -4.318719 -4.391231 -4.450468 -4.489162 -4.492443 -4.462833 -4.414205 -4.344649 -4.229993 -4.052878 -3.862622 -3.617101 -3.180330 -4.029064 -4.034945 -4.062845 -4.102940 -4.156423 -4.218084 -4.276252 -4.325371 -4.367213 -4.402173 -4.421513 -4.412405 -4.374304 -4.318452 -4.247595 -4.135591 -3.963853 -3.785282 -3.562033 -3.180330 -4.478491 -4.407792 -4.355849 -4.321985 -4.308413 -4.310236 -4.315947 -4.319933 -4.324666 -4.330465 -4.327111 -4.301520 -4.252668 -4.190865 -4.120364 -4.018235 -3.859696 -3.692739 -3.496239 -3.180330 -15.49837 -15.17942 -14.80232 -14.37323 -13.89756 -13.38002 -12.82450 -12.23433 -11.61235 -10.96096 -10.28222 -9.577939 -8.849681 -8.098831 -7.326626 -6.534167 -5.722448 -4.892368 -4.044744 -3.180330 -0.6571018 -1.232960 -1.670109 -2.107076 -2.489928 -2.821366 -3.042359 -3.263433 -3.521612 -3.760302 -3.966487 -4.053841 -4.199713 -4.375703 -4.527488 -4.610056 -4.583131 -4.557564 -4.304725 -3.322024 -0.1676288 -0.7931506 -1.301423 -1.791915 -2.232248 -2.610643 -2.849324 -3.143579 -3.444306 -3.724052 -3.954605 -4.009120 -4.194276 -4.387903 -4.552215 -4.622867 -4.577847 -4.547382 -4.286036 -3.322024 8.3458140E-02 -0.5587074 -1.115682 -1.628923 -2.091125 -2.472650 -2.791728 -3.117004 -3.436533 -3.727637 -3.952624 -4.029636 -4.224721 -4.418347 -4.582417 -4.627687 -4.578677 -4.537005 -4.265958 -3.322024 0.1919937 -0.4543053 -1.023422 -1.546803 -2.007152 -2.425645 -2.794629 -3.138883 -3.461312 -3.748567 -3.954424 -4.084977 -4.275956 -4.460608 -4.614896 -4.624853 -4.582548 -4.525823 -4.244363 -3.322024 0.1873707 -0.4397059 -1.003587 -1.516873 -1.995315 -2.438964 -2.833582 -3.183593 -3.499609 -3.781858 -3.995278 -4.155412 -4.335522 -4.509389 -4.646475 -4.632767 -4.587648 -4.513411 -4.221097 -3.322024 0.1069468 -0.4956344 -1.041782 -1.554347 -2.040673 -2.493521 -2.895360 -3.237358 -3.552115 -3.828268 -4.060251 -4.234834 -4.400930 -4.561696 -4.673499 -4.647245 -4.592604 -4.499227 -4.195982 -3.322024 -3.5410058E-02 -0.6083284 -1.138531 -1.642956 -2.126517 -2.574714 -2.963296 -3.303138 -3.618910 -3.900620 -4.140507 -4.313354 -4.471078 -4.613145 -4.692851 -4.664492 -4.595737 -4.482789 -4.168864 -3.322024 -0.2283885 -0.7713541 -1.279351 -1.770307 -2.239870 -2.664817 -3.044720 -3.390903 -3.704190 -3.992090 -4.227740 -4.396477 -4.543355 -4.661289 -4.714102 -4.682207 -4.595720 -4.463608 -4.140390 -3.322024 -0.4676229 -0.9766945 -1.459306 -1.926466 -2.365519 -2.776542 -3.155933 -3.496557 -3.814275 -4.095523 -4.317828 -4.484058 -4.610915 -4.702554 -4.738305 -4.696842 -4.591923 -4.441217 -4.110746 -3.322024 -0.7487677 -1.220047 -1.669411 -2.100912 -2.521841 -2.920459 -3.291335 -3.632094 -3.939347 -4.200348 -4.417263 -4.569541 -4.673094 -4.738829 -4.760711 -4.706440 -4.583008 -4.415054 -4.079715 -3.322024 -1.065289 -1.489094 -1.905891 -2.314184 -2.711860 -3.099423 -3.460953 -3.783288 -4.067348 -4.319744 -4.519608 -4.644386 -4.725173 -4.772356 -4.777757 -4.708972 -4.568360 -4.384475 -4.047029 -3.322024 -1.411812 -1.798536 -2.183789 -2.564372 -2.944027 -3.313956 -3.643015 -3.943930 -4.215180 -4.440776 -4.607296 -4.709408 -4.768026 -4.799129 -4.786716 -4.703301 -4.546923 -4.348907 -4.012384 -3.322024 -1.802477 -2.150831 -2.503238 -2.856414 -3.198185 -3.531240 -3.844617 -4.124867 -4.354494 -4.543046 -4.681529 -4.761044 -4.800809 -4.814719 -4.785307 -4.687832 -4.517396 -4.307624 -3.975409 -3.322024 -2.231651 -2.536991 -2.845798 -3.155006 -3.470315 -3.778516 -4.047923 -4.276848 -4.469453 -4.622296 -4.735570 -4.797938 -4.820090 -4.815711 -4.770536 -4.661313 -4.478429 -4.260022 -3.935573 -3.322024 -2.689210 -2.944513 -3.213533 -3.479153 -3.740316 -3.992121 -4.213928 -4.397346 -4.551485 -4.677918 -4.770249 -4.814438 -4.820831 -4.798909 -4.739515 -4.620728 -4.428368 -4.206542 -3.892854 -3.322024 -3.174568 -3.363469 -3.568343 -3.769383 -3.971738 -4.164701 -4.337240 -4.484928 -4.609043 -4.709168 -4.778451 -4.804971 -4.796248 -4.760531 -4.688940 -4.562879 -4.365520 -4.145867 -3.846257 -3.322024 -3.659679 -3.765314 -3.892121 -4.026912 -4.166814 -4.306257 -4.432395 -4.540745 -4.632175 -4.705547 -4.752092 -4.762600 -4.739794 -4.695317 -4.615358 -4.484345 -4.288707 -4.075648 -3.794282 -3.322024 -4.131197 -4.149851 -4.194830 -4.254227 -4.328978 -4.410654 -4.487718 -4.553353 -4.610962 -4.657671 -4.682578 -4.679012 -4.645046 -4.596688 -4.513481 -4.382463 -4.193789 -3.992299 -3.734736 -3.322024 -4.625702 -4.557905 -4.511984 -4.487870 -4.488505 -4.502484 -4.521214 -4.537015 -4.555059 -4.570610 -4.572091 -4.552566 -4.508105 -4.457079 -4.374816 -4.253499 -4.078674 -3.889945 -3.662993 -3.322024 -17.32631 -16.97215 -16.54842 -16.06312 -15.52328 -14.93471 -14.30230 -13.63007 -12.92142 -12.17921 -11.40587 -10.60353 -9.773998 -8.918903 -8.039673 -7.137585 -6.213786 -5.269313 -4.305104 -3.322024 -0.5357789 -1.170164 -1.643485 -2.124781 -2.539472 -2.893335 -3.145401 -3.352930 -3.619371 -3.867341 -4.086090 -4.192683 -4.324143 -4.509495 -4.672915 -4.773383 -4.750327 -4.742948 -4.495997 -3.454340 2.4180498E-02 -0.6650406 -1.231153 -1.772601 -2.246194 -2.659703 -2.925025 -3.212085 -3.524718 -3.820976 -4.072538 -4.138337 -4.315418 -4.521667 -4.701118 -4.792218 -4.747531 -4.735113 -4.477560 -3.454340 0.3098508 -0.4086069 -1.030160 -1.588656 -2.091483 -2.516289 -2.845373 -3.177134 -3.511357 -3.826126 -4.073775 -4.157738 -4.351311 -4.557439 -4.736918 -4.802607 -4.752749 -4.727523 -4.457583 -3.454340 0.4342676 -0.2892670 -0.9198301 -1.492618 -2.005585 -2.443935 -2.831368 -3.193013 -3.540779 -3.855541 -4.075531 -4.216516 -4.409869 -4.606089 -4.777073 -4.803051 -4.762750 -4.719435 -4.435897 -3.454340 0.4430170 -0.2616072 -0.8858101 -1.459362 -1.969372 -2.437217 -2.859417 -3.241246 -3.591630 -3.891195 -4.118730 -4.292068 -4.479417 -4.662231 -4.817505 -4.815230 -4.774902 -4.710163 -4.412315 -3.454340 0.3605974 -0.3094052 -0.9189167 -1.475521 -1.996079 -2.482587 -2.921447 -3.311667 -3.650057 -3.940759 -4.185340 -4.376559 -4.554166 -4.723368 -4.853629 -4.836511 -4.786640 -4.699127 -4.386645 -3.454340 0.2133176 -0.4214197 -1.004505 -1.554118 -2.076306 -2.565116 -3.008909 -3.384228 -3.715293 -4.015292 -4.268704 -4.465625 -4.632336 -4.787038 -4.883050 -4.862179 -4.796644 -4.685763 -4.358671 -3.454340 1.1273966E-02 -0.5852447 -1.145807 -1.679724 -2.195480 -2.676346 -3.097416 -3.464061 -3.805230 -4.105788 -4.362786 -4.554980 -4.713463 -4.847116 -4.914437 -4.888582 -4.803429 -4.669501 -4.329099 -3.454340 -0.2396003 -0.7990481 -1.328542 -1.845586 -2.341576 -2.793083 -3.199209 -3.574314 -3.909796 -4.214926 -4.463056 -4.648489 -4.796013 -4.900484 -4.948709 -4.911665 -4.805895 -4.649668 -4.298317 -3.454340 -0.5351455 -1.052987 -1.552474 -2.043220 -2.499131 -2.933486 -3.335689 -3.703245 -4.040511 -4.335163 -4.567734 -4.745541 -4.871365 -4.950580 -4.980960 -4.929063 -4.803323 -4.625724 -4.266025 -3.454340 -0.8687937 -1.344539 -1.806053 -2.255522 -2.693655 -3.109115 -3.502254 -3.864663 -4.185090 -4.459486 -4.683162 -4.838482 -4.938890 -4.996197 -5.008118 -4.939517 -4.794027 -4.596849 -4.231924 -3.454340 -1.239320 -1.668489 -2.091706 -2.511122 -2.924129 -3.327501 -3.706407 -4.038182 -4.337837 -4.598785 -4.793817 -4.920055 -4.996047 -5.033422 -5.026745 -4.941334 -4.776732 -4.562412 -4.195683 -3.454340 -1.651461 -2.036857 -2.422982 -2.812100 -3.202219 -3.572512 -3.915686 -4.230569 -4.508424 -4.726561 -4.887684 -4.986267 -5.041824 -5.059772 -5.033828 -4.932362 -4.750423 -4.521511 -4.156896 -3.454340 -2.108629 -2.448627 -2.800064 -3.143749 -3.492498 -3.835153 -4.154306 -4.424997 -4.649962 -4.830307 -4.958145 -5.033749 -5.072694 -5.071462 -5.026662 -4.909855 -4.713714 -4.473372 -4.115054 -3.454340 -2.604336 -2.888595 -3.189175 -3.497895 -3.811954 -4.099423 -4.359100 -4.578454 -4.759045 -4.901671 -5.005824 -5.061475 -5.081322 -5.063920 -5.001786 -4.871252 -4.665155 -4.418386 -4.069510 -3.454340 -3.141257 -3.358605 -3.594718 -3.838667 -4.082829 -4.311478 -4.512629 -4.684970 -4.831499 -4.946891 -5.025803 -5.061929 -5.062250 -5.031321 -4.955069 -4.814133 -4.602282 -4.355115 -4.019972 -3.454340 -3.682544 -3.813590 -3.968156 -4.134227 -4.306654 -4.474690 -4.626842 -4.756405 -4.867242 -4.953393 -5.007452 -5.025392 -5.009510 -4.966755 -4.881385 -4.735120 -4.523327 -4.281031 -3.964497 -3.454340 -4.216225 -4.247891 -4.312779 -4.395165 -4.493071 -4.597438 -4.693698 -4.777749 -4.851457 -4.907994 -4.938697 -4.940791 -4.912931 -4.862891 -4.774086 -4.629469 -4.423320 -4.191891 -3.900650 -3.454340 -4.756969 -4.691449 -4.657124 -4.646072 -4.659784 -4.690111 -4.720695 -4.751514 -4.782876 -4.808379 -4.814808 -4.801188 -4.764407 -4.710559 -4.622898 -4.489468 -4.295488 -4.081228 -3.823226 -3.454340 -19.19886 -18.80894 -18.33708 -17.79359 -17.18716 -16.52499 -15.81289 -15.05569 -14.25737 -13.42125 -12.55017 -11.64655 -10.71250 -9.749874 -8.760301 -7.745234 -6.705981 -5.643719 -4.559515 -3.454340 -0.4230214 -1.119348 -1.640574 -2.131180 -2.579383 -2.962554 -3.240642 -3.440416 -3.715803 -3.970418 -4.198070 -4.324165 -4.441027 -4.634751 -4.807374 -4.923632 -4.903733 -4.914954 -4.676718 -3.578443 0.2140664 -0.5388953 -1.150442 -1.733627 -2.260801 -2.702148 -2.996133 -3.286689 -3.605211 -3.912179 -4.180501 -4.263860 -4.430258 -4.646603 -4.838844 -4.949136 -4.903113 -4.909780 -4.658867 -3.578443 0.5374810 -0.2446023 -0.9261541 -1.551851 -2.090212 -2.549939 -2.912597 -3.244632 -3.586101 -3.913785 -4.186711 -4.281581 -4.472492 -4.686798 -4.879614 -4.965429 -4.913467 -4.905355 -4.639288 -3.578443 0.6797092 -0.1137824 -0.8186435 -1.439564 -1.995230 -2.477894 -2.881592 -3.251333 -3.612435 -3.948963 -4.194177 -4.345487 -4.537982 -4.743362 -4.925871 -4.969760 -4.929887 -4.900812 -4.617814 -3.578443 0.6933521 -8.4898710E-02 -0.7708242 -1.396663 -1.959072 -2.453375 -2.890367 -3.293462 -3.668268 -3.997366 -4.237459 -4.426293 -4.616307 -4.807514 -4.974049 -4.986621 -4.948816 -4.895309 -4.594230 -3.578443 0.6126837 -0.1264728 -0.7953536 -1.412080 -1.968897 -2.476536 -2.942423 -3.364100 -3.742014 -4.050760 -4.309064 -4.513799 -4.701698 -4.877425 -5.021037 -5.015877 -4.967735 -4.888089 -4.568315 -3.578443 0.4596151 -0.2365326 -0.8802091 -1.476419 -2.031528 -2.551983 -3.028568 -3.456771 -3.815519 -4.126022 -4.394021 -4.608734 -4.789127 -4.949910 -5.060474 -5.050474 -4.984848 -4.878469 -4.539824 -3.578443 0.2483384 -0.4037909 -1.015707 -1.594941 -2.148046 -2.665239 -3.141379 -3.546323 -3.900550 -4.220000 -4.490535 -4.709089 -4.878334 -5.021925 -5.101788 -5.085377 -4.998951 -4.865789 -4.509512 -3.578443 -1.4860532E-02 -0.6216817 -1.201444 -1.763934 -2.300849 -2.805686 -3.250732 -3.647770 -4.010273 -4.329246 -4.599534 -4.806928 -4.970283 -5.089202 -5.147659 -5.116331 -5.008568 -4.849247 -4.477900 -3.578443 -0.3250220 -0.8863943 -1.431651 -1.971153 -2.481243 -2.949637 -3.381282 -3.779841 -4.137970 -4.457855 -4.713762 -4.910465 -5.062314 -5.151740 -5.190483 -5.142065 -5.012349 -4.828076 -4.444715 -3.578443 -0.6755095 -1.193970 -1.704259 -2.204758 -2.674170 -3.127469 -3.546079 -3.938305 -4.292550 -4.593999 -4.833898 -5.019352 -5.143004 -5.209999 -5.226749 -5.160713 -5.008802 -4.801398 -4.409609 -3.578443 -1.068737 -1.541461 -2.003063 -2.462834 -2.909673 -3.341342 -3.752330 -4.130937 -4.456045 -4.738922 -4.963236 -5.115984 -5.217360 -5.259313 -5.254637 -5.169523 -4.996980 -4.768500 -4.372131 -3.578443 -1.501487 -1.921133 -2.344768 -2.768355 -3.193204 -3.605321 -3.985627 -4.329377 -4.637655 -4.896307 -5.076550 -5.199551 -5.275956 -5.297099 -5.270997 -5.166388 -4.975649 -4.728244 -4.331845 -3.578443 -1.984209 -2.353026 -2.736252 -3.127550 -3.512756 -3.884421 -4.236248 -4.555451 -4.817108 -5.021574 -5.169231 -5.261264 -5.316213 -5.318416 -5.272106 -5.149477 -4.943100 -4.679694 -4.288174 -3.578443 -2.516065 -2.829044 -3.159058 -3.501748 -3.853756 -4.195321 -4.488617 -4.745392 -4.955650 -5.116172 -5.231899 -5.301406 -5.334857 -5.318634 -5.253731 -5.116338 -4.896897 -4.623329 -4.240294 -3.578443 -3.087445 -3.338618 -3.611782 -3.892256 -4.178298 -4.447967 -4.680608 -4.879689 -5.045564 -5.175825 -5.264733 -5.312838 -5.325800 -5.292210 -5.211099 -5.062459 -4.834329 -4.557642 -4.188086 -3.578443 -3.689271 -3.846812 -4.033353 -4.231667 -4.436993 -4.635641 -4.811196 -4.965534 -5.094551 -5.193967 -5.255752 -5.283143 -5.279056 -5.230885 -5.138138 -4.982915 -4.753271 -4.480114 -4.129570 -3.578443 -4.286937 -4.333258 -4.418838 -4.525047 -4.649478 -4.775096 -4.888612 -4.994235 -5.084619 -5.154554 -5.190329 -5.198201 -5.182726 -5.125056 -5.026894 -4.871899 -4.648637 -4.385862 -4.061913 -3.578443 -4.882406 -4.813667 -4.790283 -4.794149 -4.826827 -4.867837 -4.911393 -4.960518 -5.006211 -5.046203 -5.056693 -5.048284 -5.024890 -4.962506 -4.865279 -4.720243 -4.511105 -4.267380 -3.979004 -3.578443 -21.11357 -20.68730 -20.16617 -19.56228 -18.88704 -18.14875 -17.35437 -16.50948 -15.61868 -14.68578 -13.71403 -12.70616 -11.66458 -10.59137 -9.488622 -8.357479 -7.199411 -6.016228 -4.808876 -3.578443 -0.3288138 -1.086883 -1.658720 -2.147605 -2.612780 -3.020114 -3.331070 -3.522696 -3.809610 -4.070574 -4.304574 -4.448458 -4.551600 -4.752921 -4.932909 -5.062157 -5.045707 -5.074310 -4.846965 -3.695293 0.3906006 -0.4313975 -1.082647 -1.686905 -2.247814 -2.742774 -3.062852 -3.356340 -3.687871 -4.001066 -4.281048 -4.384180 -4.539279 -4.764893 -4.967907 -5.093808 -5.047786 -5.071838 -4.829855 -3.695293 0.7574173 -8.7842174E-02 -0.8142585 -1.480611 -2.085544 -2.581141 -2.969672 -3.321704 -3.663907 -3.999119 -4.288514 -4.403013 -4.588500 -4.810023 -5.014028 -5.115065 -5.063464 -5.070824 -4.810869 -3.695293 0.9230841 6.7196123E-02 -0.6914744 -1.384160 -1.984403 -2.500795 -2.942586 -3.319480 -3.685286 -4.033248 -4.303879 -4.471819 -4.662102 -4.873496 -5.066394 -5.122817 -5.086431 -5.070039 -4.789790 -3.695293 0.9475520 0.1023564 -0.6564513 -1.334885 -1.941146 -2.479023 -2.938044 -3.349391 -3.738098 -4.090367 -4.354973 -4.557731 -4.748861 -4.947253 -5.122384 -5.144169 -5.112511 -5.068623 -4.766398 -3.695293 0.8645589 5.4077525E-02 -0.6728776 -1.344931 -1.951217 -2.488502 -2.968953 -3.413164 -3.815799 -4.156923 -4.427332 -4.650448 -4.842011 -5.026588 -5.178021 -5.181045 -5.139032 -5.065646 -4.740399 -3.695293 0.7039967 -5.4666653E-02 -0.7550674 -1.408541 -2.001719 -2.542879 -3.047406 -3.505519 -3.907043 -4.236244 -4.517286 -4.747509 -4.939648 -5.107369 -5.228452 -5.223247 -5.164225 -5.060179 -4.711496 -3.695293 0.4830438 -0.2250918 -0.8933074 -1.517938 -2.103466 -2.652238 -3.160928 -3.618341 -3.999630 -4.331696 -4.614740 -4.852231 -5.038719 -5.189588 -5.278322 -5.265504 -5.185871 -5.051560 -4.680485 -3.695293 0.2064407 -0.4503369 -1.077144 -1.685732 -2.256694 -2.799103 -3.296674 -3.726496 -4.106850 -4.443931 -4.727650 -4.963080 -5.138047 -5.270151 -5.333200 -5.305929 -5.202405 -5.038833 -4.648191 -3.695293 -0.1180107 -0.7235516 -1.315161 -1.896194 -2.448378 -2.968196 -3.430050 -3.854319 -4.236568 -4.572549 -4.852402 -5.072221 -5.240015 -5.343538 -5.385827 -5.342003 -5.212687 -5.021036 -4.614201 -3.695293 -0.4848309 -1.046028 -1.597731 -2.145642 -2.665031 -3.143078 -3.597355 -4.012112 -4.391066 -4.721073 -4.978951 -5.188412 -5.337410 -5.414160 -5.433465 -5.368919 -5.215951 -4.997416 -4.578103 -3.695293 -0.8952694 -1.410512 -1.920533 -2.415391 -2.898779 -3.362408 -3.797354 -4.208081 -4.574195 -4.872596 -5.116531 -5.304343 -5.422504 -5.475234 -5.472617 -5.385746 -5.210632 -4.966917 -4.539495 -3.695293 -1.351439 -1.808516 -2.269568 -2.728079 -3.183359 -3.627284 -4.046988 -4.427027 -4.758963 -5.041660 -5.256196 -5.403092 -5.494653 -5.523425 -5.498888 -5.390616 -5.194607 -4.928444 -4.497900 -3.695293 -1.856227 -2.257781 -2.671466 -3.096014 -3.525176 -3.932234 -4.312957 -4.664721 -4.969284 -5.199244 -5.370138 -5.483133 -5.547700 -5.555094 -5.508336 -5.380683 -5.165668 -4.880908 -4.452687 -3.695293 -2.417758 -2.763897 -3.126286 -3.501576 -3.885721 -4.261364 -4.609944 -4.897975 -5.138158 -5.320038 -5.449874 -5.536911 -5.578832 -5.564599 -5.496942 -5.352208 -5.121514 -4.824967 -4.403005 -3.695293 -3.027115 -3.303330 -3.610800 -3.938298 -4.260509 -4.567021 -4.838141 -5.065294 -5.252354 -5.396530 -5.496273 -5.558916 -5.579415 -5.544917 -5.459130 -5.300960 -5.059223 -4.758874 -4.348236 -3.695293 -3.681623 -3.866788 -4.085614 -4.320628 -4.561885 -4.786685 -4.989000 -5.166952 -5.316593 -5.428315 -5.498928 -5.537806 -5.538414 -5.487045 -5.388248 -5.222105 -4.976450 -4.679589 -4.287117 -3.695293 -4.346061 -4.405662 -4.513728 -4.646152 -4.798994 -4.946116 -5.084421 -5.208964 -5.316194 -5.395445 -5.438276 -5.457580 -5.442183 -5.379790 -5.275161 -5.108896 -4.867755 -4.581789 -4.216265 -3.695293 -4.999196 -4.926652 -4.913646 -4.935305 -4.986672 -5.043563 -5.108545 -5.172750 -5.232404 -5.278046 -5.295887 -5.298727 -5.274879 -5.208896 -5.105833 -4.948091 -4.722845 -4.456868 -4.129307 -3.695293 -23.06822 -22.60505 -22.03277 -21.36712 -20.62088 -19.80418 -18.92505 -17.98991 -17.00400 -15.97164 -14.89647 -13.78158 -12.62966 -11.44303 -10.22375 -8.973653 -7.694362 -6.387341 -5.053916 -3.695293 -0.2441130 -1.065651 -1.685366 -2.188319 -2.655243 -3.073276 -3.410963 -3.601720 -3.898264 -4.167801 -4.406924 -4.566486 -4.656127 -4.864474 -5.050872 -5.191998 -5.177603 -5.222803 -5.009220 -3.805691 0.5508345 -0.3384484 -1.051675 -1.658771 -2.233405 -2.755007 -3.128784 -3.422456 -3.767313 -4.089026 -4.377588 -4.499515 -4.643606 -4.876968 -5.089103 -5.229418 -5.182106 -5.223287 -4.993310 -3.805691 0.9669197 4.8070062E-02 -0.7196993 -1.410041 -2.047600 -2.606625 -3.023726 -3.389554 -3.747357 -4.084009 -4.384194 -4.518195 -4.699796 -4.927442 -5.141027 -5.256602 -5.203095 -5.226017 -4.975398 -3.805691 1.155596 0.2387272 -0.5651757 -1.299886 -1.965845 -2.520202 -2.991514 -3.396510 -3.762918 -4.116062 -4.403873 -4.596539 -4.782861 -4.997894 -5.200918 -5.268753 -5.232942 -5.229294 -4.955233 -3.805691 1.193127 0.2885190 -0.5240187 -1.268829 -1.921116 -2.493899 -2.992372 -3.415431 -3.808473 -4.174220 -4.462496 -4.687494 -4.878669 -5.079267 -5.264907 -5.295051 -5.266723 -5.232185 -4.932485 -3.805691 1.115898 0.2422316 -0.5508810 -1.276816 -1.926996 -2.507340 -3.011850 -3.464281 -3.882831 -4.250599 -4.546640 -4.784476 -4.977600 -5.168337 -5.328541 -5.337885 -5.301292 -5.233737 -4.906867 -3.805691 0.9468554 0.1233360 -0.6326020 -1.335920 -1.979393 -2.550167 -3.069890 -3.550698 -3.980697 -4.344825 -4.634919 -4.886213 -5.082645 -5.258347 -5.387259 -5.388283 -5.334505 -5.232876 -4.878044 -3.805691 0.7147811 -5.0177630E-02 -0.7708395 -1.450487 -2.069227 -2.641813 -3.178587 -3.667867 -4.092907 -4.441788 -4.739110 -4.993129 -5.190936 -5.348393 -5.447625 -5.440202 -5.363802 -5.228806 -4.846813 -3.805691 0.4231892 -0.2826671 -0.9610407 -1.610855 -2.215024 -2.787971 -3.322202 -3.799933 -4.203047 -4.555270 -4.851767 -5.110626 -5.298132 -5.437883 -5.512493 -5.489834 -5.388203 -5.220623 -4.814288 -3.805691 9.0030923E-02 -0.5665825 -1.201383 -1.824399 -2.409778 -2.970947 -3.481365 -3.928387 -4.333864 -4.683104 -4.982160 -5.231517 -5.405845 -5.525403 -5.577559 -5.533345 -5.406748 -5.207283 -4.779999 -3.805691 -0.2957779 -0.9017059 -1.493641 -2.079087 -2.644034 -3.169777 -3.643797 -4.091726 -4.485700 -4.836427 -5.123521 -5.351047 -5.513975 -5.607328 -5.635475 -5.569128 -5.417458 -5.187707 -4.743492 -3.805691 -0.7268402 -1.278937 -1.829548 -2.372559 -2.889305 -3.383570 -3.850307 -4.281981 -4.672615 -5.003757 -5.266304 -5.479704 -5.614578 -5.682541 -5.682532 -5.595156 -5.418710 -5.160598 -4.704293 -3.805691 -1.203645 -1.700365 -2.195506 -2.690124 -3.179125 -3.648135 -4.101776 -4.518580 -4.875731 -5.178025 -5.423903 -5.598966 -5.703378 -5.741529 -5.716473 -5.609159 -5.408514 -5.124678 -4.661790 -3.805691 -1.730611 -2.164025 -2.608094 -3.065337 -3.525943 -3.974205 -4.388701 -4.765959 -5.098347 -5.367858 -5.558263 -5.697326 -5.768233 -5.782761 -5.734687 -5.607882 -5.384677 -5.078679 -4.615285 -3.805691 -2.318077 -2.690920 -3.085911 -3.500809 -3.914685 -4.319024 -4.700500 -5.039808 -5.307034 -5.514649 -5.660654 -5.764072 -5.809274 -5.801790 -5.731303 -5.586038 -5.344723 -5.022953 -4.563869 -3.805691 -2.963337 -3.263404 -3.598193 -3.961856 -4.337200 -4.674709 -4.982127 -5.242379 -5.452873 -5.609611 -5.721255 -5.799722 -5.819453 -5.791380 -5.700183 -5.539113 -5.285175 -4.955317 -4.506345 -3.805691 -3.667611 -3.873220 -4.125830 -4.400680 -4.679662 -4.935686 -5.166683 -5.365239 -5.532004 -5.655349 -5.735427 -5.788896 -5.786889 -5.740859 -5.633618 -5.461086 -5.202643 -4.872784 -4.441989 -3.805691 -4.390475 -4.466753 -4.598591 -4.761835 -4.940556 -5.114717 -5.278572 -5.422111 -5.542036 -5.629985 -5.681702 -5.712615 -5.694219 -5.635737 -5.520853 -5.344318 -5.090286 -4.769976 -4.366975 -3.805691 -5.103481 -5.036507 -5.030383 -5.073148 -5.138158 -5.216509 -5.302818 -5.385177 -5.456494 -5.506810 -5.536292 -5.550871 -5.521606 -5.457958 -5.345265 -5.174294 -4.935000 -4.639459 -4.274428 -3.805691 -25.06082 -24.56020 -23.93568 -23.20647 -22.38695 -21.48961 -20.52341 -19.49562 -18.41213 -17.27778 -16.09686 -14.87210 -13.60720 -12.30449 -10.96626 -9.594510 -8.191288 -6.757472 -5.295245 -3.805691 -0.1660423 -1.050596 -1.715804 -2.230201 -2.716701 -3.132348 -3.485219 -3.675389 -3.983349 -4.259580 -4.505913 -4.678994 -4.755407 -4.970240 -5.161533 -5.313996 -5.300484 -5.361843 -5.163171 -3.910313 0.7035908 -0.2572789 -1.017397 -1.668066 -2.236302 -2.766999 -3.175955 -3.487332 -3.841707 -4.175781 -4.471903 -4.611260 -4.742506 -4.982857 -5.200613 -5.357908 -5.307026 -5.365759 -5.148767 -3.910313 1.166219 0.1756459 -0.6597643 -1.361522 -2.010624 -2.600390 -3.076360 -3.455223 -3.825098 -4.170051 -4.478214 -4.627900 -4.808087 -5.038629 -5.256482 -5.391942 -5.333818 -5.372145 -5.132267 -3.910313 1.385633 0.3921290 -0.4550084 -1.216828 -1.917148 -2.533209 -3.037488 -3.462056 -3.848652 -4.199950 -4.500442 -4.714277 -4.901111 -5.115653 -5.322481 -5.409701 -5.370687 -5.379866 -5.113297 -3.910313 1.435898 0.4656016 -0.3919819 -1.179247 -1.894711 -2.505028 -3.033772 -3.490333 -3.884325 -4.256085 -4.562492 -4.814484 -5.004854 -5.204961 -5.394159 -5.441043 -5.412668 -5.387933 -5.091538 -3.910313 1.360704 0.4264692 -0.4172615 -1.206529 -1.900732 -2.515893 -3.060561 -3.525522 -3.949497 -4.334661 -4.656138 -4.915044 -5.111773 -5.301172 -5.465518 -5.491811 -5.455790 -5.394766 -5.066674 -3.910313 1.191382 0.3038813 -0.5145664 -1.264676 -1.950027 -2.565859 -3.105404 -3.597130 -4.046216 -4.440564 -4.754525 -5.019666 -5.220948 -5.400747 -5.534662 -5.551082 -5.496881 -5.399181 -5.038432 -3.910313 0.9429666 0.1212627 -0.6521074 -1.380497 -2.047320 -2.644215 -3.197441 -3.710644 -4.168829 -4.551289 -4.857784 -5.130517 -5.335809 -5.497987 -5.605075 -5.612461 -5.535141 -5.400360 -5.007509 -3.910313 0.6416429 -0.1186396 -0.8467040 -1.545584 -2.180545 -2.779245 -3.340276 -3.855490 -4.297647 -4.661619 -4.977424 -5.248322 -5.452703 -5.595879 -5.682332 -5.670531 -5.568652 -5.397040 -4.975186 -3.910313 0.2940949 -0.4148911 -1.093612 -1.753131 -2.373919 -2.964340 -3.517512 -4.007524 -4.424173 -4.797941 -5.106421 -5.375211 -5.564838 -5.695096 -5.756630 -5.722510 -5.595702 -5.388159 -4.940971 -3.910313 -0.1090294 -0.7595479 -1.392659 -2.014902 -2.612898 -3.184155 -3.699249 -4.162470 -4.584612 -4.947278 -5.255638 -5.505723 -5.681622 -5.790360 -5.825802 -5.767541 -5.614365 -5.372546 -4.904402 -3.910313 -0.5584428 -1.147727 -1.737334 -2.320620 -2.885782 -3.406652 -3.903299 -4.358963 -4.768563 -5.124383 -5.411406 -5.642179 -5.798749 -5.874768 -5.885151 -5.802413 -5.622935 -5.348975 -4.864852 -3.910313 -1.056769 -1.587310 -2.125078 -2.654619 -3.175066 -3.676775 -4.152025 -4.597970 -4.991104 -5.310928 -5.576224 -5.781804 -5.896658 -5.945796 -5.931490 -5.822717 -5.619926 -5.315786 -4.821668 -3.910313 -1.607645 -2.069577 -2.548210 -3.037603 -3.525670 -4.004498 -4.460772 -4.864054 -5.220381 -5.518213 -5.738230 -5.895520 -5.976861 -5.998843 -5.959124 -5.826161 -5.602168 -5.271603 -4.774038 -3.910313 -2.217768 -2.616319 -3.040762 -3.489643 -3.943207 -4.375576 -4.787452 -5.157510 -5.467348 -5.695861 -5.863081 -5.979545 -6.031621 -6.030174 -5.963454 -5.810027 -5.565966 -5.216829 -4.721148 -3.910313 -2.898259 -3.220574 -3.582784 -3.978441 -4.388296 -4.779788 -5.119107 -5.409981 -5.641695 -5.817693 -5.941424 -6.028926 -6.054974 -6.030077 -5.939131 -5.768519 -5.507065 -5.149437 -4.661437 -3.910313 -3.646260 -3.874425 -4.155812 -4.471519 -4.789288 -5.081699 -5.340986 -5.561126 -5.740006 -5.878472 -5.972954 -6.031883 -6.033337 -5.984681 -5.876519 -5.694342 -5.422683 -5.065931 -4.594665 -3.910313 -4.425851 -4.520172 -4.676667 -4.871390 -5.077299 -5.281332 -5.470203 -5.633056 -5.764814 -5.864880 -5.932105 -5.964242 -5.945061 -5.879790 -5.762336 -5.577484 -5.306655 -4.960402 -4.516543 -3.910313 -5.204495 -5.139417 -5.145940 -5.205091 -5.290020 -5.394672 -5.499061 -5.596826 -5.679073 -5.742878 -5.784499 -5.797159 -5.767189 -5.696118 -5.579118 -5.400543 -5.145306 -4.823281 -4.419633 -3.910313 -27.08958 -26.55094 -25.87286 -25.07788 -24.18363 -23.20356 -22.14809 -21.02537 -19.84196 -18.60322 -17.31366 -15.97706 -14.59670 -13.17542 -11.71573 -10.21980 -8.689623 -7.126948 -5.533367 -3.910313 -8.7734021E-02 -1.037988 -1.750170 -2.276189 -2.776659 -3.203466 -3.560487 -3.744236 -4.065257 -4.347270 -4.601351 -4.786443 -4.850402 -5.070895 -5.266159 -5.428721 -5.413944 -5.492532 -5.307756 -4.009733 0.8507864 -0.1800233 -0.9922040 -1.670145 -2.273284 -2.791177 -3.219974 -3.543005 -3.913255 -4.255745 -4.565166 -4.720220 -4.837099 -5.084675 -5.305701 -5.479599 -5.422806 -5.499298 -5.294699 -4.009733 1.357384 0.2957833 -0.5928043 -1.351321 -1.994463 -2.593089 -3.101524 -3.519428 -3.898248 -4.255211 -4.572261 -4.734291 -4.911819 -5.145805 -5.364198 -5.521195 -5.454866 -5.509916 -5.279286 -4.009733 1.605506 0.5404266 -0.3732086 -1.153305 -1.868006 -2.516140 -3.081348 -3.524486 -3.925440 -4.286022 -4.596885 -4.824792 -5.016220 -5.230816 -5.434449 -5.544992 -5.499499 -5.522676 -5.261259 -4.009733 1.670111 0.6291327 -0.2720170 -1.090259 -1.842147 -2.512240 -3.071328 -3.550996 -3.968950 -4.339120 -4.659792 -4.932387 -5.126648 -5.328407 -5.511033 -5.581652 -5.550086 -5.535501 -5.240326 -4.009733 1.595617 0.6029180 -0.2874967 -1.117334 -1.872514 -2.521504 -3.094509 -3.597853 -4.020820 -4.415761 -4.756258 -5.040999 -5.240017 -5.430790 -5.592793 -5.641160 -5.602134 -5.547568 -5.215967 -4.009733 1.430587 0.4808489 -0.3875614 -1.198168 -1.921878 -2.569818 -3.151104 -3.651136 -4.109835 -4.522788 -4.866243 -5.146636 -5.356191 -5.537216 -5.670784 -5.710476 -5.653280 -5.557386 -5.187687 -4.009733 1.171935 0.2895893 -0.5358665 -1.312689 -2.017630 -2.660170 -3.224839 -3.752377 -4.231442 -4.648254 -4.975091 -5.260632 -5.473763 -5.647007 -5.750580 -5.780347 -5.700862 -5.563495 -5.156363 -4.009733 0.8593745 4.2778812E-02 -0.7357510 -1.478102 -2.159120 -2.776268 -3.358639 -3.897843 -4.377706 -4.771073 -5.093386 -5.378529 -5.595500 -5.753631 -5.838452 -5.847993 -5.743146 -5.565068 -5.123797 -4.009733 0.4942458 -0.2641093 -0.9904907 -1.689596 -2.340237 -2.959505 -3.539015 -4.071756 -4.518446 -4.903280 -5.226654 -5.511946 -5.719536 -5.859517 -5.925416 -5.909947 -5.778193 -5.561041 -5.089338 -4.009733 7.5030349E-02 -0.6165767 -1.294911 -1.953239 -2.583142 -3.186116 -3.746101 -4.237272 -4.674053 -5.058161 -5.380943 -5.654024 -5.841878 -5.966552 -6.006562 -5.962445 -5.805119 -5.549907 -5.052391 -4.009733 -0.3916630 -1.021121 -1.648991 -2.266129 -2.871253 -3.437943 -3.952404 -4.437540 -4.862111 -5.241115 -5.551354 -5.793209 -5.968724 -6.062493 -6.076018 -6.004142 -5.821295 -5.530218 -5.012372 -4.009733 -0.9105659 -1.476605 -2.050071 -2.625183 -3.173124 -3.704473 -4.207523 -4.673572 -5.089627 -5.443888 -5.721603 -5.945813 -6.086368 -6.147795 -6.130287 -6.033486 -5.823984 -5.500462 -4.968596 -4.009733 -1.484768 -1.980216 -2.490685 -3.012857 -3.529193 -4.034490 -4.520038 -4.963384 -5.337946 -5.657662 -5.909024 -6.081698 -6.183459 -6.213192 -6.167564 -6.046186 -5.810035 -5.458567 -4.920145 -4.009733 -2.118127 -2.543070 -2.995615 -3.474193 -3.961419 -4.433370 -4.871759 -5.267898 -5.610616 -5.869399 -6.061479 -6.186347 -6.250994 -6.252721 -6.182662 -6.036394 -5.777516 -5.405033 -4.865980 -4.009733 -2.825516 -3.177511 -3.567093 -3.992405 -4.431509 -4.862491 -5.249204 -5.565538 -5.824977 -6.018049 -6.161084 -6.249016 -6.286100 -6.258339 -6.168115 -5.997821 -5.722457 -5.337303 -4.804523 -4.009733 -3.611019 -3.869641 -4.182169 -4.532410 -4.890463 -5.222037 -5.511120 -5.751277 -5.945874 -6.097156 -6.206285 -6.262045 -6.272709 -6.220775 -6.112638 -5.923170 -5.639627 -5.251558 -4.735386 -4.009733 -4.454313 -4.566230 -4.749238 -4.974181 -5.212226 -5.447490 -5.657586 -5.840575 -5.986882 -6.097120 -6.172927 -6.201136 -6.189970 -6.120395 -6.001882 -5.801787 -5.521302 -5.141709 -4.655166 -4.009733 -5.299631 -5.235714 -5.255870 -5.330865 -5.440226 -5.567795 -5.691298 -5.806432 -5.906030 -5.974368 -6.023593 -6.032430 -6.008017 -5.930865 -5.815351 -5.616692 -5.352755 -4.998982 -4.555756 -4.009733 -29.15287 -28.57568 -27.84276 -26.98061 -26.00950 -24.94469 -23.79785 -22.57804 -21.29250 -19.94713 -18.54687 -17.09587 -15.59773 -14.05553 -12.47199 -10.84952 -9.190238 -7.496064 -5.768713 -4.009733 -1.6703274E-02 -1.026488 -1.784471 -2.324940 -2.837867 -3.275152 -3.640484 -3.812813 -4.140976 -4.431556 -4.692281 -4.889265 -4.941397 -5.166947 -5.367276 -5.536767 -5.521111 -5.615526 -5.447521 -4.104444 1.000352 -0.1018366 -0.9719300 -1.679776 -2.300092 -2.840224 -3.269660 -3.592988 -3.982071 -4.331556 -4.655435 -4.826923 -4.927758 -5.182693 -5.411659 -5.594406 -5.531636 -5.625865 -5.436537 -4.104444 1.543249 0.4191378 -0.5335329 -1.328978 -2.018178 -2.600655 -3.123442 -3.569906 -3.969015 -4.333000 -4.666661 -4.838411 -5.011054 -5.251053 -5.475802 -5.642855 -5.569838 -5.640918 -5.423137 -4.104444 1.821140 0.6860234 -0.2854895 -1.124595 -1.836970 -2.496747 -3.094513 -3.584202 -3.996667 -4.372486 -4.693180 -4.931809 -5.124767 -5.344176 -5.552657 -5.672315 -5.622696 -5.658492 -5.406958 -4.104444 1.889348 0.7905900 -0.1774824 -1.015617 -1.787062 -2.490060 -3.106214 -3.607293 -4.044358 -4.424805 -4.755264 -5.041643 -5.245238 -5.449221 -5.637506 -5.713258 -5.682062 -5.676962 -5.387587 -4.104444 1.815839 0.7698666 -0.1675541 -1.028895 -1.820831 -2.527486 -3.125387 -3.652467 -4.102316 -4.496659 -4.852061 -5.157078 -5.363898 -5.559256 -5.727081 -5.780371 -5.743018 -5.694267 -5.364544 -4.104444 1.658106 0.6518619 -0.2619404 -1.116811 -1.893956 -2.572885 -3.180044 -3.715667 -4.176707 -4.600998 -4.968608 -5.270915 -5.484899 -5.674981 -5.814740 -5.856939 -5.802495 -5.709627 -5.337295 -4.104444 1.400442 0.4567163 -0.4191397 -1.244112 -1.989245 -2.661511 -3.266280 -3.797067 -4.292319 -4.729146 -5.089036 -5.382705 -5.606262 -5.792942 -5.902171 -5.935126 -5.858221 -5.721659 -5.306667 -4.104444 1.076416 0.1971208 -0.6259970 -1.412337 -2.131759 -2.786190 -3.379777 -3.937339 -4.441042 -4.870273 -5.209410 -5.506932 -5.732023 -5.908491 -5.997857 -6.010833 -5.908661 -5.728845 -5.274768 -4.104444 0.6916632 -0.1153297 -0.8882669 -1.632116 -2.315268 -2.954765 -3.558769 -4.116184 -4.603671 -5.006088 -5.349260 -5.637743 -5.863959 -6.020357 -6.094567 -6.080271 -5.951849 -5.730133 -5.240953 -4.104444 0.2535242 -0.4791846 -1.202199 -1.894846 -2.556308 -3.185434 -3.778995 -4.310574 -4.762938 -5.165763 -5.500453 -5.784833 -5.994376 -6.135010 -6.184573 -6.140820 -5.985721 -5.723664 -5.204478 -4.104444 -0.2320917 -0.8979783 -1.562987 -2.214768 -2.849100 -3.455957 -4.008271 -4.507642 -4.959425 -5.347073 -5.677127 -5.937756 -6.131271 -6.245456 -6.266096 -6.191347 -6.008628 -5.708232 -5.164607 -4.104444 -0.7716401 -1.368346 -1.976693 -2.586926 -3.178561 -3.731901 -4.264988 -4.750025 -5.188238 -5.565303 -5.863977 -6.100546 -6.263331 -6.341154 -6.331059 -6.227866 -6.018497 -5.682174 -5.120538 -4.104444 -1.361656 -1.893243 -2.437215 -2.987939 -3.536800 -4.068105 -4.579298 -5.047040 -5.453848 -5.791072 -6.065568 -6.257856 -6.373661 -6.415733 -6.377841 -6.247349 -6.011304 -5.643672 -5.071599 -4.104444 -2.018284 -2.471457 -2.952276 -3.457604 -3.973863 -4.484832 -4.954532 -5.374044 -5.739651 -6.034961 -6.244430 -6.381268 -6.454483 -6.467601 -6.400578 -6.244839 -5.983280 -5.592603 -5.016240 -4.104444 -2.752992 -3.127296 -3.551989 -4.004898 -4.472445 -4.936136 -5.361638 -5.715738 -5.995428 -6.211638 -6.366058 -6.458191 -6.498878 -6.487224 -6.393146 -6.213155 -5.930364 -5.526223 -4.953183 -4.104444 -3.571447 -3.851624 -4.203040 -4.589385 -4.983382 -5.356472 -5.674035 -5.938434 -6.147246 -6.310170 -6.425001 -6.484664 -6.495203 -6.457084 -6.344058 -6.144076 -5.847905 -5.440494 -4.880956 -4.104444 -4.474393 -4.606710 -4.817050 -5.072182 -5.344429 -5.609055 -5.844471 -6.040597 -6.204564 -6.323205 -6.403415 -6.434024 -6.418784 -6.359818 -6.233708 -6.024879 -5.727679 -5.328804 -4.796334 -4.104444 -5.388162 -5.327279 -5.360020 -5.454612 -5.591527 -5.741611 -5.885285 -6.012246 -6.120741 -6.202342 -6.255812 -6.264612 -6.233196 -6.169964 -6.038605 -5.834622 -5.552946 -5.178721 -4.690536 -4.104444 -31.24921 -30.63293 -29.84394 -28.91301 -27.86324 -26.71180 -25.47160 -24.15264 -22.76286 -21.30871 -19.79559 -18.22801 -16.60987 -14.94452 -13.23491 -11.48364 -9.693000 -7.865057 -6.001649 -4.104444 4.5111261E-02 -1.018616 -1.818128 -2.373081 -2.900216 -3.344943 -3.722815 -3.882534 -4.214908 -4.512491 -4.779463 -4.987410 -5.028265 -5.258460 -5.464001 -5.639143 -5.623337 -5.729807 -5.580794 -4.194872 1.141043 -2.1184700E-02 -0.9494331 -1.693584 -2.331816 -2.888089 -3.332629 -3.644664 -4.040727 -4.405159 -4.740494 -4.931420 -5.014786 -5.275038 -5.512403 -5.703321 -5.635884 -5.742775 -5.572087 -4.194872 1.728977 0.5531306 -0.4771470 -1.314561 -2.026520 -2.638551 -3.152303 -3.611000 -4.038155 -4.408541 -4.758132 -4.939631 -5.107410 -5.351418 -5.583784 -5.758324 -5.681350 -5.761522 -5.560943 -4.194872 2.030996 0.8429674 -0.2068256 -1.083290 -1.844473 -2.490409 -3.101103 -3.629827 -4.065905 -4.451798 -4.789631 -5.035064 -5.229588 -5.452805 -5.668430 -5.794394 -5.742126 -5.783367 -5.546997 -4.194872 2.086759 0.9498609 -7.7338293E-02 -0.9707618 -1.744353 -2.462584 -3.115106 -3.659310 -4.114039 -4.513611 -4.849160 -5.145477 -5.360031 -5.564914 -5.761362 -5.840305 -5.809165 -5.806654 -5.529655 -4.194872 2.013595 0.9345203 -6.4640634E-02 -0.9497254 -1.762972 -2.505554 -3.151879 -3.701238 -4.179399 -4.579686 -4.944306 -5.263500 -5.488995 -5.684494 -5.857986 -5.913040 -5.877991 -5.829407 -5.508396 -4.194872 1.866333 0.8154104 -0.1412520 -1.031583 -1.847656 -2.573315 -3.206467 -3.767474 -4.250490 -4.676573 -5.060767 -5.384155 -5.613757 -5.804769 -5.953861 -5.996758 -5.945541 -5.850227 -5.482700 -4.194872 1.625540 0.6190310 -0.3001935 -1.172707 -1.958140 -2.663882 -3.295532 -3.851700 -4.353129 -4.803945 -5.193284 -5.501147 -5.740405 -5.927098 -6.047568 -6.084055 -6.008985 -5.867789 -5.453260 -4.194872 1.287638 0.3521236 -0.5209926 -1.348361 -2.103124 -2.794868 -3.410410 -3.976142 -4.500419 -4.955513 -5.324982 -5.625544 -5.867697 -6.050869 -6.150596 -6.168168 -6.067136 -5.880648 -5.422544 -4.194872 0.8823920 2.7342152E-02 -0.7899218 -1.571877 -2.299088 -2.957888 -3.577594 -4.156889 -4.677127 -5.109138 -5.459643 -5.761671 -6.005783 -6.172201 -6.256142 -6.247019 -6.118351 -5.887730 -5.389784 -4.194872 0.4282088 -0.3489048 -1.113305 -1.844339 -2.531049 -3.186150 -3.802195 -4.372366 -4.856236 -5.264019 -5.617871 -5.914384 -6.146553 -6.295679 -6.354759 -6.316446 -6.159896 -5.887233 -5.354178 -4.194872 -7.4943133E-02 -0.7799342 -1.480901 -2.166945 -2.828850 -3.465020 -4.057001 -4.580074 -5.048371 -5.453110 -5.800179 -6.081693 -6.284479 -6.418930 -6.443238 -6.374944 -6.189173 -5.877300 -5.314929 -4.194872 -0.6337126 -1.265608 -1.906831 -2.547235 -3.174311 -3.765954 -4.317274 -4.832029 -5.280600 -5.677707 -6.000544 -6.249148 -6.430759 -6.526489 -6.518331 -6.420044 -6.204951 -5.855821 -5.271492 -4.194872 -1.241378 -1.804307 -2.383075 -2.967649 -3.541350 -4.107165 -4.637967 -5.131430 -5.563344 -5.919062 -6.208457 -6.428244 -6.555118 -6.616734 -6.576534 -6.447794 -6.204553 -5.820497 -5.222090 -4.194872 -1.919500 -2.400823 -2.911541 -3.443552 -3.985292 -4.525924 -5.035908 -5.479170 -5.861334 -6.181899 -6.415233 -6.568619 -6.649881 -6.677009 -6.610557 -6.451575 -6.183229 -5.770910 -5.165932 -4.194872 -2.679936 -3.077546 -3.527626 -4.017134 -4.513327 -5.006001 -5.462070 -5.860571 -6.157676 -6.395095 -6.560873 -6.661811 -6.710782 -6.703047 -6.608268 -6.423787 -6.135409 -5.704294 -5.101817 -4.194872 -3.529341 -3.831211 -4.209337 -4.640867 -5.072749 -5.479336 -5.835225 -6.116547 -6.339454 -6.515047 -6.635952 -6.702177 -6.718393 -6.682800 -6.559797 -6.355599 -6.054672 -5.616958 -5.026987 -4.194872 -4.486782 -4.639887 -4.880764 -5.168511 -5.475111 -5.769988 -6.025436 -6.239870 -6.407879 -6.543605 -6.626711 -6.659359 -6.647552 -6.592989 -6.450029 -6.235251 -5.931622 -5.501959 -4.938641 -4.194872 -5.470265 -5.413966 -5.459341 -5.575613 -5.737819 -5.914313 -6.077562 -6.223618 -6.331066 -6.427891 -6.481993 -6.489297 -6.463966 -6.397963 -6.251586 -6.040873 -5.748555 -5.347139 -4.827575 -4.194872 -33.37725 -32.72158 -31.87506 -30.87380 -29.74368 -28.50376 -27.16830 -25.74823 -24.25221 -22.68726 -21.05920 -19.37296 -17.63273 -15.84212 -14.00432 -12.12212 -10.19798 -8.234110 -6.232477 -4.194872 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -1.055659 -1.079538 -1.099396 -1.116788 -1.129653 -1.136415 -1.157262 -1.174762 -1.188168 -1.196485 -1.196197 -1.191145 -1.177170 -1.158259 -1.140924 -1.111687 -1.066244 -0.9983448 -0.8934833 -0.6128114 -1.077444 -1.097366 -1.116679 -1.131850 -1.141205 -1.146834 -1.166533 -1.182786 -1.194876 -1.199226 -1.199611 -1.192800 -1.176930 -1.156560 -1.138340 -1.108256 -1.061997 -0.9938926 -0.8894286 -0.6128114 -1.098267 -1.117257 -1.134034 -1.145303 -1.153135 -1.157950 -1.176404 -1.191157 -1.201723 -1.204210 -1.202823 -1.194165 -1.176338 -1.154881 -1.135517 -1.104738 -1.057619 -0.9897280 -0.8852706 -0.6128114 -1.121171 -1.137283 -1.149672 -1.159276 -1.165832 -1.169941 -1.186716 -1.199828 -1.205899 -1.209140 -1.205815 -1.195213 -1.174428 -1.153219 -1.132797 -1.101130 -1.053128 -0.9850366 -0.8810313 -0.6128114 -1.144276 -1.155390 -1.166251 -1.174014 -1.179818 -1.182619 -1.197448 -1.205924 -1.212660 -1.213972 -1.208601 -1.195923 -1.173825 -1.151597 -1.129972 -1.097122 -1.048507 -0.9802254 -0.8766475 -0.6128114 -1.165339 -1.174819 -1.183495 -1.190522 -1.194732 -1.195931 -1.208655 -1.214775 -1.219427 -1.218678 -1.211151 -1.194771 -1.173377 -1.149445 -1.127183 -1.092948 -1.043889 -0.9752941 -0.8721371 -0.6128114 -1.188387 -1.195089 -1.202850 -1.208209 -1.210566 -1.209858 -1.217246 -1.223742 -1.226190 -1.223262 -1.211242 -1.195695 -1.173131 -1.147874 -1.124402 -1.088679 -1.039382 -0.9702435 -0.8674881 -0.6128114 -1.212494 -1.217830 -1.223589 -1.226945 -1.224775 -1.221509 -1.228885 -1.232886 -1.232995 -1.227712 -1.213791 -1.196999 -1.172099 -1.146178 -1.121135 -1.084454 -1.034503 -0.9650753 -0.8626984 -0.6128114 -1.239368 -1.242248 -1.245673 -1.244268 -1.241993 -1.236248 -1.240847 -1.242289 -1.239842 -1.229671 -1.216926 -1.198728 -1.172283 -1.144914 -1.117676 -1.080114 -1.030704 -0.9597986 -0.8577201 -0.6128114 -1.268319 -1.266330 -1.266849 -1.264882 -1.259976 -1.251731 -1.253348 -1.251987 -1.244144 -1.235233 -1.220800 -1.199423 -1.172390 -1.143221 -1.114314 -1.076202 -1.025645 -0.9544185 -0.8525401 -0.6128114 -1.297469 -1.294326 -1.291792 -1.286824 -1.279119 -1.268207 -1.263457 -1.259372 -1.252771 -1.241997 -1.223662 -1.201618 -1.173541 -1.141406 -1.111430 -1.072750 -1.020584 -0.9489492 -0.8471110 -0.6128114 -1.331136 -1.324651 -1.318969 -1.310850 -1.299925 -1.283128 -1.278617 -1.272002 -1.263263 -1.248010 -1.228731 -1.205451 -1.177347 -1.144107 -1.109404 -1.070814 -1.015596 -0.9437644 -0.8413666 -0.6128114 -1.368497 -1.358643 -1.349356 -1.335028 -1.320749 -1.304172 -1.297074 -1.284918 -1.273600 -1.257304 -1.236336 -1.211574 -1.182207 -1.148715 -1.109874 -1.067057 -1.010813 -0.9381337 -0.8351827 -0.6128114 -1.408834 -1.395289 -1.382304 -1.367256 -1.349623 -1.327446 -1.317180 -1.303106 -1.288664 -1.270192 -1.246819 -1.220561 -1.190519 -1.155185 -1.114370 -1.064002 -1.006404 -0.9326122 -0.8284549 -0.6128114 -1.460797 -1.443704 -1.424443 -1.405274 -1.382237 -1.358597 -1.344712 -1.327165 -1.308200 -1.286297 -1.261416 -1.233528 -1.203522 -1.165291 -1.118577 -1.065262 -1.003943 -0.9270942 -0.8197283 -0.6128114 -1.525623 -1.502837 -1.480567 -1.456206 -1.430548 -1.405271 -1.378143 -1.357743 -1.334950 -1.311610 -1.285078 -1.256657 -1.217945 -1.174378 -1.125219 -1.070830 -1.004146 -0.9222689 -0.8085601 -0.6128114 -1.612070 -1.584858 -1.557505 -1.530634 -1.501423 -1.474227 -1.447023 -1.415229 -1.386677 -1.351145 -1.316829 -1.278731 -1.236627 -1.189279 -1.138094 -1.076267 -1.003383 -0.9148611 -0.7954870 -0.6128114 -1.743972 -1.708247 -1.680147 -1.647628 -1.613622 -1.578903 -1.542557 -1.504022 -1.464245 -1.421818 -1.376574 -1.332977 -1.278591 -1.221537 -1.157043 -1.084740 -1.000679 -0.8956691 -0.7794415 -0.6128114 -2.007897 -1.963138 -1.916997 -1.874584 -1.823999 -1.771742 -1.717643 -1.663652 -1.604232 -1.542531 -1.477251 -1.407830 -1.332957 -1.250994 -1.160863 -1.066257 -0.9684983 -0.8665498 -0.7576644 -0.6128114 -2.074072 -2.009172 -1.942870 -1.875177 -1.806105 -1.735666 -1.664116 -1.590736 -1.516274 -1.440498 -1.363413 -1.285034 -1.205372 -1.124439 -1.042249 -0.9588103 -0.8741248 -0.7882220 -0.7011136 -0.6128114 -1.025247 -1.081121 -1.130179 -1.208970 -1.277938 -1.344624 -1.401435 -1.448227 -1.478665 -1.514461 -1.563757 -1.603651 -1.628223 -1.637638 -1.622823 -1.609518 -1.583252 -1.519270 -1.390106 -1.004622 -1.052067 -1.102523 -1.153799 -1.228590 -1.301427 -1.367196 -1.420959 -1.463819 -1.487514 -1.525254 -1.573850 -1.609473 -1.633980 -1.639953 -1.621138 -1.606298 -1.578792 -1.513752 -1.384542 -1.004622 -1.080562 -1.131138 -1.186032 -1.257949 -1.328683 -1.387625 -1.439295 -1.477923 -1.499827 -1.537993 -1.584855 -1.617736 -1.637944 -1.641217 -1.618919 -1.603022 -1.574155 -1.508028 -1.378825 -1.004622 -1.116905 -1.165220 -1.218768 -1.291553 -1.352847 -1.409431 -1.457258 -1.489777 -1.514841 -1.552189 -1.593357 -1.625807 -1.642419 -1.641663 -1.616900 -1.599667 -1.569333 -1.502081 -1.372951 -1.004622 -1.159077 -1.208256 -1.260515 -1.322321 -1.379610 -1.432210 -1.472923 -1.506283 -1.531873 -1.567451 -1.604764 -1.633729 -1.645448 -1.641092 -1.615015 -1.596216 -1.564319 -1.495749 -1.366918 -1.004622 -1.210149 -1.256626 -1.299856 -1.355412 -1.408052 -1.453151 -1.492757 -1.525599 -1.550210 -1.579814 -1.616073 -1.638565 -1.648286 -1.640219 -1.613218 -1.592659 -1.559118 -1.489160 -1.360741 -1.004622 -1.262671 -1.303250 -1.340836 -1.391250 -1.435593 -1.478110 -1.515771 -1.546804 -1.566757 -1.595184 -1.624404 -1.643885 -1.650327 -1.639899 -1.611547 -1.589003 -1.553746 -1.482343 -1.354428 -1.004622 -1.319054 -1.351966 -1.384731 -1.426720 -1.467610 -1.506649 -1.541253 -1.567230 -1.586238 -1.610587 -1.634624 -1.649485 -1.652039 -1.640026 -1.610037 -1.585324 -1.548224 -1.475305 -1.347976 -1.004622 -1.378650 -1.403427 -1.429272 -1.467009 -1.503526 -1.537981 -1.566776 -1.590598 -1.606113 -1.622805 -1.642837 -1.654263 -1.654490 -1.640630 -1.608672 -1.581637 -1.542563 -1.468060 -1.341389 -1.004622 -1.439771 -1.458520 -1.479597 -1.511382 -1.542389 -1.569911 -1.595419 -1.615023 -1.623718 -1.636226 -1.652033 -1.659709 -1.657624 -1.641821 -1.607630 -1.578033 -1.536258 -1.460636 -1.334673 -1.004622 -1.506181 -1.519363 -1.534339 -1.558058 -1.582412 -1.605193 -1.623956 -1.638352 -1.642849 -1.650993 -1.661998 -1.666358 -1.661750 -1.643717 -1.607055 -1.574655 -1.529575 -1.453053 -1.327843 -1.004622 -1.578469 -1.584108 -1.592228 -1.608703 -1.625885 -1.641440 -1.655089 -1.663929 -1.664040 -1.667226 -1.674010 -1.674772 -1.667199 -1.646592 -1.607149 -1.571577 -1.522985 -1.445395 -1.320925 -1.004622 -1.655373 -1.653389 -1.652695 -1.661869 -1.671292 -1.681570 -1.689702 -1.692837 -1.688289 -1.686702 -1.688847 -1.685624 -1.674636 -1.650881 -1.608305 -1.567675 -1.516661 -1.437866 -1.313966 -1.004622 -1.737460 -1.728121 -1.720270 -1.721765 -1.723862 -1.727231 -1.729238 -1.726896 -1.717549 -1.710715 -1.707711 -1.700056 -1.685028 -1.657467 -1.612089 -1.564776 -1.510923 -1.430765 -1.307053 -1.004622 -1.833144 -1.814493 -1.798235 -1.791293 -1.785429 -1.781656 -1.777371 -1.769108 -1.754239 -1.741550 -1.732659 -1.719768 -1.700125 -1.667952 -1.621315 -1.563787 -1.506423 -1.424523 -1.300332 -1.004622 -1.950165 -1.921224 -1.894983 -1.878543 -1.864116 -1.851986 -1.840004 -1.824549 -1.802830 -1.783119 -1.767340 -1.747701 -1.722502 -1.685840 -1.635509 -1.568415 -1.504719 -1.419978 -1.294945 -1.004622 -2.107773 -2.066709 -2.027799 -1.999832 -1.974606 -1.951829 -1.929628 -1.904293 -1.872691 -1.842691 -1.817951 -1.790889 -1.757624 -1.714666 -1.658495 -1.588388 -1.508741 -1.418859 -1.289520 -1.004622 -2.347424 -2.289226 -2.232332 -2.188535 -2.149561 -2.112108 -2.076459 -2.039208 -1.998366 -1.953025 -1.903166 -1.864852 -1.821393 -1.768356 -1.704382 -1.626289 -1.532467 -1.427953 -1.286968 -1.004622 -2.789728 -2.716578 -2.645470 -2.575618 -2.512222 -2.447265 -2.385822 -2.329576 -2.270374 -2.207572 -2.139650 -2.066208 -1.985259 -1.898220 -1.812790 -1.716589 -1.598904 -1.463293 -1.290852 -1.004622 -4.355299 -4.224098 -4.087332 -3.945099 -3.797502 -3.644641 -3.486600 -3.323721 -3.155353 -2.982341 -2.804555 -2.622086 -2.435235 -2.243408 -2.047439 -1.847162 -1.642623 -1.433973 -1.221286 -1.004622 -0.9073313 -1.029834 -1.143458 -1.233293 -1.314672 -1.427854 -1.535449 -1.629610 -1.709658 -1.762464 -1.812335 -1.892714 -1.955067 -1.999554 -2.015705 -1.996097 -1.992159 -1.937384 -1.793081 -1.332105 -0.9190307 -1.041662 -1.155008 -1.239179 -1.330151 -1.446417 -1.552184 -1.648308 -1.725906 -1.771818 -1.823470 -1.901835 -1.963547 -2.006062 -2.017280 -1.993011 -1.987532 -1.930979 -1.785934 -1.332105 -0.9482303 -1.064529 -1.168932 -1.259993 -1.354499 -1.469401 -1.574765 -1.667763 -1.739771 -1.781893 -1.839107 -1.915379 -1.973411 -2.011565 -2.017034 -1.990263 -1.982727 -1.924238 -1.778532 -1.332105 -0.9889727 -1.093430 -1.197181 -1.291241 -1.387296 -1.498288 -1.600361 -1.687423 -1.750976 -1.798555 -1.855307 -1.929785 -1.982112 -2.015799 -2.014829 -1.987653 -1.977658 -1.917143 -1.770865 -1.332105 -1.034697 -1.137005 -1.238449 -1.331595 -1.425744 -1.531593 -1.626526 -1.705178 -1.767299 -1.817336 -1.875133 -1.941777 -1.990897 -2.018498 -2.011884 -1.984952 -1.972249 -1.909670 -1.762924 -1.332105 -1.093000 -1.192818 -1.288921 -1.378773 -1.469152 -1.566342 -1.652429 -1.725261 -1.788735 -1.839498 -1.893339 -1.954458 -1.998757 -2.019535 -2.009605 -1.982123 -1.966343 -1.901800 -1.754753 -1.332105 -1.166501 -1.257124 -1.346147 -1.431417 -1.514736 -1.602206 -1.680025 -1.751325 -1.812360 -1.863092 -1.912356 -1.967191 -2.005070 -2.018909 -2.007721 -1.979057 -1.960148 -1.892683 -1.746379 -1.332105 -1.246078 -1.328315 -1.409509 -1.487401 -1.561966 -1.640507 -1.714002 -1.780610 -1.839771 -1.885213 -1.929602 -1.978617 -2.009537 -2.018391 -2.006019 -1.975705 -1.953540 -1.883895 -1.737802 -1.332105 -1.335529 -1.406020 -1.478057 -1.546480 -1.613086 -1.685273 -1.752378 -1.814074 -1.867177 -1.908339 -1.947286 -1.988220 -2.012145 -2.018545 -2.004423 -1.972087 -1.946537 -1.874631 -1.729412 -1.332105 -1.431616 -1.490350 -1.551868 -1.611735 -1.670455 -1.734985 -1.795597 -1.849140 -1.896078 -1.932603 -1.964354 -1.996491 -2.015048 -2.019036 -2.002816 -1.968015 -1.939192 -1.864737 -1.720420 -1.332105 -1.535104 -1.582833 -1.633357 -1.683002 -1.734026 -1.789219 -1.841004 -1.887027 -1.926908 -1.956935 -1.980681 -2.004727 -2.018764 -2.019849 -2.001251 -1.963710 -1.931529 -1.854426 -1.711778 -1.332105 -1.647525 -1.682662 -1.721823 -1.762160 -1.803038 -1.847608 -1.890039 -1.927922 -1.959009 -1.981006 -1.997800 -2.014954 -2.023539 -2.021080 -1.999797 -1.959311 -1.923512 -1.843809 -1.703107 -1.332105 -1.769786 -1.792037 -1.819186 -1.848616 -1.878340 -1.911579 -1.943472 -1.971195 -1.992535 -2.007193 -2.017656 -2.027723 -2.029939 -2.023344 -1.998829 -1.955166 -1.915287 -1.833049 -1.693482 -1.332105 -1.903281 -1.912398 -1.926993 -1.943916 -1.961288 -1.981269 -2.001097 -2.018999 -2.031085 -2.037859 -2.041355 -2.043921 -2.039147 -2.027472 -1.999094 -1.951742 -1.906508 -1.822513 -1.683751 -1.332105 -2.052717 -2.047411 -2.046071 -2.048140 -2.052216 -2.060309 -2.068394 -2.075935 -2.077694 -2.075521 -2.070937 -2.065726 -2.053054 -2.035239 -2.001897 -1.948780 -1.898504 -1.813117 -1.674120 -1.332105 -2.220525 -2.198235 -2.182669 -2.171186 -2.161744 -2.156781 -2.151694 -2.147634 -2.137701 -2.125316 -2.111230 -2.097058 -2.075425 -2.049594 -2.009439 -1.948187 -1.892603 -1.805193 -1.664986 -1.332105 -2.434175 -2.392610 -2.358329 -2.329293 -2.303814 -2.284043 -2.264148 -2.246669 -2.223050 -2.197884 -2.171776 -2.146417 -2.112153 -2.075730 -2.030241 -1.963656 -1.891592 -1.799487 -1.657270 -1.332105 -2.748213 -2.680414 -2.621773 -2.568764 -2.520013 -2.479640 -2.439935 -2.403830 -2.361131 -2.317076 -2.270891 -2.229589 -2.181499 -2.132186 -2.076854 -2.000133 -1.903880 -1.801895 -1.653049 -1.332105 -3.317859 -3.211278 -3.115999 -3.026392 -2.940563 -2.853950 -2.786190 -2.722737 -2.659650 -2.593641 -2.519865 -2.440539 -2.363282 -2.286604 -2.201597 -2.101235 -1.975348 -1.832060 -1.661654 -1.332105 -6.924547 -6.725896 -6.514347 -6.290972 -6.055847 -5.809285 -5.551589 -5.283147 -5.004237 -4.715214 -4.416409 -4.108054 -3.790533 -3.464062 -3.128941 -2.785440 -2.433744 -2.074167 -1.707116 -1.332105 -0.7512295 -0.9321911 -1.104895 -1.259977 -1.374323 -1.482612 -1.630209 -1.766373 -1.888366 -1.985951 -2.028993 -2.130348 -2.226268 -2.302321 -2.348983 -2.330663 -2.345201 -2.301037 -2.143896 -1.613434 -0.7209949 -0.9098810 -1.091841 -1.247832 -1.358067 -1.481167 -1.637733 -1.779804 -1.904532 -1.999241 -2.035598 -2.142508 -2.238709 -2.313765 -2.355603 -2.328398 -2.341470 -2.294506 -2.135070 -1.613434 -0.7306315 -0.9165807 -1.094027 -1.242931 -1.366664 -1.503626 -1.660015 -1.800084 -1.921800 -2.006935 -2.053639 -2.161129 -2.253746 -2.324879 -2.359752 -2.327557 -2.337789 -2.287539 -2.125801 -1.613434 -0.7655928 -0.9394375 -1.107388 -1.260507 -1.400922 -1.538865 -1.688932 -1.824785 -1.937376 -2.016681 -2.077766 -2.181991 -2.269970 -2.334694 -2.361418 -2.327497 -2.333852 -2.280088 -2.116048 -1.613434 -0.8185676 -0.9771537 -1.142697 -1.303253 -1.443806 -1.579656 -1.722901 -1.849564 -1.951327 -2.036428 -2.105765 -2.203806 -2.285521 -2.342792 -2.360143 -2.328430 -2.329554 -2.271592 -2.106167 -1.613434 -0.8885503 -1.038439 -1.200382 -1.357376 -1.495079 -1.626552 -1.759347 -1.874244 -1.973015 -2.061179 -2.133719 -2.225022 -2.299950 -2.348933 -2.358471 -2.328588 -2.324762 -2.262856 -2.095989 -1.613434 -0.9798228 -1.121479 -1.272771 -1.418938 -1.553206 -1.677432 -1.796841 -1.904481 -2.002355 -2.089527 -2.160860 -2.244806 -2.312065 -2.352575 -2.357959 -2.328479 -2.320065 -2.253185 -2.085518 -1.613434 -1.088950 -1.217308 -1.353467 -1.490022 -1.615786 -1.729618 -1.839337 -1.942533 -2.037174 -2.119653 -2.187443 -2.263059 -2.321796 -2.353925 -2.358561 -2.327712 -2.313722 -2.242965 -2.074744 -1.613434 -1.206508 -1.322859 -1.446088 -1.568262 -1.681656 -1.786885 -1.889753 -1.986276 -2.074517 -2.151095 -2.213430 -2.279552 -2.329192 -2.355736 -2.358533 -2.326114 -2.306590 -2.231938 -2.063629 -1.613434 -1.337612 -1.439171 -1.545553 -1.653354 -1.755144 -1.852011 -1.946344 -2.033930 -2.113472 -2.183522 -2.239125 -2.294831 -2.335355 -2.358216 -2.358005 -2.324412 -2.299214 -2.220062 -2.052176 -1.613434 -1.480415 -1.562854 -1.652741 -1.747486 -1.837829 -1.924019 -2.007629 -2.084397 -2.154414 -2.216259 -2.264433 -2.309349 -2.342334 -2.360286 -2.356658 -2.320336 -2.290179 -2.207320 -2.040382 -1.613434 -1.632807 -1.696612 -1.771256 -1.851675 -1.928591 -2.001226 -2.072862 -2.138704 -2.197289 -2.249599 -2.289351 -2.324895 -2.350287 -2.362253 -2.355084 -2.315166 -2.280576 -2.193519 -2.028248 -1.613434 -1.799710 -1.844944 -1.901473 -1.964224 -2.026004 -2.084871 -2.143492 -2.196682 -2.242807 -2.284250 -2.315120 -2.341970 -2.358968 -2.364307 -2.352033 -2.309743 -2.269706 -2.178767 -2.015768 -1.613434 -1.980123 -2.004756 -2.041147 -2.087305 -2.132942 -2.176345 -2.220845 -2.260046 -2.292395 -2.321438 -2.343182 -2.360932 -2.369078 -2.367230 -2.349465 -2.303146 -2.258142 -2.163614 -2.003002 -1.613434 -2.178228 -2.181777 -2.197788 -2.224699 -2.252631 -2.279142 -2.307266 -2.330207 -2.348211 -2.364545 -2.375740 -2.383564 -2.382254 -2.372099 -2.347586 -2.296222 -2.245731 -2.148746 -1.990054 -1.613434 -2.403740 -2.385828 -2.378918 -2.382907 -2.389642 -2.396566 -2.407821 -2.414632 -2.417310 -2.418337 -2.416954 -2.413166 -2.401675 -2.381454 -2.348751 -2.290476 -2.233938 -2.135109 -1.977245 -1.613434 -2.673394 -2.627672 -2.594048 -2.576248 -2.561287 -2.547026 -2.538673 -2.526019 -2.510776 -2.493213 -2.476948 -2.459183 -2.434649 -2.401548 -2.357412 -2.295210 -2.225656 -2.124324 -1.965379 -1.613434 -3.051145 -2.968641 -2.900147 -2.853000 -2.810448 -2.769060 -2.735927 -2.699472 -2.660737 -2.618606 -2.580930 -2.541438 -2.496908 -2.447043 -2.389916 -2.316752 -2.228730 -2.120508 -1.956826 -1.613434 -3.740639 -3.603869 -3.475500 -3.374111 -3.280218 -3.191014 -3.121505 -3.052993 -2.980111 -2.903732 -2.826627 -2.749121 -2.674239 -2.591034 -2.498879 -2.399818 -2.273461 -2.141919 -1.960700 -1.613434 -9.740750 -9.472783 -9.182953 -8.872050 -8.540804 -8.190005 -7.820441 -7.432890 -7.028074 -6.606737 -6.169502 -5.717065 -5.249949 -4.768794 -4.274045 -3.766279 -3.245886 -2.713362 -2.169075 -1.613434 -0.6272361 -0.8253571 -1.046900 -1.253966 -1.431109 -1.535794 -1.712828 -1.881050 -2.038479 -2.176726 -2.260818 -2.338248 -2.462534 -2.563766 -2.638154 -2.640966 -2.655130 -2.623799 -2.455916 -1.860027 -0.5355403 -0.7566442 -0.9899792 -1.209260 -1.391998 -1.509737 -1.702138 -1.881864 -2.049536 -2.192650 -2.264186 -2.354062 -2.480147 -2.581119 -2.651464 -2.641064 -2.653613 -2.617974 -2.445991 -1.860027 -0.5138902 -0.7398194 -0.9732141 -1.188816 -1.369030 -1.524851 -1.716757 -1.899881 -2.068347 -2.204414 -2.275173 -2.380400 -2.502774 -2.599518 -2.661876 -2.641886 -2.652777 -2.611574 -2.435460 -1.860027 -0.5336677 -0.7569983 -0.9836731 -1.192193 -1.384677 -1.552801 -1.746158 -1.927647 -2.090333 -2.213072 -2.302608 -2.413105 -2.528103 -2.617046 -2.669787 -2.644466 -2.652890 -2.604602 -2.424283 -1.860027 -0.5854717 -0.7982758 -1.017721 -1.228436 -1.420925 -1.598075 -1.786424 -1.962556 -2.111468 -2.233724 -2.335153 -2.445633 -2.552793 -2.633213 -2.674394 -2.648312 -2.651697 -2.596879 -2.412407 -1.860027 -0.6617835 -0.8640993 -1.078401 -1.283144 -1.476802 -1.655512 -1.837719 -1.998119 -2.138150 -2.263466 -2.369956 -2.475961 -2.575041 -2.647636 -2.676055 -2.652840 -2.649770 -2.588268 -2.399809 -1.860027 -0.7645683 -0.9538200 -1.157336 -1.357377 -1.547425 -1.723936 -1.889219 -2.039400 -2.175476 -2.298313 -2.403897 -2.504118 -2.595088 -2.658866 -2.679308 -2.657178 -2.646807 -2.578676 -2.386737 -1.860027 -0.8885681 -1.064621 -1.257467 -1.448748 -1.630348 -1.791792 -1.946605 -2.089263 -2.217959 -2.335361 -2.437495 -2.530467 -2.612768 -2.666266 -2.683555 -2.661055 -2.643174 -2.567989 -2.373648 -1.860027 -1.035682 -1.196501 -1.375587 -1.551968 -1.714740 -1.867512 -2.010972 -2.142752 -2.263122 -2.374254 -2.470982 -2.555706 -2.628319 -2.672953 -2.687358 -2.662257 -2.637642 -2.555997 -2.360391 -1.860027 -1.202517 -1.346230 -1.502423 -1.660319 -1.810808 -1.949647 -2.078921 -2.200024 -2.311471 -2.414360 -2.503888 -2.580180 -2.641961 -2.679938 -2.689975 -2.661429 -2.629919 -2.542711 -2.346691 -1.860027 -1.382291 -1.502544 -1.639763 -1.780002 -1.912278 -2.036237 -2.152550 -2.262003 -2.362830 -2.455458 -2.536403 -2.603362 -2.655652 -2.686579 -2.691117 -2.658661 -2.620332 -2.528059 -2.332512 -1.860027 -1.576374 -1.675156 -1.788274 -1.906144 -2.020487 -2.130529 -2.233167 -2.328756 -2.416460 -2.497805 -2.568278 -2.626040 -2.669463 -2.692366 -2.690113 -2.652959 -2.608697 -2.511818 -2.317822 -1.860027 -1.786856 -1.858853 -1.946450 -2.043823 -2.140453 -2.233723 -2.319567 -2.399295 -2.473464 -2.541783 -2.600582 -2.648532 -2.682641 -2.696653 -2.687558 -2.644456 -2.594864 -2.493963 -2.302648 -1.860027 -2.011821 -2.059303 -2.122460 -2.196841 -2.270923 -2.344065 -2.412653 -2.475526 -2.534328 -2.588471 -2.634324 -2.670393 -2.695177 -2.699949 -2.683180 -2.633893 -2.579092 -2.474826 -2.286982 -1.860027 -2.261447 -2.279576 -2.314626 -2.363844 -2.415421 -2.466663 -2.515082 -2.559398 -2.601674 -2.638525 -2.669966 -2.693387 -2.708244 -2.702961 -2.677949 -2.621899 -2.561479 -2.455378 -2.270902 -1.860027 -2.538136 -2.526924 -2.533543 -2.555520 -2.581760 -2.608546 -2.632927 -2.654135 -2.677422 -2.696321 -2.712699 -2.721108 -2.724229 -2.708052 -2.673632 -2.609811 -2.542149 -2.435700 -2.254545 -1.860027 -2.868711 -2.825334 -2.797003 -2.786264 -2.782328 -2.780037 -2.777850 -2.774015 -2.775715 -2.772742 -2.770896 -2.761079 -2.750142 -2.720782 -2.674412 -2.600479 -2.523926 -2.417460 -2.238422 -1.860027 -3.312195 -3.221410 -3.152369 -3.104894 -3.064831 -3.027134 -2.991003 -2.954459 -2.926632 -2.896375 -2.869734 -2.835654 -2.803685 -2.753932 -2.691668 -2.608986 -2.514392 -2.403970 -2.223815 -1.860027 -4.116922 -3.950233 -3.805997 -3.693757 -3.595819 -3.499032 -3.406039 -3.319403 -3.247301 -3.176005 -3.104015 -3.028538 -2.953603 -2.877151 -2.780349 -2.670437 -2.539172 -2.410315 -2.218435 -1.860027 -12.77138 -12.43298 -12.06073 -11.65612 -11.22064 -10.75584 -10.26325 -9.744214 -9.200136 -8.632277 -8.041727 -7.429603 -6.796912 -6.144513 -5.473290 -4.784029 -4.077417 -3.354144 -2.614829 -1.860027 -0.5135810 -0.7250618 -0.9981058 -1.249504 -1.474563 -1.639745 -1.786042 -1.985965 -2.173758 -2.341905 -2.464576 -2.522820 -2.669298 -2.790770 -2.889804 -2.918084 -2.930488 -2.913054 -2.739835 -2.079525 -0.3620275 -0.6057890 -0.8905214 -1.159881 -1.402117 -1.567499 -1.758345 -1.973473 -2.175134 -2.354405 -2.474048 -2.541526 -2.691896 -2.813446 -2.910648 -2.924078 -2.932458 -2.908873 -2.729233 -2.079525 -0.3007990 -0.5603343 -0.8430850 -1.112954 -1.347566 -1.551045 -1.765939 -1.988857 -2.188556 -2.369915 -2.478370 -2.578334 -2.724782 -2.839528 -2.928571 -2.926117 -2.936939 -2.904216 -2.717852 -2.079525 -0.2983058 -0.5637149 -0.8385916 -1.099074 -1.341872 -1.569670 -1.795385 -2.010414 -2.212518 -2.386436 -2.506683 -2.625323 -2.760268 -2.866128 -2.944162 -2.932450 -2.941075 -2.898874 -2.705637 -2.079525 -0.3403596 -0.6026744 -0.8685445 -1.125929 -1.376319 -1.612497 -1.832877 -2.045551 -2.244799 -2.411391 -2.544521 -2.670380 -2.794611 -2.891417 -2.956379 -2.941939 -2.945181 -2.892577 -2.692517 -2.079525 -0.4193108 -0.6719356 -0.9338303 -1.188460 -1.436667 -1.667008 -1.884163 -2.094686 -2.285491 -2.447824 -2.588547 -2.711038 -2.826529 -2.914660 -2.964233 -2.952899 -2.949285 -2.885062 -2.678418 -2.079525 -0.5317302 -0.7732058 -1.027596 -1.276572 -1.511105 -1.734419 -1.950208 -2.154524 -2.333407 -2.493380 -2.630302 -2.748647 -2.856062 -2.934566 -2.972282 -2.964055 -2.950823 -2.876168 -2.663608 -2.079525 -0.6738467 -0.9002879 -1.145058 -1.376573 -1.600685 -1.819025 -2.028268 -2.218829 -2.387760 -2.541116 -2.671872 -2.784883 -2.883856 -2.950678 -2.982148 -2.972769 -2.950758 -2.865752 -2.648309 -2.079525 -0.8416585 -1.049057 -1.272768 -1.494340 -1.709224 -1.918337 -2.109432 -2.286423 -2.446030 -2.587495 -2.712960 -2.819885 -2.909639 -2.965133 -2.991675 -2.979107 -2.947692 -2.853604 -2.632408 -2.079525 -1.030018 -1.215839 -1.422812 -1.631251 -1.832982 -2.018954 -2.194805 -2.357947 -2.502829 -2.634634 -2.753382 -2.853549 -2.932862 -2.980254 -3.000329 -2.982756 -2.941993 -2.839648 -2.616211 -2.079525 -1.242677 -1.407073 -1.594340 -1.779094 -1.956387 -2.127653 -2.284186 -2.429108 -2.562097 -2.683827 -2.793341 -2.884714 -2.954303 -2.994297 -3.006598 -2.982603 -2.933226 -2.823719 -2.599721 -2.079525 -1.479223 -1.615315 -1.772326 -1.934930 -2.091612 -2.238746 -2.375395 -2.505305 -2.625687 -2.735281 -2.832162 -2.913746 -2.974524 -3.006084 -3.010351 -2.978548 -2.921419 -2.805681 -2.582496 -2.079525 -1.727682 -1.837415 -1.966912 -2.101683 -2.231856 -2.356540 -2.475077 -2.588322 -2.692592 -2.788060 -2.871197 -2.941313 -2.992304 -3.014575 -3.010746 -2.970959 -2.906510 -2.785353 -2.564513 -2.079525 -2.001347 -2.076880 -2.173072 -2.279354 -2.386308 -2.487832 -2.584065 -2.676620 -2.763223 -2.842879 -2.911085 -2.967555 -3.007048 -3.019525 -3.007457 -2.959776 -2.888488 -2.762864 -2.545698 -2.079525 -2.296316 -2.337826 -2.402603 -2.478497 -2.556260 -2.630481 -2.702790 -2.773035 -2.839490 -2.900796 -2.952976 -2.992747 -3.019304 -3.021321 -3.000760 -2.945496 -2.867429 -2.738528 -2.526033 -2.079525 -2.626510 -2.629690 -2.657623 -2.700310 -2.747375 -2.792045 -2.837066 -2.882233 -2.924830 -2.963858 -2.997868 -3.020188 -3.031829 -3.021796 -2.991802 -2.928903 -2.843793 -2.713242 -2.505592 -2.079525 -3.011235 -2.973490 -2.960836 -2.966244 -2.978208 -2.986541 -2.997524 -3.013209 -3.027616 -3.042155 -3.055151 -3.056820 -3.050408 -3.025808 -2.984124 -2.912077 -2.817751 -2.687200 -2.484609 -2.079525 -3.524100 -3.430379 -3.363629 -3.322336 -3.289804 -3.256311 -3.225147 -3.203735 -3.181578 -3.162601 -3.147544 -3.122959 -3.091785 -3.046149 -2.985575 -2.901278 -2.794353 -2.663100 -2.464431 -2.079525 -4.443517 -4.257622 -4.094810 -3.976049 -3.872447 -3.768417 -3.667764 -3.583844 -3.499272 -3.422112 -3.362801 -3.293376 -3.218181 -3.140121 -3.044143 -2.933975 -2.793044 -2.652752 -2.451649 -2.079525 -15.99132 -15.58112 -15.12262 -14.61836 -14.07101 -13.48318 -12.85730 -12.19571 -11.50051 -10.77364 -10.01684 -9.231688 -8.419641 -7.582025 -6.720036 -5.834761 -4.927192 -3.998245 -3.048763 -2.079525 -0.3785884 -0.6425525 -0.9425208 -1.240524 -1.516568 -1.736783 -1.865740 -2.089926 -2.295308 -2.489617 -2.647503 -2.686363 -2.854233 -2.992055 -3.112267 -3.165833 -3.176766 -3.174649 -3.001374 -2.277299 -0.1625015 -0.4500180 -0.7832208 -1.109401 -1.410759 -1.631126 -1.815189 -2.058067 -2.285438 -2.500275 -2.660317 -2.707517 -2.880770 -3.020223 -3.140789 -3.179263 -3.184234 -3.173072 -2.990601 -2.277299 -5.4021146E-02 -0.3717369 -0.7124011 -1.041249 -1.330838 -1.577057 -1.811663 -2.062036 -2.298030 -2.516063 -2.661045 -2.758486 -2.923169 -3.054352 -3.167293 -3.185470 -3.193545 -3.171135 -2.978858 -2.277299 -3.6645200E-02 -0.3621763 -0.6971044 -1.010442 -1.300129 -1.573678 -1.828365 -2.085502 -2.326633 -2.533366 -2.688903 -2.822052 -2.968401 -3.090728 -3.191922 -3.196231 -3.204634 -3.168453 -2.966077 -2.277299 -7.7705808E-02 -0.3998219 -0.7183526 -1.024060 -1.319427 -1.600245 -1.868022 -2.126542 -2.357953 -2.559578 -2.735271 -2.877902 -3.014351 -3.125762 -3.213416 -3.212585 -3.217186 -3.164556 -2.952177 -2.277299 -0.1614562 -0.4691204 -0.7803490 -1.080542 -1.370900 -1.656096 -1.926313 -2.177233 -2.402166 -2.608596 -2.788838 -2.931249 -3.057217 -3.158842 -3.230445 -3.231260 -3.227461 -3.159220 -2.937061 -2.277299 -0.2803877 -0.5750743 -0.8767996 -1.168667 -1.454424 -1.734021 -1.995704 -2.238649 -2.463101 -2.671118 -2.840986 -2.982362 -3.098738 -3.189484 -3.245997 -3.250034 -3.234909 -3.152227 -2.920906 -2.277299 -0.4352374 -0.7131535 -1.002223 -1.284570 -1.561162 -1.825248 -2.074845 -2.315886 -2.537651 -2.729020 -2.895334 -3.029097 -3.138637 -3.216977 -3.264234 -3.266563 -3.239681 -3.143385 -2.904204 -2.277299 -0.6228075 -0.8798081 -1.152773 -1.424118 -1.678674 -1.928566 -2.172541 -2.406517 -2.608640 -2.789396 -2.945033 -3.072582 -3.175109 -3.242519 -3.282906 -3.280791 -3.241272 -3.132353 -2.886837 -2.277299 -0.8361760 -1.071456 -1.323984 -1.571383 -1.812734 -2.051766 -2.285324 -2.492646 -2.681688 -2.847260 -2.991775 -3.113279 -3.207624 -3.267702 -3.299835 -3.290842 -3.239343 -3.119014 -2.868665 -2.277299 -1.076366 -1.281894 -1.511181 -1.741860 -1.968053 -2.186030 -2.390334 -2.582760 -2.753174 -2.903651 -3.037989 -3.151241 -3.236669 -3.290362 -3.313920 -3.296152 -3.233881 -3.103142 -2.849489 -2.277299 -1.339785 -1.518129 -1.724792 -1.933018 -2.129039 -2.319120 -2.502870 -2.670451 -2.823727 -2.962640 -3.084398 -3.186542 -3.263207 -3.309026 -3.323637 -3.296700 -3.224788 -3.084587 -2.830120 -2.277299 -1.633782 -1.779748 -1.950822 -2.127022 -2.298944 -2.459476 -2.614408 -2.761249 -2.899020 -3.024026 -3.131021 -3.220696 -3.286827 -3.322947 -3.328084 -3.292098 -3.211681 -3.062903 -2.809650 -2.277299 -1.946469 -2.056785 -2.193305 -2.336518 -2.473892 -2.605547 -2.736800 -2.861496 -2.978852 -3.086345 -3.177903 -3.252958 -3.306835 -3.331162 -3.326949 -3.282286 -3.194195 -3.038207 -2.787940 -2.277299 -2.292920 -2.358320 -2.453092 -2.561075 -2.668117 -2.769765 -2.871353 -2.970135 -3.064149 -3.151282 -3.224845 -3.283453 -3.322594 -3.334091 -3.319956 -3.266966 -3.171936 -3.010848 -2.764949 -2.277299 -2.674230 -2.696145 -2.747473 -2.813876 -2.883633 -2.951753 -3.021098 -3.091437 -3.158696 -3.221123 -3.273012 -3.312490 -3.335503 -3.333047 -3.307602 -3.246540 -3.144994 -2.980502 -2.740600 -2.277299 -3.113239 -3.084098 -3.087741 -3.109376 -3.138113 -3.167688 -3.199306 -3.233974 -3.269725 -3.301642 -3.328615 -3.346021 -3.350338 -3.331830 -3.292480 -3.222575 -3.113928 -2.948416 -2.714966 -2.277299 -3.688073 -3.593973 -3.537579 -3.501929 -3.477399 -3.457004 -3.439913 -3.429781 -3.427535 -3.420824 -3.414594 -3.401845 -3.381834 -3.341400 -3.282244 -3.199233 -3.081979 -2.916347 -2.688941 -2.277299 -4.691870 -4.495097 -4.341555 -4.212675 -4.101191 -3.998760 -3.901953 -3.815086 -3.748821 -3.677494 -3.609326 -3.547726 -3.485335 -3.407659 -3.312706 -3.206925 -3.065147 -2.893614 -2.668197 -2.277299 -19.38085 -18.89751 -18.34903 -17.73945 -17.07299 -16.35368 -15.58524 -14.77105 -13.91415 -13.01723 -12.08276 -11.11289 -10.10957 -9.074553 -8.009408 -6.915556 -5.794293 -4.646791 -3.474128 -2.277299 -0.2396483 -0.5849411 -0.8959827 -1.230668 -1.544085 -1.816362 -1.946847 -2.196659 -2.417600 -2.627130 -2.810387 -2.836118 -3.021558 -3.174704 -3.312622 -3.389853 -3.399497 -3.412737 -3.244816 -2.457263 5.1046077E-02 -0.3078303 -0.6768048 -1.044088 -1.396655 -1.693889 -1.882200 -2.151069 -2.395646 -2.630426 -2.828934 -2.859800 -3.052538 -3.208871 -3.349261 -3.412018 -3.410770 -3.414597 -3.234473 -2.457263 0.2044615 -0.1815512 -0.5702969 -0.9478368 -1.308763 -1.612036 -1.870001 -2.146318 -2.399686 -2.646981 -2.836996 -2.923009 -3.105655 -3.252553 -3.385309 -3.425182 -3.427528 -3.416440 -3.222960 -2.457263 0.2393775 -0.1451841 -0.5368569 -0.9157650 -1.268554 -1.585060 -1.875803 -2.157674 -2.422530 -2.671220 -2.858650 -2.997995 -3.163072 -3.300346 -3.420077 -3.440614 -3.448097 -3.417600 -3.210196 -2.457263 0.2048017 -0.1753015 -0.5614105 -0.9301530 -1.271835 -1.597613 -1.901508 -2.190495 -2.462081 -2.703790 -2.906586 -3.068130 -3.220702 -3.347662 -3.452062 -3.464618 -3.467658 -3.417563 -3.196090 -2.457263 0.1149653 -0.2548702 -0.6294183 -0.9789250 -1.314892 -1.640570 -1.948958 -2.246272 -2.518698 -2.752533 -2.966907 -3.138036 -3.277871 -3.393516 -3.480314 -3.492694 -3.486420 -3.415862 -3.180523 -2.457263 -1.8427437E-02 -0.3717839 -0.7247841 -1.063906 -1.391679 -1.711262 -2.023453 -2.319371 -2.577093 -2.818106 -3.034827 -3.200837 -3.334611 -3.436439 -3.506296 -3.520369 -3.501764 -3.412349 -3.163582 -2.457263 -0.1872021 -0.5173882 -0.8545641 -1.180084 -1.497476 -1.812767 -2.118892 -2.396256 -2.653491 -2.894296 -3.099987 -3.260392 -3.386069 -3.476366 -3.534834 -3.547021 -3.514270 -3.406701 -3.145998 -2.457263 -0.3888526 -0.6964577 -1.014877 -1.326506 -1.632133 -1.937733 -2.218868 -2.490040 -2.744799 -2.972110 -3.161512 -3.313532 -3.431767 -3.513131 -3.563491 -3.569902 -3.523419 -3.398410 -3.127671 -2.457263 -0.6250978 -0.9055699 -1.204410 -1.499898 -1.787013 -2.063829 -2.336947 -2.600528 -2.840368 -3.043792 -3.220722 -3.361702 -3.472725 -3.547984 -3.589612 -3.587618 -3.528201 -3.387429 -3.108433 -2.457263 -0.8914963 -1.141814 -1.420369 -1.688278 -1.950690 -2.212945 -2.473295 -2.712427 -2.927748 -3.115797 -3.274447 -3.407458 -3.510192 -3.579314 -3.611937 -3.599771 -3.528316 -3.373445 -3.088100 -2.457263 -1.186753 -1.403042 -1.649390 -1.895748 -2.139411 -2.380002 -2.605948 -2.820150 -3.013872 -3.181461 -3.327639 -3.451434 -3.545185 -3.605939 -3.628891 -3.605757 -3.523710 -3.356273 -3.066344 -2.457263 -1.509073 -1.692200 -1.908343 -2.128089 -2.336115 -2.541154 -2.742150 -2.926188 -3.096165 -3.248635 -3.381604 -3.493617 -3.577253 -3.626191 -3.639235 -3.605009 -3.513645 -3.335026 -3.043766 -2.457263 -1.870241 -2.009532 -2.182790 -2.364897 -2.540984 -2.710884 -2.876648 -3.035725 -3.184955 -3.319116 -3.434645 -3.532630 -3.604325 -3.640210 -3.641981 -3.597508 -3.497383 -3.309779 -3.019592 -2.457263 -2.256856 -2.351707 -2.481750 -2.619858 -2.755108 -2.890923 -3.026121 -3.157158 -3.280434 -3.391910 -3.486868 -3.567873 -3.625480 -3.647139 -3.636398 -3.582386 -3.474360 -3.280692 -2.993582 -2.457263 -2.687088 -2.729518 -2.810586 -2.903534 -2.997675 -3.092999 -3.191312 -3.289088 -3.384523 -3.468773 -3.539777 -3.599841 -3.640310 -3.647004 -3.622524 -3.559810 -3.444516 -3.246904 -2.965499 -2.457263 -3.181693 -3.164052 -3.188777 -3.229188 -3.275669 -3.327299 -3.384926 -3.442981 -3.503874 -3.554623 -3.596311 -3.631737 -3.652134 -3.641850 -3.602236 -3.530411 -3.408646 -3.210583 -2.935172 -2.457263 -3.812241 -3.721774 -3.680622 -3.655679 -3.639990 -3.634500 -3.639256 -3.647522 -3.662600 -3.673120 -3.676316 -3.680501 -3.672988 -3.640739 -3.582036 -3.496647 -3.368341 -3.172580 -2.902601 -2.457263 -4.899316 -4.684165 -4.536182 -4.411791 -4.297316 -4.197095 -4.113789 -4.040289 -3.980381 -3.922807 -3.859724 -3.808111 -3.752387 -3.683769 -3.591163 -3.484329 -3.337172 -3.141168 -2.870950 -2.457263 -22.92415 -22.36635 -21.72444 -21.00384 -20.21147 -19.35290 -18.43334 -17.45744 -16.42928 -15.35247 -14.23018 -13.06520 -11.86002 -10.61683 -9.337589 -8.024076 -6.677896 -5.300500 -3.893214 -2.457263 -9.9291906E-02 -0.5229762 -0.8633681 -1.235872 -1.577256 -1.883572 -2.032179 -2.300866 -2.539786 -2.761100 -2.961148 -2.989084 -3.177032 -3.340976 -3.494741 -3.593199 -3.597768 -3.630609 -3.472558 -2.622362 0.2651175 -0.1729960 -0.5822564 -0.9891706 -1.377382 -1.725847 -1.946554 -2.249331 -2.507578 -2.760719 -2.981400 -3.010637 -3.213522 -3.382128 -3.540056 -3.624950 -3.614450 -3.636723 -3.463281 -2.622362 0.4585508 1.7121669E-03 -0.4370138 -0.8570678 -1.260083 -1.622575 -1.937760 -2.237463 -2.509357 -2.773510 -2.994018 -3.087608 -3.276201 -3.437212 -3.586337 -3.647050 -3.639129 -3.643302 -3.452661 -2.622362 0.5165036 6.6139802E-02 -0.3806687 -0.8051081 -1.212294 -1.598074 -1.935086 -2.239749 -2.528283 -2.796309 -3.017702 -3.170512 -3.345961 -3.496977 -3.631638 -3.667559 -3.668507 -3.649367 -3.440579 -2.622362 0.4888918 4.8158906E-02 -0.3920879 -0.8149098 -1.224234 -1.606206 -1.943785 -2.266502 -2.559508 -2.834795 -3.072471 -3.248284 -3.419669 -3.557523 -3.675391 -3.700233 -3.698263 -3.654504 -3.426921 -2.622362 0.3948505 -2.8584741E-02 -0.4589045 -0.8736514 -1.269966 -1.633279 -1.983029 -2.307361 -2.613028 -2.893008 -3.133093 -3.327476 -3.491988 -3.617953 -3.716347 -3.738289 -3.725710 -3.657965 -3.411555 -2.622362 0.2534294 -0.1541010 -0.5684420 -0.9647297 -1.336714 -1.699188 -2.044141 -2.374671 -2.683309 -2.959266 -3.203257 -3.405221 -3.560403 -3.674100 -3.754254 -3.776773 -3.751198 -3.659429 -3.394465 -2.622362 6.8955235E-02 -0.3182404 -0.7075675 -1.078854 -1.440239 -1.792171 -2.136808 -2.465439 -2.766170 -3.035862 -3.281400 -3.475615 -3.624465 -3.726073 -3.793520 -3.813310 -3.773631 -3.658418 -3.376570 -2.622362 -0.1534993 -0.5099769 -0.8739078 -1.228551 -1.573857 -1.918453 -2.255199 -2.570525 -2.858011 -3.126300 -3.362330 -3.540987 -3.680921 -3.773680 -3.832161 -3.845400 -3.791238 -3.654342 -3.357896 -2.622362 -0.4072768 -0.7328725 -1.074577 -1.410079 -1.740625 -2.071022 -2.385249 -2.682792 -2.967275 -3.224490 -3.434101 -3.603744 -3.731078 -3.818226 -3.867829 -3.871716 -3.802982 -3.647030 -3.338184 -2.622362 -0.6976613 -0.9897228 -1.306797 -1.621067 -1.931781 -2.230655 -2.526993 -2.815037 -3.084123 -3.308610 -3.504957 -3.659297 -3.777440 -3.858148 -3.899260 -3.891475 -3.809122 -3.636001 -3.317194 -2.622362 -1.020165 -1.278122 -1.567111 -1.849846 -2.128834 -2.410111 -2.690933 -2.951214 -3.187005 -3.391336 -3.566125 -3.711146 -3.821127 -3.892834 -3.924472 -3.904323 -3.809485 -3.620814 -3.294646 -2.622362 -1.375623 -1.593276 -1.844239 -2.099315 -2.354209 -2.607167 -2.848633 -3.081164 -3.287271 -3.465986 -3.625966 -3.760642 -3.860686 -3.921128 -3.941929 -3.909592 -3.803339 -3.600742 -3.270128 -2.622362 -1.766162 -1.941876 -2.157152 -2.372200 -2.585101 -2.801543 -3.008109 -3.203980 -3.383180 -3.543574 -3.686246 -3.805854 -3.894343 -3.942470 -3.950486 -3.906616 -3.789767 -3.575623 -3.244399 -2.622362 -2.199686 -2.321327 -2.486321 -2.659068 -2.828280 -2.999634 -3.169702 -3.334860 -3.488063 -3.624537 -3.745763 -3.846770 -3.920696 -3.954757 -3.949252 -3.894094 -3.767863 -3.545687 -3.216326 -2.622362 -2.679381 -2.742974 -2.850162 -2.969457 -3.091485 -3.220647 -3.351845 -3.479610 -3.601067 -3.709304 -3.804454 -3.883788 -3.938888 -3.956370 -3.937695 -3.871391 -3.737521 -3.510226 -3.185526 -2.622362 -3.226561 -3.223361 -3.267753 -3.327749 -3.395168 -3.473629 -3.559036 -3.644678 -3.727635 -3.802122 -3.864094 -3.917187 -3.948829 -3.948533 -3.916240 -3.838436 -3.698799 -3.468713 -3.151527 -2.622362 -3.910953 -3.822428 -3.794254 -3.785429 -3.786071 -3.798443 -3.824282 -3.856030 -3.889128 -3.919232 -3.941489 -3.960351 -3.961069 -3.938004 -3.889007 -3.797324 -3.652132 -3.423125 -3.113881 -2.622362 -5.071471 -4.848199 -4.700623 -4.576713 -4.465499 -4.374686 -4.305797 -4.250794 -4.203191 -4.158296 -4.114933 -4.073986 -4.018573 -3.957886 -3.878592 -3.765311 -3.610527 -3.378043 -3.073716 -2.622362 -26.60814 -25.97457 -25.23518 -24.39881 -23.47413 -22.46904 -21.39047 -20.24453 -19.03647 -17.77084 -16.45159 -15.08216 -13.66559 -12.20455 -10.70142 -9.158332 -7.577211 -5.959808 -4.307705 -2.622362 4.3563519E-02 -0.4571555 -0.8403392 -1.253941 -1.629313 -1.956528 -2.153600 -2.392640 -2.651252 -2.891234 -3.102097 -3.161309 -3.320454 -3.495404 -3.661868 -3.777392 -3.778655 -3.831396 -3.685866 -2.774865 0.4834326 -3.2355849E-02 -0.4998104 -0.9585962 -1.374875 -1.756456 -2.014355 -2.331156 -2.619123 -2.886399 -3.125752 -3.168688 -3.364757 -3.543208 -3.716480 -3.819944 -3.801656 -3.842519 -3.678232 -2.774865 0.7134610 0.1823204 -0.3172687 -0.7835261 -1.220196 -1.622341 -1.983648 -2.326667 -2.623771 -2.899858 -3.140796 -3.250309 -3.440343 -3.608966 -3.772927 -3.850956 -3.836640 -3.854949 -3.669069 -2.774865 0.7918636 0.2687730 -0.2344831 -0.7040781 -1.152804 -1.580971 -1.980228 -2.331749 -2.634807 -2.925899 -3.162973 -3.342783 -3.522703 -3.682378 -3.829616 -3.878443 -3.875631 -3.867250 -3.658261 -2.774865 0.7689662 0.2658053 -0.2299758 -0.7015952 -1.153480 -1.591140 -1.993276 -2.342602 -2.665347 -2.960049 -3.221957 -3.428673 -3.607161 -3.758456 -3.886964 -3.922303 -3.915453 -3.879038 -3.645637 -2.774865 0.6743246 0.1913934 -0.2907774 -0.7532738 -1.202934 -1.631544 -2.019195 -2.376813 -2.709449 -3.016235 -3.292130 -3.509547 -3.690751 -3.831093 -3.941407 -3.971535 -3.953987 -3.889232 -3.631039 -2.774865 0.5230726 6.3391715E-02 -0.4015608 -0.8505831 -1.285919 -1.691845 -2.074291 -2.436193 -2.773630 -3.090161 -3.363662 -3.590275 -3.773587 -3.900629 -3.991524 -4.021148 -3.990283 -3.897145 -3.614373 -2.774865 0.3263795 -0.1096767 -0.5529362 -0.9815170 -1.388326 -1.781583 -2.159986 -2.519735 -2.862849 -3.175472 -3.443415 -3.673318 -3.846557 -3.965605 -4.041683 -4.067455 -4.022361 -3.902152 -3.596754 -2.774865 8.7447211E-02 -0.3207106 -0.7355154 -1.132909 -1.522717 -1.902876 -2.273491 -2.633305 -2.969038 -3.265742 -3.535429 -3.755685 -3.915580 -4.024732 -4.091244 -4.108819 -4.048882 -3.903738 -3.578309 -2.774865 -0.1896857 -0.5598747 -0.9432873 -1.319975 -1.689496 -2.057940 -2.419321 -2.764253 -3.077164 -3.373232 -3.633311 -3.830602 -3.978303 -4.079029 -4.137576 -4.145055 -4.069054 -3.901524 -3.558727 -2.774865 -0.4993140 -0.8325168 -1.188910 -1.540653 -1.890672 -2.243542 -2.579125 -2.900126 -3.207982 -3.489030 -3.716257 -3.901503 -4.034396 -4.128326 -4.178851 -4.174229 -4.083119 -3.894773 -3.537692 -2.774865 -0.8472975 -1.143877 -1.467764 -1.793133 -2.116557 -2.434987 -2.750039 -3.060053 -3.344784 -3.586340 -3.795106 -3.962163 -4.085894 -4.172534 -4.212817 -4.195873 -4.090284 -3.883047 -3.514873 -2.774865 -1.231247 -1.487678 -1.775807 -2.062927 -2.352147 -2.649901 -2.946087 -3.216783 -3.465788 -3.679806 -3.863285 -4.018061 -4.132795 -4.210347 -4.238664 -4.208726 -4.089949 -3.865788 -3.489916 -2.774865 -1.653185 -1.860050 -2.107897 -2.361343 -2.619008 -2.874702 -3.126397 -3.365025 -3.577457 -3.764233 -3.930917 -4.070084 -4.173472 -4.239789 -4.255249 -4.211662 -4.080668 -3.842427 -3.462479 -2.774865 -2.126408 -2.279951 -2.474384 -2.678776 -2.887578 -3.099774 -3.306981 -3.505441 -3.689371 -3.854040 -3.998607 -4.117774 -4.206320 -4.258457 -4.260694 -4.203119 -4.061197 -3.813194 -3.432870 -2.774865 -2.647477 -2.737942 -2.875571 -3.020991 -3.172548 -3.335836 -3.501583 -3.662045 -3.811301 -3.947018 -4.065471 -4.160567 -4.229113 -4.264354 -4.253016 -4.182213 -4.030755 -3.777203 -3.399966 -2.774865 -3.248047 -3.260699 -3.328937 -3.410428 -3.502174 -3.608963 -3.723698 -3.837861 -3.945438 -4.044157 -4.132231 -4.196302 -4.240273 -4.257228 -4.230989 -4.148037 -3.989221 -3.732876 -3.363064 -2.774865 -3.990931 -3.909287 -3.890090 -3.893641 -3.914671 -3.952631 -4.002109 -4.056975 -4.110296 -4.160117 -4.208298 -4.234219 -4.247700 -4.241542 -4.196701 -4.101512 -3.935467 -3.682360 -3.321528 -2.774865 -5.217290 -4.991740 -4.838763 -4.714069 -4.613087 -4.539089 -4.488829 -4.450880 -4.417175 -4.387923 -4.368379 -4.331231 -4.291515 -4.243045 -4.166642 -4.055826 -3.883714 -3.627576 -3.275534 -2.774865 -30.42189 -29.71124 -28.87115 -27.91376 -26.85065 -25.69224 -24.44742 -23.12380 -21.72793 -20.26534 -18.74079 -17.15842 -15.52183 -13.83416 -12.09826 -10.31662 -8.491511 -6.624970 -4.718852 -2.774865 0.1927742 -0.3794934 -0.8164945 -1.274450 -1.680231 -2.041491 -2.276647 -2.484506 -2.753630 -3.009340 -3.236267 -3.324764 -3.455116 -3.639609 -3.816571 -3.946574 -3.945144 -4.015577 -3.886308 -2.916559 0.7106479 0.1061764 -0.4227083 -0.9291900 -1.392320 -1.807638 -2.087578 -2.406351 -2.714604 -3.008410 -3.261588 -3.324531 -3.506625 -3.695453 -3.880196 -3.999517 -3.975854 -4.032032 -3.880908 -2.916559 0.9683721 0.3658229 -0.2022557 -0.7268714 -1.209202 -1.634594 -2.023453 -2.391378 -2.729018 -3.027984 -3.282530 -3.408782 -3.597168 -3.773392 -3.948817 -4.040746 -4.021122 -4.050800 -3.873848 -2.916559 1.066859 0.4710190 -9.6365385E-02 -0.6237128 -1.105789 -1.566293 -2.000863 -2.402751 -2.750587 -3.051917 -3.310961 -3.506176 -3.696425 -3.860340 -4.018987 -4.076440 -4.071865 -4.070179 -3.864978 -2.916559 1.048936 0.4778214 -7.7955276E-02 -0.5966769 -1.088940 -1.562931 -2.014839 -2.425371 -2.772365 -3.090896 -3.366659 -3.596927 -3.790298 -3.948971 -4.089887 -4.130652 -4.123545 -4.089236 -3.854060 -2.916559 0.9525121 0.4059384 -0.1285537 -0.6395382 -1.130704 -1.605707 -2.056236 -2.452869 -2.811319 -3.141702 -3.437293 -3.687218 -3.880767 -4.036990 -4.157342 -4.190505 -4.174060 -4.106777 -3.840891 -2.916559 0.7928673 0.2762651 -0.2392626 -0.7338589 -1.215854 -1.682338 -2.111555 -2.502037 -2.872746 -3.210840 -3.517746 -3.767827 -3.970540 -4.119053 -4.220306 -4.250651 -4.221207 -4.122020 -3.825326 -2.916559 0.5821018 9.4934732E-02 -0.3942912 -0.8696437 -1.335759 -1.776830 -2.187499 -2.584248 -2.951928 -3.300689 -3.604325 -3.854941 -4.059382 -4.196410 -4.282599 -4.308485 -4.263238 -4.134152 -3.808629 -2.916559 0.3270803 -0.1262806 -0.5880693 -1.040763 -1.475831 -1.894982 -2.299659 -2.687933 -3.061267 -3.405242 -3.697637 -3.949718 -4.139765 -4.268932 -4.343636 -4.361801 -4.299491 -4.142611 -3.791099 -2.916559 3.1426992E-02 -0.3838832 -0.8146298 -1.232433 -1.644194 -2.048012 -2.441575 -2.827576 -3.189287 -3.511666 -3.804895 -4.043871 -4.217482 -4.334196 -4.400494 -4.409086 -4.329042 -4.146529 -3.772324 -2.916559 -0.3019097 -0.6753643 -1.070148 -1.460130 -1.847769 -2.236992 -2.618826 -2.984966 -3.320961 -3.639192 -3.915752 -4.127451 -4.286991 -4.393605 -4.451390 -4.447918 -4.351637 -4.145023 -3.751863 -2.916559 -0.6702303 -1.004992 -1.365434 -1.724327 -2.088480 -2.459492 -2.807341 -3.150210 -3.477446 -3.771347 -4.009316 -4.203132 -4.347657 -4.447581 -4.494662 -4.478168 -4.366811 -4.137647 -3.729332 -2.916559 -1.081870 -1.371522 -1.695939 -2.023679 -2.349334 -2.681920 -3.013766 -3.340819 -3.629918 -3.885049 -4.095920 -4.268120 -4.403512 -4.493997 -4.529435 -4.498868 -4.373115 -4.123944 -3.704333 -2.916559 -1.533842 -1.774104 -2.053359 -2.337509 -2.630798 -2.937292 -3.231972 -3.511314 -3.766348 -3.985467 -4.171845 -4.329254 -4.453032 -4.530888 -4.553789 -4.508828 -4.368670 -4.103022 -3.676243 -2.916559 -2.036337 -2.219381 -2.450807 -2.689040 -2.932330 -3.187782 -3.438864 -3.673102 -3.886605 -4.080995 -4.247515 -4.385845 -4.493976 -4.556777 -4.565316 -4.506002 -4.352237 -4.075111 -3.645093 -2.916559 -2.603383 -2.716850 -2.883699 -3.060844 -3.247174 -3.444570 -3.645196 -3.838421 -4.017145 -4.179853 -4.321880 -4.435657 -4.523884 -4.569610 -4.561056 -4.488368 -4.322999 -4.039145 -3.610225 -2.916559 -3.253727 -3.283406 -3.371611 -3.477519 -3.600353 -3.737324 -3.881787 -4.025780 -4.159452 -4.282340 -4.393657 -4.476450 -4.539866 -4.566651 -4.539552 -4.454317 -4.280580 -3.993287 -3.570496 -2.916559 -4.052089 -3.980827 -3.973112 -3.991922 -4.034727 -4.097801 -4.174541 -4.255047 -4.329001 -4.399737 -4.468454 -4.513222 -4.545665 -4.549510 -4.501610 -4.403636 -4.223009 -3.938237 -3.524818 -2.916559 -5.346406 -5.114060 -4.958988 -4.838586 -4.751560 -4.697198 -4.667211 -4.647934 -4.630498 -4.617279 -4.612930 -4.597709 -4.577195 -4.539707 -4.459557 -4.345662 -4.160724 -3.876491 -3.472292 -2.916559 -34.35604 -33.56700 -32.62283 -31.53955 -30.33235 -29.01426 -27.59641 -26.08807 -24.49710 -22.83006 -21.09257 -19.28945 -17.42491 -15.50261 -13.52582 -11.49745 -9.420085 -7.296094 -5.127599 -2.916559 0.3368707 -0.2950633 -0.7744524 -1.286835 -1.733855 -2.119224 -2.399052 -2.582688 -2.855471 -3.120022 -3.360190 -3.479055 -3.582465 -3.773886 -3.959235 -4.103941 -4.098377 -4.185439 -4.074458 -3.048875 0.9393541 0.2663690 -0.3331287 -0.9053379 -1.407487 -1.863109 -2.182523 -2.489813 -2.806249 -3.117405 -3.392565 -3.475344 -3.642417 -3.838002 -4.031834 -4.168275 -4.136723 -4.207468 -4.071884 -3.048875 1.233388 0.5530223 -9.0406775E-02 -0.6712189 -1.200750 -1.679263 -2.078205 -2.460010 -2.817139 -3.149410 -3.422709 -3.564931 -3.749463 -3.931265 -4.112437 -4.220244 -4.192735 -4.233112 -4.067566 -3.048875 1.341236 0.6712297 3.9880350E-02 -0.5439078 -1.084478 -1.570612 -2.025767 -2.457216 -2.848853 -3.187422 -3.455400 -3.665470 -3.861794 -4.032022 -4.196716 -4.265140 -4.255972 -4.260322 -4.061225 -3.048875 1.327873 0.6872489 7.1386337E-02 -0.5053536 -1.037723 -1.541505 -2.024797 -2.481543 -2.885776 -3.221711 -3.517287 -3.758437 -3.968988 -4.132192 -4.281912 -4.328747 -4.320695 -4.287358 -4.052582 -3.048875 1.228355 0.6172951 2.5850749E-02 -0.5339763 -1.064382 -1.575172 -2.066745 -2.527949 -2.920455 -3.271310 -3.583535 -3.850798 -4.067377 -4.230943 -4.362454 -4.400382 -4.382574 -4.313004 -4.041450 -3.048875 1.061117 0.4843520 -8.1877835E-02 -0.6223888 -1.146251 -1.652120 -2.141505 -2.578949 -2.971517 -3.338526 -3.664050 -3.943240 -4.162657 -4.327992 -4.440100 -4.472582 -4.440184 -4.336215 -4.027560 -3.048875 0.8365983 0.2958727 -0.2407148 -0.7598446 -1.268485 -1.763756 -2.226021 -2.647116 -3.052972 -3.421291 -3.757656 -4.034387 -4.259123 -4.418578 -4.516201 -4.541758 -4.491906 -4.356220 -4.012177 -3.048875 0.5647271 6.2858768E-02 -0.4424109 -0.9365922 -1.425553 -1.892064 -2.329556 -2.753901 -3.150685 -3.528551 -3.860259 -4.133620 -4.357164 -4.502832 -4.588022 -4.605324 -4.537714 -4.371964 -3.996012 -3.048875 0.2520625 -0.2074154 -0.6805919 -1.148689 -1.602206 -2.042986 -2.470757 -2.885241 -3.284270 -3.650064 -3.968415 -4.241835 -4.447067 -4.581158 -4.653733 -4.661223 -4.577436 -4.382720 -3.978362 -3.048875 -9.9239968E-02 -0.5177975 -0.9545534 -1.382529 -1.810378 -2.230503 -2.647312 -3.055891 -3.435764 -3.780326 -4.093616 -4.346067 -4.531408 -4.650501 -4.713693 -4.708984 -4.609138 -4.387516 -3.958760 -3.048875 -0.4908584 -0.8628815 -1.261633 -1.655596 -2.055679 -2.458874 -2.861824 -3.239060 -3.597335 -3.933382 -4.215553 -4.438527 -4.604651 -4.712870 -4.766094 -4.748610 -4.632143 -4.386052 -3.936874 -3.048875 -0.9252731 -1.250880 -1.610037 -1.969336 -2.340405 -2.712381 -3.077906 -3.439206 -3.782292 -4.076324 -4.321990 -4.518636 -4.670894 -4.767942 -4.809616 -4.778143 -4.645293 -4.377456 -3.912235 -3.048875 -1.407779 -1.680501 -1.995225 -2.312159 -2.638970 -2.979185 -3.325426 -3.649573 -3.941264 -4.200477 -4.409867 -4.588530 -4.730488 -4.814249 -4.842226 -4.795989 -4.646600 -4.360648 -3.884290 -3.048875 -1.940909 -2.153006 -2.412495 -2.685816 -2.973779 -3.265731 -3.560270 -3.836786 -4.082990 -4.304310 -4.493578 -4.654955 -4.780628 -4.849805 -4.861348 -4.799801 -4.634747 -4.335473 -3.852248 -3.048875 -2.552383 -2.688472 -2.878983 -3.088895 -3.314722 -3.551496 -3.786257 -4.011078 -4.220716 -4.411170 -4.576339 -4.714636 -4.819335 -4.870477 -4.863739 -4.787403 -4.608268 -4.300484 -3.816092 -3.048875 -3.245016 -3.296066 -3.403724 -3.533989 -3.689738 -3.860877 -4.036705 -4.209224 -4.371847 -4.521120 -4.653820 -4.764001 -4.842366 -4.871615 -4.846646 -4.756496 -4.566092 -4.253918 -3.774221 -3.048875 -4.101095 -4.036143 -4.043875 -4.082864 -4.149368 -4.238105 -4.340521 -4.446332 -4.547482 -4.642670 -4.729584 -4.802812 -4.849466 -4.852637 -4.808502 -4.705064 -4.505703 -4.193959 -3.725241 -3.048875 -5.460030 -5.221516 -5.065348 -4.955572 -4.883615 -4.848857 -4.836699 -4.834509 -4.838810 -4.849603 -4.862995 -4.875131 -4.870581 -4.833110 -4.758389 -4.637686 -4.432740 -4.123553 -3.667573 -3.048875 -38.40252 -37.53382 -36.48221 -35.26851 -33.91172 -32.42805 -30.83084 -29.13124 -27.33840 -25.45997 -23.50245 -21.47139 -19.37159 -17.20727 -14.98213 -12.69948 -10.36229 -7.973217 -5.534679 -3.048875 0.4711879 -0.2183486 -0.7619169 -1.278857 -1.769281 -2.195310 -2.509012 -2.681133 -2.959456 -3.228167 -3.475166 -3.624110 -3.702666 -3.901764 -4.092861 -4.248788 -4.241059 -4.342337 -4.250588 -3.172978 1.161575 0.4255145 -0.2259441 -0.8493670 -1.425110 -1.913207 -2.271900 -2.591870 -2.903090 -3.221060 -3.511400 -3.624382 -3.774894 -3.975064 -4.174620 -4.325193 -4.286501 -4.370316 -4.251215 -3.172978 1.493942 0.7495765 4.5327857E-02 -0.6179577 -1.194806 -1.712639 -2.160956 -2.544039 -2.907687 -3.254858 -3.556212 -3.717219 -3.900656 -4.083342 -4.266849 -4.388412 -4.355129 -4.403366 -4.249909 -3.172978 1.617472 0.8786821 0.1744004 -0.4684173 -1.057934 -1.598281 -2.072240 -2.516112 -2.931878 -3.307868 -3.601555 -3.824596 -4.024368 -4.200623 -4.362914 -4.443686 -4.431808 -4.438745 -4.246447 -3.172978 1.606002 0.8917193 0.2182205 -0.4118090 -1.002078 -1.539951 -2.041933 -2.526515 -2.975046 -3.358079 -3.661702 -3.922178 -4.140057 -4.312664 -4.460844 -4.518041 -4.508835 -4.474390 -4.240557 -3.172978 1.502064 0.8270561 0.1767562 -0.4351356 -1.009885 -1.550733 -2.073822 -2.573305 -3.028696 -3.403144 -3.733774 -4.013399 -4.249105 -4.422059 -4.558025 -4.603218 -4.582573 -4.508540 -4.231976 -3.172978 1.326147 0.6906419 7.0751123E-02 -0.5161762 -1.080583 -1.622333 -2.146994 -2.647283 -3.079423 -3.465696 -3.811465 -4.110718 -4.352794 -4.528121 -4.649002 -4.688128 -4.650771 -4.540327 -4.220441 -3.172978 1.088924 0.4943539 -9.0738922E-02 -0.6536263 -1.202439 -1.734745 -2.253587 -2.722277 -3.147688 -3.549185 -3.904649 -4.214917 -4.453429 -4.630670 -4.736939 -4.767960 -4.713549 -4.568782 -4.207275 -3.172978 0.8010423 0.2499951 -0.2987831 -0.8357841 -1.363696 -1.880683 -2.368300 -2.817116 -3.250411 -3.649285 -4.014724 -4.316416 -4.558646 -4.726513 -4.820338 -4.840281 -4.770171 -4.592692 -4.193273 -3.172978 0.4710413 -3.2511681E-02 -0.5472008 -1.055827 -1.560260 -2.042225 -2.504772 -2.951097 -3.376600 -3.779238 -4.131477 -4.430354 -4.667950 -4.815494 -4.896393 -4.905196 -4.819230 -4.611269 -4.177813 -3.172978 0.1023926 -0.3589999 -0.8366297 -1.310088 -1.774161 -2.231712 -2.679022 -3.118265 -3.540905 -3.922297 -4.261008 -4.554713 -4.763077 -4.896036 -4.966033 -4.962359 -4.859643 -4.623445 -4.160331 -3.172978 -0.3125764 -0.7239971 -1.158052 -1.589585 -2.024873 -2.460048 -2.896895 -3.325207 -3.714917 -4.079664 -4.407103 -4.665636 -4.853497 -4.968102 -5.028531 -5.011194 -4.891040 -4.628444 -4.140196 -3.172978 -0.7694855 -1.128958 -1.520312 -1.915277 -2.319615 -2.734091 -3.142793 -3.533232 -3.910025 -4.258438 -4.536093 -4.766459 -4.930347 -5.034008 -5.082541 -5.049697 -4.912169 -4.625288 -4.116873 -3.172978 -1.279537 -1.582899 -1.926390 -2.282940 -2.647380 -3.020423 -3.399773 -3.772595 -4.108832 -4.402903 -4.648412 -4.848737 -4.998173 -5.090992 -5.124726 -5.076659 -4.920216 -4.612644 -4.089627 -3.172978 -1.843368 -2.083525 -2.370804 -2.674360 -2.998256 -3.341962 -3.673160 -3.988835 -4.276468 -4.525586 -4.742130 -4.925021 -5.057074 -5.136133 -5.152325 -5.089451 -4.913420 -4.590097 -4.057606 -3.172978 -2.483068 -2.650967 -2.871277 -3.109249 -3.373150 -3.653301 -3.925568 -4.182142 -4.422788 -4.640872 -4.832414 -4.991087 -5.104067 -5.165128 -5.162357 -5.083486 -4.890526 -4.556082 -4.020707 -3.172978 -3.223378 -3.294356 -3.428225 -3.586134 -3.772783 -3.977828 -4.185496 -4.389216 -4.582500 -4.759820 -4.917142 -5.045519 -5.133026 -5.172012 -5.150989 -5.055099 -4.850419 -4.508791 -3.977402 -3.172978 -4.136347 -4.083882 -4.104643 -4.166019 -4.259502 -4.374918 -4.502697 -4.634696 -4.766997 -4.889718 -4.999266 -5.087585 -5.141893 -5.154593 -5.114410 -5.001746 -4.789629 -4.445659 -3.925934 -3.172978 -5.560581 -5.317094 -5.167201 -5.067751 -5.015368 -4.996083 -5.002248 -5.021479 -5.055187 -5.092019 -5.128958 -5.155863 -5.157367 -5.128912 -5.058296 -4.926327 -4.710220 -4.370280 -3.863665 -3.172978 -42.55429 -41.60466 -40.44265 -39.09381 -37.58234 -35.92743 -34.14500 -32.24800 -30.24697 -28.15070 -25.96657 -23.70087 -21.35904 -18.94584 -16.46568 -13.92180 -11.31752 -8.656326 -5.940656 -3.172978 0.6008238 -0.1513054 -0.7649910 -1.279790 -1.790672 -2.249815 -2.611693 -2.772864 -3.062461 -3.335006 -3.585145 -3.758980 -3.817511 -4.022967 -4.218681 -4.383366 -4.374901 -4.487114 -4.415102 -3.289828 1.375477 0.5762079 -0.1248677 -0.7780094 -1.396634 -1.962639 -2.356538 -2.688290 -3.010796 -3.325662 -3.621360 -3.767227 -3.903896 -4.106483 -4.311325 -4.471236 -4.429074 -4.520679 -4.419118 -3.289828 1.749774 0.9407381 0.1887173 -0.5201726 -1.183269 -1.748147 -2.229896 -2.653035 -3.008818 -3.360208 -3.674322 -3.869499 -4.049817 -4.230097 -4.416543 -4.544463 -4.510602 -4.561103 -4.421094 -3.289828 1.889313 1.087234 0.3319951 -0.3877641 -1.034232 -1.616242 -2.141265 -2.594921 -3.018152 -3.411869 -3.738903 -3.981666 -4.184860 -4.361083 -4.526367 -4.610414 -4.600692 -4.604678 -4.420801 -3.289828 1.882725 1.102967 0.3655576 -0.3229340 -0.9634181 -1.552553 -2.082942 -2.577204 -3.051180 -3.475941 -3.812340 -4.083000 -4.306613 -4.488919 -4.637302 -4.695107 -4.689795 -4.648949 -4.417986 -3.289828 1.774113 1.031985 0.3261180 -0.3367894 -0.9642158 -1.544011 -2.086889 -2.613739 -3.110471 -3.537576 -3.879705 -4.178504 -4.422448 -4.609940 -4.746000 -4.793358 -4.774627 -4.692207 -4.412321 -3.289828 1.588648 0.8944260 0.2210926 -0.4156857 -1.022950 -1.596861 -2.153438 -2.687778 -3.183788 -3.595481 -3.963088 -4.273729 -4.533741 -4.721502 -4.850798 -4.889560 -4.854530 -4.733587 -4.403373 -3.289828 1.338558 0.6895301 5.6492858E-02 -0.5526794 -1.139081 -1.707427 -2.260671 -2.788396 -3.252591 -3.673983 -4.051870 -4.381936 -4.641251 -4.830794 -4.948945 -4.978564 -4.928093 -4.771524 -4.392532 -3.289828 1.034701 0.4348243 -0.1583468 -0.7392598 -1.303304 -1.857758 -2.397823 -2.889898 -3.348247 -3.774707 -4.163401 -4.498927 -4.749716 -4.940547 -5.043172 -5.062048 -4.994702 -4.804394 -4.380979 -3.289828 0.6871479 0.1392042 -0.4171602 -0.9665363 -1.507035 -2.040263 -2.542734 -3.019033 -3.475601 -3.902290 -4.292724 -4.613422 -4.867899 -5.041234 -5.130153 -5.138921 -5.053257 -4.831420 -4.367823 -3.289828 0.3005283 -0.2028598 -0.7166871 -1.230453 -1.744439 -2.235248 -2.718386 -3.183564 -3.638441 -4.059941 -4.427800 -4.745466 -4.985422 -5.135515 -5.210792 -5.206631 -5.103383 -4.851588 -4.352284 -3.289828 -0.1340686 -0.5832007 -1.056982 -1.527563 -1.998951 -2.467903 -2.931895 -3.393153 -3.836049 -4.224492 -4.585443 -4.883636 -5.087826 -5.218904 -5.283454 -5.266165 -5.143924 -4.863678 -4.333726 -3.289828 -0.6153535 -1.006850 -1.431999 -1.862332 -2.300101 -2.747008 -3.196408 -3.627888 -4.034178 -4.416102 -4.748422 -4.998049 -5.178092 -5.294255 -5.345482 -5.314714 -5.173342 -4.866109 -4.311512 -3.289828 -1.146793 -1.482107 -1.856539 -2.243589 -2.650044 -3.062631 -3.471434 -3.877370 -4.266148 -4.597689 -4.880092 -5.095987 -5.255060 -5.360765 -5.395480 -5.350158 -5.188684 -4.857593 -4.284895 -3.289828 -1.739762 -2.009586 -2.327391 -2.662295 -3.019644 -3.396518 -3.780352 -4.133440 -4.462595 -4.746516 -4.986037 -5.180245 -5.323987 -5.415527 -5.431664 -5.369161 -5.188476 -4.837480 -4.253046 -3.289828 -2.410147 -2.602750 -2.852174 -3.129194 -3.426570 -3.745034 -4.060302 -4.354746 -4.627702 -4.873587 -5.087080 -5.259072 -5.382218 -5.453759 -5.449244 -5.367973 -5.170371 -4.804540 -4.215334 -3.289828 -3.192610 -3.283682 -3.443194 -3.634645 -3.854410 -4.092281 -4.333764 -4.570483 -4.798458 -5.004321 -5.184502 -5.327441 -5.423686 -5.468955 -5.442607 -5.343143 -5.131879 -4.757224 -4.171154 -3.289828 -4.160716 -4.119873 -4.161148 -4.243134 -4.364150 -4.509068 -4.664656 -4.825634 -4.990780 -5.143623 -5.275697 -5.378719 -5.441066 -5.456662 -5.406762 -5.290851 -5.069419 -4.692224 -4.118073 -3.289828 -5.653906 -5.403454 -5.257888 -5.170434 -5.138956 -5.141811 -5.165032 -5.212548 -5.277749 -5.344959 -5.402625 -5.442489 -5.454790 -5.429463 -5.345742 -5.211215 -4.984082 -4.613482 -4.052747 -3.289828 -46.80515 -45.77333 -44.49729 -43.00955 -41.33845 -39.50706 -37.53387 -35.43371 -33.21860 -30.89843 -28.48152 -25.97494 -23.38476 -20.71629 -17.97421 -15.16262 -12.28523 -9.345352 -6.345975 -3.289828 0.7282012 -9.0800665E-02 -0.7738802 -1.310614 -1.822116 -2.294155 -2.693369 -2.859864 -3.158183 -3.440014 -3.692186 -3.885301 -3.926227 -4.136993 -4.337147 -4.511261 -4.499680 -4.622919 -4.571201 -3.400226 1.587991 0.7223548 -5.1857077E-02 -0.7219322 -1.360509 -1.961814 -2.439112 -2.781083 -3.116495 -3.433940 -3.729805 -3.902446 -4.030620 -4.231860 -4.440300 -4.610112 -4.562556 -4.662928 -4.579212 -3.400226 2.002424 1.123880 0.3225873 -0.4210474 -1.125552 -1.775326 -2.298089 -2.745662 -3.128229 -3.469144 -3.786718 -4.012401 -4.194900 -4.371695 -4.560474 -4.695410 -4.657660 -4.711565 -4.585195 -3.400226 2.159054 1.293347 0.4870367 -0.2785740 -0.9994747 -1.636456 -2.196429 -2.696828 -3.117078 -3.515718 -3.862328 -4.136377 -4.341878 -4.518384 -4.685983 -4.773175 -4.760509 -4.763859 -4.588871 -3.400226 2.156096 1.312894 0.5255550 -0.2303683 -0.9261387 -1.559807 -2.139618 -2.649550 -3.130032 -3.577124 -3.952406 -4.239799 -4.473373 -4.658105 -4.808857 -4.870940 -4.861688 -4.817470 -4.589745 -3.400226 2.044493 1.241649 0.4738965 -0.2427914 -0.9174523 -1.546713 -2.120628 -2.659201 -3.181948 -3.653787 -4.033367 -4.336619 -4.589087 -4.789006 -4.927266 -4.979795 -4.958915 -4.870599 -4.587523 -3.400226 1.848725 1.094105 0.3689891 -0.3195812 -0.9726895 -1.585357 -2.164142 -2.726694 -3.263012 -3.728361 -4.107381 -4.436274 -4.704833 -4.907609 -5.042205 -5.087155 -5.049784 -4.921230 -4.581725 -3.400226 1.584680 0.8823125 0.2006879 -0.4578686 -1.083136 -1.684553 -2.268992 -2.833102 -3.356735 -3.799510 -4.203611 -4.542262 -4.821496 -5.022598 -5.155104 -5.188921 -5.133019 -4.967735 -4.573666 -3.400226 1.265532 0.6158502 -2.1388976E-02 -0.6461594 -1.248657 -1.836736 -2.412199 -2.960128 -3.449666 -3.902417 -4.308537 -4.663081 -4.936320 -5.141634 -5.260001 -5.283036 -5.207850 -5.008626 -4.564757 -3.400226 0.9018604 0.3061237 -0.2896637 -0.8802370 -1.457014 -2.026815 -2.581012 -3.089455 -3.577990 -4.025878 -4.443457 -4.791320 -5.060499 -5.258887 -5.359628 -5.367732 -5.273622 -5.043262 -4.554029 -3.400226 0.4975314 -4.6111364E-02 -0.6006916 -1.152916 -1.703526 -2.246784 -2.757169 -3.259226 -3.734828 -4.190016 -4.595791 -4.923747 -5.192176 -5.360910 -5.448623 -5.443921 -5.330896 -5.070055 -4.540652 -3.400226 4.4370074E-02 -0.4420583 -0.9525407 -1.468549 -1.975869 -2.479260 -2.974891 -3.462190 -3.936471 -4.373675 -4.752146 -5.073770 -5.312462 -5.457203 -5.527146 -5.510415 -5.379294 -5.088173 -4.523881 -3.400226 -0.4594932 -0.8856854 -1.346344 -1.811288 -2.282798 -2.760086 -3.241370 -3.718403 -4.158544 -4.569348 -4.935205 -5.214305 -5.421064 -5.541101 -5.596552 -5.565666 -5.416416 -5.096579 -4.503014 -3.400226 -1.013867 -1.378564 -1.784855 -2.205020 -2.643811 -3.097479 -3.544396 -3.981393 -4.403143 -4.790967 -5.096029 -5.336072 -5.509130 -5.615059 -5.654944 -5.608431 -5.438981 -5.093784 -4.477234 -3.400226 -1.634820 -1.932351 -2.278280 -2.650497 -3.041226 -3.449928 -3.867883 -4.278823 -4.640766 -4.967405 -5.228585 -5.435273 -5.588017 -5.677606 -5.699339 -5.634898 -5.444728 -5.078826 -4.445725 -3.400226 -2.336142 -2.550910 -2.826801 -3.137516 -3.480137 -3.833230 -4.187866 -4.527556 -4.834912 -5.108734 -5.340162 -5.524681 -5.656747 -5.724772 -5.724653 -5.640920 -5.430771 -5.049238 -4.407153 -3.400226 -3.158305 -3.265316 -3.451123 -3.676409 -3.935094 -4.207117 -4.480421 -4.753510 -5.015336 -5.249715 -5.445563 -5.599657 -5.705379 -5.747935 -5.724251 -5.621228 -5.394296 -5.002858 -4.361385 -3.400226 -4.172040 -4.142874 -4.205348 -4.315851 -4.466270 -4.640593 -4.825921 -5.023344 -5.218109 -5.398137 -5.546306 -5.656781 -5.727632 -5.740624 -5.691815 -5.570264 -5.331268 -4.935558 -4.305659 -3.400226 -5.727656 -5.479310 -5.345443 -5.273653 -5.261044 -5.285432 -5.337531 -5.419620 -5.511434 -5.601395 -5.672600 -5.718625 -5.741508 -5.711542 -5.630595 -5.486319 -5.242066 -4.852870 -4.236785 -3.400226 -51.14960 -50.03434 -48.64146 -47.01073 -45.17513 -43.16224 -40.99304 -38.68431 -36.24953 -33.69979 -31.04457 -28.29100 -25.44656 -22.51686 -19.50706 -16.42171 -13.26513 -10.04022 -6.751004 -3.400226 0.8545645 -3.6013938E-02 -0.7825503 -1.343528 -1.882749 -2.346145 -2.763023 -2.937227 -3.249681 -3.537129 -3.797130 -4.004715 -4.028951 -4.245753 -4.448222 -4.631503 -4.617014 -4.749905 -4.717124 -3.504848 1.798915 0.8622296 2.2984287E-02 -0.7069625 -1.342845 -1.955219 -2.481716 -2.872110 -3.215242 -3.544775 -3.838876 -4.032621 -4.151265 -4.352870 -4.558177 -4.741923 -4.688995 -4.797031 -4.729331 -3.504848 2.252410 1.306731 0.4353921 -0.3375996 -1.064293 -1.753294 -2.362548 -2.836642 -3.238752 -3.585769 -3.900652 -4.144046 -4.337742 -4.511623 -4.690573 -4.839889 -4.797246 -4.853190 -4.739527 -3.504848 2.426936 1.494175 0.6328522 -0.1705800 -0.9303625 -1.646101 -2.251484 -2.779932 -3.237658 -3.624303 -3.980344 -4.278649 -4.497796 -4.673320 -4.830723 -4.929039 -4.912425 -4.914745 -4.747243 -3.504848 2.429046 1.519818 0.6822726 -0.1205431 -0.8807592 -1.568895 -2.184800 -2.743905 -3.221576 -3.677407 -4.073986 -4.394210 -4.634161 -4.820406 -4.969838 -5.038089 -5.027071 -4.978378 -4.752133 -3.504848 2.311444 1.448559 0.6296582 -0.1484809 -0.8736172 -1.546656 -2.168327 -2.723951 -3.254633 -3.751949 -4.173440 -4.489755 -4.754455 -4.956509 -5.100781 -5.159891 -5.136020 -5.040830 -4.753824 -3.504848 2.106328 1.294947 0.5137089 -0.2271878 -0.9255431 -1.584220 -2.190458 -2.770477 -3.331359 -3.845532 -4.257830 -4.591743 -4.870250 -5.085772 -5.228795 -5.277682 -5.236937 -5.099938 -4.752087 -3.504848 1.828570 1.072386 0.3412119 -0.3646957 -1.036014 -1.670974 -2.279947 -2.874443 -3.441257 -3.934156 -4.344582 -4.700975 -4.992578 -5.208182 -5.352033 -5.388752 -5.329797 -5.155180 -4.748041 -3.504848 1.493255 0.7974784 0.1122740 -0.5564591 -1.198246 -1.819031 -2.423976 -3.014628 -3.557027 -4.026464 -4.458766 -4.821458 -5.119719 -5.332234 -5.468429 -5.492119 -5.414542 -5.205187 -4.743092 -3.504848 1.118239 0.4719977 -0.1648256 -0.7980094 -1.412257 -2.012304 -2.605280 -3.168745 -3.677088 -4.162003 -4.583844 -4.957011 -5.244683 -5.456773 -5.573879 -5.585954 -5.490963 -5.248693 -4.736238 -3.504848 0.6880505 0.1046546 -0.4876399 -1.079456 -1.663807 -2.244365 -2.804100 -3.330499 -3.843027 -4.313482 -4.741655 -5.097892 -5.383389 -5.574559 -5.672500 -5.669529 -5.557981 -5.284344 -4.726669 -3.504848 0.2161522 -0.3058348 -0.8518858 -1.403158 -1.955940 -2.492942 -3.020789 -3.538395 -4.039618 -4.509167 -4.912954 -5.255707 -5.526598 -5.681486 -5.759722 -5.744107 -5.614683 -5.310842 -4.713308 -3.504848 -0.3048295 -0.7659782 -1.264171 -1.763426 -2.269897 -2.777992 -3.286650 -3.797625 -4.287953 -4.719857 -5.108544 -5.427056 -5.646614 -5.775377 -5.837626 -5.807265 -5.659944 -5.326092 -4.695255 -3.504848 -0.8821091 -1.276390 -1.713071 -2.167119 -2.638616 -3.122223 -3.615950 -4.087706 -4.539827 -4.960310 -5.305536 -5.566112 -5.750112 -5.856615 -5.904945 -5.858548 -5.689840 -5.328369 -4.671406 -3.504848 -1.528671 -1.852894 -2.226304 -2.632338 -3.063596 -3.504475 -3.954402 -4.402920 -4.820859 -5.173654 -5.459770 -5.677544 -5.837888 -5.928277 -5.958835 -5.893899 -5.701497 -5.317006 -4.641028 -3.504848 -2.259967 -2.496986 -2.800341 -3.142046 -3.519613 -3.922611 -4.313544 -4.696745 -5.044566 -5.341245 -5.583663 -5.774940 -5.914221 -5.985673 -5.994147 -5.907499 -5.693053 -5.290190 -4.602425 -3.504848 -3.120555 -3.244305 -3.453600 -3.713065 -4.011615 -4.324297 -4.635110 -4.947648 -5.237548 -5.493637 -5.701163 -5.860444 -5.974056 -6.019354 -6.002738 -5.893494 -5.661489 -5.245496 -4.555361 -3.504848 -4.176007 -4.156958 -4.243480 -4.384238 -4.567160 -4.772926 -4.994992 -5.228664 -5.452535 -5.654003 -5.813061 -5.926573 -6.005141 -6.019602 -5.976352 -5.845952 -5.600943 -5.177912 -4.496868 -3.504848 -5.793470 -5.545438 -5.426201 -5.375665 -5.384237 -5.433758 -5.515341 -5.628150 -5.746497 -5.861535 -5.943041 -5.992193 -6.016869 -5.993085 -5.916771 -5.760442 -5.508022 -5.090938 -4.423391 -3.504848 -55.58271 -54.38276 -52.87003 -51.09190 -49.08784 -46.88874 -44.51858 -41.99615 -39.33646 -36.55177 -33.65232 -30.64675 -27.54248 -24.34594 -21.06279 -17.69800 -14.25602 -10.74084 -7.156037 -3.504848 0.9775279 1.4184370E-02 -0.7923896 -1.379000 -1.941150 -2.420049 -2.834043 -3.005649 -3.336687 -3.629438 -3.898591 -4.117785 -4.127357 -4.349615 -4.554597 -4.744572 -4.725189 -4.870724 -4.853257 -3.604268 2.009745 0.9957843 9.2818335E-02 -0.6840756 -1.372173 -1.963669 -2.512986 -2.942343 -3.311454 -3.644917 -3.950163 -4.158815 -4.267521 -4.471106 -4.672601 -4.867648 -4.806008 -4.923708 -4.869192 -3.604268 2.499778 1.484119 0.5487780 -0.2864825 -1.020640 -1.724043 -2.375610 -2.923284 -3.342164 -3.705676 -4.016686 -4.270104 -4.474751 -4.648220 -4.815692 -4.977228 -4.926929 -4.988357 -4.882880 -3.604268 2.693695 1.691553 0.7647545 -7.3799357E-02 -0.8596931 -1.614277 -2.302757 -2.860501 -3.342380 -3.743213 -4.096234 -4.408849 -4.650171 -4.822732 -4.970520 -5.079525 -5.057405 -5.059038 -4.894126 -3.604268 2.700984 1.720936 0.8316900 -1.1550839E-02 -0.8100185 -1.570737 -2.229596 -2.817768 -3.335021 -3.780266 -4.188221 -4.535786 -4.787045 -4.978546 -5.121761 -5.198614 -5.185909 -5.131679 -4.902776 -3.604268 2.576533 1.651399 0.7829528 -4.1962359E-02 -0.8285523 -1.548918 -2.205159 -2.810787 -3.337000 -3.846484 -4.292796 -4.643462 -4.910494 -5.123015 -5.267224 -5.330088 -5.306818 -5.203648 -4.908074 -3.604268 2.359701 1.492405 0.6638322 -0.1378843 -0.8817640 -1.580368 -2.233843 -2.827086 -3.400691 -3.940521 -4.397041 -4.741499 -5.031813 -5.260080 -5.402306 -5.458385 -5.419142 -5.273391 -4.909539 -3.604268 2.069679 1.258803 0.4777077 -0.2757389 -0.9901646 -1.669144 -2.300479 -2.917721 -3.511205 -4.055395 -4.486471 -4.855159 -5.153913 -5.391829 -5.532801 -5.579763 -5.522419 -5.338465 -4.908473 -3.604268 1.718325 0.9753968 0.2423288 -0.4708219 -1.153400 -1.804764 -2.438495 -3.059205 -3.652612 -4.157166 -4.594057 -4.973419 -5.284052 -5.515736 -5.658526 -5.694084 -5.616492 -5.397260 -4.907021 -3.604268 1.326079 0.6370730 -4.3914065E-02 -0.7177688 -1.367843 -2.001281 -2.622662 -3.235036 -3.786381 -4.278753 -4.723745 -5.115268 -5.420678 -5.644681 -5.774238 -5.797522 -5.700441 -5.448620 -4.903650 -3.604268 0.8783752 0.2565016 -0.3792132 -1.009135 -1.625772 -2.237806 -2.840452 -3.409325 -3.944489 -4.438797 -4.885658 -5.271474 -5.560919 -5.776284 -5.883511 -5.890884 -5.776037 -5.491013 -4.897131 -3.604268 0.3872166 -0.1707050 -0.7558745 -1.340940 -1.926662 -2.511277 -3.067447 -3.620575 -4.144642 -4.640069 -5.075791 -5.430494 -5.713735 -5.894411 -5.981906 -5.975092 -5.841243 -5.523453 -4.886683 -3.604268 -0.1523711 -0.6477653 -1.178252 -1.718279 -2.259180 -2.798964 -3.338846 -3.877974 -4.398145 -4.867402 -5.271503 -5.615658 -5.853801 -6.003692 -6.069094 -6.048027 -5.894015 -5.544228 -4.871360 -3.604268 -0.7521321 -1.176555 -1.644411 -2.131273 -2.634761 -3.148018 -3.673058 -4.198513 -4.675185 -5.116111 -5.498216 -5.779576 -5.975604 -6.096728 -6.146493 -6.108501 -5.931179 -5.550962 -4.849977 -3.604268 -1.422528 -1.770114 -2.174561 -2.610477 -3.078135 -3.560238 -4.042760 -4.527131 -4.987450 -5.371325 -5.677731 -5.913388 -6.076228 -6.180544 -6.211336 -6.151869 -5.950518 -5.542405 -4.821389 -3.604268 -2.178803 -2.443016 -2.773870 -3.145805 -3.557080 -3.998126 -4.442698 -4.865519 -5.252986 -5.569234 -5.820088 -6.022242 -6.166989 -6.251047 -6.258017 -6.172077 -5.948008 -5.516076 -4.783830 -3.604268 -3.069030 -3.219528 -3.455539 -3.745695 -4.084221 -4.439581 -4.793847 -5.140666 -5.459216 -5.735297 -5.951226 -6.122596 -6.239638 -6.298828 -6.277698 -6.162823 -5.918652 -5.470012 -4.737060 -3.604268 -4.176344 -4.168177 -4.274327 -4.446289 -4.663421 -4.906436 -5.165047 -5.432088 -5.685357 -5.904145 -6.074776 -6.205962 -6.284211 -6.311075 -6.259721 -6.117709 -5.857108 -5.399708 -4.679310 -3.604268 -5.852900 -5.606039 -5.496519 -5.475309 -5.511034 -5.586718 -5.696942 -5.835308 -5.985280 -6.112514 -6.210567 -6.279931 -6.308403 -6.291462 -6.203773 -6.033192 -5.759779 -5.309210 -4.605833 -3.604268 -60.10012 -58.81427 -57.17879 -55.24974 -53.07273 -50.68288 -48.10705 -45.36606 -42.47647 -39.45178 -36.30319 -33.04017 -29.67081 -26.20215 -22.64032 -18.99074 -15.25825 -11.44716 -7.561338 -3.604268 1.095689 6.0193468E-02 -0.8030548 -1.416716 -2.000109 -2.495672 -2.915641 -3.073736 -3.412907 -3.717914 -3.994071 -4.225974 -4.221933 -4.447965 -4.657955 -4.851479 -4.828210 -4.984370 -4.984687 -3.698979 2.216327 1.126329 0.1606792 -0.6653782 -1.388370 -2.012837 -2.550439 -2.997813 -3.401672 -3.740421 -4.057614 -4.283323 -4.379979 -4.585279 -4.790293 -4.985429 -4.917196 -5.044424 -5.005476 -3.698979 2.747442 1.655997 0.6582776 -0.2275844 -1.019989 -1.709278 -2.378607 -2.978218 -3.441717 -3.812742 -4.134722 -4.396032 -4.603970 -4.782784 -4.947804 -5.106793 -5.052763 -5.118328 -5.024074 -3.698979 2.961537 1.881981 0.8964012 1.2313888E-03 -0.8024008 -1.576138 -2.305001 -2.936076 -3.440376 -3.867019 -4.213444 -4.534315 -4.788980 -4.969662 -5.114824 -5.220418 -5.198913 -5.198240 -5.040159 -3.698979 2.972874 1.919741 0.9688639 9.0295412E-02 -0.7389342 -1.537571 -2.271426 -2.889719 -3.434762 -3.892563 -4.299112 -4.662203 -4.936121 -5.136681 -5.276659 -5.350873 -5.340382 -5.280670 -5.053368 -3.698979 2.838513 1.850426 0.9319575 6.5039016E-02 -0.7623338 -1.551253 -2.243458 -2.876627 -3.440036 -3.939742 -4.401767 -4.784705 -5.062066 -5.284564 -5.429657 -5.494750 -5.472134 -5.361562 -5.063108 -3.698979 2.609534 1.686830 0.8097985 -3.5505716E-02 -0.8401424 -1.580443 -2.265996 -2.904312 -3.476196 -4.027987 -4.517038 -4.892514 -5.186959 -5.421720 -5.573788 -5.634384 -5.594469 -5.439417 -5.068639 -3.698979 2.305410 1.444528 0.6157289 -0.1883478 -0.9488525 -1.664247 -2.338981 -2.967096 -3.580502 -4.147252 -4.624665 -4.998252 -5.309717 -5.555665 -5.709720 -5.765669 -5.706384 -5.512312 -5.071266 -3.698979 1.938509 1.144462 0.3714083 -0.3900647 -1.110975 -1.798754 -2.456953 -3.104959 -3.725134 -4.275838 -4.727153 -5.124093 -5.442167 -5.689726 -5.842634 -5.889119 -5.808552 -5.578304 -5.073368 -3.698979 1.527730 0.7996050 7.3419377E-02 -0.6418135 -1.326730 -1.990031 -2.642654 -3.285384 -3.886106 -4.399608 -4.864174 -5.259023 -5.587116 -5.822654 -5.972339 -6.002748 -5.899667 -5.636670 -5.073503 -3.698979 1.069604 0.4053155 -0.2736783 -0.9394875 -1.590001 -2.231988 -2.870451 -3.488611 -4.046519 -4.567245 -5.020350 -5.422420 -5.732074 -5.962614 -6.090974 -6.104691 -5.980084 -5.685773 -5.070253 -3.698979 0.5574376 -3.8413785E-02 -0.6605759 -1.279242 -1.898346 -2.516033 -3.122631 -3.699342 -4.257115 -4.760277 -5.216866 -5.594626 -5.891353 -6.100351 -6.200847 -6.196193 -6.050541 -5.724733 -5.062332 -3.698979 -3.2958402E-03 -0.5307866 -1.093795 -1.667665 -2.252304 -2.821847 -3.396560 -3.963450 -4.508506 -5.005296 -5.428634 -5.786654 -6.057445 -6.225844 -6.296397 -6.275199 -6.110507 -5.752285 -5.048714 -3.698979 -0.6227000 -1.078241 -1.578634 -2.097785 -2.633385 -3.176867 -3.735344 -4.292937 -4.809468 -5.265595 -5.666506 -5.980995 -6.200451 -6.334278 -6.382468 -6.341007 -6.154572 -5.765533 -5.028508 -3.698979 -1.315961 -1.688004 -2.121888 -2.589227 -3.087957 -3.610070 -4.135521 -4.649857 -5.136615 -5.561762 -5.885455 -6.139357 -6.318379 -6.430206 -6.456442 -6.389437 -6.179556 -5.762749 -5.000386 -3.698979 -2.096580 -2.384362 -2.745924 -3.149106 -3.594239 -4.070346 -4.562503 -5.029885 -5.444822 -5.789236 -6.056273 -6.267065 -6.422286 -6.511574 -6.511345 -6.415926 -6.182059 -5.741121 -4.963114 -3.698979 -3.014132 -3.187562 -3.454105 -3.777885 -4.152565 -4.552977 -4.952782 -5.333402 -5.677886 -5.966561 -6.202957 -6.382724 -6.509750 -6.568218 -6.537274 -6.412960 -6.156874 -5.697780 -4.915390 -3.698979 -4.169516 -4.176247 -4.303142 -4.506598 -4.762196 -5.042699 -5.339046 -5.636971 -5.915478 -6.148267 -6.340469 -6.479281 -6.567666 -6.588842 -6.523437 -6.371736 -6.097116 -5.628083 -4.856019 -3.698979 -5.903866 -5.657730 -5.561233 -5.566378 -5.635911 -5.741986 -5.884301 -6.057617 -6.224059 -6.368296 -6.485138 -6.566789 -6.602776 -6.576048 -6.469790 -6.287743 -5.996889 -5.533651 -4.780036 -3.698979 -64.69788 -63.32493 -61.56387 -59.48021 -57.12621 -54.54133 -51.75533 -48.79116 -45.66695 -42.39745 -38.99484 -35.46944 -31.83005 -28.08425 -24.23871 -20.29929 -16.27122 -12.15911 -7.967110 -3.698979 1.209739 0.1018659 -0.8153958 -1.456187 -2.059936 -2.566810 -3.003789 -3.144609 -3.486615 -3.801705 -4.084693 -4.328586 -4.311613 -4.540153 -4.755910 -4.953622 -4.927366 -5.089330 -5.107334 -3.789407 2.419301 1.252792 0.2277802 -0.6484935 -1.409252 -2.061916 -2.612213 -3.053340 -3.470194 -3.833571 -4.156521 -4.405288 -4.487782 -4.690754 -4.899566 -5.099317 -5.024684 -5.154886 -5.132545 -3.789407 2.993040 1.823902 0.7668874 -0.1723789 -1.007187 -1.737839 -2.388038 -3.011089 -3.533258 -3.917214 -4.250660 -4.517918 -4.728129 -4.907655 -5.073829 -5.231759 -5.176940 -5.236276 -5.155794 -3.789407 3.238044 2.065386 1.024884 8.0315053E-02 -0.7805237 -1.548041 -2.297007 -2.982831 -3.533175 -3.973771 -4.334925 -4.651642 -4.920536 -5.109807 -5.254547 -5.360088 -5.336781 -5.325139 -5.176802 -3.789407 3.246711 2.113608 1.106803 0.1730421 -0.6775115 -1.498755 -2.275656 -2.956767 -3.524383 -4.015787 -4.410457 -4.779771 -5.079633 -5.281390 -5.428481 -5.501360 -5.488974 -5.416229 -5.194720 -3.789407 3.095693 2.046587 1.075269 0.1662821 -0.6951892 -1.521120 -2.279296 -2.942912 -3.538504 -4.040697 -4.505880 -4.907766 -5.213090 -5.435346 -5.591939 -5.652650 -5.629800 -5.506142 -5.208961 -3.789407 2.854155 1.876808 0.9530326 6.4003326E-02 -0.7846289 -1.577953 -2.301150 -2.970243 -3.565474 -4.113166 -4.620719 -5.029530 -5.332532 -5.574530 -5.746514 -5.800978 -5.759243 -5.593165 -5.218960 -3.789407 2.534753 1.625190 0.7504089 -9.8794311E-02 -0.9091430 -1.662813 -2.371939 -3.031309 -3.648156 -4.231269 -4.748853 -5.139650 -5.462003 -5.713813 -5.890078 -5.941522 -5.876803 -5.675064 -5.225688 -3.789407 2.162001 1.315263 0.4948702 -0.3098840 -1.072579 -1.797145 -2.487036 -3.150988 -3.792200 -4.380793 -4.864671 -5.262542 -5.591691 -5.856758 -6.028252 -6.069720 -5.985129 -5.750127 -5.231829 -3.789407 1.730655 0.9561797 0.1853349 -0.5680197 -1.289505 -1.983847 -2.664911 -3.334659 -3.972427 -4.527878 -4.992334 -5.400591 -5.741173 -5.995772 -6.163594 -6.190458 -6.083179 -5.817153 -5.235623 -3.789407 1.250099 0.5467948 -0.1716114 -0.8721898 -1.555624 -2.229973 -2.897637 -3.558063 -4.155245 -4.682156 -5.155988 -5.566494 -5.900206 -6.141982 -6.290516 -6.298241 -6.172769 -5.873175 -5.235726 -3.789407 0.7213762 8.7759443E-02 -0.5690659 -1.221944 -1.872791 -2.520128 -3.168203 -3.783629 -4.359931 -4.882810 -5.355143 -5.754282 -6.067264 -6.298533 -6.406404 -6.394989 -6.251215 -5.917819 -5.230860 -3.789407 0.1437174 -0.4157942 -1.012394 -1.620699 -2.236038 -2.850175 -3.454967 -4.055886 -4.614888 -5.133555 -5.583451 -5.952304 -6.255689 -6.436440 -6.509688 -6.481123 -6.317304 -5.950398 -5.220017 -3.789407 -0.4954442 -0.9800279 -1.513854 -2.066759 -2.633345 -3.210622 -3.800682 -4.385566 -4.937675 -5.413404 -5.832297 -6.179238 -6.419057 -6.557918 -6.601660 -6.554248 -6.367175 -5.968428 -5.201543 -3.789407 -1.209344 -1.608937 -2.070340 -2.568003 -3.097385 -3.652795 -4.229519 -4.768122 -5.277756 -5.727682 -6.089608 -6.364443 -6.554961 -6.659964 -6.682150 -6.610923 -6.397059 -5.969625 -5.174593 -3.789407 -2.013953 -2.325225 -2.714132 -3.152544 -3.632279 -4.145095 -4.672436 -5.189481 -5.629137 -5.999548 -6.289738 -6.508501 -6.669219 -6.750818 -6.744808 -6.645865 -6.404287 -5.950651 -5.137825 -3.789407 -2.958285 -3.153667 -3.445921 -3.809324 -4.224485 -4.665669 -5.115013 -5.529704 -5.892098 -6.199676 -6.450208 -6.637505 -6.768059 -6.819657 -6.781008 -6.651493 -6.383815 -5.908895 -5.088607 -3.789407 -4.154451 -4.177410 -4.329394 -4.564406 -4.857806 -5.180621 -5.515944 -5.849251 -6.142522 -6.396407 -6.599645 -6.745843 -6.834655 -6.850694 -6.777318 -6.616468 -6.327366 -5.839654 -5.026224 -3.789407 -5.949975 -5.702723 -5.619793 -5.650373 -5.751997 -5.898179 -6.079957 -6.276944 -6.461622 -6.628827 -6.755257 -6.838142 -6.869594 -6.842324 -6.730846 -6.535076 -6.227627 -5.741835 -4.946018 -3.789407 -69.07755 -67.91139 -66.02174 -63.77997 -61.24509 -58.46106 -55.46062 -52.26885 -48.90553 -45.38663 -41.72538 -37.93293 -34.01877 -29.99109 -25.85708 -21.62304 -17.29455 -12.87656 -8.373505 -3.789407 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.936214 -1.969825 -2.001262 -2.030694 -2.057462 -2.081070 -2.112080 -2.140986 -2.167383 -2.190826 -2.210173 -2.226055 -2.236909 -2.244742 -2.251789 -2.250990 -2.239180 -2.211074 -2.153557 -1.934567 -1.960466 -1.992184 -2.022530 -2.050300 -2.074931 -2.097152 -2.127021 -2.154651 -2.179649 -2.200904 -2.219159 -2.233223 -2.242137 -2.248233 -2.253760 -2.251415 -2.238060 -2.208730 -2.150511 -1.934567 -1.985527 -2.015944 -2.044457 -2.069916 -2.092888 -2.114010 -2.142569 -2.168719 -2.192149 -2.211648 -2.228089 -2.240236 -2.247130 -2.251641 -2.255544 -2.251663 -2.236738 -2.206289 -2.147315 -1.934567 -2.012070 -2.040444 -2.066422 -2.090072 -2.111727 -2.131636 -2.158619 -2.183136 -2.204087 -2.222428 -2.236917 -2.247044 -2.251713 -2.254942 -2.257202 -2.251712 -2.235202 -2.203559 -2.143964 -1.934567 -2.039414 -2.064945 -2.089091 -2.111184 -2.131533 -2.149916 -2.175115 -2.197056 -2.216812 -2.233183 -2.245603 -2.253597 -2.256533 -2.258117 -2.258661 -2.251408 -2.233429 -2.200613 -2.140430 -1.934567 -2.066716 -2.090319 -2.112763 -2.133481 -2.152140 -2.168773 -2.192026 -2.211881 -2.229580 -2.243848 -2.254084 -2.259574 -2.261278 -2.260998 -2.259927 -2.250824 -2.231429 -2.197433 -2.136703 -1.934567 -2.095269 -2.116853 -2.137781 -2.156727 -2.173470 -2.188136 -2.208369 -2.226816 -2.242321 -2.254360 -2.261746 -2.265985 -2.265925 -2.263827 -2.260961 -2.249960 -2.229198 -2.193995 -2.132761 -1.934567 -2.125133 -2.144914 -2.163848 -2.180779 -2.194645 -2.207035 -2.225700 -2.241800 -2.254974 -2.264640 -2.269951 -2.272364 -2.270188 -2.266391 -2.261505 -2.248814 -2.226602 -2.190274 -2.128582 -1.934567 -2.156671 -2.174170 -2.190845 -2.204735 -2.216995 -2.226985 -2.243134 -2.256767 -2.267441 -2.274126 -2.278198 -2.278674 -2.274526 -2.268784 -2.261641 -2.247313 -2.223925 -2.186243 -2.124128 -1.934567 -2.189570 -2.203821 -2.217910 -2.229984 -2.239701 -2.247173 -2.260627 -2.271610 -2.279059 -2.284482 -2.286471 -2.284486 -2.278555 -2.270587 -2.261427 -2.245538 -2.220613 -2.181863 -2.119362 -1.934567 -2.223034 -2.235153 -2.246431 -2.255756 -2.262762 -2.267547 -2.277194 -2.285663 -2.291791 -2.295002 -2.294242 -2.290385 -2.282499 -2.271857 -2.260899 -2.243439 -2.216891 -2.177092 -2.114228 -1.934567 -2.258346 -2.267437 -2.275743 -2.282142 -2.286165 -2.287245 -2.295187 -2.301140 -2.304883 -2.305078 -2.302282 -2.296308 -2.287256 -2.274679 -2.260076 -2.241180 -2.212714 -2.171949 -2.108652 -1.934567 -2.294996 -2.300917 -2.305951 -2.308370 -2.309465 -2.308796 -2.314077 -2.316531 -2.317677 -2.315710 -2.310545 -2.302695 -2.291732 -2.277492 -2.259248 -2.237947 -2.208032 -2.166199 -2.102518 -1.934567 -2.332475 -2.335109 -2.336940 -2.337176 -2.335247 -2.330905 -2.333254 -2.333158 -2.331412 -2.326763 -2.319194 -2.309216 -2.296386 -2.280046 -2.259743 -2.234205 -2.202780 -2.159851 -2.095697 -1.934567 -2.373945 -2.373274 -2.370918 -2.367706 -2.362005 -2.355162 -2.354276 -2.350710 -2.345390 -2.337883 -2.328121 -2.315934 -2.301317 -2.282583 -2.259343 -2.231394 -2.197238 -2.152757 -2.087418 -1.934567 -2.419744 -2.414881 -2.409247 -2.402012 -2.393753 -2.385063 -2.375082 -2.368616 -2.360277 -2.350459 -2.338308 -2.324038 -2.305516 -2.283819 -2.258376 -2.228619 -2.191835 -2.144940 -2.077304 -1.934567 -2.472284 -2.463672 -2.454396 -2.444662 -2.433475 -2.422184 -2.410055 -2.395917 -2.381794 -2.365297 -2.349159 -2.330593 -2.309363 -2.284935 -2.257215 -2.224083 -2.184289 -2.134473 -2.065297 -1.934567 -2.539209 -2.524159 -2.511777 -2.498014 -2.483153 -2.467405 -2.450490 -2.432248 -2.412834 -2.391862 -2.369221 -2.345784 -2.318544 -2.289055 -2.255791 -2.217842 -2.172992 -2.116397 -2.050329 -1.934567 -2.653339 -2.632135 -2.610192 -2.588650 -2.564681 -2.539786 -2.513874 -2.487304 -2.458739 -2.428773 -2.396957 -2.362894 -2.325959 -2.285366 -2.240540 -2.192971 -2.142946 -2.089421 -2.029640 -1.934567 -2.590475 -2.561377 -2.531642 -2.501274 -2.470281 -2.438669 -2.406688 -2.373612 -2.340175 -2.306140 -2.271521 -2.236322 -2.200550 -2.164211 -2.127311 -2.089854 -2.051837 -2.013280 -1.974188 -1.934567 -1.833741 -1.902932 -1.967184 -2.047275 -2.121858 -2.192754 -2.257404 -2.315241 -2.363677 -2.416524 -2.476393 -2.530385 -2.576182 -2.612777 -2.636058 -2.660152 -2.675066 -2.665532 -2.610681 -2.326377 -1.859055 -1.925890 -1.991135 -2.070766 -2.146709 -2.217153 -2.280329 -2.335783 -2.380366 -2.433295 -2.492351 -2.544139 -2.588381 -2.622103 -2.641897 -2.663713 -2.676281 -2.664259 -2.607434 -2.326377 -1.889040 -1.955556 -2.022356 -2.100850 -2.175639 -2.243257 -2.304475 -2.356781 -2.399450 -2.451869 -2.509449 -2.559053 -2.600375 -2.631148 -2.647524 -2.667218 -2.677309 -2.662746 -2.603983 -2.326377 -1.926118 -1.991614 -2.057531 -2.135429 -2.206139 -2.271531 -2.329554 -2.377860 -2.420839 -2.472000 -2.526581 -2.574346 -2.612633 -2.639880 -2.653273 -2.670630 -2.678122 -2.660963 -2.600314 -2.326377 -1.969845 -2.034624 -2.099002 -2.171762 -2.239363 -2.301301 -2.354574 -2.402170 -2.444206 -2.493472 -2.545170 -2.589946 -2.624563 -2.648149 -2.659087 -2.673909 -2.678688 -2.658826 -2.596408 -2.326377 -2.020731 -2.083008 -2.142419 -2.210766 -2.274394 -2.331185 -2.382762 -2.428948 -2.469221 -2.514824 -2.564247 -2.604917 -2.636372 -2.656261 -2.664910 -2.677015 -2.678976 -2.656359 -2.592254 -2.326377 -2.075577 -2.133507 -2.188269 -2.252057 -2.309942 -2.364313 -2.413774 -2.457770 -2.494616 -2.537843 -2.582830 -2.620085 -2.647775 -2.664635 -2.670709 -2.679907 -2.678952 -2.653538 -2.587834 -2.326377 -2.134543 -2.186646 -2.236503 -2.294213 -2.349202 -2.400629 -2.447253 -2.487455 -2.521909 -2.561426 -2.602169 -2.635233 -2.658955 -2.673174 -2.676437 -2.682555 -2.678574 -2.650330 -2.583121 -2.326377 -2.196543 -2.241965 -2.286327 -2.340645 -2.391979 -2.439711 -2.482004 -2.519253 -2.550041 -2.584285 -2.620927 -2.649889 -2.670503 -2.681821 -2.682022 -2.684906 -2.677787 -2.646693 -2.578083 -2.326377 -2.260427 -2.300936 -2.341165 -2.390826 -2.437728 -2.480315 -2.519110 -2.552284 -2.577794 -2.607671 -2.639789 -2.664828 -2.682310 -2.690529 -2.687440 -2.686912 -2.676286 -2.642586 -2.572685 -2.326377 -2.329322 -2.364964 -2.399978 -2.443611 -2.485215 -2.523550 -2.556974 -2.585346 -2.606264 -2.631346 -2.658883 -2.680299 -2.694388 -2.699230 -2.692640 -2.688525 -2.674109 -2.637950 -2.566881 -2.326377 -2.403110 -2.432531 -2.461675 -2.499624 -2.535457 -2.567904 -2.596259 -2.619357 -2.635309 -2.655556 -2.678914 -2.696372 -2.706705 -2.707888 -2.697564 -2.689629 -2.671340 -2.632733 -2.560620 -2.326377 -2.480475 -2.503692 -2.525760 -2.557552 -2.586850 -2.614074 -2.636895 -2.654423 -2.665678 -2.681249 -2.699986 -2.713103 -2.719314 -2.716480 -2.702177 -2.689432 -2.667910 -2.626891 -2.553836 -2.326377 -2.561151 -2.577758 -2.593295 -2.618520 -2.641234 -2.662305 -2.679434 -2.691781 -2.698162 -2.708602 -2.722274 -2.730654 -2.732318 -2.725079 -2.707114 -2.688576 -2.663763 -2.620396 -2.546449 -2.326377 -2.647693 -2.656426 -2.664681 -2.682971 -2.699072 -2.714164 -2.725553 -2.732220 -2.733202 -2.738075 -2.746164 -2.749282 -2.745996 -2.734055 -2.713577 -2.687122 -2.658881 -2.613195 -2.538357 -2.326377 -2.742459 -2.743136 -2.743621 -2.754588 -2.763721 -2.772001 -2.776823 -2.777045 -2.771820 -2.770495 -2.772447 -2.769486 -2.760720 -2.744572 -2.720262 -2.686561 -2.653450 -2.605273 -2.529609 -2.326377 -2.853734 -2.845307 -2.836661 -2.839231 -2.840238 -2.840339 -2.837231 -2.829589 -2.816654 -2.807055 -2.801344 -2.792016 -2.777531 -2.756617 -2.727829 -2.690795 -2.647941 -2.596751 -2.519626 -2.326377 -2.997060 -2.977137 -2.957132 -2.949221 -2.940094 -2.929497 -2.917480 -2.902438 -2.883900 -2.861954 -2.837591 -2.821570 -2.800622 -2.773523 -2.739847 -2.698143 -2.647508 -2.588814 -2.508514 -2.326377 -3.225308 -3.197538 -3.169249 -3.139914 -3.110959 -3.079875 -3.051767 -3.026750 -2.998872 -2.968139 -2.933865 -2.896127 -2.854613 -2.810407 -2.767513 -2.717646 -2.657842 -2.587204 -2.495947 -2.326377 -3.828560 -3.769727 -3.708366 -3.644529 -3.578260 -3.509606 -3.438635 -3.365640 -3.289922 -3.212273 -3.132508 -3.050670 -2.967028 -2.880917 -2.793114 -2.703414 -2.611837 -2.518451 -2.423288 -2.326377 -1.702223 -1.828565 -1.944814 -2.045136 -2.140344 -2.253601 -2.360173 -2.457012 -2.542596 -2.611279 -2.680176 -2.766787 -2.842998 -2.907647 -2.955369 -2.984749 -3.024312 -3.033057 -2.982974 -2.653861 -1.708524 -1.837583 -1.955382 -2.053559 -2.154384 -2.271403 -2.379352 -2.477624 -2.561959 -2.626415 -2.695777 -2.782328 -2.857924 -2.920564 -2.964429 -2.989719 -3.026978 -3.032610 -2.979488 -2.653861 -1.733777 -1.860471 -1.973846 -2.075323 -2.179372 -2.297065 -2.405113 -2.501593 -2.582294 -2.643514 -2.715140 -2.800728 -2.874133 -2.933589 -2.972875 -2.994979 -3.029549 -3.031887 -2.975734 -2.653861 -1.772496 -1.892258 -2.005109 -2.108778 -2.213867 -2.329606 -2.435334 -2.527786 -2.602678 -2.665591 -2.736734 -2.820782 -2.890805 -2.946467 -2.980504 -3.000431 -3.031966 -3.030855 -2.971689 -2.653861 -1.818770 -1.937122 -2.048932 -2.152059 -2.255413 -2.367353 -2.468139 -2.554476 -2.627311 -2.690747 -2.761335 -2.841293 -2.908032 -2.958907 -2.987897 -3.005960 -3.034167 -3.029472 -2.967329 -2.653861 -1.877572 -1.994123 -2.102586 -2.202883 -2.302397 -2.408149 -2.502203 -2.583736 -2.656593 -2.719237 -2.786979 -2.862905 -2.925328 -2.970664 -2.995815 -3.011501 -3.036122 -3.027694 -2.962652 -2.653861 -1.950190 -2.060541 -2.163734 -2.259347 -2.352736 -2.450830 -2.538329 -2.618315 -2.689010 -2.750188 -2.814031 -2.885132 -2.942200 -2.981553 -3.004105 -3.016960 -3.037712 -3.025273 -2.957647 -2.653861 -2.030656 -2.134202 -2.230765 -2.319620 -2.405062 -2.495943 -2.580270 -2.656706 -2.725132 -2.782031 -2.841452 -2.907276 -2.958284 -2.992712 -3.012624 -3.022242 -3.038898 -3.022530 -2.952281 -2.653861 -2.119732 -2.213541 -2.302242 -2.382414 -2.460948 -2.547181 -2.626803 -2.699210 -2.762830 -2.815454 -2.869630 -2.928777 -2.973335 -3.004469 -3.021246 -3.027323 -3.039611 -3.019199 -2.946601 -2.653861 -2.214391 -2.297856 -2.377388 -2.450484 -2.523208 -2.603456 -2.677958 -2.744076 -2.802412 -2.850206 -2.897840 -2.949492 -2.988874 -3.016586 -3.029820 -3.031924 -3.039777 -3.015114 -2.940382 -2.653861 -2.314338 -2.388821 -2.459619 -2.525005 -2.591440 -2.664138 -2.731610 -2.791534 -2.843722 -2.885296 -2.925594 -2.970243 -3.005155 -3.028934 -3.038225 -3.036046 -3.039287 -3.010294 -2.933776 -2.653861 -2.422639 -2.486837 -2.548564 -2.606497 -2.664372 -2.728319 -2.788147 -2.841193 -2.885828 -2.919988 -2.953719 -2.992462 -3.022086 -3.041367 -3.046354 -3.039579 -3.038063 -3.004673 -2.926621 -2.653861 -2.539272 -2.592935 -2.644915 -2.693533 -2.741796 -2.796453 -2.847422 -2.892025 -2.928123 -2.955685 -2.983717 -3.016131 -3.039679 -3.053893 -3.054037 -3.042429 -3.035744 -2.998170 -2.918627 -2.653861 -2.664328 -2.707201 -2.748182 -2.786174 -2.823842 -2.867884 -2.908583 -2.944682 -2.973130 -2.993989 -3.015685 -3.041227 -3.058105 -3.066459 -3.061281 -3.044538 -3.031810 -2.990774 -2.909849 -2.653861 -2.798468 -2.829434 -2.857622 -2.883513 -2.909941 -2.943690 -2.974484 -3.002172 -3.022303 -3.035388 -3.049838 -3.068130 -3.077588 -3.079339 -3.068197 -3.044986 -3.026662 -2.982471 -2.900169 -2.653861 -2.940234 -2.958160 -2.974592 -2.989173 -3.004680 -3.027908 -3.047921 -3.066261 -3.077114 -3.081209 -3.087392 -3.097571 -3.098945 -3.093006 -3.075128 -3.043727 -3.020345 -2.972985 -2.889434 -2.653861 -3.100418 -3.104655 -3.107704 -3.109357 -3.112782 -3.124757 -3.133252 -3.140820 -3.141139 -3.134588 -3.130957 -3.131807 -3.123238 -3.108519 -3.085658 -3.049014 -3.012998 -2.962223 -2.877497 -2.653861 -3.300142 -3.287527 -3.274377 -3.259731 -3.247857 -3.246331 -3.241406 -3.235798 -3.223210 -3.203674 -3.183550 -3.172776 -3.154917 -3.131234 -3.101390 -3.058329 -3.006370 -2.950938 -2.864281 -2.653861 -3.604011 -3.569290 -3.536468 -3.502958 -3.468014 -3.432872 -3.410923 -3.387826 -3.363210 -3.333362 -3.296576 -3.253307 -3.216584 -3.180812 -3.137594 -3.084701 -3.018179 -2.943590 -2.851174 -2.653861 -5.157303 -5.068347 -4.973272 -4.872968 -4.767378 -4.656682 -4.541017 -4.420588 -4.295527 -4.165998 -4.032156 -3.894111 -3.752031 -3.606017 -3.456202 -3.302703 -3.145607 -2.985046 -2.821340 -2.653861 -1.548753 -1.732505 -1.902192 -2.054641 -2.179442 -2.301683 -2.445978 -2.579206 -2.698634 -2.799209 -2.866798 -2.972915 -3.075149 -3.163960 -3.233270 -3.265985 -3.324216 -3.349049 -3.303276 -2.935190 -1.512939 -1.707721 -1.886843 -2.042129 -2.166719 -2.299882 -2.453215 -2.592304 -2.714734 -2.813833 -2.876701 -2.987429 -3.090991 -3.179286 -3.245153 -3.271309 -3.327950 -3.349387 -3.299426 -2.935190 -1.517521 -1.714449 -1.892537 -2.043837 -2.176365 -2.319319 -2.475143 -2.614380 -2.735651 -2.828417 -2.894771 -3.007035 -3.109675 -3.195494 -3.256427 -3.277588 -3.331814 -3.349445 -3.295206 -2.935190 -1.550198 -1.740563 -1.912764 -2.066901 -2.208603 -2.353558 -2.506188 -2.643124 -2.758254 -2.845857 -2.919032 -3.030356 -3.130394 -3.212014 -3.266792 -3.284613 -3.335673 -3.349175 -3.290573 -2.935190 -1.601658 -1.781769 -1.953047 -2.112521 -2.254966 -2.396304 -2.544723 -2.674940 -2.781050 -2.871327 -2.948209 -3.056324 -3.152189 -3.228370 -3.275785 -3.292538 -3.339451 -3.348390 -3.285684 -2.935190 -1.669412 -1.843751 -2.013800 -2.171984 -2.310514 -2.447605 -2.587750 -2.707541 -2.810697 -2.902569 -2.980409 -3.083933 -3.174540 -3.244159 -3.284741 -3.300442 -3.343045 -3.347234 -3.280429 -2.935190 -1.757419 -1.925499 -2.088721 -2.239067 -2.374469 -2.504234 -2.631987 -2.745187 -2.847785 -2.938611 -3.014638 -3.112452 -3.196578 -3.258730 -3.294815 -3.308540 -3.346690 -3.345479 -3.274788 -2.935190 -1.863259 -2.019846 -2.171644 -2.315231 -2.442849 -2.561624 -2.680523 -2.790696 -2.890767 -2.978081 -3.050499 -3.141358 -3.217834 -3.272005 -3.306030 -3.316601 -3.349513 -3.343147 -3.268719 -2.935190 -1.977347 -2.123501 -2.264866 -2.396567 -2.512633 -2.623471 -2.737056 -2.842359 -2.937628 -3.020133 -3.087433 -3.170007 -3.237792 -3.286225 -3.317388 -3.324452 -3.351794 -3.340091 -3.262166 -2.935190 -2.103457 -2.235810 -2.362427 -2.481764 -2.589027 -2.693259 -2.800030 -2.898417 -2.987027 -3.063963 -3.125026 -3.198080 -3.257015 -3.301737 -3.328907 -3.332376 -3.353697 -3.336196 -3.255070 -2.935190 -2.237134 -2.352504 -2.465932 -2.575297 -2.674142 -2.769592 -2.867568 -2.957507 -3.038558 -3.108408 -3.162417 -3.225282 -3.277782 -3.317556 -3.340293 -3.339058 -3.354410 -3.331326 -3.247360 -2.935190 -2.377363 -2.478107 -2.579696 -2.677837 -2.766177 -2.850540 -2.938634 -3.019619 -3.091406 -3.152823 -3.198864 -3.253929 -3.300018 -3.333755 -3.351715 -3.344893 -3.354245 -3.325227 -3.238945 -2.935190 -2.530168 -2.615897 -2.702790 -2.787573 -2.864011 -2.936405 -3.013417 -3.083977 -3.145204 -3.197042 -3.236340 -3.284422 -3.322981 -3.350090 -3.361969 -3.350066 -3.352625 -3.317744 -3.229708 -2.935190 -2.694602 -2.762637 -2.833929 -2.905224 -2.967966 -3.027220 -3.091712 -3.150711 -3.200871 -3.243527 -3.275638 -3.315958 -3.346584 -3.366561 -3.371751 -3.353620 -3.349460 -3.309043 -3.219510 -2.935190 -2.870128 -2.920687 -2.976044 -3.030933 -3.078475 -3.123820 -3.174486 -3.221624 -3.260840 -3.293307 -3.316707 -3.348791 -3.370985 -3.382740 -3.380327 -3.355337 -3.343967 -3.299036 -3.208164 -2.935190 -3.060445 -3.092719 -3.130424 -3.167563 -3.198599 -3.228877 -3.265091 -3.299800 -3.327006 -3.347705 -3.360523 -3.382881 -3.396282 -3.398581 -3.387737 -3.354955 -3.336034 -3.287534 -3.195447 -2.935190 -3.269274 -3.281646 -3.301665 -3.321744 -3.335308 -3.348751 -3.369114 -3.389130 -3.402550 -3.409339 -3.409535 -3.420858 -3.423616 -3.415106 -3.394637 -3.357997 -3.326252 -3.274325 -3.181080 -2.935190 -3.517846 -3.508077 -3.508404 -3.508979 -3.502640 -3.496638 -3.499149 -3.501623 -3.498194 -3.487838 -3.471384 -3.467389 -3.456861 -3.436151 -3.406644 -3.362948 -3.315586 -3.259476 -3.164853 -2.935190 -3.886813 -3.848973 -3.820706 -3.790495 -3.754702 -3.719429 -3.699433 -3.678798 -3.654274 -3.623296 -3.587690 -3.546400 -3.520820 -3.484813 -3.437706 -3.383110 -3.311414 -3.246121 -3.147496 -2.935190 -6.568760 -6.448566 -6.318460 -6.178835 -6.030122 -5.872708 -5.706984 -5.533314 -5.352037 -5.163488 -4.967951 -4.765730 -4.557065 -4.342227 -4.121421 -3.894888 -3.662807 -3.425386 -3.182789 -2.935190 -1.412338 -1.629293 -1.848221 -2.048651 -2.223197 -2.351351 -2.524644 -2.687886 -2.838339 -2.969945 -3.063351 -3.158979 -3.283296 -3.392127 -3.480636 -3.525476 -3.587934 -3.627517 -3.585770 -3.181782 -1.317727 -1.555932 -1.790074 -2.003612 -2.185583 -2.322897 -2.510748 -2.686367 -2.846583 -2.982458 -3.067959 -3.170760 -3.299044 -3.409272 -3.495351 -3.531320 -3.592584 -3.628673 -3.581756 -3.181782 -1.289409 -1.536473 -1.774830 -1.988293 -2.169738 -2.329185 -2.521763 -2.702847 -2.866072 -2.997273 -3.079616 -3.191421 -3.319926 -3.428539 -3.509634 -3.537820 -3.597781 -3.629564 -3.577289 -3.181782 -1.306909 -1.554086 -1.788534 -1.996565 -2.186479 -2.355581 -2.550884 -2.732254 -2.891562 -3.012160 -3.104140 -3.219336 -3.344753 -3.448925 -3.523085 -3.545688 -3.603675 -3.630137 -3.572325 -3.181782 -1.358483 -1.597961 -1.825802 -2.035735 -2.225693 -2.401223 -2.594178 -2.771007 -2.918259 -3.036943 -3.136179 -3.251304 -3.371670 -3.469822 -3.534983 -3.554852 -3.609296 -3.630290 -3.566807 -3.181782 -1.434791 -1.665390 -1.889476 -2.095036 -2.286729 -2.462442 -2.649565 -2.811707 -2.949789 -3.071810 -3.174220 -3.285639 -3.399474 -3.490531 -3.545213 -3.565030 -3.614858 -3.629920 -3.560692 -3.181782 -1.535771 -1.755694 -1.971924 -2.174626 -2.363811 -2.536390 -2.706299 -2.856807 -2.992760 -3.114069 -3.215577 -3.321591 -3.427625 -3.509907 -3.557136 -3.575852 -3.620176 -3.628926 -3.554078 -3.181782 -1.655612 -1.865252 -2.074388 -2.271346 -2.452988 -2.609873 -2.767191 -2.911791 -3.043026 -3.160959 -3.259501 -3.358347 -3.455333 -3.527080 -3.570547 -3.587263 -3.625349 -3.627187 -3.547172 -3.181782 -1.797156 -1.994475 -2.193425 -2.377902 -2.541635 -2.689113 -2.836522 -2.972514 -3.097703 -3.211043 -3.305121 -3.395608 -3.482074 -3.544544 -3.584959 -3.597944 -3.629686 -3.624528 -3.539850 -3.181782 -1.957972 -2.139544 -2.317641 -2.485918 -2.639810 -2.775432 -2.911015 -3.037832 -3.156093 -3.263031 -3.351308 -3.432768 -3.507273 -3.563699 -3.599855 -3.608160 -3.632931 -3.620827 -3.531909 -3.181782 -2.129085 -2.286376 -2.448617 -2.603174 -2.742701 -2.866269 -2.990985 -3.107945 -3.217485 -3.316216 -3.397238 -3.468473 -3.533868 -3.584160 -3.614959 -3.617795 -3.635048 -3.615916 -3.523257 -3.181782 -2.309361 -2.445549 -2.588165 -2.725176 -2.850908 -2.963044 -3.076576 -3.182141 -3.280828 -3.370144 -3.441726 -3.504318 -3.562034 -3.605556 -3.629387 -3.625959 -3.635702 -3.609513 -3.513782 -3.181782 -2.499895 -2.612247 -2.734979 -2.855685 -2.967506 -3.066247 -3.166132 -3.259338 -3.346099 -3.424187 -3.486534 -3.541243 -3.591013 -3.626627 -3.643296 -3.632308 -3.634501 -3.601350 -3.503355 -3.181782 -2.700543 -2.791294 -2.894400 -2.996630 -3.090959 -3.174549 -3.259608 -3.339203 -3.413001 -3.480533 -3.533188 -3.578604 -3.619747 -3.647259 -3.655753 -3.636730 -3.631166 -3.591431 -3.491797 -3.181782 -2.918771 -2.984091 -3.065118 -3.147240 -3.223011 -3.289465 -3.357533 -3.422868 -3.484076 -3.539594 -3.581321 -3.616040 -3.647962 -3.666534 -3.666397 -3.638848 -3.625118 -3.579983 -3.478878 -3.181782 -3.152190 -3.193094 -3.251374 -3.311219 -3.366553 -3.414363 -3.463726 -3.512244 -3.559092 -3.601868 -3.631490 -3.654044 -3.675271 -3.684282 -3.674915 -3.638233 -3.615522 -3.566442 -3.464277 -3.181782 -3.411767 -3.426823 -3.459759 -3.495270 -3.527380 -3.552973 -3.581818 -3.611664 -3.641945 -3.669645 -3.685252 -3.693599 -3.702627 -3.700899 -3.681149 -3.635016 -3.602257 -3.550392 -3.447560 -3.181782 -3.711246 -3.697296 -3.705478 -3.715402 -3.721571 -3.721366 -3.725740 -3.732604 -3.742024 -3.751152 -3.749305 -3.740153 -3.733589 -3.717844 -3.687368 -3.636302 -3.586167 -3.531230 -3.428045 -3.181782 -4.134685 -4.082779 -4.057928 -4.035508 -4.009708 -3.975340 -3.945297 -3.920539 -3.900354 -3.880724 -3.855516 -3.817065 -3.787507 -3.754619 -3.709856 -3.648268 -3.571690 -3.510182 -3.405698 -3.181782 -8.055264 -7.903459 -7.736310 -7.554644 -7.359212 -7.150799 -6.930118 -6.697793 -6.454455 -6.200665 -5.936908 -5.663671 -5.381393 -5.090451 -4.791226 -4.484056 -4.169244 -3.847087 -3.517852 -3.181782 -1.287083 -1.532926 -1.804211 -2.049248 -2.265742 -2.435282 -2.597101 -2.789184 -2.967273 -3.124454 -3.243286 -3.327864 -3.470698 -3.596219 -3.702555 -3.760916 -3.823857 -3.876594 -3.839519 -3.401281 -1.133037 -1.408392 -1.697706 -1.962224 -2.196124 -2.368660 -2.559787 -2.770354 -2.963480 -3.130598 -3.246444 -3.334853 -3.484875 -3.614020 -3.720033 -3.768546 -3.829412 -3.878689 -3.835443 -3.401281 -1.069784 -1.359027 -1.652367 -1.921795 -2.152731 -2.349987 -2.560477 -2.780145 -2.976213 -3.145028 -3.250692 -3.356640 -3.507980 -3.635869 -3.737517 -3.774430 -3.836489 -3.880610 -3.830830 -3.401281 -1.066600 -1.359993 -1.649274 -1.911092 -2.149633 -2.368132 -2.587742 -2.803599 -3.001235 -3.162575 -3.273190 -3.390022 -3.536861 -3.660161 -3.754408 -3.783034 -3.843937 -3.882245 -3.825620 -3.401281 -1.108990 -1.397821 -1.676733 -1.937567 -2.185373 -2.413045 -2.629225 -2.841994 -3.034706 -3.187223 -3.307814 -3.429141 -3.568846 -3.685593 -3.769691 -3.794174 -3.851902 -3.883453 -3.819742 -3.401281 -1.186572 -1.465652 -1.739472 -1.999860 -2.248631 -2.472862 -2.685648 -2.893235 -3.074106 -3.225717 -3.352849 -3.471194 -3.602936 -3.711125 -3.782271 -3.807214 -3.860432 -3.884067 -3.813119 -3.401281 -1.294729 -1.566091 -1.834050 -2.090094 -2.326813 -2.546699 -2.755962 -2.952428 -3.124141 -3.276259 -3.401592 -3.515567 -3.637951 -3.735724 -3.795584 -3.821789 -3.868403 -3.883954 -3.805859 -3.401281 -1.433624 -1.694986 -1.954890 -2.193442 -2.421338 -2.636920 -2.835860 -3.018744 -3.184562 -3.332836 -3.453959 -3.561825 -3.673542 -3.758186 -3.811745 -3.836333 -3.876084 -3.882966 -3.798043 -3.401281 -1.599570 -1.844277 -2.085176 -2.315137 -2.534897 -2.739873 -2.921218 -3.092979 -3.251834 -3.391302 -3.507948 -3.608770 -3.708709 -3.779681 -3.829666 -3.850849 -3.882694 -3.880898 -3.789572 -3.401281 -1.781402 -2.007279 -2.236094 -2.454427 -2.661377 -2.844873 -3.013927 -3.173836 -3.320412 -3.451644 -3.562352 -3.655331 -3.741821 -3.804134 -3.848995 -3.865090 -3.888214 -3.877568 -3.780578 -3.401281 -1.985030 -2.191622 -2.404769 -2.601092 -2.786082 -2.958196 -3.110899 -3.255746 -3.391398 -3.514061 -3.616394 -3.699709 -3.774767 -3.830432 -3.868359 -3.878056 -3.892210 -3.872762 -3.770995 -3.401281 -2.211061 -2.388327 -2.573793 -2.752824 -2.920393 -3.071662 -3.208358 -3.340774 -3.465486 -3.577970 -3.669157 -3.742296 -3.809185 -3.857289 -3.887638 -3.889342 -3.894353 -3.866201 -3.760467 -3.401281 -2.441444 -2.592951 -2.754093 -2.909455 -3.054915 -3.188415 -3.310640 -3.429625 -3.541388 -3.641830 -3.721599 -3.785814 -3.843941 -3.883553 -3.905604 -3.898799 -3.894267 -3.857502 -3.748833 -3.401281 -2.687410 -2.805760 -2.938812 -3.071342 -3.197917 -3.313838 -3.418446 -3.521074 -3.618598 -3.706754 -3.775928 -3.829858 -3.877956 -3.907842 -3.921314 -3.905790 -3.891518 -3.846595 -3.735869 -3.401281 -2.943667 -3.032142 -3.138820 -3.246710 -3.350272 -3.445717 -3.531498 -3.616777 -3.699135 -3.773974 -3.831666 -3.873674 -3.910255 -3.929446 -3.933940 -3.909812 -3.885449 -3.833436 -3.721283 -3.401281 -3.223282 -3.278173 -3.354858 -3.435338 -3.514234 -3.587572 -3.652849 -3.719069 -3.783891 -3.843134 -3.887545 -3.916754 -3.940798 -3.948073 -3.942713 -3.910006 -3.875449 -3.818130 -3.704687 -3.401281 -3.530774 -3.552278 -3.596553 -3.646179 -3.697338 -3.744218 -3.785330 -3.829675 -3.874376 -3.915997 -3.944826 -3.959490 -3.969641 -3.963603 -3.947016 -3.905321 -3.860429 -3.799389 -3.685485 -3.401281 -3.887375 -3.871263 -3.880046 -3.894925 -3.913143 -3.929486 -3.941567 -3.959475 -3.979816 -3.999575 -4.008752 -4.005635 -3.999048 -3.977207 -3.946579 -3.897594 -3.839510 -3.775829 -3.662853 -3.401281 -4.375321 -4.309989 -4.275953 -4.250162 -4.228944 -4.203303 -4.173241 -4.152477 -4.136798 -4.122998 -4.103680 -4.072148 -4.042611 -4.004317 -3.956399 -3.895221 -3.812924 -3.747121 -3.636108 -3.401281 -9.610223 -9.426191 -9.220298 -8.993936 -8.748446 -8.485076 -8.204950 -7.909122 -7.598527 -7.274015 -6.936351 -6.586218 -6.224251 -5.851023 -5.467052 -5.072810 -4.668729 -4.255207 -3.832610 -3.401281 -1.157213 -1.456821 -1.759253 -2.049906 -2.311090 -2.520909 -2.674394 -2.889030 -3.085804 -3.266120 -3.409810 -3.481025 -3.640871 -3.781219 -3.904004 -3.975580 -4.036794 -4.101813 -4.070477 -3.599054 -0.9418704 -1.265961 -1.603503 -1.924803 -2.210774 -2.423543 -2.610495 -2.847743 -3.067520 -3.265904 -3.410068 -3.481492 -3.652030 -3.799034 -3.924143 -3.985536 -4.043567 -4.104977 -4.066486 -3.599054 -0.8346162 -1.184894 -1.536698 -1.865086 -2.146219 -2.376373 -2.597841 -2.845189 -3.075609 -3.278171 -3.408028 -3.505398 -3.676440 -3.823066 -3.945246 -3.991953 -4.051886 -4.108093 -4.061865 -3.599054 -0.8148516 -1.172654 -1.523856 -1.838612 -2.121539 -2.377985 -2.615807 -2.868168 -3.102372 -3.294971 -3.426785 -3.545572 -3.708602 -3.851353 -3.966298 -4.001106 -4.061759 -4.110978 -4.056543 -3.599054 -0.8547493 -1.208447 -1.540682 -1.849865 -2.143151 -2.410752 -2.659716 -2.911267 -3.135595 -3.317133 -3.465284 -3.591408 -3.746426 -3.881457 -3.985935 -4.014456 -4.073091 -4.113419 -4.050431 -3.599054 -0.9359706 -1.272482 -1.595333 -1.902226 -2.195582 -2.471193 -2.722931 -2.965235 -3.177099 -3.361948 -3.517143 -3.642829 -3.787044 -3.912394 -4.002521 -4.030800 -4.084411 -4.115245 -4.043432 -3.599054 -1.048147 -1.373438 -1.685987 -1.987132 -2.279484 -2.553063 -2.797342 -3.027215 -3.235333 -3.423986 -3.574277 -3.698436 -3.830195 -3.943201 -4.018243 -4.049265 -4.095436 -4.116294 -4.035594 -3.599054 -1.196743 -1.508265 -1.809742 -2.102653 -2.387572 -2.648170 -2.880712 -3.104793 -3.311759 -3.488790 -3.637418 -3.755119 -3.874711 -3.972222 -4.038139 -4.068318 -4.106014 -4.116385 -4.027167 -3.599054 -1.377803 -1.673500 -1.962508 -2.244080 -2.506644 -2.755143 -2.982537 -3.200923 -3.391333 -3.559473 -3.700338 -3.811602 -3.918251 -3.999612 -4.061248 -4.087963 -4.115637 -4.115244 -4.018052 -3.599054 -1.587429 -1.865591 -2.135345 -2.391730 -2.642616 -2.883185 -3.102391 -3.297486 -3.475970 -3.631687 -3.762989 -3.866729 -3.958899 -4.029763 -4.085793 -4.106898 -4.123975 -4.112660 -4.008116 -3.599054 -1.821225 -2.070858 -2.320278 -2.563063 -2.801678 -3.023604 -3.216079 -3.398931 -3.560835 -3.704019 -3.825536 -3.919515 -3.997685 -4.061594 -4.110948 -4.124441 -4.130770 -4.108372 -3.997176 -3.599054 -2.071672 -2.298342 -2.529673 -2.753761 -2.962986 -3.160271 -3.335773 -3.497610 -3.644695 -3.777117 -3.887410 -3.970107 -4.038445 -4.093559 -4.135135 -4.140338 -4.135666 -4.102037 -3.985687 -3.599054 -2.351102 -2.546888 -2.744518 -2.938999 -3.127617 -3.299125 -3.451678 -3.596466 -3.730478 -3.850019 -3.948340 -4.022251 -4.080292 -4.124962 -4.157250 -4.153888 -4.138109 -4.093111 -3.972920 -3.599054 -2.638154 -2.798793 -2.966152 -3.130397 -3.288682 -3.437689 -3.572083 -3.699694 -3.817632 -3.922931 -4.010540 -4.074467 -4.121682 -4.154089 -4.176501 -4.164301 -4.137417 -4.081494 -3.958614 -3.599054 -2.941784 -3.060501 -3.192728 -3.327341 -3.460392 -3.585732 -3.698445 -3.806760 -3.907696 -3.997912 -4.072692 -4.125162 -4.160637 -4.180238 -4.191946 -4.170588 -4.132657 -4.067305 -3.942438 -3.599054 -3.264896 -3.344252 -3.440364 -3.541437 -3.644711 -3.743394 -3.832841 -3.919911 -4.001236 -4.074552 -4.134083 -4.172942 -4.195812 -4.202530 -4.202558 -4.171477 -4.122903 -4.049873 -3.923912 -3.599054 -3.620646 -3.657891 -3.714269 -3.778755 -3.849085 -3.917406 -3.979157 -4.040803 -4.099386 -4.152743 -4.194855 -4.217899 -4.226298 -4.220011 -4.207058 -4.165619 -4.107517 -4.028895 -3.902322 -3.599054 -4.033895 -4.024035 -4.035265 -4.056678 -4.087433 -4.118953 -4.146606 -4.177948 -4.209507 -4.238339 -4.258994 -4.262186 -4.252748 -4.231687 -4.204464 -4.152637 -4.084862 -4.002244 -3.876617 -3.599054 -4.584063 -4.517952 -4.476014 -4.446179 -4.426574 -4.407846 -4.386681 -4.373403 -4.365480 -4.358324 -4.345798 -4.320905 -4.287572 -4.245640 -4.196622 -4.137130 -4.052678 -3.968568 -3.845441 -3.599054 -11.22807 -11.01120 -10.76490 -10.49135 -10.19262 -9.870596 -9.526965 -9.163231 -8.780727 -8.380641 -7.964028 -7.531832 -7.084896 -6.623978 -6.149762 -5.662865 -5.163854 -4.653240 -4.131495 -3.599054 -1.025090 -1.396883 -1.722749 -2.050903 -2.347383 -2.598233 -2.753196 -2.989345 -3.202263 -3.398754 -3.562904 -3.622520 -3.797038 -3.951275 -4.088291 -4.172707 -4.231152 -4.307646 -4.282875 -3.779018 -0.7422758 -1.138272 -1.510960 -1.875491 -2.210446 -2.481185 -2.666708 -2.928009 -3.167956 -3.388260 -3.561686 -3.615397 -3.804435 -3.968849 -4.111216 -4.185452 -4.238261 -4.312066 -4.279158 -3.779018 -0.5981066 -1.020940 -1.413032 -1.792504 -2.139039 -2.412518 -2.644648 -2.915862 -3.166749 -3.398199 -3.560224 -3.640038 -3.830411 -3.995429 -4.136239 -4.193514 -4.248582 -4.316646 -4.274714 -3.779018 -0.5600942 -0.9850532 -1.384758 -1.767566 -2.105730 -2.397518 -2.657540 -2.931344 -3.188796 -3.418684 -3.571825 -3.685012 -3.867070 -4.028159 -4.162014 -4.202905 -4.261662 -4.321114 -4.269459 -3.779018 -0.5895295 -1.008917 -1.407594 -1.777216 -2.112925 -2.420558 -2.694824 -2.970490 -3.228146 -3.443468 -3.610649 -3.739739 -3.910342 -4.064203 -4.186609 -4.218643 -4.275687 -4.325224 -4.263287 -3.779018 -0.6734776 -1.082015 -1.466408 -1.819299 -2.157525 -2.470835 -2.752110 -3.029863 -3.279944 -3.487128 -3.667355 -3.803132 -3.959071 -4.102215 -4.208212 -4.239039 -4.290699 -4.328720 -4.256079 -3.779018 -0.8003020 -1.189965 -1.551542 -1.898976 -2.232775 -2.545337 -2.832210 -3.103912 -3.336782 -3.551199 -3.736255 -3.868928 -4.011668 -4.140362 -4.227682 -4.261763 -4.305589 -4.331452 -4.247818 -3.779018 -0.9596962 -1.326326 -1.674796 -2.009067 -2.336242 -2.647899 -2.930516 -3.183222 -3.415987 -3.629738 -3.808587 -3.936626 -4.064316 -4.177246 -4.252251 -4.286689 -4.320231 -4.333181 -4.238913 -3.779018 -1.152439 -1.498670 -1.828760 -2.151725 -2.469235 -2.772432 -3.034164 -3.283404 -3.512583 -3.715635 -3.882509 -4.002625 -4.115174 -4.211193 -4.281012 -4.311903 -4.334166 -4.333547 -4.229285 -3.779018 -1.379404 -1.702749 -2.015850 -2.323848 -2.623289 -2.900964 -3.159550 -3.402160 -3.616996 -3.800967 -3.957594 -4.066709 -4.163673 -4.247422 -4.311708 -4.336380 -4.346795 -4.332358 -4.218790 -3.779018 -1.637894 -1.937301 -2.231601 -2.510892 -2.788018 -3.056617 -3.304971 -3.524825 -3.717629 -3.887942 -4.029583 -4.129399 -4.211010 -4.286254 -4.342996 -4.359555 -4.357692 -4.329263 -4.207251 -3.779018 -1.924142 -2.191162 -2.455624 -2.718033 -2.979752 -3.230163 -3.446338 -3.644552 -3.818084 -3.969951 -4.099754 -4.190197 -4.260811 -4.325998 -4.373294 -4.380479 -4.366336 -4.323858 -4.194383 -3.779018 -2.227327 -2.467554 -2.709256 -2.948074 -3.174442 -3.391412 -3.587399 -3.760018 -3.913607 -4.051339 -4.169128 -4.250943 -4.311557 -4.364777 -4.401416 -4.398308 -4.371943 -4.315376 -4.180587 -3.779018 -2.565929 -2.765500 -2.967633 -3.170174 -3.367708 -3.552645 -3.720148 -3.872790 -4.010497 -4.133790 -4.239050 -4.310319 -4.360507 -4.400919 -4.426261 -4.412351 -4.373553 -4.303664 -4.165104 -3.779018 -2.912147 -3.069543 -3.233175 -3.395920 -3.557801 -3.714036 -3.858761 -3.990731 -4.109957 -4.217412 -4.308718 -4.367666 -4.405424 -4.432974 -4.446476 -4.421355 -4.370059 -4.288911 -4.147481 -3.779018 -3.280657 -3.388266 -3.509511 -3.635794 -3.763461 -3.887923 -4.005518 -4.113979 -4.212426 -4.301573 -4.376865 -4.421893 -4.445100 -4.459394 -4.460512 -4.423974 -4.360259 -4.269963 -4.127143 -3.779018 -3.685641 -3.741723 -3.815454 -3.898779 -3.987989 -4.078188 -4.164378 -4.244528 -4.318560 -4.385881 -4.441949 -4.471190 -4.478371 -4.478265 -4.466286 -4.418333 -4.343694 -4.247235 -4.103234 -3.779018 -4.150757 -4.152907 -4.171600 -4.203348 -4.246779 -4.295814 -4.344084 -4.389274 -4.432877 -4.473983 -4.506368 -4.515788 -4.504308 -4.487565 -4.461791 -4.402348 -4.318815 -4.218155 -4.074258 -3.779018 -4.764229 -4.700896 -4.652067 -4.621059 -4.604817 -4.597080 -4.591994 -4.587818 -4.587009 -4.589933 -4.587976 -4.565193 -4.529451 -4.488983 -4.445379 -4.379045 -4.282388 -4.180832 -4.037692 -3.779018 -12.90406 -12.65376 -12.36566 -12.04228 -11.68733 -11.30325 -10.89236 -10.45672 -9.998104 -9.518086 -9.018037 -8.499171 -7.962564 -7.409168 -6.839845 -6.255364 -5.656433 -5.043684 -4.417699 -3.779018 -0.9012254 -1.341389 -1.700911 -2.063285 -2.387851 -2.668974 -2.834087 -3.086386 -3.316293 -3.526176 -3.706334 -3.762909 -3.943026 -4.108078 -4.257785 -4.354741 -4.408128 -4.496743 -4.479620 -3.944117 -0.5474038 -1.015288 -1.431241 -1.834912 -2.206063 -2.520990 -2.721389 -3.008893 -3.266266 -3.506643 -3.701606 -3.745927 -3.946623 -4.125288 -4.283494 -4.370713 -4.415857 -4.502542 -4.476381 -3.944117 -0.3624653 -0.8577707 -1.298452 -1.721142 -2.110694 -2.433506 -2.699598 -2.989941 -3.259708 -3.512276 -3.699911 -3.772589 -3.973327 -4.154946 -4.312759 -4.381417 -4.428123 -4.508758 -4.472324 -3.944117 -0.3034225 -0.8014738 -1.251100 -1.678801 -2.070841 -2.421026 -2.712180 -3.001819 -3.279757 -3.531778 -3.708446 -3.821243 -4.014641 -4.192291 -4.343459 -4.391032 -4.444012 -4.515022 -4.467343 -3.944117 -0.3254544 -0.8158383 -1.263012 -1.686874 -2.087443 -2.442456 -2.742263 -3.039898 -3.316222 -3.560494 -3.751147 -3.881906 -4.066159 -4.234624 -4.373641 -4.409398 -4.461806 -4.521117 -4.461308 -3.944117 -0.4101823 -0.8827441 -1.321073 -1.742367 -2.133708 -2.480242 -2.796531 -3.092687 -3.368690 -3.610421 -3.810012 -3.952839 -4.124018 -4.280625 -4.401430 -4.433905 -4.480559 -4.526687 -4.454083 -3.944117 -0.5419399 -0.9954286 -1.421922 -1.823825 -2.197457 -2.551003 -2.868090 -3.165735 -3.435777 -3.677230 -3.881707 -4.029236 -4.184307 -4.327110 -4.425856 -4.462123 -4.500032 -4.531505 -4.445588 -3.944117 -0.7176098 -1.149109 -1.548696 -1.928625 -2.298129 -2.643920 -2.964100 -3.257117 -3.521613 -3.758022 -3.963779 -4.105634 -4.246332 -4.372309 -4.455541 -4.492691 -4.519526 -4.535251 -4.436359 -3.944117 -0.9293116 -1.327655 -1.703547 -2.070175 -2.425071 -2.767742 -3.082325 -3.365635 -3.619470 -3.853898 -4.052382 -4.182490 -4.307175 -4.414007 -4.489977 -4.523732 -4.538008 -4.537540 -4.426392 -3.944117 -1.169587 -1.540924 -1.893892 -2.242445 -2.587704 -2.918400 -3.215925 -3.485738 -3.735432 -3.959622 -4.137850 -4.259959 -4.366127 -4.457926 -4.527066 -4.554100 -4.554862 -4.538075 -4.415510 -3.944117 -1.446826 -1.788031 -2.120028 -2.450357 -2.776342 -3.079762 -3.365665 -3.627329 -3.861687 -4.058005 -4.224219 -4.332788 -4.422865 -4.504909 -4.564994 -4.582940 -4.569783 -4.536407 -4.403514 -3.944117 -1.757074 -2.069658 -2.379075 -2.676641 -2.973449 -3.265442 -3.538399 -3.773284 -3.978328 -4.157225 -4.304364 -4.401591 -4.481382 -4.552498 -4.602068 -4.609388 -4.582153 -4.531967 -4.390137 -3.944117 -2.096885 -2.373743 -2.648266 -2.924474 -3.202194 -3.466910 -3.702466 -3.911961 -4.091903 -4.249100 -4.382405 -4.470673 -4.539639 -4.598755 -4.636527 -4.632709 -4.591012 -4.524036 -4.374996 -3.944117 -2.463004 -2.705928 -2.952136 -3.190857 -3.426668 -3.656031 -3.861118 -4.039681 -4.198167 -4.339968 -4.460940 -4.539287 -4.595615 -4.641965 -4.666980 -4.651680 -4.595381 -4.512289 -4.358563 -3.944117 -2.861131 -3.053060 -3.253180 -3.451861 -3.647605 -3.836613 -4.011502 -4.167324 -4.307574 -4.432222 -4.537875 -4.605330 -4.647423 -4.680358 -4.692122 -4.664724 -4.593755 -4.497142 -4.339720 -3.944117 -3.277695 -3.414707 -3.562249 -3.714710 -3.870466 -4.025764 -4.171569 -4.301267 -4.418989 -4.524520 -4.612555 -4.666596 -4.693391 -4.711601 -4.710068 -4.669899 -4.584935 -4.477486 -4.317797 -3.944117 -3.730448 -3.807073 -3.901027 -4.004139 -4.115175 -4.231043 -4.342649 -4.441895 -4.532771 -4.616046 -4.683428 -4.720502 -4.731307 -4.732945 -4.718163 -4.664865 -4.568390 -4.451656 -4.291786 -3.944117 -4.246310 -4.258992 -4.291186 -4.337165 -4.396598 -4.464191 -4.533211 -4.594716 -4.652169 -4.706889 -4.750051 -4.766109 -4.758396 -4.741252 -4.713147 -4.647369 -4.541740 -4.418360 -4.259971 -3.944117 -4.920765 -4.858925 -4.812565 -4.783517 -4.773933 -4.778039 -4.787333 -4.795114 -4.804808 -4.817744 -4.825795 -4.810376 -4.775143 -4.734943 -4.691638 -4.615475 -4.504010 -4.374684 -4.219031 -3.944117 -14.63411 -14.34977 -14.01782 -13.64280 -13.22884 -12.77951 -12.29790 -11.78668 -11.24814 -10.68424 -10.09669 -9.487007 -8.856495 -8.206324 -7.537535 -6.851061 -6.147749 -5.428365 -4.693607 -3.944117 -0.7778465 -1.292555 -1.683527 -2.085778 -2.440208 -2.742957 -2.937691 -3.175466 -3.422288 -3.648291 -3.840848 -3.913376 -4.079170 -4.254412 -4.414618 -4.523003 -4.571074 -4.672049 -4.662922 -4.096621 -0.3582348 -0.9027204 -1.364814 -1.813681 -2.213551 -2.560578 -2.783881 -3.078497 -3.360880 -3.618913 -3.833275 -3.881482 -4.079715 -4.270716 -4.443206 -4.542747 -4.579476 -4.679444 -4.660371 -4.096621 -0.1385159 -0.7037609 -1.204529 -1.667156 -2.089523 -2.448440 -2.747150 -3.060325 -3.352951 -3.622434 -3.831001 -3.906038 -4.108922 -4.302739 -4.476473 -4.556159 -4.594378 -4.687651 -4.656911 -4.096621 -5.5307351E-02 -0.6228900 -1.129584 -1.600329 -2.032328 -2.422158 -2.761378 -3.077830 -3.370319 -3.643992 -3.834314 -3.959897 -4.155673 -4.345526 -4.512366 -4.566316 -4.613184 -4.696151 -4.652416 -4.096621 -6.6683792E-02 -0.6241340 -1.125599 -1.596113 -2.038393 -2.446938 -2.799073 -3.110721 -3.408939 -3.672885 -3.879058 -4.027447 -4.213398 -4.395609 -4.549044 -4.587800 -4.634672 -4.704746 -4.646736 -4.096621 -0.1495195 -0.6865692 -1.178795 -1.645854 -2.092266 -2.498129 -2.846175 -3.162856 -3.460240 -3.721656 -3.944996 -4.102104 -4.278932 -4.448615 -4.583611 -4.616811 -4.657923 -4.713008 -4.639699 -4.096621 -0.2870940 -0.8006650 -1.277809 -1.738171 -2.172132 -2.561853 -2.913501 -3.233800 -3.526552 -3.795896 -4.019989 -4.182341 -4.350145 -4.503636 -4.613342 -4.650747 -4.682103 -4.720540 -4.631174 -4.096621 -0.4713022 -0.9585856 -1.418535 -1.858875 -2.265999 -2.651299 -3.004073 -3.321115 -3.618047 -3.885554 -4.105358 -4.268542 -4.421119 -4.557799 -4.648099 -4.686817 -4.706108 -4.726963 -4.621817 -4.096621 -0.6982012 -1.156639 -1.586193 -1.994320 -2.393473 -2.768888 -3.116825 -3.435827 -3.727449 -3.981772 -4.201408 -4.358103 -4.493291 -4.608285 -4.689099 -4.723620 -4.729355 -4.731892 -4.611726 -4.096621 -0.9626982 -1.380200 -1.778544 -2.170548 -2.550019 -2.918025 -3.261031 -3.569018 -3.842661 -4.093690 -4.304194 -4.444839 -4.562794 -4.660017 -4.733648 -4.760325 -4.750852 -4.734909 -4.600698 -4.096621 -1.255326 -1.637536 -2.010789 -2.379244 -2.745133 -3.100572 -3.421812 -3.711208 -3.979073 -4.216489 -4.400620 -4.529358 -4.628622 -4.715053 -4.779081 -4.795724 -4.770549 -4.735438 -4.588500 -4.096621 -1.586638 -1.934695 -2.282648 -2.627789 -2.968770 -3.293099 -3.599696 -3.878390 -4.123839 -4.328619 -4.497127 -4.607743 -4.695446 -4.770758 -4.822699 -4.828764 -4.787344 -4.732873 -4.574836 -4.096621 -1.954524 -2.270534 -2.585312 -2.893725 -3.206289 -3.514294 -3.803154 -4.043459 -4.257341 -4.438051 -4.585404 -4.685695 -4.761425 -4.824923 -4.863303 -4.857775 -4.800303 -4.726492 -4.559343 -4.096621 -2.354127 -2.627138 -2.907041 -3.189459 -3.475577 -3.740453 -3.985266 -4.197780 -4.380543 -4.538873 -4.672211 -4.762979 -4.824653 -4.875536 -4.900018 -4.881601 -4.808100 -4.715777 -4.541717 -4.096621 -2.792291 -3.022530 -3.254405 -3.488377 -3.726829 -3.952389 -4.158023 -4.337024 -4.498386 -4.640221 -4.758595 -4.837004 -4.884308 -4.920498 -4.931070 -4.898666 -4.809104 -4.701275 -4.521951 -4.096621 -3.254668 -3.423428 -3.603913 -3.784997 -3.970963 -4.155478 -4.328938 -4.481686 -4.618659 -4.740622 -4.841750 -4.905483 -4.937987 -4.957067 -4.953676 -4.907444 -4.801693 -4.681699 -4.498742 -4.096621 -3.754806 -3.854163 -3.973803 -4.100385 -4.236327 -4.376944 -4.511611 -4.631964 -4.740825 -4.838799 -4.918608 -4.965219 -4.981738 -4.982327 -4.964581 -4.904547 -4.785048 -4.654644 -4.470924 -4.096621 -4.324664 -4.348401 -4.396558 -4.459361 -4.537628 -4.626266 -4.713255 -4.792655 -4.866192 -4.934079 -4.987279 -5.013028 -5.010936 -4.992240 -4.959590 -4.886750 -4.755282 -4.617997 -4.436533 -4.096621 -5.056663 -4.995698 -4.954385 -4.932961 -4.933196 -4.950200 -4.972281 -4.993593 -5.016732 -5.041725 -5.057718 -5.051786 -5.022995 -4.981444 -4.931629 -4.850325 -4.712822 -4.566952 -4.391570 -4.096621 -16.41466 -16.09571 -15.71861 -15.28952 -14.81385 -14.29631 -13.74079 -13.15063 -12.52864 -11.87725 -11.19851 -10.49423 -9.765972 -9.015121 -8.242917 -7.450458 -6.638739 -5.808659 -4.961035 -4.096621 -0.6506115 -1.234526 -1.673369 -2.108683 -2.489833 -2.820912 -3.042678 -3.263567 -3.522025 -3.761157 -3.968194 -4.057513 -4.207351 -4.391627 -4.560574 -4.679164 -4.722820 -4.834870 -4.834416 -4.238315 -0.1679038 -0.7933521 -1.299821 -1.792087 -2.232496 -2.610889 -2.849119 -3.143816 -3.444836 -3.725094 -3.956820 -4.013752 -4.203783 -4.407295 -4.591531 -4.702447 -4.732320 -4.844007 -4.832758 -4.238315 8.3204895E-02 -0.5582119 -1.115917 -1.629032 -2.091020 -2.472739 -2.791907 -3.117379 -3.437235 -3.729086 -3.955601 -4.035665 -4.236778 -4.442234 -4.629440 -4.719200 -4.749940 -4.854410 -4.830110 -4.238315 0.1919046 -0.4543775 -1.023489 -1.546804 -2.007176 -2.425763 -2.794821 -3.139381 -3.462315 -3.750588 -3.958470 -4.092948 -4.291441 -4.490274 -4.671378 -4.729856 -4.772753 -4.865515 -4.826323 -4.238315 0.1873554 -0.4397389 -1.003565 -1.516897 -1.995373 -2.439160 -2.833929 -3.184348 -3.501088 -3.784743 -4.000866 -4.166085 -4.355552 -4.546465 -4.714483 -4.753691 -4.799100 -4.876958 -4.821218 -4.238315 0.1069420 -0.4956650 -1.041819 -1.554423 -2.040829 -2.493804 -2.895942 -3.238508 -3.554323 -3.832450 -4.068066 -4.249272 -4.427020 -4.608261 -4.755445 -4.786862 -4.827805 -4.888242 -4.814588 -4.238315 -3.5430435E-02 -0.6083469 -1.138595 -1.643075 -2.126764 -2.575205 -2.964246 -3.304941 -3.622258 -3.906741 -4.151553 -4.332973 -4.505271 -4.671751 -4.791409 -4.825939 -4.857391 -4.898941 -4.806244 -4.238315 -0.2284218 -0.7714231 -1.279481 -1.770552 -2.240332 -2.665666 -3.046290 -3.393771 -3.709332 -4.001167 -4.243489 -4.423340 -4.588384 -4.735135 -4.832711 -4.869089 -4.886741 -4.908604 -4.796957 -4.238315 -0.4677042 -0.9768414 -1.459568 -1.926935 -2.366362 -2.778040 -3.158583 -3.501204 -3.822303 -4.109131 -4.340434 -4.521109 -4.670235 -4.795532 -4.881224 -4.913190 -4.915443 -4.916791 -4.786966 -4.238315 -0.7489506 -1.220364 -1.669952 -2.101843 -2.523430 -2.923157 -3.295893 -3.639761 -3.952035 -4.220883 -4.450024 -4.620795 -4.751277 -4.855691 -4.932957 -4.956717 -4.942347 -4.922944 -4.776037 -4.238315 -1.065718 -1.489797 -1.907040 -2.316066 -2.714916 -3.104373 -3.468949 -3.796112 -4.087568 -4.351142 -4.567333 -4.715097 -4.827955 -4.919171 -4.985162 -4.998117 -4.967066 -4.926394 -4.763880 -4.238315 -1.412845 -1.800137 -2.186282 -2.568242 -2.950011 -3.323207 -3.657220 -3.965648 -4.247924 -4.488979 -4.676408 -4.806705 -4.902729 -4.983352 -5.036040 -5.036801 -4.988740 -4.926530 -4.750165 -4.238315 -1.805014 -2.154550 -2.508726 -2.864505 -3.210086 -3.548726 -3.870276 -4.162220 -4.407384 -4.616394 -4.781114 -4.894207 -4.976891 -5.045266 -5.084339 -5.071729 -5.006155 -4.922545 -4.734490 -4.238315 -2.237974 -2.545768 -2.858066 -3.172166 -3.494356 -3.812166 -4.094392 -4.340096 -4.553864 -4.732657 -4.877742 -4.979416 -5.049419 -5.103118 -5.128006 -5.102119 -5.017988 -4.913762 -4.716285 -4.238315 -2.705311 -2.965612 -3.241419 -3.516022 -3.788849 -4.055757 -4.296444 -4.502566 -4.683743 -4.842142 -4.971957 -5.060188 -5.117984 -5.155447 -5.165034 -5.125253 -5.022525 -4.900773 -4.695556 -4.238315 -3.215984 -3.414402 -3.631334 -3.847253 -4.067698 -4.282121 -4.479914 -4.656796 -4.814003 -4.951220 -5.061995 -5.134986 -5.178397 -5.200123 -5.192831 -5.137917 -5.017902 -4.882146 -4.671262 -4.238315 -3.765300 -3.886101 -4.031003 -4.187252 -4.351369 -4.518270 -4.674937 -4.816936 -4.944716 -5.057103 -5.145463 -5.200843 -5.226363 -5.233090 -5.208362 -5.136397 -5.002881 -4.855298 -4.641837 -4.238315 -4.387984 -4.424071 -4.489324 -4.571794 -4.672009 -4.781707 -4.888675 -4.986024 -5.076829 -5.158111 -5.218610 -5.252156 -5.256784 -5.248043 -5.206029 -5.117729 -4.972861 -4.816649 -4.605051 -4.238315 -5.175853 -5.117315 -5.082459 -5.071487 -5.086984 -5.117346 -5.153838 -5.188602 -5.226700 -5.263007 -5.285457 -5.287346 -5.264732 -5.235658 -5.175821 -5.077289 -4.925501 -4.759969 -4.556233 -4.238315 -18.24260 -17.88844 -17.46471 -16.97941 -16.43957 -15.85101 -15.21859 -14.54636 -13.83771 -13.09550 -12.32216 -11.51982 -10.69029 -9.835195 -8.955964 -8.053876 -7.130076 -6.185604 -5.221395 -4.238315 -0.5715898 -1.130342 -1.647838 -2.124051 -2.541785 -2.893733 -3.145186 -3.352706 -3.619443 -3.867730 -4.087040 -4.194793 -4.328872 -4.520040 -4.696363 -4.825997 -4.864548 -4.986460 -4.995520 -4.370631 3.1995427E-02 -0.6645250 -1.229027 -1.772085 -2.246850 -2.659442 -2.924874 -3.212256 -3.524891 -3.821583 -4.073719 -4.141065 -4.321402 -4.534716 -4.729397 -4.853654 -4.875073 -4.997396 -4.994985 -4.370631 0.3097141 -0.4081199 -1.030742 -1.589114 -2.091111 -2.516080 -2.845560 -3.177166 -3.511652 -3.826926 -4.075447 -4.161363 -4.359063 -4.573824 -4.771281 -4.874270 -4.895631 -5.010178 -4.993395 -4.370631 0.4342056 -0.2891347 -0.9200444 -1.492534 -2.005600 -2.444014 -2.831473 -3.193192 -3.541277 -3.856646 -4.077874 -4.221441 -4.420042 -4.626831 -4.819072 -4.886419 -4.923145 -5.024138 -4.990562 -4.370631 0.4429792 -0.2616159 -0.8857291 -1.459375 -1.969460 -2.437296 -2.859587 -3.241681 -3.592425 -3.892827 -4.122062 -4.298840 -4.492907 -4.688684 -4.869022 -4.912595 -4.955201 -5.038666 -4.986269 -4.370631 0.3605911 -0.3094036 -0.9189074 -1.475569 -1.996140 -2.482687 -2.921726 -3.312257 -3.651257 -3.943181 -4.190136 -4.385951 -4.572165 -4.757294 -4.916875 -4.950592 -4.989463 -5.053260 -4.980288 -4.370631 0.2133132 -0.4214137 -1.004544 -1.554173 -2.076416 -2.565347 -3.009381 -3.385196 -3.717189 -4.018955 -4.275692 -4.478772 -4.656483 -4.830735 -4.960625 -4.996132 -5.024859 -5.067437 -4.972357 -4.370631 1.1263122E-02 -0.5852748 -1.145851 -1.679824 -2.195710 -2.676767 -3.098244 -3.465650 -3.808251 -4.111398 -4.373065 -4.573477 -4.746046 -4.903471 -5.009648 -5.046053 -5.060173 -5.080699 -4.963313 -4.370631 -0.2396331 -0.7991064 -1.328656 -1.845803 -2.341994 -2.793859 -3.200665 -3.577006 -3.914679 -4.223631 -4.478307 -4.674717 -4.840197 -4.973139 -5.065704 -5.096779 -5.094616 -5.092426 -4.953627 -4.370631 -0.5352231 -1.053133 -1.552730 -2.043682 -2.499962 -2.934964 -3.338314 -3.707864 -4.048538 -4.348824 -4.590527 -4.783003 -4.931271 -5.044217 -5.124738 -5.146510 -5.127773 -5.102113 -4.942977 -4.370631 -0.8689943 -1.344881 -1.806633 -2.256517 -2.695348 -3.111972 -3.507076 -3.872754 -4.198452 -4.481100 -4.717599 -4.892048 -5.020063 -5.116737 -5.184706 -5.194678 -5.158212 -5.108935 -4.931039 -4.370631 -1.239839 -1.669326 -2.093058 -2.513307 -2.927639 -3.333136 -3.715454 -4.052541 -4.360353 -4.633467 -4.845906 -4.996412 -5.105623 -5.188313 -5.243283 -5.240310 -5.184896 -5.112241 -4.917455 -4.370631 -1.652841 -2.038958 -2.426181 -2.816976 -3.209647 -3.583811 -3.932851 -4.256488 -4.546935 -4.782047 -4.965971 -5.094521 -5.189227 -5.258313 -5.298683 -5.281927 -5.207000 -5.111050 -4.901782 -4.370631 -2.112366 -2.453973 -2.807757 -3.154822 -3.508471 -3.858227 -4.187536 -4.471952 -4.714851 -4.918053 -5.074486 -5.186150 -5.270340 -5.325025 -5.349542 -5.317379 -5.223336 -5.104492 -4.883469 -4.370631 -2.614667 -2.902472 -3.207988 -3.523523 -3.846925 -4.146633 -4.422315 -4.661677 -4.866505 -5.037961 -5.177163 -5.274784 -5.344700 -5.386160 -5.393684 -5.344545 -5.232521 -5.093116 -4.861829 -4.370631 -3.170478 -3.395262 -3.641056 -3.897556 -4.157507 -4.405367 -4.629251 -4.828449 -5.006036 -5.156545 -5.275801 -5.357886 -5.410342 -5.438096 -5.428106 -5.361373 -5.231919 -5.075352 -4.836611 -4.370631 -3.764760 -3.909188 -4.080007 -4.265731 -4.461035 -4.655293 -4.836928 -4.999339 -5.146077 -5.270887 -5.367172 -5.431018 -5.464804 -5.475669 -5.448354 -5.364487 -5.219640 -5.048415 -4.805752 -4.370631 -4.438363 -4.486623 -4.571640 -4.677177 -4.801037 -4.934019 -5.061068 -5.177902 -5.286138 -5.378127 -5.446134 -5.487342 -5.500061 -5.492300 -5.447567 -5.348693 -5.190123 -5.007908 -4.766761 -4.370631 -5.279660 -5.223110 -5.200009 -5.202685 -5.232322 -5.280515 -5.330253 -5.381632 -5.434667 -5.482071 -5.511069 -5.520705 -5.507369 -5.477259 -5.413711 -5.304929 -5.136049 -4.947053 -4.714368 -4.370631 -20.11515 -19.72523 -19.25337 -18.70988 -18.10345 -17.44128 -16.72918 -15.97198 -15.17366 -14.33754 -13.46646 -12.56284 -11.62879 -10.66617 -9.676591 -8.661524 -7.622272 -6.560010 -5.475806 -4.370631 -0.5064820 -1.150779 -1.636045 -2.123374 -2.579921 -2.961414 -3.241649 -3.440346 -3.716033 -3.970661 -4.198543 -4.325404 -4.443946 -4.641733 -4.823998 -4.963609 -4.997047 -5.128436 -5.147131 -4.494734 0.2062581 -0.5311027 -1.150084 -1.732635 -2.259245 -2.701586 -2.996728 -3.286942 -3.605343 -3.912495 -4.181153 -4.265460 -4.434025 -4.655389 -4.859181 -4.996455 -5.008299 -5.141307 -5.147906 -4.494734 0.5387807 -0.2445368 -0.9257880 -1.552053 -2.090353 -2.549917 -2.912643 -3.244530 -3.586254 -3.914204 -4.187656 -4.283780 -4.477476 -4.698025 -4.904720 -5.021431 -5.032515 -5.156647 -5.147537 -4.494734 0.6800042 -0.1137134 -0.8188344 -1.439555 -1.995375 -2.477822 -2.881752 -3.251428 -3.612664 -3.949571 -4.195528 -4.348536 -4.544673 -4.757870 -4.957073 -5.035832 -5.064969 -5.173684 -5.145830 -4.494734 0.6934277 -8.4739946E-02 -0.7709058 -1.396751 -1.959164 -2.453347 -2.890451 -3.293648 -3.668696 -3.998280 -4.239443 -4.430584 -4.625378 -4.826388 -5.012998 -5.064891 -5.102339 -5.191679 -5.142541 -4.494734 0.6127586 -0.1263863 -0.7953303 -1.412060 -1.968885 -2.476568 -2.942556 -3.364412 -3.742676 -4.052164 -4.312013 -4.519909 -4.714096 -4.902131 -5.069786 -5.108973 -5.142380 -5.209980 -5.137407 -4.494734 0.4595851 -0.2365545 -0.8802159 -1.476471 -2.031579 -2.552090 -3.028814 -3.457297 -3.816597 -4.128222 -4.398446 -4.617516 -4.806167 -4.982408 -5.121420 -5.161467 -5.183591 -5.228028 -5.130131 -4.494734 0.2483475 -0.4038056 -1.015714 -1.594984 -2.148146 -2.665453 -3.141821 -3.547202 -3.902319 -4.223472 -4.497241 -4.721827 -4.901880 -5.064830 -5.178060 -5.217841 -5.225113 -5.245270 -5.121597 -4.494734 -1.4873963E-02 -0.6217089 -1.201490 -1.764032 -2.301057 -2.806093 -3.251534 -3.649323 -4.013248 -4.334810 -4.609815 -4.825486 -5.003034 -5.145875 -5.243285 -5.274426 -5.265836 -5.260988 -5.112451 -4.494734 -0.3250533 -0.8864581 -1.431775 -1.971386 -2.481680 -2.950446 -3.382794 -3.782632 -4.143040 -4.466911 -4.729644 -4.937730 -5.108091 -5.226561 -5.310359 -5.330695 -5.304779 -5.274475 -5.102396 -4.494734 -0.6756038 -1.194136 -1.704554 -2.205286 -2.675104 -3.129123 -3.548992 -3.943406 -4.301358 -4.608891 -4.858674 -5.059733 -5.206785 -5.308727 -5.376865 -5.385541 -5.340811 -5.284881 -5.091058 -4.494734 -1.069000 -1.541900 -2.003799 -2.464069 -2.911736 -3.344784 -3.758070 -4.140448 -4.471525 -4.763725 -5.002295 -5.175605 -5.306218 -5.389291 -5.442354 -5.437058 -5.373369 -5.291502 -5.077940 -4.494734 -1.502240 -1.922320 -2.346639 -2.771303 -3.197844 -3.612634 -3.997128 -4.347323 -4.665319 -4.938116 -5.137719 -5.287265 -5.399114 -5.467799 -5.505194 -5.484007 -5.401597 -5.293119 -5.062565 -4.494734 -1.986430 -2.356294 -2.741087 -3.134711 -3.523391 -3.900221 -4.259736 -4.590013 -4.866674 -5.090858 -5.264185 -5.389064 -5.486053 -5.541745 -5.563334 -5.525432 -5.424058 -5.288687 -5.044304 -4.494734 -2.522723 -2.838206 -3.171769 -3.519476 -3.878633 -4.230195 -4.536709 -4.810749 -5.042555 -5.229169 -5.377240 -5.486303 -5.567650 -5.609287 -5.614245 -5.559819 -5.438406 -5.278848 -5.022262 -4.494734 -3.107940 -3.364932 -3.645852 -3.936532 -4.236035 -4.522647 -4.775887 -4.999362 -5.193799 -5.357198 -5.484923 -5.577903 -5.642286 -5.667870 -5.654725 -5.583134 -5.441807 -5.261967 -4.996366 -4.494734 -3.752956 -3.922105 -4.123195 -4.339298 -4.565819 -4.789192 -4.993089 -5.179030 -5.342874 -5.480216 -5.584355 -5.658200 -5.704468 -5.711749 -5.679788 -5.590483 -5.431995 -5.235253 -4.964528 -4.494734 -4.478279 -4.540679 -4.645697 -4.774834 -4.925475 -5.080160 -5.224924 -5.363894 -5.489493 -5.595778 -5.670378 -5.718867 -5.745714 -5.732769 -5.681557 -5.575514 -5.403274 -5.193500 -4.923820 -4.494734 -5.378185 -5.318733 -5.306466 -5.324771 -5.374465 -5.434433 -5.498497 -5.569672 -5.638164 -5.701437 -5.736350 -5.752497 -5.754129 -5.717357 -5.646040 -5.527523 -5.345402 -5.128998 -4.868049 -4.494734 -22.02986 -21.60359 -21.08246 -20.47857 -19.80333 -19.06504 -18.27066 -17.42577 -16.53497 -15.60207 -14.63032 -13.62245 -12.58087 -11.50766 -10.40491 -9.273770 -8.115702 -6.932519 -5.725166 -4.494734 -0.4194027 -1.206384 -1.757506 -2.113211 -2.621429 -3.014359 -3.328594 -3.521207 -3.809897 -4.070765 -4.304766 -4.449116 -4.553388 -4.757547 -4.944692 -5.092537 -5.121869 -5.261245 -5.289537 -4.611584 0.3680901 -0.4544191 -1.073730 -1.687331 -2.250830 -2.741914 -3.063432 -3.356750 -3.687763 -4.001234 -4.281384 -4.385108 -4.541653 -4.770803 -4.982533 -5.130241 -5.134439 -5.275958 -5.291646 -4.611584 0.7515842 -8.5739918E-02 -0.8169216 -1.479259 -2.086131 -2.581419 -2.970293 -3.321961 -3.664122 -3.999294 -4.289000 -4.404367 -4.591708 -4.817719 -5.032374 -5.158812 -5.162544 -5.293928 -5.292556 -4.611584 0.9238165 6.7006841E-02 -0.6907485 -1.382934 -1.983261 -2.501277 -2.942967 -3.319660 -3.685468 -4.033587 -4.304652 -4.473707 -4.666496 -4.883632 -5.089574 -5.175186 -5.200081 -5.314036 -5.292029 -4.611584 0.9477280 0.1019305 -0.6565689 -1.334241 -1.941439 -2.478945 -2.938199 -3.349511 -3.738349 -4.090904 -4.356162 -4.560457 -4.754961 -4.960717 -5.151819 -5.207053 -5.243109 -5.335559 -5.289812 -4.611584 0.8645824 5.4147087E-02 -0.6728694 -1.345082 -1.951174 -2.488588 -2.969023 -3.413291 -3.816133 -4.157747 -4.429142 -4.654415 -4.850541 -5.044579 -5.215540 -5.256928 -5.289259 -5.357722 -5.285565 -4.611584 0.7039793 -5.4707386E-02 -0.7551242 -1.408623 -2.001789 -2.542934 -3.047556 -3.505797 -3.907666 -4.237568 -4.520086 -4.753364 -4.951666 -5.131526 -5.276316 -5.315089 -5.337133 -5.379748 -5.278929 -4.611584 0.4830439 -0.2251088 -0.8933309 -1.517979 -2.103518 -2.652330 -3.161158 -3.618824 -4.000674 -4.333847 -4.619116 -4.860965 -5.055746 -5.222182 -5.339357 -5.376736 -5.384901 -5.401119 -5.270830 -4.611584 0.2064257 -0.4503435 -1.077174 -1.685788 -2.256802 -2.799308 -3.297122 -3.727399 -4.108659 -4.447496 -4.734568 -4.976212 -5.162308 -5.314279 -5.411204 -5.440732 -5.431407 -5.420989 -5.262264 -4.611584 -0.1180260 -0.7235795 -1.315218 -1.896313 -2.448610 -2.968642 -3.430924 -3.856005 -4.239775 -4.578557 -4.863467 -5.092051 -5.274826 -5.403201 -5.485535 -5.505374 -5.475965 -5.438493 -5.252790 -4.611584 -0.4848734 -1.046109 -1.597881 -2.145922 -2.665547 -3.144033 -3.599119 -4.015328 -4.396862 -4.731354 -4.996778 -5.218673 -5.387486 -5.494878 -5.560823 -5.566682 -5.518352 -5.452978 -5.241961 -4.611584 -0.8954021 -1.410744 -1.920936 -2.416091 -2.899993 -3.364514 -3.800997 -4.214362 -4.584869 -4.890346 -5.145601 -5.350760 -5.494294 -5.584183 -5.635104 -5.624720 -5.557519 -5.463415 -5.229338 -4.611584 -1.351852 -1.809189 -2.270666 -2.729863 -3.186262 -3.632011 -4.054689 -4.439481 -4.778810 -5.072820 -5.303864 -5.473776 -5.597226 -5.669990 -5.705724 -5.678807 -5.591785 -5.468661 -5.214397 -4.611584 -1.857546 -2.259786 -2.674513 -3.100647 -3.532261 -3.943065 -4.329540 -4.689928 -5.006927 -5.253738 -5.447385 -5.589993 -5.693293 -5.751587 -5.770689 -5.727241 -5.619295 -5.467547 -5.196449 -4.611584 -2.422062 -2.769970 -3.134891 -3.513854 -3.903371 -4.286792 -4.646469 -4.949050 -5.208019 -5.413512 -5.572997 -5.696806 -5.784311 -5.826581 -5.828141 -5.767334 -5.637979 -5.460951 -5.174565 -4.611584 -3.041504 -3.322164 -3.635718 -3.971596 -4.304923 -4.626093 -4.915755 -5.165015 -5.378066 -5.553263 -5.689953 -5.795835 -5.866865 -5.891632 -5.874595 -5.795674 -5.644907 -5.446984 -5.148088 -4.611584 -3.730738 -3.925907 -4.157457 -4.408587 -4.669294 -4.917196 -5.146166 -5.354290 -5.537333 -5.686365 -5.798920 -5.883966 -5.935659 -5.941200 -5.905100 -5.807848 -5.637655 -5.422261 -5.115723 -4.611584 -4.510217 -4.585143 -4.712188 -4.867145 -5.046002 -5.222358 -5.392011 -5.550169 -5.692834 -5.809494 -5.892154 -5.953318 -5.981907 -5.966388 -5.911067 -5.796732 -5.610147 -5.380953 -5.073935 -4.611584 -5.469839 -5.405987 -5.404297 -5.440956 -5.510021 -5.587191 -5.673953 -5.761385 -5.845069 -5.915375 -5.959028 -5.988077 -5.990750 -5.952022 -5.876568 -5.747096 -5.550815 -5.314241 -5.016243 -4.611584 -23.98451 -23.52134 -22.94906 -22.28341 -21.53717 -20.72047 -19.84134 -18.90620 -17.92029 -16.88794 -15.81276 -14.69787 -13.54595 -12.35932 -11.14004 -9.889944 -8.610653 -7.303632 -5.970207 -4.611584 -0.3283474 -1.185699 -1.855937 -2.362364 -2.619803 -3.068395 -3.421973 -3.597873 -3.899346 -4.167619 -4.406985 -4.566850 -4.657231 -4.867537 -5.059219 -5.215052 -5.239703 -5.386348 -5.424995 -4.721982 0.5310811 -0.3708657 -1.109488 -1.660400 -2.223289 -2.754897 -3.125889 -3.420998 -3.767696 -4.089019 -4.377938 -4.500081 -4.645112 -4.880946 -5.099619 -5.257447 -5.253425 -5.403074 -5.428755 -4.721982 0.9592977 3.3382010E-02 -0.7235228 -1.413886 -2.045319 -2.608974 -3.023249 -3.388969 -3.747104 -4.083987 -4.384530 -4.519030 -4.701848 -4.932715 -5.154428 -5.290742 -5.285497 -5.423885 -5.431291 -4.721982 1.152005 0.2385580 -0.5666782 -1.298746 -1.965615 -2.520094 -2.991838 -3.396182 -3.762927 -4.116204 -4.404315 -4.597695 -4.785751 -5.004986 -5.218130 -5.310191 -5.328469 -5.447225 -5.432338 -4.721982 1.194077 0.2893506 -0.5234809 -1.268737 -1.920570 -2.493940 -2.992081 -3.415469 -3.808681 -4.174522 -4.463213 -4.689223 -4.882773 -5.088871 -5.287146 -5.345523 -5.377690 -5.472335 -5.431529 -4.721982 1.116007 0.2422785 -0.5512671 -1.276771 -1.927026 -2.507164 -3.011927 -3.464370 -3.883010 -4.251068 -4.547749 -4.787050 -4.983469 -5.181440 -5.357395 -5.399683 -5.430369 -5.498458 -5.428531 -4.721982 0.9468364 0.1234241 -0.6325670 -1.335971 -1.979294 -2.550220 -3.069970 -3.550861 -3.981052 -4.345602 -4.636690 -4.890118 -5.091111 -5.276308 -5.424747 -5.464170 -5.484743 -5.524689 -5.422938 -4.721982 0.7148281 -5.0163779E-02 -0.7708098 -1.450452 -2.069247 -2.641870 -3.178719 -3.668127 -4.093513 -4.443122 -4.741968 -4.999108 -5.203243 -5.373136 -5.496383 -5.533542 -5.538670 -5.550410 -5.415672 -4.721982 0.4231788 -0.2826807 -0.9610376 -1.610874 -2.215091 -2.788075 -3.322450 -3.800452 -4.204146 -4.557550 -4.856415 -5.119866 -5.316108 -5.472117 -5.575994 -5.604703 -5.591687 -5.574901 -5.408067 -4.721982 9.0026565E-02 -0.5665953 -1.201404 -1.824454 -2.409902 -2.971192 -3.481862 -3.929407 -4.335894 -4.687088 -4.989845 -5.245933 -5.432292 -5.572890 -5.660425 -5.674645 -5.643410 -5.597292 -5.399628 -4.721982 -0.2957996 -0.9017494 -1.493721 -2.079236 -2.644323 -3.170330 -3.644861 -4.093761 -4.489517 -4.843503 -5.136358 -5.373672 -5.553113 -5.673096 -5.743463 -5.742777 -5.692459 -5.616646 -5.389864 -4.721982 -0.7269071 -1.279060 -1.829770 -2.372954 -2.890022 -3.384859 -3.852627 -4.286128 -4.679941 -5.016482 -5.287905 -5.515554 -5.672434 -5.773605 -5.822991 -5.808296 -5.737834 -5.631721 -5.378264 -4.721982 -1.203873 -1.700749 -2.196149 -2.691206 -3.180945 -3.651194 -4.106937 -4.527232 -4.889988 -5.201196 -5.460803 -5.655680 -5.788694 -5.867068 -5.898742 -5.870263 -5.778107 -5.641233 -5.364150 -4.721982 -1.731399 -2.165259 -2.610016 -3.068345 -3.530665 -3.981648 -4.400436 -4.784321 -5.126633 -5.410624 -5.620699 -5.786325 -5.892953 -5.955124 -5.970449 -5.926902 -5.811674 -5.643856 -5.346752 -4.721982 -2.320869 -2.694956 -3.091751 -3.509343 -3.927219 -4.337557 -4.727833 -5.079568 -5.362884 -5.591747 -5.764690 -5.901817 -5.990368 -6.037193 -6.034925 -5.974263 -5.836488 -5.640144 -5.325068 -4.721982 -2.973460 -3.276902 -3.616383 -3.986718 -4.371367 -4.721258 -5.044821 -5.325100 -5.559414 -5.744898 -5.891293 -6.010899 -6.080002 -6.110524 -6.088650 -6.009012 -5.849237 -5.627726 -5.297803 -4.721982 -3.705485 -3.919435 -4.183133 -4.472330 -4.769188 -5.046581 -5.302414 -5.529341 -5.728149 -5.887825 -6.008774 -6.107829 -6.157259 -6.169028 -6.126256 -6.025809 -5.846479 -5.603248 -5.264268 -4.721982 -4.530575 -4.621387 -4.771807 -4.957050 -5.161578 -5.364658 -5.559823 -5.736700 -5.892202 -6.018474 -6.110197 -6.183784 -6.211232 -6.201535 -6.138219 -6.016752 -5.820522 -5.560739 -5.220420 -4.721982 -5.549778 -5.490207 -5.495863 -5.554156 -5.638440 -5.737961 -5.847335 -5.953481 -6.050244 -6.126968 -6.183270 -6.225086 -6.224303 -6.189441 -6.106025 -5.965110 -5.756693 -5.492580 -5.159259 -4.721982 -25.97711 -25.47649 -24.85197 -24.12276 -23.30324 -22.40590 -21.43970 -20.41191 -19.32842 -18.19407 -17.01315 -15.78839 -14.52349 -13.22078 -11.88255 -10.51080 -9.107579 -7.673762 -6.211536 -4.721982 -0.2445823 -1.166374 -1.884345 -2.455958 -2.938850 -3.083948 -3.491377 -3.667412 -3.978484 -4.259395 -4.506557 -4.679193 -4.756139 -4.972275 -5.167464 -5.331480 -5.351099 -5.504793 -5.553322 -4.826604 0.6868219 -0.2860732 -1.077293 -1.746506 -2.256496 -2.761846 -3.171399 -3.483773 -3.842418 -4.175471 -4.472255 -4.611668 -4.743413 -4.985545 -5.208175 -5.379446 -5.365710 -5.523955 -5.558897 -4.826604 1.160095 0.1617729 -0.6846336 -1.377868 -2.008499 -2.597567 -3.079214 -3.455457 -3.826675 -4.170274 -4.478308 -4.628366 -4.809419 -5.042268 -5.266271 -5.418544 -5.402312 -5.547459 -5.563259 -4.826604 1.382199 0.3853983 -0.4606663 -1.218836 -1.916178 -2.533404 -3.037677 -3.462848 -3.848748 -4.200240 -4.500751 -4.714979 -4.903005 -5.120610 -5.335267 -5.442444 -5.450922 -5.574350 -5.566023 -4.826604 1.433907 0.4644566 -0.3915053 -1.178790 -1.894405 -2.503788 -3.033381 -3.490286 -3.884398 -4.256278 -4.562931 -4.815553 -5.007617 -5.211806 -5.410970 -5.481482 -5.506892 -5.603827 -5.566841 -4.826604 1.361051 0.4265482 -0.4170282 -1.206594 -1.900062 -2.515364 -3.060211 -3.525821 -3.949626 -4.334945 -4.656803 -4.916710 -5.115822 -5.310706 -5.487688 -5.542064 -5.566587 -5.634506 -5.565347 -4.826604 1.191518 0.3039937 -0.5147797 -1.264688 -1.949894 -2.565651 -3.105430 -3.597163 -4.046412 -4.441025 -4.755650 -5.022274 -5.226911 -5.414106 -5.563988 -5.613732 -5.627263 -5.665433 -5.561210 -4.826604 0.9430621 0.1212962 -0.6521297 -1.380572 -2.047318 -2.644340 -3.197474 -3.710805 -4.169158 -4.552098 -4.859646 -5.134611 -5.344686 -5.516764 -5.643931 -5.690712 -5.688623 -5.696033 -5.555223 -4.826604 0.6416442 -0.1186612 -0.8467645 -1.545599 -2.180572 -2.779310 -3.340411 -3.855770 -4.298324 -4.663081 -4.980555 -5.254827 -5.466026 -5.622405 -5.733992 -5.768309 -5.749318 -5.725256 -5.548937 -4.826604 0.2940928 -0.4148957 -1.093630 -1.753174 -2.373986 -2.964479 -3.517797 -4.008131 -4.425461 -4.800598 -5.111741 -5.385656 -5.584905 -5.732752 -5.825304 -5.844646 -5.808273 -5.752245 -5.541830 -4.826604 -0.1090411 -0.7595698 -1.392696 -2.014983 -2.613062 -3.184474 -3.699893 -4.163752 -4.587137 -4.952135 -5.264837 -5.522620 -5.712101 -5.843865 -5.917109 -5.920007 -5.864233 -5.776030 -5.533412 -4.826604 -0.5584776 -1.147792 -1.737455 -2.320847 -2.886200 -3.407440 -3.904777 -4.361707 -4.773599 -5.133471 -5.427459 -5.669789 -5.845309 -5.950665 -6.006313 -5.992519 -5.916271 -5.795536 -5.523007 -4.826604 -1.056895 -1.587530 -2.125457 -2.655276 -3.176205 -3.678761 -4.155480 -4.603963 -5.001364 -5.328142 -5.604604 -5.827231 -5.967293 -6.053089 -6.091982 -6.059219 -5.963726 -5.809136 -5.509890 -4.826604 -1.608118 -2.070335 -2.549425 -3.039560 -3.528820 -4.009610 -4.469074 -4.877414 -5.241612 -5.551432 -5.788543 -5.969402 -6.083370 -6.149771 -6.170955 -6.119442 -6.004169 -5.815408 -5.493180 -4.826604 -2.219584 -2.619005 -3.044740 -3.495582 -3.952127 -4.389076 -4.807855 -5.188008 -5.511933 -5.759017 -5.950624 -6.098146 -6.190788 -6.241459 -6.241690 -6.172388 -6.034392 -5.815020 -5.471939 -4.826604 -2.905401 -3.230258 -3.596087 -3.996954 -4.414336 -4.816399 -5.169548 -5.478137 -5.731735 -5.934246 -6.090087 -6.216898 -6.290782 -6.323750 -6.302196 -6.213902 -6.050339 -5.805837 -5.444466 -4.826604 -3.675468 -3.910527 -4.201366 -4.529665 -4.863708 -5.175774 -5.458144 -5.704629 -5.914097 -6.087488 -6.221237 -6.325399 -6.378345 -6.388140 -6.345996 -6.237865 -6.049328 -5.783954 -5.410576 -4.826604 -4.545103 -4.652872 -4.827262 -5.043553 -5.274777 -5.507113 -5.727197 -5.922847 -6.090229 -6.228728 -6.336301 -6.412354 -6.439974 -6.424919 -6.361567 -6.234211 -6.024593 -5.742704 -5.365741 -4.826604 -5.627238 -5.568479 -5.586567 -5.662616 -5.767507 -5.894463 -6.023485 -6.145977 -6.254500 -6.345905 -6.415498 -6.456953 -6.456460 -6.415654 -6.329845 -6.183056 -5.960621 -5.672154 -5.302349 -4.826604 -28.00587 -27.46723 -26.78915 -25.99417 -25.09992 -24.11985 -23.06438 -21.94166 -20.75825 -19.51951 -18.22995 -16.89335 -15.51299 -14.09171 -12.63202 -11.13609 -9.605913 -8.043240 -6.449658 -4.826604 -0.1609934 -1.149489 -1.914128 -2.505718 -3.038422 -3.456162 -3.499837 -3.732485 -4.067208 -4.344625 -4.602238 -4.786593 -4.850832 -5.072270 -5.270367 -5.441978 -5.455202 -5.617444 -5.673923 -4.926024 0.8364989 -0.2053036 -1.047089 -1.757484 -2.369229 -2.812620 -3.198704 -3.540393 -3.912095 -4.257370 -4.565207 -4.720510 -4.837694 -5.086492 -5.311154 -5.496134 -5.471069 -5.638463 -5.681066 -4.926024 1.352505 0.2841111 -0.6175361 -1.391602 -2.005691 -2.589761 -3.094466 -3.515564 -3.897085 -4.255291 -4.572309 -4.734519 -4.912665 -5.148289 -5.371367 -5.541898 -5.511744 -5.665209 -5.686837 -4.926024 1.602866 0.5340540 -0.3856732 -1.160596 -1.862963 -2.515039 -3.080477 -3.523013 -3.925056 -4.286258 -4.597120 -4.825176 -5.017498 -5.234293 -5.443956 -5.570841 -5.566828 -5.696175 -5.690958 -4.926024 1.668463 0.6255138 -0.2736332 -1.087903 -1.837956 -2.512816 -3.070454 -3.551718 -3.969002 -4.339273 -4.659978 -4.933072 -5.128489 -5.333288 -5.523731 -5.614030 -5.630017 -5.729499 -5.693120 -4.926024 1.594510 0.6022838 -0.2871190 -1.117078 -1.872804 -2.521704 -3.094139 -3.597785 -4.020943 -4.415885 -4.756647 -5.042108 -5.242796 -5.437719 -5.609842 -5.681990 -5.697189 -5.764596 -5.692743 -4.926024 1.431035 0.4813341 -0.3871682 -1.198064 -1.921614 -2.569604 -3.151268 -3.651190 -4.109935 -4.523044 -4.866940 -5.148370 -5.360379 -5.547120 -5.693736 -5.762148 -5.766415 -5.800215 -5.689259 -4.926024 1.171980 0.2896343 -0.5357196 -1.312554 -2.017770 -2.660151 -3.224880 -3.752489 -4.231670 -4.648759 -4.976303 -5.263443 -5.480151 -5.661244 -5.781550 -5.845860 -5.835564 -5.835161 -5.683658 -4.926024 0.8593596 4.2808507E-02 -0.7357146 -1.478077 -2.159136 -2.776317 -3.358706 -3.898031 -4.378115 -4.772007 -5.095480 -5.383102 -5.605318 -5.774177 -5.880402 -5.931150 -5.903512 -5.868931 -5.678070 -4.926024 0.4942519 -0.2641283 -0.9904971 -1.689625 -2.340278 -2.959573 -3.539173 -4.072125 -4.519258 -4.905033 -5.230334 -5.519513 -5.734736 -5.889328 -5.982301 -6.015457 -5.969048 -5.900717 -5.671834 -4.926024 7.5026140E-02 -0.6165893 -1.294928 -1.953286 -2.583224 -3.186297 -3.746490 -4.238081 -4.675714 -5.061495 -5.387523 -5.666669 -5.865561 -6.010009 -6.083734 -6.096178 -6.032116 -5.929256 -5.664296 -4.926024 -0.3916813 -1.021156 -1.649059 -2.266257 -2.871503 -3.438429 -3.953343 -4.439359 -4.865568 -5.247609 -5.563270 -5.814456 -6.005909 -6.125638 -6.180497 -6.173391 -6.090957 -5.953325 -5.654845 -4.926024 -0.9106368 -1.476731 -2.050296 -2.625584 -3.173839 -3.705763 -4.209837 -4.677721 -5.096983 -5.456713 -5.743349 -5.981963 -6.144647 -6.239382 -6.271300 -6.247387 -6.143689 -5.971535 -5.642733 -4.926024 -1.485054 -1.980684 -2.491455 -3.014132 -3.531301 -4.037997 -4.525901 -4.973125 -5.353893 -5.683354 -5.949319 -6.142846 -6.274212 -6.345335 -6.357308 -6.315838 -6.188022 -5.981821 -5.626943 -4.926024 -2.119312 -2.544862 -2.998332 -3.478329 -3.967778 -4.443212 -4.886980 -5.291237 -5.646015 -5.920966 -6.134795 -6.288378 -6.390719 -6.442322 -6.436858 -6.374972 -6.222956 -5.984964 -5.606312 -4.926024 -2.830559 -3.184479 -3.576841 -4.006207 -4.451315 -4.890988 -5.289646 -5.621419 -5.900925 -6.118136 -6.291046 -6.416316 -6.499294 -6.528121 -6.506596 -6.420541 -6.245091 -5.978290 -5.579104 -4.926024 -3.633425 -3.897818 -4.218356 -4.579494 -4.952058 -5.301525 -5.612038 -5.876777 -6.100307 -6.284704 -6.431993 -6.532188 -6.593719 -6.600405 -6.559122 -6.446819 -6.249337 -5.957517 -5.544874 -4.926024 -4.555541 -4.679864 -4.879866 -5.125917 -5.388425 -5.651489 -5.892076 -6.107746 -6.289343 -6.437716 -6.554179 -6.626900 -6.663437 -6.645645 -6.582729 -6.443408 -6.227171 -5.915745 -5.500074 -4.926024 -5.699875 -5.641276 -5.673295 -5.765812 -5.896162 -6.047642 -6.195995 -6.337338 -6.463773 -6.560686 -6.639051 -6.677857 -6.684385 -6.638958 -6.555816 -6.390995 -6.161736 -5.843603 -5.436347 -4.926024 -30.06916 -29.49197 -28.75905 -27.89690 -26.92579 -25.86098 -24.71414 -23.49433 -22.20879 -20.86342 -19.46316 -18.01217 -16.51402 -14.97182 -13.38829 -11.76581 -10.10653 -8.412355 -6.685004 -4.926024 -8.5588291E-02 -1.134101 -1.944002 -2.555583 -3.103770 -3.567199 -3.879364 -3.712183 -4.140505 -4.438554 -4.690419 -4.888790 -4.941644 -5.167827 -5.370255 -5.546826 -5.554725 -5.724619 -5.790542 -5.020735 0.9881777 -0.1240622 -1.021990 -1.762851 -2.405368 -2.940367 -3.262011 -3.578235 -3.981920 -4.329061 -4.655257 -4.826589 -4.928124 -5.183936 -5.415588 -5.607107 -5.571312 -5.748208 -5.799836 -5.020735 1.539335 0.4094240 -0.5550128 -1.369003 -2.067256 -2.614538 -3.128006 -3.561858 -3.967781 -4.334536 -4.666356 -4.838388 -5.011611 -5.252752 -5.481045 -5.658984 -5.617076 -5.778395 -5.807798 -5.020735 1.819124 0.6808880 -0.2969410 -1.144282 -1.842818 -2.485679 -3.091420 -3.582273 -3.996772 -4.372447 -4.692836 -4.931980 -5.125642 -5.346610 -5.559722 -5.692749 -5.679223 -5.813178 -5.814065 -5.020735 1.888094 0.7873964 -0.1829903 -1.016879 -1.783678 -2.489306 -3.105822 -3.605814 -4.044900 -4.424714 -4.755576 -5.042147 -5.246462 -5.452712 -5.647093 -5.739200 -5.749896 -5.851173 -5.818197 -5.020735 1.814993 0.7687821 -0.1661806 -1.027123 -1.820073 -2.527595 -3.126197 -3.652803 -4.102445 -4.496659 -4.852307 -5.157823 -5.365826 -5.564299 -5.740184 -5.813544 -5.824572 -5.890572 -5.819667 -5.020735 1.657915 0.6519461 -0.2620801 -1.116763 -1.893861 -2.573250 -3.180103 -3.715619 -4.176822 -4.601205 -4.969045 -5.272085 -5.487857 -5.682320 -5.832705 -5.899560 -5.900653 -5.930897 -5.817857 -5.020735 1.400428 0.4566473 -0.4190970 -1.244203 -1.989134 -2.661598 -3.266262 -3.796998 -4.292388 -4.729498 -5.089833 -5.384623 -5.610867 -5.803716 -5.926836 -5.989982 -5.976418 -5.971089 -5.813706 -5.020735 1.076407 0.1971188 -0.6259434 -1.412332 -2.131777 -2.786206 -3.379831 -3.937408 -4.441271 -4.870883 -5.210816 -5.510156 -5.739270 -5.924405 -6.031871 -6.081507 -6.050979 -6.009937 -5.809699 -5.020735 0.6916678 -0.1153336 -0.8882764 -1.632135 -2.315285 -2.954806 -3.558871 -4.116427 -4.604193 -5.007243 -5.351817 -5.643216 -5.875471 -6.043934 -6.141631 -6.171347 -6.123159 -6.046721 -5.805180 -5.020735 0.2535199 -0.4791934 -1.202213 -1.894870 -2.556367 -3.185541 -3.779228 -4.311089 -4.764032 -5.168058 -5.505142 -5.794238 -6.012772 -6.170143 -6.249638 -6.258040 -6.191770 -6.079909 -5.799371 -5.020735 -0.2321012 -0.8979990 -1.563025 -2.214841 -2.849254 -3.456254 -4.008870 -4.508840 -4.961804 -5.351689 -5.685906 -5.954075 -6.160957 -6.297894 -6.356040 -6.342031 -6.256180 -6.108597 -5.791484 -5.020735 -0.7716804 -1.368418 -1.976827 -2.587171 -3.179009 -3.732735 -4.266544 -4.752907 -5.193517 -5.574811 -5.880609 -6.129227 -6.311418 -6.419194 -6.454955 -6.421221 -6.315452 -6.131325 -5.780647 -5.020735 -1.361829 -1.893535 -2.437706 -2.988768 -3.538213 -4.070514 -4.583439 -5.054133 -5.465842 -5.810877 -6.097612 -6.308352 -6.450876 -6.531135 -6.547952 -6.494812 -6.366630 -6.146390 -5.766069 -5.020735 -2.019059 -2.472656 -2.954132 -3.460491 -3.978401 -4.492008 -4.965892 -5.391949 -5.767525 -6.076940 -6.305648 -6.468784 -6.577091 -6.637224 -6.633064 -6.560372 -6.406937 -6.154018 -5.746102 -5.020735 -2.756567 -3.132324 -3.559142 -4.015216 -4.487497 -4.958209 -5.393820 -5.761634 -6.059057 -6.297371 -6.479630 -6.606842 -6.691452 -6.734749 -6.708856 -6.613266 -6.433076 -6.151371 -5.719285 -5.020735 -3.588619 -3.873527 -4.231794 -4.627558 -5.034176 -5.423563 -5.760706 -6.048433 -6.284091 -6.478326 -6.629964 -6.732915 -6.793591 -6.813980 -6.768939 -6.647504 -6.440844 -6.133974 -5.684017 -5.020735 -4.560056 -4.703968 -4.930426 -5.205769 -5.501868 -5.793624 -6.058383 -6.286912 -6.485848 -6.641819 -6.762734 -6.838245 -6.871466 -6.865145 -6.797279 -6.651235 -6.421376 -6.094339 -5.636965 -5.020735 -5.767010 -5.710457 -5.755255 -5.867773 -6.026945 -6.201487 -6.370746 -6.524777 -6.661850 -6.772151 -6.855936 -6.895809 -6.896305 -6.866062 -6.769349 -6.600771 -6.355528 -6.019041 -5.569003 -5.020735 -32.16550 -31.54922 -30.76023 -29.82930 -28.77953 -27.62809 -26.38789 -25.06893 -23.67915 -22.22500 -20.71188 -19.14430 -17.52616 -15.86081 -14.15120 -12.39993 -10.60929 -8.781347 -6.917940 -5.020735 -2.0307731E-02 -1.122958 -1.973807 -2.604557 -3.167650 -3.646516 -4.009735 -3.784049 -4.211162 -4.519373 -4.780014 -4.986958 -5.028566 -5.259103 -5.466117 -5.646779 -5.650723 -5.825122 -5.901833 -5.111163 1.130556 -4.0767692E-02 -0.9949501 -1.773196 -2.434694 -3.008434 -3.384015 -3.603423 -4.043592 -4.403820 -4.740296 -4.931382 -5.015071 -5.275838 -5.515235 -5.713082 -5.668501 -5.850369 -5.913367 -5.111163 1.725824 0.5451168 -0.4959767 -1.351437 -2.080642 -2.675634 -3.129086 -3.605758 -4.038946 -4.406610 -4.758661 -4.939662 -5.107768 -5.352558 -5.587617 -5.770882 -5.720586 -5.883245 -5.923653 -5.111163 2.029444 0.8388328 -0.2167487 -1.103677 -1.867855 -2.468963 -3.106292 -3.627010 -4.065185 -4.450883 -4.789559 -5.035294 -5.230123 -5.454496 -5.673673 -5.810534 -5.789584 -5.921276 -5.932331 -5.111163 2.085794 0.9472404 -8.3526015E-02 -0.9799708 -1.738272 -2.465761 -3.113198 -3.659578 -4.113344 -4.513417 -4.849330 -5.145782 -5.360879 -5.567410 -5.768600 -5.861080 -5.866744 -5.963062 -5.938788 -5.111163 2.012888 0.9326620 -6.6981830E-02 -0.9454935 -1.764495 -2.504481 -3.151194 -3.701301 -4.179368 -4.579737 -4.944495 -5.263948 -5.490307 -5.688170 -5.868052 -5.939987 -5.947974 -6.006922 -5.942461 -5.111163 1.865842 0.8148257 -0.1403071 -1.032162 -1.847145 -2.572932 -3.206169 -3.767552 -4.250633 -4.676591 -5.061064 -5.384934 -5.615839 -5.810223 -5.967911 -6.031856 -6.030696 -6.051783 -5.942752 -5.111163 1.625757 0.6193786 -0.3000433 -1.172513 -1.958194 -2.663902 -3.295583 -3.851681 -4.353252 -4.804151 -5.193795 -5.502456 -5.743727 -5.935260 -6.067196 -6.129923 -6.112659 -6.096660 -5.940451 -5.111163 1.287666 0.3521028 -0.5210213 -1.348326 -2.103044 -2.794865 -3.410477 -3.976236 -4.500595 -4.955886 -5.325918 -5.627809 -5.873032 -6.063176 -6.178160 -6.228146 -6.193375 -6.140482 -5.938452 -5.111163 0.8823884 2.7335888E-02 -0.7898770 -1.571840 -2.299078 -2.957909 -3.577625 -4.157031 -4.677447 -5.109894 -5.461407 -5.765622 -6.014477 -6.190824 -6.295015 -6.325531 -6.272034 -6.182608 -5.935986 -5.111163 0.4282099 -0.3489124 -1.113322 -1.844345 -2.531083 -3.186219 -3.802343 -4.372696 -4.856952 -5.265589 -5.621222 -5.921381 -6.160854 -6.324065 -6.409631 -6.419105 -6.346874 -6.221664 -5.932220 -5.111163 -7.4946478E-02 -0.7799416 -1.480920 -2.166991 -2.828940 -3.465200 -4.057383 -4.580867 -5.050003 -5.456392 -5.806665 -6.094249 -6.308163 -6.462439 -6.520601 -6.508987 -6.416364 -6.256165 -5.926315 -5.111163 -0.6337361 -1.265651 -1.906911 -2.547385 -3.174595 -3.766495 -4.318315 -4.834039 -5.284380 -5.684729 -6.013310 -6.271867 -6.470318 -6.592850 -6.627054 -6.594783 -6.480529 -6.284258 -5.917624 -5.111163 -1.241483 -1.804489 -2.383388 -2.968191 -3.542294 -4.108823 -4.640896 -5.136612 -5.572356 -5.934319 -6.233933 -6.469872 -6.620658 -6.717532 -6.728821 -6.675059 -6.538127 -6.303800 -5.904313 -5.111163 -1.920008 -2.401625 -2.912810 -3.445573 -3.988526 -4.531146 -5.044411 -5.492932 -5.883221 -6.215772 -6.466275 -6.643579 -6.757292 -6.828894 -6.823164 -6.746021 -6.585724 -6.314740 -5.885409 -5.111163 -2.682476 -3.081185 -3.532893 -4.024859 -4.524780 -5.023104 -5.487635 -5.898247 -6.210866 -6.468353 -6.659967 -6.793807 -6.884616 -6.929996 -6.902957 -6.802994 -6.618769 -6.314283 -5.859534 -5.111163 -3.542517 -3.848261 -4.232085 -4.671759 -5.114667 -5.535674 -5.909798 -6.212658 -6.460677 -6.665643 -6.821988 -6.930181 -6.995622 -7.018082 -6.963967 -6.839921 -6.631402 -6.298377 -5.823717 -5.111163 -4.559167 -4.722859 -4.979147 -5.286076 -5.615496 -5.936453 -6.220603 -6.466579 -6.668921 -6.841390 -6.965047 -7.042835 -7.079874 -7.079562 -6.996218 -6.846581 -6.613570 -6.259164 -5.775043 -5.111163 -5.828342 -5.775508 -5.833009 -5.968329 -6.153660 -6.355330 -6.544827 -6.719036 -6.854939 -6.981420 -7.066842 -7.105956 -7.114092 -7.082839 -6.972291 -6.798800 -6.544941 -6.183199 -5.703929 -5.111163 -34.29354 -33.63787 -32.79136 -31.79009 -30.65997 -29.42006 -28.08459 -26.66452 -25.16850 -23.60355 -21.97549 -20.28925 -18.54902 -16.75841 -14.92061 -13.03841 -11.11427 -9.150400 -7.148768 -5.111163 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.870378 -1.898500 -1.923996 -1.946963 -1.966712 -1.982723 -2.005426 -2.025272 -2.041791 -2.054465 -2.062055 -2.065150 -2.062111 -2.054884 -2.045544 -2.026943 -1.995849 -1.946944 -1.867121 -1.624412 -1.889500 -1.915561 -1.939794 -1.960960 -1.978473 -1.992997 -2.014464 -2.032973 -2.048083 -2.058604 -2.065222 -2.066693 -2.062001 -2.053409 -2.043015 -2.023466 -1.991566 -1.942333 -1.862862 -1.624412 -1.908932 -1.933521 -1.955783 -1.974540 -1.990297 -2.003621 -2.023708 -2.040712 -2.054277 -2.063125 -2.068082 -2.067871 -2.061490 -2.051709 -2.040199 -2.019743 -1.987042 -1.937607 -1.858450 -1.624412 -1.929285 -1.951695 -1.971327 -1.988181 -2.002523 -2.014556 -2.033033 -2.048414 -2.059554 -2.067379 -2.070582 -2.068632 -2.060398 -2.049757 -2.037150 -2.015750 -1.982264 -1.932575 -1.853878 -1.624412 -1.949844 -1.969327 -1.987029 -2.002238 -2.015194 -2.025660 -2.042359 -2.055204 -2.065267 -2.071295 -2.072675 -2.068923 -2.059343 -2.047534 -2.033797 -2.011336 -1.977210 -1.927308 -1.849119 -1.624412 -1.969750 -1.987209 -2.003125 -2.016879 -2.028111 -2.036828 -2.051629 -2.062487 -2.070650 -2.074798 -2.074294 -2.068419 -2.058018 -2.044875 -2.030143 -2.006572 -1.971887 -1.921789 -1.844162 -1.624412 -1.990184 -2.005555 -2.019883 -2.031835 -2.041159 -2.047957 -2.059828 -2.069440 -2.075620 -2.077819 -2.074833 -2.068085 -2.056397 -2.042006 -2.026150 -2.001456 -1.966293 -1.915994 -1.838986 -1.624412 -2.011134 -2.024648 -2.036967 -2.046920 -2.053416 -2.058041 -2.068510 -2.075984 -2.080105 -2.080270 -2.075594 -2.067465 -2.054204 -2.038723 -2.021557 -1.995987 -1.960295 -1.909900 -1.833569 -1.624412 -2.032866 -2.044107 -2.054203 -2.061179 -2.066193 -2.068584 -2.076758 -2.082040 -2.083996 -2.081585 -2.076078 -2.066514 -2.051865 -2.035110 -2.016446 -1.990092 -1.954178 -1.903476 -1.827872 -1.624412 -2.055005 -2.063059 -2.070667 -2.075977 -2.078631 -2.078737 -2.084510 -2.087486 -2.086630 -2.083358 -2.076261 -2.064822 -2.049018 -2.030750 -2.010875 -1.983849 -1.947382 -1.896687 -1.821860 -1.624412 -2.076673 -2.082742 -2.087717 -2.090492 -2.090694 -2.088423 -2.090789 -2.091649 -2.089877 -2.084891 -2.075635 -2.062936 -2.045866 -2.025697 -2.004874 -1.977210 -1.940137 -1.889488 -1.815476 -1.624412 -2.099097 -2.102363 -2.104626 -2.104773 -2.102341 -2.096778 -2.097831 -2.096641 -2.092997 -2.085601 -2.074925 -2.060789 -2.043310 -2.022032 -1.998464 -1.970346 -1.932397 -1.881900 -1.808645 -1.624412 -2.121691 -2.122104 -2.121454 -2.118035 -2.113094 -2.106201 -2.105098 -2.101003 -2.095357 -2.086430 -2.074075 -2.058824 -2.040256 -2.018193 -1.991938 -1.962433 -1.924112 -1.873688 -1.801253 -1.624412 -2.143905 -2.141443 -2.138029 -2.132865 -2.125411 -2.115436 -2.112000 -2.105981 -2.098127 -2.087227 -2.073252 -2.056698 -2.037142 -2.013936 -1.986631 -1.953937 -1.915216 -1.864860 -1.793170 -1.624412 -2.168726 -2.163469 -2.156457 -2.148429 -2.137849 -2.125988 -2.120017 -2.111241 -2.100591 -2.087646 -2.072331 -2.054480 -2.034100 -2.009513 -1.980310 -1.946300 -1.905988 -1.855270 -1.783627 -1.624412 -2.196473 -2.187691 -2.178035 -2.166697 -2.154274 -2.141340 -2.127055 -2.116200 -2.103411 -2.089049 -2.072298 -2.053375 -2.030117 -2.003618 -1.973309 -1.938622 -1.896860 -1.844940 -1.772247 -1.624412 -2.229476 -2.217699 -2.205210 -2.192196 -2.177706 -2.163040 -2.147508 -2.129932 -2.112332 -2.092305 -2.072603 -2.050430 -2.025553 -1.997441 -1.965997 -1.929119 -1.885554 -1.831947 -1.758971 -1.624412 -2.275325 -2.258013 -2.243364 -2.227302 -2.210117 -2.192019 -2.172733 -2.152096 -2.130261 -2.106849 -2.081750 -2.055824 -2.026098 -1.994102 -1.958324 -1.917849 -1.870466 -1.811340 -1.742730 -1.624412 -2.367046 -2.344622 -2.321453 -2.298665 -2.273463 -2.247330 -2.220175 -2.192349 -2.162532 -2.131308 -2.098231 -2.062902 -2.024700 -1.982839 -1.936749 -1.887914 -1.836620 -1.781821 -1.720765 -1.624412 -2.280320 -2.251222 -2.221487 -2.191119 -2.160126 -2.128514 -2.096533 -2.063457 -2.030020 -1.995986 -1.961366 -1.926167 -1.890395 -1.854056 -1.817156 -1.779699 -1.741682 -1.703125 -1.664033 -1.624412 -1.818592 -1.885327 -1.946745 -2.023471 -2.094118 -2.160394 -2.219627 -2.271109 -2.312121 -2.356217 -2.405643 -2.447238 -2.478322 -2.497417 -2.499986 -2.499596 -2.485415 -2.441513 -2.346537 -2.016222 -1.841905 -1.906057 -1.968186 -2.044142 -2.115795 -2.181253 -2.238647 -2.287392 -2.324225 -2.368011 -2.416230 -2.455294 -2.484556 -2.500681 -2.499886 -2.497516 -2.481617 -2.436317 -2.341024 -2.016222 -1.869508 -1.933063 -1.996422 -2.070904 -2.141040 -2.203321 -2.258391 -2.303644 -2.338208 -2.381077 -2.427450 -2.464027 -2.490188 -2.503324 -2.499301 -2.495160 -2.477494 -2.430815 -2.335290 -2.016222 -1.903719 -1.965940 -2.028073 -2.101591 -2.167305 -2.226987 -2.278508 -2.319426 -2.353895 -2.395117 -2.438174 -2.472637 -2.495638 -2.505301 -2.498528 -2.492487 -2.473015 -2.424977 -2.329320 -2.016222 -1.943990 -2.005143 -2.065367 -2.133406 -2.195638 -2.251505 -2.297945 -2.337766 -2.370894 -2.409860 -2.449744 -2.481021 -2.500316 -2.506454 -2.497499 -2.489452 -2.468148 -2.418719 -2.323096 -2.016222 -1.990698 -2.048982 -2.103891 -2.167145 -2.225037 -2.275424 -2.319793 -2.357810 -2.388803 -2.423811 -2.461164 -2.488243 -2.504389 -2.507052 -2.496146 -2.486006 -2.462858 -2.412063 -2.316608 -2.016222 -2.040534 -2.094100 -2.143986 -2.202308 -2.254119 -2.301716 -2.343584 -2.379043 -2.406300 -2.438654 -2.471440 -2.495057 -2.507562 -2.507462 -2.494421 -2.482105 -2.457109 -2.404986 -2.309835 -2.016222 -2.093478 -2.140854 -2.185459 -2.237355 -2.285898 -2.330172 -2.368845 -2.400204 -2.424783 -2.453240 -2.481713 -2.501210 -2.509978 -2.507564 -2.492267 -2.477710 -2.450859 -2.397454 -2.302751 -2.016222 -2.148253 -2.188593 -2.227348 -2.275476 -2.319989 -2.360225 -2.394271 -2.422403 -2.443124 -2.466260 -2.490655 -2.506217 -2.512153 -2.507282 -2.489599 -2.472765 -2.444049 -2.389426 -2.295325 -2.016222 -2.203493 -2.238554 -2.272800 -2.315921 -2.355670 -2.390488 -2.420777 -2.444658 -2.460056 -2.478842 -2.498858 -2.510761 -2.513945 -2.506546 -2.486382 -2.467215 -2.436376 -2.380858 -2.287520 -2.016222 -2.261979 -2.291816 -2.320515 -2.357324 -2.391519 -2.421864 -2.446670 -2.465690 -2.476533 -2.490672 -2.506380 -2.515019 -2.515332 -2.505271 -2.482551 -2.461010 -2.427875 -2.371693 -2.279293 -2.016222 -2.323227 -2.346555 -2.369125 -2.400038 -2.428303 -2.452699 -2.472421 -2.486254 -2.492311 -2.501902 -2.513809 -2.519007 -2.516248 -2.503400 -2.478041 -2.454030 -2.418628 -2.361878 -2.270591 -2.016222 -2.385536 -2.402458 -2.417836 -2.442508 -2.464252 -2.483465 -2.497802 -2.506316 -2.507991 -2.513333 -2.521173 -2.522732 -2.516713 -2.500891 -2.472809 -2.445477 -2.408565 -2.351367 -2.261348 -2.016222 -2.448210 -2.458475 -2.467341 -2.485547 -2.500885 -2.514207 -2.523177 -2.526901 -2.524196 -2.525037 -2.528581 -2.526306 -2.516800 -2.497803 -2.467488 -2.435992 -2.397630 -2.340132 -2.251485 -2.016222 -2.513284 -2.515867 -2.517690 -2.529285 -2.538395 -2.546183 -2.549944 -2.548615 -2.541247 -2.537388 -2.536349 -2.529945 -2.516761 -2.494499 -2.463266 -2.425634 -2.385803 -2.328119 -2.240900 -2.016222 -2.582595 -2.577551 -2.572100 -2.576953 -2.579750 -2.581459 -2.579473 -2.572613 -2.560050 -2.551128 -2.545215 -2.534119 -2.516953 -2.492120 -2.458840 -2.415892 -2.373265 -2.315315 -2.229641 -2.016222 -2.663751 -2.650379 -2.636644 -2.634041 -2.629721 -2.624333 -2.615574 -2.602093 -2.583156 -2.567401 -2.555361 -2.539543 -2.518394 -2.490652 -2.454861 -2.410660 -2.360487 -2.301838 -2.217132 -2.016222 -2.771897 -2.748223 -2.724388 -2.712663 -2.699617 -2.684991 -2.668855 -2.649592 -2.626726 -2.600361 -2.571483 -2.550887 -2.525267 -2.493405 -2.454885 -2.408256 -2.352626 -2.288876 -2.203476 -2.016222 -2.959984 -2.930143 -2.899750 -2.868274 -2.837132 -2.803818 -2.773465 -2.746195 -2.716020 -2.682949 -2.646295 -2.606141 -2.562182 -2.515502 -2.470114 -2.417722 -2.355375 -2.282176 -2.188352 -2.016222 -3.518405 -3.459572 -3.398211 -3.334374 -3.268105 -3.199451 -3.128481 -3.055485 -2.979768 -2.902119 -2.822353 -2.740515 -2.656873 -2.570762 -2.482960 -2.393259 -2.301682 -2.208296 -2.113133 -2.016222 -1.698546 -1.823980 -1.939101 -2.038028 -2.131519 -2.242587 -2.346394 -2.439743 -2.520910 -2.584066 -2.646010 -2.723546 -2.788049 -2.837568 -2.865762 -2.870165 -2.877137 -2.843596 -2.739586 -2.343706 -1.704236 -1.832245 -1.948750 -2.045357 -2.144227 -2.258768 -2.363618 -2.458013 -2.537515 -2.596034 -2.657928 -2.734801 -2.798061 -2.844987 -2.868913 -2.869095 -2.873903 -2.838086 -2.732928 -2.343706 -1.728682 -1.854161 -1.966065 -2.065741 -2.167552 -2.282446 -2.387023 -2.479216 -2.554660 -2.609504 -2.673068 -2.748359 -2.808815 -2.852023 -2.871049 -2.867947 -2.870316 -2.832166 -2.725965 -2.343706 -1.766350 -1.884720 -1.995870 -2.097456 -2.199988 -2.312568 -2.414419 -2.502156 -2.571370 -2.627360 -2.689841 -2.762959 -2.819454 -2.858388 -2.871951 -2.866602 -2.866310 -2.825799 -2.718676 -2.343706 -1.811283 -1.928007 -2.037833 -2.138556 -2.238996 -2.347374 -2.443854 -2.525043 -2.591700 -2.647623 -2.708923 -2.777355 -2.830002 -2.863758 -2.872142 -2.864928 -2.861814 -2.818943 -2.711035 -2.343706 -1.868338 -1.982972 -2.089126 -2.186657 -2.282851 -2.384609 -2.473911 -2.549823 -2.615921 -2.670441 -2.728286 -2.792099 -2.839926 -2.867855 -2.872304 -2.862839 -2.856792 -2.811551 -2.703040 -2.343706 -1.938665 -2.046771 -2.147283 -2.239720 -2.329344 -2.422988 -2.505261 -2.579058 -2.642395 -2.694824 -2.748176 -2.806619 -2.848678 -2.870463 -2.872249 -2.860223 -2.851115 -2.803380 -2.694678 -2.343706 -2.016145 -2.117059 -2.210521 -2.295747 -2.376956 -2.462893 -2.541430 -2.611085 -2.671527 -2.719094 -2.767467 -2.820146 -2.855843 -2.872605 -2.871799 -2.856965 -2.844737 -2.794740 -2.685915 -2.343706 -2.101308 -2.192054 -2.277186 -2.353250 -2.427033 -2.507750 -2.580982 -2.646001 -2.701040 -2.743765 -2.786396 -2.832036 -2.861120 -2.874521 -2.870789 -2.853023 -2.837582 -2.785370 -2.676797 -2.343706 -2.190843 -2.270765 -2.346228 -2.414672 -2.482069 -2.556198 -2.623684 -2.681841 -2.731026 -2.768404 -2.804116 -2.842056 -2.865869 -2.875919 -2.869030 -2.848094 -2.829567 -2.775105 -2.667103 -2.343706 -2.284069 -2.354483 -2.420644 -2.480797 -2.541297 -2.607274 -2.667136 -2.718555 -2.761094 -2.791852 -2.820005 -2.850871 -2.870227 -2.876602 -2.866362 -2.842161 -2.820582 -2.763962 -2.656984 -2.343706 -2.383505 -2.443054 -2.499547 -2.551646 -2.603014 -2.659683 -2.711364 -2.755443 -2.790071 -2.813192 -2.834693 -2.859694 -2.873995 -2.876356 -2.862641 -2.835101 -2.810540 -2.751871 -2.646280 -2.343706 -2.488381 -2.536814 -2.582995 -2.625235 -2.666475 -2.713390 -2.755804 -2.791165 -2.817097 -2.833544 -2.849404 -2.868351 -2.877072 -2.875120 -2.857658 -2.826800 -2.799084 -2.738749 -2.634692 -2.343706 -2.597890 -2.635015 -2.669713 -2.700886 -2.731170 -2.767217 -2.799195 -2.825975 -2.844278 -2.854162 -2.864011 -2.876652 -2.879516 -2.872768 -2.851386 -2.817189 -2.785686 -2.724577 -2.622282 -2.343706 -2.711534 -2.736395 -2.758035 -2.776919 -2.795869 -2.821613 -2.843762 -2.862313 -2.872636 -2.875224 -2.878505 -2.884814 -2.881433 -2.869511 -2.843906 -2.805350 -2.770740 -2.709339 -2.608930 -2.343706 -2.826560 -2.838355 -2.848278 -2.855965 -2.864217 -2.879783 -2.891625 -2.901426 -2.903231 -2.897745 -2.893871 -2.893412 -2.883537 -2.865767 -2.835550 -2.791208 -2.754279 -2.692759 -2.594486 -2.343706 -2.952086 -2.950628 -2.947706 -2.943096 -2.939997 -2.945174 -2.946517 -2.946674 -2.939241 -2.924569 -2.912515 -2.904572 -2.886836 -2.862564 -2.829859 -2.783007 -2.736429 -2.674743 -2.578803 -2.343706 -3.107574 -3.090385 -3.072488 -3.052909 -3.035946 -3.029185 -3.018800 -3.007591 -2.989207 -2.963654 -2.937324 -2.920155 -2.895688 -2.865208 -2.828403 -2.778199 -2.718936 -2.656047 -2.561802 -2.343706 -3.356937 -3.319540 -3.283998 -3.247693 -3.209888 -3.171792 -3.146823 -3.120634 -3.092864 -3.059757 -3.019609 -2.972889 -2.932651 -2.893293 -2.846427 -2.789825 -2.719536 -2.641134 -2.544872 -2.343706 -4.847148 -4.758192 -4.663117 -4.562813 -4.457223 -4.346527 -4.230862 -4.110434 -3.985371 -3.855843 -3.722001 -3.583956 -3.441876 -3.295862 -3.146047 -2.992548 -2.835452 -2.674891 -2.511185 -2.343706 -1.547828 -1.731270 -1.900549 -2.052443 -2.176515 -2.297801 -2.440804 -2.572286 -2.689345 -2.786713 -2.850064 -2.950287 -3.044270 -3.121507 -3.174532 -3.184635 -3.210637 -3.189448 -3.079291 -2.625035 -1.511842 -1.706259 -1.884893 -2.039530 -2.163278 -2.295325 -2.447154 -2.584230 -2.703959 -2.799470 -2.857712 -2.961943 -3.056538 -3.132457 -3.181250 -3.184278 -3.208251 -3.184001 -3.071489 -2.625035 -1.516178 -1.712664 -1.890168 -2.040708 -2.172242 -2.313876 -2.467945 -2.604865 -2.723065 -2.811854 -2.873079 -2.978193 -3.071117 -3.143748 -3.186866 -3.184391 -3.205620 -3.178060 -3.063258 -2.625035 -1.548504 -1.738330 -1.909832 -2.063062 -2.203573 -2.346967 -2.497553 -2.631814 -2.743479 -2.826678 -2.894115 -2.997587 -3.087127 -3.154753 -3.191052 -3.184733 -3.202595 -3.171569 -3.054556 -2.625035 -1.599478 -1.778930 -1.949357 -2.107729 -2.248745 -2.388241 -2.534267 -2.661416 -2.763649 -2.848970 -2.919451 -3.018969 -3.103533 -3.164939 -3.193316 -3.185425 -3.199078 -3.164346 -3.045538 -2.625035 -1.666556 -1.840077 -2.009077 -2.165920 -2.302741 -2.437643 -2.575002 -2.691307 -2.790075 -2.876362 -2.947087 -3.041231 -3.119725 -3.173842 -3.194888 -3.185492 -3.194950 -3.156517 -3.036091 -2.625035 -1.753618 -1.920670 -2.082598 -2.231317 -2.364656 -2.491832 -2.616372 -2.725589 -2.823189 -2.907741 -2.975898 -3.063524 -3.134746 -3.180753 -3.196802 -3.185113 -3.190417 -3.147860 -3.026191 -2.625035 -1.858123 -2.013428 -2.163626 -2.305221 -2.430366 -2.546108 -2.661289 -2.766875 -2.861261 -2.941563 -3.005322 -3.085188 -3.148026 -3.185516 -3.199014 -3.184018 -3.184608 -3.138386 -3.015794 -2.625035 -1.970343 -2.114876 -2.254249 -2.383537 -2.496669 -2.603943 -2.713194 -2.813226 -2.902066 -2.976772 -3.034612 -3.105430 -3.158940 -3.190176 -3.200439 -3.181988 -3.177774 -3.127949 -3.004844 -2.625035 -2.093782 -2.224094 -2.348267 -2.464696 -2.568469 -2.668497 -2.770232 -2.862609 -2.943998 -3.012309 -3.063130 -3.123755 -3.167897 -3.194946 -3.201023 -3.179250 -3.170042 -3.116432 -2.993284 -2.625035 -2.223635 -2.336473 -2.446920 -2.552767 -2.647453 -2.737983 -2.830161 -2.913300 -2.986312 -3.046729 -3.089773 -3.139675 -3.176900 -3.198704 -3.200390 -3.174476 -3.160625 -3.103698 -2.981041 -2.625035 -2.358378 -2.455991 -2.553937 -2.647853 -2.731295 -2.809969 -2.891453 -2.964831 -3.027802 -3.079052 -3.113531 -3.155162 -3.185669 -3.201378 -3.198611 -3.168000 -3.149789 -3.089496 -2.968025 -2.625035 -2.503208 -2.585099 -2.667621 -2.747426 -2.818170 -2.884069 -2.953675 -3.015885 -3.067623 -3.108715 -3.135951 -3.170299 -3.193234 -3.202576 -3.194422 -3.159946 -3.136972 -3.073661 -2.954118 -2.625035 -2.656047 -2.719468 -2.785620 -2.851158 -2.907428 -2.959457 -3.015850 -3.065909 -3.106090 -3.137595 -3.157378 -3.183957 -3.199275 -3.202138 -3.188395 -3.149357 -3.122064 -3.056339 -2.939183 -2.625035 -2.814652 -2.859852 -2.909379 -2.957850 -2.998290 -3.035852 -3.077965 -3.115815 -3.144834 -3.166082 -3.177285 -3.196043 -3.203698 -3.199482 -3.179747 -3.135989 -3.104285 -3.037439 -2.923032 -2.625035 -2.980473 -3.006822 -3.038225 -3.068590 -3.092237 -3.114524 -3.142116 -3.167608 -3.184882 -3.194829 -3.196147 -3.206172 -3.206358 -3.194440 -3.168451 -3.119553 -3.083474 -3.016768 -2.905442 -2.625035 -3.154204 -3.160582 -3.174349 -3.187817 -3.194267 -3.200130 -3.212476 -3.224056 -3.228513 -3.225758 -3.215894 -3.216597 -3.208198 -3.187917 -3.155107 -3.105507 -3.060205 -2.994114 -2.886136 -2.625035 -3.353505 -3.338555 -3.333594 -3.328680 -3.316440 -3.304210 -3.300258 -3.296045 -3.285584 -3.267855 -3.243727 -3.231765 -3.212963 -3.183642 -3.145198 -3.092285 -3.035431 -2.969548 -2.864903 -2.625035 -3.656404 -3.615363 -3.584011 -3.550705 -3.511474 -3.472594 -3.448909 -3.424469 -3.395967 -3.360841 -3.320957 -3.275282 -3.245190 -3.204535 -3.152656 -3.093190 -3.016536 -2.946206 -2.842475 -2.625035 -6.258605 -6.138412 -6.008305 -5.868680 -5.719967 -5.562553 -5.396829 -5.223159 -5.041882 -4.853333 -4.657796 -4.455575 -4.246910 -4.032073 -3.811266 -3.584733 -3.352653 -3.115231 -2.872634 -2.625035 -1.412108 -1.628947 -1.847741 -2.047951 -2.222201 -2.349942 -2.522646 -2.685040 -2.834273 -2.964107 -3.054980 -3.146981 -3.265809 -3.366361 -3.442194 -3.467790 -3.500643 -3.493579 -3.379924 -2.871628 -1.317440 -1.555522 -1.789495 -2.002776 -2.184390 -2.321213 -2.508362 -2.682976 -2.841755 -2.975577 -3.058244 -3.156964 -3.279125 -3.380267 -3.452717 -3.468626 -3.499392 -3.488574 -3.371298 -2.871628 -1.289055 -1.535964 -1.774099 -1.987255 -2.168270 -2.327118 -2.518852 -2.698739 -2.860268 -2.989111 -3.068264 -3.175434 -3.297119 -3.395784 -3.462294 -3.469628 -3.498219 -3.483007 -3.362131 -2.871628 -1.306438 -1.553419 -1.787593 -1.995245 -2.184628 -2.352996 -2.547273 -2.727206 -2.884523 -3.002432 -3.090750 -3.200687 -3.318522 -3.411840 -3.470472 -3.471393 -3.497235 -3.476812 -3.352378 -2.871628 -1.357847 -1.597069 -1.824561 -2.034015 -2.223315 -2.397935 -2.589635 -2.764738 -2.909668 -3.025251 -3.120269 -3.229439 -3.341391 -3.427745 -3.476486 -3.473799 -3.495454 -3.469879 -3.341984 -2.871628 -1.433907 -1.664171 -1.887808 -2.092756 -2.283617 -2.458195 -2.643779 -2.803870 -2.939236 -3.057643 -3.155197 -3.259895 -3.364418 -3.442711 -3.480164 -3.476495 -3.493050 -3.462094 -3.330904 -2.871628 -1.534516 -1.753996 -1.969640 -2.171552 -2.359675 -2.530832 -2.698877 -2.846939 -2.979683 -3.096777 -3.192714 -3.291163 -3.386938 -3.455507 -3.484675 -3.479045 -3.489802 -3.453350 -3.319225 -2.871628 -1.653800 -1.862846 -2.071206 -2.267136 -2.447421 -2.602553 -2.757597 -2.899256 -3.026699 -3.139727 -3.231891 -3.322263 -3.408018 -3.465171 -3.489679 -3.481314 -3.485759 -3.443517 -3.307152 -2.871628 -1.794495 -1.991008 -2.188923 -2.372068 -2.534095 -2.679387 -2.824016 -2.956480 -3.077190 -3.184829 -3.271633 -3.352688 -3.426968 -3.473997 -3.494576 -3.481935 -3.480217 -3.432412 -3.294557 -2.871628 -1.953998 -2.134474 -2.311213 -2.477770 -2.629489 -2.762400 -2.894598 -3.017189 -3.130165 -3.230513 -3.310547 -3.381588 -3.443029 -3.483129 -3.498719 -3.481079 -3.472895 -3.419910 -3.281239 -2.871628 -2.123085 -2.278905 -2.439340 -2.591673 -2.728462 -2.848677 -2.969273 -3.081182 -3.184533 -3.275711 -3.347484 -3.407344 -3.458803 -3.491975 -3.501683 -3.478533 -3.463713 -3.405836 -3.267106 -2.871628 -2.300187 -2.434392 -2.574644 -2.708810 -2.831107 -2.939102 -3.047637 -3.147228 -3.238753 -3.319511 -3.380872 -3.431160 -3.474119 -3.499922 -3.502438 -3.473358 -3.452310 -3.389911 -3.252045 -2.871628 -2.485695 -2.595431 -2.715101 -2.832183 -2.939707 -3.033401 -3.127324 -3.213553 -3.292151 -3.360725 -3.411937 -3.453485 -3.487872 -3.505466 -3.500957 -3.465132 -3.438270 -3.371865 -3.235927 -2.871628 -2.678339 -2.765669 -2.864852 -2.962555 -3.051644 -3.129200 -3.207273 -3.278898 -3.343611 -3.400749 -3.441506 -3.473168 -3.498620 -3.508209 -3.496161 -3.453647 -3.421290 -3.351675 -3.218573 -2.871628 -2.883681 -2.944678 -3.020861 -3.097494 -3.167039 -3.226516 -3.286686 -3.343173 -3.394516 -3.439035 -3.468458 -3.489251 -3.505657 -3.506968 -3.487528 -3.438452 -3.400784 -3.329531 -3.199755 -2.871628 -3.096394 -3.132096 -3.184682 -3.238210 -3.286533 -3.326646 -3.367493 -3.406671 -3.443322 -3.474972 -3.492454 -3.501566 -3.508160 -3.501287 -3.474588 -3.419057 -3.375892 -3.304880 -3.179150 -2.871628 -3.323021 -3.332317 -3.359101 -3.387958 -3.412827 -3.430638 -3.451028 -3.471769 -3.492311 -3.509603 -3.514100 -3.510425 -3.506629 -3.491302 -3.457066 -3.395550 -3.346387 -3.277299 -3.156328 -2.871628 -3.571345 -3.552063 -3.554606 -3.558552 -3.558332 -3.551404 -3.548574 -3.547787 -3.549183 -3.549861 -3.539159 -3.520619 -3.504241 -3.478290 -3.437101 -3.374877 -3.313121 -3.246187 -3.130605 -2.871628 -3.919852 -3.864532 -3.836212 -3.810189 -3.780521 -3.742142 -3.707839 -3.678538 -3.653638 -3.629107 -3.598808 -3.555049 -3.519970 -3.481416 -3.430821 -3.363240 -3.280533 -3.212783 -3.101950 -2.871628 -7.745110 -7.593304 -7.426156 -7.244489 -7.049057 -6.840644 -6.619963 -6.387639 -6.144300 -5.890510 -5.626753 -5.353517 -5.071238 -4.780296 -4.481071 -4.173902 -3.859090 -3.536932 -3.207697 -2.871628 -1.286988 -1.532822 -1.804060 -2.049022 -2.265395 -2.434764 -2.596320 -2.787991 -2.965452 -3.121671 -3.239016 -3.321374 -3.460642 -3.580412 -3.677296 -3.720071 -3.757021 -3.764566 -3.650654 -3.091126 -1.132958 -1.408276 -1.697530 -1.961946 -2.195705 -2.368024 -2.558828 -2.768900 -2.961277 -3.127249 -3.241376 -3.327256 -3.473213 -3.595909 -3.691525 -3.723469 -3.757170 -3.760404 -3.641417 -3.091126 -1.069688 -1.358877 -1.652142 -1.921455 -2.152203 -2.349191 -2.559272 -2.778334 -2.973499 -3.140949 -3.244641 -3.347648 -3.494353 -3.615016 -3.705271 -3.724672 -3.758297 -3.755690 -3.631520 -3.091126 -1.066469 -1.359788 -1.648973 -1.910634 -2.148942 -2.367100 -2.586201 -2.801313 -2.997844 -3.157567 -3.265880 -3.379278 -3.520837 -3.636055 -3.717870 -3.727978 -3.759223 -3.750292 -3.620904 -3.091126 -1.108802 -1.397539 -1.676311 -1.936942 -2.184449 -2.411684 -2.627222 -2.839062 -3.030421 -3.181025 -3.298891 -3.416213 -3.549908 -3.657629 -3.728244 -3.733116 -3.760039 -3.744054 -3.609499 -3.091126 -1.186298 -1.465243 -1.738875 -1.998991 -2.247368 -2.471031 -2.683002 -2.889421 -3.068646 -3.217968 -3.341858 -3.455553 -3.580452 -3.678596 -3.735247 -3.739363 -3.760725 -3.736794 -3.597229 -3.091126 -1.294314 -1.565489 -1.833184 -2.088858 -2.325055 -2.544201 -2.752411 -2.947413 -3.117122 -3.266470 -3.387966 -3.496543 -3.611152 -3.697809 -3.742137 -3.746255 -3.760137 -3.728364 -3.584190 -3.091126 -1.432981 -1.694074 -1.953613 -2.191660 -2.418855 -2.633456 -2.831040 -3.012098 -3.175449 -3.320373 -3.436958 -3.538566 -3.641488 -3.713943 -3.750824 -3.752140 -3.758462 -3.718600 -3.570451 -3.091126 -1.598556 -1.842878 -2.083264 -2.312523 -2.531329 -2.735008 -2.914625 -3.084092 -3.239900 -3.375339 -3.486616 -3.580200 -3.670255 -3.727969 -3.760060 -3.756905 -3.754888 -3.707282 -3.555909 -3.091126 -1.779775 -2.005095 -2.233175 -2.450529 -2.656183 -2.837991 -3.004822 -3.161844 -3.304689 -3.431077 -3.535444 -3.620100 -3.695601 -3.743484 -3.769295 -3.760171 -3.749326 -3.694217 -3.540698 -3.091126 -1.982371 -2.188146 -2.400240 -2.595217 -2.778475 -2.948350 -3.098210 -3.239460 -3.370545 -3.487392 -3.582303 -3.656148 -3.719063 -3.759093 -3.776956 -3.760828 -3.741292 -3.679179 -3.524749 -3.091126 -2.206632 -2.382719 -2.566707 -2.743876 -2.909111 -3.057470 -3.190554 -3.318484 -3.437622 -3.543194 -3.625811 -3.688296 -3.741835 -3.773189 -3.782670 -3.758336 -3.730398 -3.661886 -3.507705 -3.091126 -2.433998 -2.583784 -2.742849 -2.895676 -3.038047 -3.167788 -3.285431 -3.398867 -3.503922 -3.596272 -3.666288 -3.718643 -3.762298 -3.784247 -3.784969 -3.752390 -3.716218 -3.641953 -3.489408 -3.091126 -2.674666 -2.790590 -2.920792 -3.049912 -3.172418 -3.283525 -3.382441 -3.478353 -3.567952 -3.646796 -3.705055 -3.746055 -3.778810 -3.790499 -3.782653 -3.742213 -3.698267 -3.619278 -3.469633 -3.091126 -2.921614 -3.006740 -3.109556 -3.212966 -3.311338 -3.400802 -3.479700 -3.557063 -3.630321 -3.694739 -3.740551 -3.768913 -3.789751 -3.790784 -3.774631 -3.727158 -3.675858 -3.593783 -3.448089 -3.091126 -3.184673 -3.235162 -3.306895 -3.381748 -3.454323 -3.520562 -3.577892 -3.635193 -3.690037 -3.738160 -3.770231 -3.785685 -3.794327 -3.784318 -3.759866 -3.706255 -3.648342 -3.565551 -3.424387 -3.091126 -3.462894 -3.479059 -3.517498 -3.560671 -3.604760 -3.643893 -3.676556 -3.711636 -3.746253 -3.776886 -3.793834 -3.795636 -3.791817 -3.770497 -3.737503 -3.678374 -3.614527 -3.533289 -3.397934 -3.091126 -3.769027 -3.747382 -3.750396 -3.759036 -3.770585 -3.779734 -3.784164 -3.793795 -3.805357 -3.815727 -3.814993 -3.801375 -3.783749 -3.750080 -3.707082 -3.645186 -3.573475 -3.495615 -3.367908 -3.091126 -4.175868 -4.106358 -4.068542 -4.038688 -4.013189 -3.983042 -3.948288 -3.922437 -3.901423 -3.881975 -3.856725 -3.819009 -3.783062 -3.738091 -3.683267 -3.615022 -3.525454 -3.452216 -3.333627 -3.091126 -9.300068 -9.116036 -8.910143 -8.683781 -8.438292 -8.174921 -7.894796 -7.598967 -7.288372 -6.963861 -6.626196 -6.276063 -5.914096 -5.540868 -5.156897 -4.762655 -4.358574 -3.945052 -3.522455 -3.091126 -1.157215 -1.456821 -1.759196 -2.049855 -2.310979 -2.520724 -2.674073 -2.888515 -3.084975 -3.264770 -3.407597 -3.477445 -3.634978 -3.771387 -3.887291 -3.946583 -3.985698 -4.008393 -3.897495 -3.288899 -0.9418614 -1.265922 -1.603455 -1.924716 -2.210623 -2.423301 -2.610100 -2.847109 -3.066500 -3.264247 -3.407385 -3.477233 -3.645082 -3.787590 -3.904983 -3.953070 -3.987686 -4.005421 -3.887899 -3.288899 -0.8345835 -1.184858 -1.536630 -1.864975 -2.146032 -2.376059 -2.597337 -2.844383 -3.074318 -3.276103 -3.404754 -3.500252 -3.668170 -3.809657 -3.923203 -3.955613 -3.990661 -4.001952 -3.877512 -3.288899 -0.8148196 -1.172592 -1.523760 -1.838453 -2.121277 -2.377568 -2.615141 -2.867116 -3.100710 -3.292361 -3.422737 -3.539281 -3.698680 -3.835557 -3.940871 -3.960317 -3.994567 -3.997779 -3.866264 -3.288899 -0.8546963 -1.208359 -1.540540 -1.849634 -2.142788 -2.410182 -2.658820 -2.909870 -3.133431 -3.313810 -3.460209 -3.583659 -3.734440 -3.862760 -3.956544 -3.968517 -3.999231 -3.992662 -3.854067 -3.288899 -0.9358849 -1.272344 -1.595116 -1.901893 -2.195065 -2.470393 -2.721699 -2.963353 -3.174249 -3.357659 -3.510713 -3.633209 -3.772482 -3.890172 -3.968521 -3.978906 -4.003137 -3.986406 -3.840826 -3.288899 -1.048008 -1.373222 -1.685656 -1.986632 -2.278728 -2.551920 -2.795622 -3.024651 -3.231531 -3.418376 -3.566066 -3.686406 -3.812403 -3.916705 -3.978853 -3.990496 -4.005929 -3.978820 -3.826580 -3.288899 -1.196513 -1.507918 -1.809225 -2.101889 -2.386446 -2.646513 -2.878281 -3.101249 -3.306620 -3.481404 -3.626840 -3.739981 -3.852862 -3.940551 -3.992320 -4.001628 -4.007368 -3.969699 -3.811552 -3.288899 -1.377413 -1.672930 -1.961684 -2.242892 -2.504943 -2.752706 -2.979046 -3.195956 -3.384335 -3.549661 -3.686626 -3.792450 -3.891306 -3.961679 -4.007755 -4.012144 -4.006865 -3.958743 -3.795641 -3.288899 -1.586755 -1.864637 -2.134005 -2.389858 -2.640005 -2.879539 -3.097307 -3.290478 -3.466352 -3.618559 -3.745111 -3.842376 -3.925580 -3.984138 -4.023149 -4.020586 -4.004001 -3.945721 -3.778714 -3.288899 -1.820037 -2.069237 -2.318067 -2.560057 -2.797599 -3.018080 -3.208635 -3.388943 -3.547520 -3.686339 -3.802084 -3.888416 -3.956359 -4.006506 -4.037401 -4.026093 -3.998417 -3.930351 -3.760588 -3.288899 -2.069537 -2.295523 -2.525948 -2.748854 -2.956556 -3.151835 -3.324744 -3.483274 -3.626133 -3.753131 -3.856465 -3.930240 -3.986943 -4.026835 -4.048631 -4.028198 -3.989662 -3.912275 -3.741707 -3.288899 -2.347182 -2.541897 -2.738166 -2.930921 -3.117346 -3.286101 -3.435220 -3.575723 -3.704377 -3.817251 -3.907299 -3.970860 -4.015836 -4.043935 -4.055391 -4.025980 -3.977091 -3.890946 -3.721350 -3.288899 -2.630864 -2.789833 -2.955155 -3.116900 -3.272130 -3.417403 -3.547257 -3.669368 -3.780642 -3.877890 -3.955778 -4.007920 -4.040736 -4.055536 -4.056491 -4.018429 -3.959941 -3.866229 -3.699257 -3.288899 -2.927953 -3.044171 -3.173448 -3.304517 -3.433357 -3.553720 -3.660593 -3.762029 -3.854868 -3.935597 -3.999270 -4.038695 -4.058778 -4.060257 -4.050567 -4.004344 -3.937222 -3.838178 -3.675097 -3.288899 -3.238278 -3.314031 -3.406018 -3.502296 -3.600036 -3.692365 -3.774586 -3.853402 -3.925321 -3.987923 -4.035336 -4.060416 -4.067564 -4.056474 -4.036152 -3.982265 -3.907950 -3.806112 -3.648390 -3.288899 -3.568899 -3.601372 -3.652478 -3.710995 -3.774617 -3.835465 -3.888959 -3.941458 -3.989935 -4.032103 -4.061956 -4.071507 -4.065016 -4.042450 -4.011558 -3.950686 -3.871378 -3.769690 -3.618425 -3.288899 -3.933770 -3.918651 -3.924250 -3.939456 -3.963363 -3.987452 -4.007094 -4.029755 -4.051951 -4.070704 -4.080636 -4.072356 -4.050626 -4.016540 -3.975462 -3.909023 -3.825751 -3.726816 -3.584153 -3.288899 -4.397944 -4.327909 -4.282067 -4.247948 -4.223758 -4.200151 -4.173770 -4.154931 -4.141031 -4.127556 -4.108435 -4.076523 -4.035820 -3.986270 -3.929328 -3.861696 -3.768867 -3.676147 -3.544223 -3.288899 -10.91791 -10.70105 -10.45475 -10.18120 -9.882466 -9.560441 -9.216810 -8.853076 -8.470572 -8.070486 -7.653873 -7.221676 -6.774741 -6.313823 -5.839607 -5.352710 -4.853699 -4.343085 -3.821340 -3.288899 -1.024968 -1.396823 -1.722790 -2.050876 -2.347356 -2.598144 -2.753070 -2.989136 -3.201879 -3.398093 -3.561747 -3.620513 -3.793528 -3.945076 -4.077118 -4.152002 -4.192046 -4.229955 -4.124738 -3.468863 -0.7422639 -1.138269 -1.510952 -1.875436 -2.210402 -2.481099 -2.666547 -2.927731 -3.167482 -3.387432 -3.560251 -3.612970 -3.800233 -3.961530 -4.098228 -4.161958 -4.195038 -4.228521 -4.115069 -3.468863 -0.5981009 -1.020936 -1.412978 -1.792457 -2.138966 -2.412398 -2.644439 -2.915496 -3.166126 -3.397138 -3.558428 -3.637047 -3.825320 -3.986715 -4.121068 -4.166862 -4.200677 -4.226745 -4.104473 -3.468863 -0.5600995 -0.9850274 -1.384719 -1.767503 -2.105634 -2.397342 -2.657252 -2.930853 -3.187972 -3.417309 -3.569554 -3.681278 -3.860842 -4.017713 -4.144224 -4.172599 -4.208434 -4.224319 -4.092864 -3.468863 -0.5895166 -1.008891 -1.407539 -1.777133 -2.112781 -2.420314 -2.694419 -2.969820 -3.227039 -3.441662 -3.607731 -3.735029 -3.902663 -4.051605 -4.165688 -4.184021 -4.216437 -4.220959 -4.080137 -3.468863 -0.6734533 -1.081969 -1.466331 -1.819167 -2.157309 -2.470481 -2.751532 -3.028924 -3.278432 -3.484725 -3.663555 -3.797133 -3.949532 -4.086939 -4.183566 -4.199327 -4.224626 -4.216372 -4.066176 -3.468863 -0.8002552 -1.189887 -1.551417 -1.898773 -2.232448 -2.544811 -2.831368 -3.102579 -3.334698 -3.547963 -3.731253 -3.861231 -3.999736 -4.121757 -4.198604 -4.216055 -4.231812 -4.210366 -4.050960 -3.468863 -0.9596140 -1.326193 -1.674585 -2.008738 -2.335730 -2.647097 -2.929271 -3.181311 -3.413075 -3.625324 -3.801945 -3.926672 -4.049304 -4.154504 -4.217772 -4.233912 -4.237748 -4.202662 -4.034854 -3.468863 -1.152288 -1.498436 -1.828402 -2.151182 -2.468415 -2.771191 -3.032301 -3.280621 -3.508452 -3.709552 -3.873626 -3.989676 -4.096200 -4.183323 -4.239933 -4.250812 -4.241855 -4.192863 -4.017777 -3.468863 -1.379121 -1.702330 -2.015230 -2.322938 -2.621958 -2.899022 -3.156715 -3.398044 -3.611073 -3.792528 -3.945618 -4.049769 -4.139587 -4.213102 -4.262563 -4.265522 -4.243412 -4.180741 -3.999580 -3.468863 -1.637357 -1.936534 -2.230508 -2.509342 -2.785826 -3.053516 -3.300583 -3.518674 -3.709079 -3.876128 -4.013342 -4.107099 -4.180295 -4.243767 -4.283993 -4.277229 -4.241856 -4.165907 -3.980087 -3.468863 -1.923100 -2.189734 -2.453663 -2.715345 -2.976071 -3.225126 -3.439493 -3.635283 -3.805628 -3.953312 -4.077576 -4.160665 -4.221393 -4.273146 -4.302259 -4.284719 -4.236526 -4.147929 -3.959013 -3.468863 -2.225265 -2.464833 -2.705658 -2.943320 -3.168186 -3.383179 -3.576597 -3.745932 -3.895335 -4.027707 -4.138614 -4.211574 -4.260661 -4.298782 -4.315713 -4.286852 -4.226506 -4.126035 -3.936746 -3.468863 -2.561740 -2.760206 -2.960933 -3.161675 -3.356930 -3.539018 -3.702972 -3.851191 -3.983412 -4.099915 -4.196734 -4.257517 -4.294487 -4.318270 -4.322721 -4.282611 -4.210711 -4.100031 -3.912536 -3.468863 -2.903493 -3.059052 -3.220454 -3.380468 -3.539018 -3.691220 -3.831069 -3.957179 -4.069385 -4.168417 -4.249608 -4.296470 -4.319513 -4.329283 -4.321327 -4.270416 -4.187934 -4.070019 -3.885933 -3.468863 -3.262354 -3.367100 -3.484957 -3.607218 -3.730160 -3.849134 -3.960298 -4.061270 -4.151067 -4.230187 -4.293854 -4.325529 -4.333118 -4.329244 -4.309345 -4.248603 -4.156890 -4.034832 -3.856363 -3.468863 -3.646317 -3.698278 -3.767288 -3.845181 -3.928196 -4.011461 -4.089783 -4.161079 -4.225193 -4.281435 -4.325126 -4.340656 -4.332458 -4.315132 -4.284070 -4.215031 -4.116951 -3.994824 -3.822971 -3.468863 -4.066342 -4.063540 -4.076815 -4.102481 -4.139074 -4.180688 -4.220753 -4.256982 -4.290810 -4.321351 -4.342337 -4.339513 -4.314845 -4.283877 -4.242946 -4.167354 -4.066475 -3.947466 -3.784267 -3.468863 -4.590817 -4.523675 -4.470988 -4.435556 -4.414444 -4.401616 -4.390861 -4.380549 -4.373188 -4.369138 -4.359789 -4.329274 -4.285361 -4.236322 -4.183849 -4.108341 -4.002195 -3.890886 -3.737735 -3.468863 -12.59390 -12.34360 -12.05551 -11.73213 -11.37718 -10.99309 -10.58221 -10.14656 -9.687949 -9.207932 -8.707882 -8.189016 -7.652409 -7.099013 -6.529690 -5.945210 -5.346278 -4.733529 -4.107544 -3.468863 -0.9009588 -1.341105 -1.700520 -2.063572 -2.387931 -2.668973 -2.834008 -3.086269 -3.316125 -3.525854 -3.705723 -3.761770 -3.940912 -4.104120 -4.250227 -4.339837 -4.378082 -4.432190 -4.335324 -3.633962 -0.5473716 -1.015086 -1.431239 -1.834829 -2.206094 -2.520957 -2.721324 -3.008774 -3.266028 -3.506224 -3.700832 -3.744529 -3.944053 -4.120550 -4.274596 -4.353589 -4.382323 -4.432520 -4.325881 -3.633962 -0.3624255 -0.8577789 -1.298429 -1.721068 -2.110671 -2.433432 -2.699513 -2.989774 -3.259405 -3.511726 -3.698918 -3.770828 -3.970159 -4.149218 -4.302218 -4.361743 -4.390556 -4.432728 -4.315376 -3.633962 -0.3034249 -0.8014571 -1.251049 -1.678750 -2.070797 -2.420954 -2.712048 -3.001586 -3.279344 -3.531044 -3.707161 -3.818997 -4.010691 -4.185308 -4.330910 -4.368396 -4.401793 -4.432396 -4.303702 -3.633962 -0.3254447 -0.8158398 -1.263000 -1.686837 -2.087380 -2.442359 -2.742077 -3.039568 -3.315651 -3.559503 -3.749446 -3.879007 -4.061184 -4.226051 -4.358639 -4.383195 -4.414238 -4.431257 -4.290730 -3.633962 -0.4101814 -0.8827265 -1.321033 -1.742315 -2.133623 -2.480083 -2.796259 -3.092215 -3.367885 -3.609061 -3.807741 -3.949059 -4.117703 -4.270030 -4.383450 -4.403416 -4.426844 -4.428902 -4.276324 -3.633962 -0.5419263 -0.9954019 -1.421874 -1.823741 -2.197312 -2.550760 -2.867678 -3.165039 -3.434624 -3.675342 -3.878637 -4.024257 -4.176236 -4.313948 -4.404271 -4.426486 -4.439244 -4.425050 -4.260402 -3.633962 -0.7175824 -1.149056 -1.548610 -1.928481 -2.297892 -2.643530 -2.963460 -3.256077 -3.519943 -3.755368 -3.959580 -4.099032 -4.235941 -4.355880 -4.429482 -4.450872 -4.450608 -4.419325 -4.243450 -3.633962 -0.9292523 -1.327558 -1.703392 -2.069925 -2.424674 -2.767111 -3.081321 -3.364059 -3.617019 -3.850112 -4.046578 -4.173670 -4.293724 -4.393435 -4.458336 -4.474494 -4.459757 -4.411287 -4.225451 -3.633962 -1.169469 -1.540737 -1.893605 -2.242001 -2.587022 -2.917353 -3.214327 -3.483314 -3.731776 -3.954157 -4.129779 -4.248080 -4.348614 -4.432016 -4.488443 -4.495963 -4.465920 -4.400582 -4.206222 -3.633962 -1.446581 -1.787665 -2.119485 -2.449550 -2.775151 -3.078006 -3.363080 -3.623533 -3.856163 -4.050078 -4.212891 -4.316692 -4.399937 -4.472057 -4.517625 -4.514129 -4.468606 -4.386712 -4.185564 -3.633962 -1.756562 -2.068927 -2.378031 -2.675154 -2.971338 -3.262440 -3.534132 -3.767273 -3.969938 -4.145607 -4.288368 -4.379640 -4.451131 -4.510590 -4.543738 -4.527783 -4.467003 -4.369068 -4.163205 -3.633962 -2.095790 -2.372249 -2.646224 -2.921678 -3.198368 -3.461687 -3.695369 -3.902359 -4.079033 -4.231960 -4.359624 -4.440473 -4.499433 -4.545009 -4.564471 -4.535792 -4.459958 -4.346903 -4.138769 -3.633962 -2.460598 -2.702791 -2.948033 -3.185492 -3.419651 -3.646857 -3.849176 -4.024221 -4.178262 -4.314413 -4.428158 -4.497372 -4.541833 -4.572732 -4.577767 -4.536497 -4.446303 -4.319845 -4.112706 -3.633962 -2.855702 -3.046326 -3.244795 -3.441386 -3.634515 -3.820299 -3.991200 -4.142109 -4.276350 -4.393661 -4.490266 -4.546707 -4.575106 -4.590890 -4.581526 -4.527866 -4.424381 -4.288186 -4.083914 -3.633962 -3.265116 -3.399874 -3.544722 -3.693884 -3.845665 -3.996245 -4.136432 -4.259497 -4.369389 -4.465711 -4.542860 -4.584135 -4.595807 -4.595829 -4.572974 -4.507511 -4.392836 -4.250785 -4.051726 -3.633962 -3.700629 -3.773725 -3.863585 -3.961869 -4.067313 -4.176758 -4.280971 -4.371855 -4.453210 -4.525693 -4.580890 -4.604241 -4.599512 -4.583278 -4.548544 -4.472682 -4.350908 -4.205950 -4.015141 -3.633962 -4.175320 -4.183424 -4.210489 -4.250579 -4.303381 -4.363577 -4.424280 -4.476729 -4.524215 -4.568029 -4.599338 -4.602583 -4.580983 -4.548578 -4.504158 -4.420731 -4.296128 -4.152379 -3.972447 -3.633962 -4.759116 -4.693743 -4.643593 -4.610083 -4.595513 -4.594169 -4.597397 -4.598622 -4.601246 -4.606591 -4.606525 -4.582636 -4.538526 -4.488876 -4.435797 -4.349445 -4.227435 -4.087198 -3.920334 -3.633962 -14.32395 -14.03962 -13.70767 -13.33265 -12.91868 -12.46935 -11.98774 -11.47653 -10.93798 -10.37408 -9.786539 -9.176852 -8.546340 -7.896168 -7.227380 -6.540906 -5.837594 -5.118210 -4.383452 -3.633962 -0.7797439 -1.290903 -1.684712 -2.085198 -2.440327 -2.742956 -2.937825 -3.175461 -3.422143 -3.648123 -3.840516 -3.912723 -4.077885 -4.251857 -4.409451 -4.512184 -4.547863 -4.618474 -4.531496 -3.786466 -0.3577982 -0.9026411 -1.364674 -1.813727 -2.213488 -2.560649 -2.783863 -3.078426 -3.360780 -3.618706 -3.832860 -3.880667 -4.078129 -4.267616 -4.437049 -4.530170 -4.553339 -4.620852 -4.522579 -3.786466 -0.1385906 -0.7037062 -1.204418 -1.667182 -2.089497 -2.448469 -2.747095 -3.060276 -3.352816 -3.622144 -3.830446 -3.904994 -4.106931 -4.298933 -4.469080 -4.541533 -4.564807 -4.623482 -4.512464 -3.786466 -5.5237241E-02 -0.6229361 -1.129593 -1.600352 -2.032348 -2.422143 -2.761315 -3.077738 -3.370095 -3.643597 -3.833577 -3.958531 -4.153140 -4.340808 -4.503435 -4.549295 -4.579602 -4.625786 -4.501024 -3.786466 -6.6701889E-02 -0.6241186 -1.125586 -1.596125 -2.038390 -2.446890 -2.798986 -3.110562 -3.408635 -3.672339 -3.878058 -4.025644 -4.210146 -4.389714 -4.538197 -4.567850 -4.596409 -4.627501 -4.488105 -3.786466 -0.1495171 -0.6865807 -1.178798 -1.645844 -2.092226 -2.498058 -2.846050 -3.162616 -3.459811 -3.720880 -3.943625 -4.099698 -4.274718 -4.441197 -4.570395 -4.593283 -4.614193 -4.628137 -4.473541 -3.786466 -0.2870798 -0.8006555 -1.277787 -1.738138 -2.172066 -2.561743 -2.913296 -3.233433 -3.525913 -3.794785 -4.018085 -4.179099 -4.344635 -4.494244 -4.597214 -4.622853 -4.631987 -4.627221 -4.457196 -3.786466 -0.4712902 -0.9585658 -1.418502 -1.858819 -2.265889 -2.651108 -3.003742 -3.320545 -3.617082 -3.883938 -4.102683 -4.264130 -4.413868 -4.545839 -4.628301 -4.653596 -4.648538 -4.624302 -4.439670 -3.786466 -0.6981778 -1.156599 -1.586128 -1.994203 -2.393277 -2.768564 -3.116284 -3.434928 -3.725978 -3.979398 -4.197600 -4.352044 -4.483678 -4.592995 -4.664626 -4.683887 -4.663085 -4.618917 -4.421034 -3.786466 -0.9626476 -1.380116 -1.778409 -2.170330 -2.549668 -2.917459 -3.260125 -3.567574 -3.840392 -4.090150 -4.298715 -4.436457 -4.549966 -4.640349 -4.703196 -4.712612 -4.674442 -4.610573 -4.401078 -3.786466 -1.255214 -1.637362 -2.010518 -2.378822 -2.744483 -3.099571 -3.420274 -3.708857 -3.975508 -4.211134 -4.392690 -4.517668 -4.611405 -4.689554 -4.740969 -4.738227 -4.682318 -4.598621 -4.379564 -3.786466 -1.586383 -1.934319 -2.282089 -2.626961 -2.967547 -3.291297 -3.597040 -3.874486 -4.118165 -4.320480 -4.485533 -4.591333 -4.672136 -4.737456 -4.774763 -4.759275 -4.685367 -4.582391 -4.356195 -3.786466 -1.953935 -2.269707 -2.584141 -2.892068 -3.203948 -3.510981 -3.798468 -4.036907 -4.248247 -4.425553 -4.568332 -4.662436 -4.729590 -4.781126 -4.802752 -4.773609 -4.682391 -4.561112 -4.330609 -3.786466 -2.352732 -2.625274 -2.904529 -3.186063 -3.470983 -3.734267 -3.976953 -4.186668 -4.365835 -4.519515 -4.646785 -4.729646 -4.780819 -4.817584 -4.823242 -4.779531 -4.671805 -4.534199 -4.302497 -3.786466 -2.788870 -3.018186 -3.248866 -3.481277 -3.717701 -3.940683 -4.143064 -4.318010 -4.474297 -4.609799 -4.720246 -4.788753 -4.823479 -4.843447 -4.833469 -4.774849 -4.651744 -4.502046 -4.271841 -3.786466 -3.246042 -3.413055 -3.591380 -3.769786 -3.952478 -4.133001 -4.301589 -4.448528 -4.578546 -4.692160 -4.783261 -4.835043 -4.853060 -4.854337 -4.829510 -4.757373 -4.620359 -4.463315 -4.237356 -3.786466 -3.732286 -3.828632 -3.944701 -4.067043 -4.198008 -4.332786 -4.460647 -4.573205 -4.673088 -4.760745 -4.828717 -4.861872 -4.862848 -4.845342 -4.806865 -4.723132 -4.576540 -4.415590 -4.197884 -3.786466 -4.265086 -4.284622 -4.327950 -4.385140 -4.456999 -4.538346 -4.617172 -4.687549 -4.751077 -4.807909 -4.849008 -4.861547 -4.844937 -4.810269 -4.760140 -4.668338 -4.516263 -4.356704 -4.151472 -3.786466 -4.906247 -4.841840 -4.796795 -4.770916 -4.766072 -4.777339 -4.793077 -4.807478 -4.823006 -4.839764 -4.847115 -4.832077 -4.793625 -4.741922 -4.681394 -4.588945 -4.439826 -4.281925 -4.094131 -3.786466 -16.10451 -15.78555 -15.40846 -14.97936 -14.50370 -13.98615 -13.43064 -12.84047 -12.21849 -11.56710 -10.88836 -10.18408 -9.455817 -8.704967 -7.932762 -7.140304 -6.328584 -5.498504 -4.650880 -3.786466 -0.6571023 -1.232962 -1.670112 -2.107083 -2.489944 -2.821400 -3.042435 -3.263595 -3.521953 -3.761020 -3.968018 -4.057136 -4.206569 -4.389966 -4.557012 -4.671241 -4.704801 -4.790387 -4.714910 -3.928160 -0.1676295 -0.7931522 -1.301427 -1.791924 -2.232268 -2.610687 -2.849423 -3.143793 -3.444756 -3.724997 -3.956600 -4.013278 -4.202797 -4.405248 -4.587233 -4.693128 -4.711861 -4.794986 -4.706804 -3.928160 8.3457150E-02 -0.5587099 -1.115688 -1.628935 -2.091154 -2.472714 -2.791870 -3.117306 -3.437161 -3.728929 -3.955296 -4.035035 -4.235518 -4.439682 -4.624207 -4.708234 -4.726585 -4.800284 -4.697376 -3.928160 0.1919920 -0.4543093 -1.023432 -1.546824 -2.007198 -2.425743 -2.794840 -3.139327 -3.462214 -3.750379 -3.958052 -4.092114 -4.289804 -4.487061 -4.664967 -4.716956 -4.745966 -4.805655 -4.686473 -3.928160 0.1873675 -0.4397132 -1.003603 -1.516909 -1.995390 -2.439121 -2.833910 -3.184262 -3.500931 -3.784446 -4.000278 -4.164958 -4.353408 -4.542381 -4.706582 -4.738398 -4.768253 -4.810659 -4.673911 -3.928160 0.1069402 -0.4956486 -1.041812 -1.554410 -2.040802 -2.493780 -2.895880 -3.238384 -3.554088 -3.832005 -4.067234 -4.247728 -4.424183 -4.603025 -4.745667 -4.768610 -4.792150 -4.814718 -4.659483 -3.928160 -3.5424136E-02 -0.6083570 -1.138589 -1.643071 -2.126743 -2.575152 -2.964139 -3.304741 -3.621900 -3.906082 -4.150365 -4.330845 -4.501485 -4.664997 -4.779283 -4.804021 -4.816042 -4.817315 -4.643003 -3.928160 -0.2284195 -0.7714139 -1.279465 -1.770524 -2.240277 -2.665571 -3.046114 -3.393461 -3.708772 -4.000181 -4.241769 -4.420375 -4.583283 -4.726370 -4.817583 -4.842609 -4.838644 -4.817905 -4.625173 -3.928160 -0.4676929 -0.9768226 -1.459537 -1.926883 -2.366266 -2.777873 -3.158289 -3.500690 -3.821418 -4.107630 -4.337922 -4.516926 -4.663319 -4.784097 -4.862202 -4.881028 -4.859344 -4.815948 -4.606191 -3.928160 -0.7489289 -1.220326 -1.669888 -2.101735 -2.523250 -2.922849 -3.295378 -3.638900 -3.950614 -4.218575 -4.446303 -4.614843 -4.741827 -4.840685 -4.908866 -4.917473 -4.876767 -4.810783 -4.585815 -3.928160 -1.065667 -1.489713 -1.906905 -2.315846 -2.714561 -3.103800 -3.468029 -3.794645 -4.085257 -4.347532 -4.561753 -4.706568 -4.814954 -4.899307 -4.954447 -4.950035 -4.890246 -4.801647 -4.563748 -3.928160 -1.412718 -1.799942 -2.185982 -2.567779 -2.949301 -3.322116 -3.655555 -3.963111 -4.244088 -4.483257 -4.667984 -4.794375 -4.884696 -4.956826 -4.996629 -4.977662 -4.898608 -4.787829 -4.539656 -3.928160 -1.804696 -2.154088 -2.508050 -2.863517 -3.208642 -3.546618 -3.867195 -4.157732 -4.400949 -4.607260 -4.768268 -4.876212 -4.951621 -5.009551 -5.033459 -4.998736 -4.900311 -4.768441 -4.513135 -3.928160 -2.237161 -2.544650 -2.856514 -3.170012 -3.491357 -3.807983 -4.088591 -4.332106 -4.542965 -4.717934 -4.857957 -4.952828 -5.013619 -5.054658 -5.061983 -5.011781 -4.893684 -4.742719 -4.483617 -3.928160 -2.703156 -2.962814 -3.237743 -3.511184 -3.782478 -4.047354 -4.285397 -4.488170 -4.665099 -4.818099 -4.941033 -5.020425 -5.066730 -5.089236 -5.079039 -5.013305 -4.876666 -4.711065 -4.451094 -3.928160 -3.210058 -3.407147 -3.622373 -3.836135 -4.053871 -4.264943 -4.458605 -4.630434 -4.781501 -4.911269 -5.012960 -5.074830 -5.104418 -5.109175 -5.080606 -4.999290 -4.847064 -4.671970 -4.414534 -3.928160 -3.748307 -3.866609 -4.008454 -4.160954 -4.320663 -4.482318 -4.632840 -4.767633 -4.887054 -4.989734 -5.066814 -5.109061 -5.119117 -5.107902 -5.061980 -4.965240 -4.803253 -4.622835 -4.372391 -3.928160 -4.338102 -4.370383 -4.431130 -4.508281 -4.602360 -4.704983 -4.804015 -4.892463 -4.973349 -5.043583 -5.091928 -5.111957 -5.101547 -5.076262 -5.015901 -4.907359 -4.740421 -4.560026 -4.322448 -3.928160 -5.035914 -4.974221 -4.935674 -4.920252 -4.930551 -4.954995 -4.984877 -5.012342 -5.042411 -5.070030 -5.083313 -5.075455 -5.042478 -5.002492 -4.931151 -4.820536 -4.656107 -4.477398 -4.260052 -3.928160 -17.93244 -17.57829 -17.15455 -16.66925 -16.12941 -15.54085 -14.90844 -14.23621 -13.52756 -12.78534 -12.01201 -11.20966 -10.38013 -9.525040 -8.645809 -7.743721 -6.819921 -5.875449 -4.911240 -3.928160 -0.5357791 -1.170164 -1.643486 -2.124783 -2.539478 -2.893348 -3.145431 -3.353001 -3.619531 -3.867702 -4.086912 -4.194589 -4.328386 -4.518949 -4.693889 -4.820151 -4.850477 -4.949444 -4.887009 -4.060476 2.4180265E-02 -0.6650410 -1.231155 -1.772604 -2.246201 -2.659719 -2.925066 -3.212181 -3.524934 -3.821460 -4.073632 -4.140790 -4.320786 -4.533360 -4.726372 -4.846702 -4.858973 -4.956314 -4.880017 -4.060476 0.3098504 -0.4086077 -1.030162 -1.588660 -2.091494 -2.516314 -2.845433 -3.177273 -3.511666 -3.826808 -4.075281 -4.160997 -4.358258 -4.572098 -4.767555 -4.865996 -4.877092 -4.964474 -4.871598 -4.060476 0.4342672 -0.2892683 -0.9198332 -1.492625 -2.005602 -2.443975 -2.831461 -3.193224 -3.541239 -3.856527 -4.077635 -4.220932 -4.418983 -4.624626 -4.814439 -4.876578 -4.901685 -4.973183 -4.861551 -4.060476 0.4430159 -0.2616097 -0.8858155 -1.459375 -1.969402 -2.437284 -2.859568 -3.241576 -3.592329 -3.892647 -4.121717 -4.298128 -4.491484 -4.685831 -4.863226 -4.900800 -4.930242 -4.981749 -4.849654 -4.060476 0.3605953 -0.3094099 -0.9189276 -1.475545 -1.996132 -2.482703 -2.921696 -3.312195 -3.651137 -3.942926 -4.189632 -4.384960 -4.570240 -4.753573 -4.909593 -4.936346 -4.960311 -4.989575 -4.835679 -4.060476 0.2133128 -0.4214298 -1.004528 -1.554166 -2.076406 -2.565322 -3.009334 -3.385086 -3.716986 -4.018566 -4.274946 -4.477367 -4.653861 -4.825845 -4.951448 -4.978803 -4.990676 -4.996073 -4.819364 -4.060476 1.1262532E-02 -0.5852679 -1.145854 -1.679820 -2.195670 -2.676721 -3.098149 -3.465480 -3.807927 -4.110792 -4.371959 -4.571469 -4.742441 -4.897003 -4.998014 -5.024834 -5.019945 -5.000627 -4.801473 -4.060476 -0.2396281 -0.7991015 -1.328644 -1.845781 -2.341946 -2.793775 -3.200502 -3.576710 -3.914144 -4.222681 -4.476638 -4.671817 -4.835194 -4.964538 -5.050838 -5.070648 -5.047108 -5.002494 -4.782423 -4.060476 -0.5352149 -1.053113 -1.552701 -2.043630 -2.499866 -2.934797 -3.338019 -3.707348 -4.047648 -4.347309 -4.587986 -4.778762 -4.924274 -5.032694 -5.105593 -5.114159 -5.071488 -5.001038 -4.761875 -4.060476 -0.8689697 -1.344840 -1.806565 -2.256402 -2.695151 -3.111644 -3.506526 -3.871838 -4.196945 -4.478656 -4.713668 -4.885793 -5.010198 -5.101168 -5.159857 -5.154407 -5.091352 -4.995305 -4.739495 -4.060476 -1.239775 -1.669225 -2.092896 -2.513047 -2.927224 -3.332477 -3.714403 -4.050883 -4.357759 -4.629446 -4.839757 -4.987104 -5.091595 -5.167087 -5.210786 -5.189917 -5.105308 -4.984511 -4.714918 -4.060476 -1.652669 -2.038698 -2.425790 -2.816385 -3.208753 -3.582462 -3.930815 -4.253426 -4.542370 -4.775362 -4.956269 -5.080531 -5.169065 -5.229088 -5.255872 -5.218579 -5.112128 -4.967558 -4.687694 -4.060476 -2.111889 -2.453298 -2.806792 -3.153446 -3.506503 -3.855402 -4.183483 -4.466196 -4.706772 -4.906834 -5.059028 -5.164883 -5.240985 -5.284382 -5.292756 -5.237473 -5.110155 -4.943464 -4.657274 -4.060476 -2.613302 -2.900657 -3.205546 -3.520225 -3.842450 -4.140584 -4.414154 -4.650757 -4.852025 -5.018940 -5.152167 -5.241961 -5.301464 -5.329109 -5.317934 -5.243559 -5.097515 -4.912548 -4.622973 -4.060476 -3.166387 -3.390169 -3.634645 -3.889424 -4.147152 -4.392200 -4.612598 -4.807453 -4.979665 -5.123612 -5.234655 -5.306473 -5.345984 -5.357418 -5.326685 -5.233692 -5.071126 -4.873133 -4.584524 -4.060476 -3.751942 -3.894290 -4.062521 -4.245020 -4.436424 -4.626008 -4.802102 -4.957949 -5.096963 -5.212772 -5.298367 -5.349525 -5.368236 -5.361173 -5.312495 -5.203349 -5.028606 -4.822390 -4.539894 -4.060476 -4.396668 -4.441543 -4.522372 -4.622905 -4.740902 -4.867098 -4.986459 -5.094622 -5.193078 -5.274287 -5.330125 -5.357632 -5.355068 -5.330185 -5.266343 -5.146261 -4.964116 -4.755893 -4.486616 -4.060476 -5.149667 -5.090178 -5.063498 -5.061758 -5.086085 -5.128091 -5.170982 -5.214732 -5.259342 -5.297802 -5.317142 -5.316383 -5.292072 -5.250335 -5.174498 -5.052760 -4.870208 -4.666932 -4.419446 -4.060476 -19.80499 -19.41507 -18.94322 -18.39972 -17.79330 -17.13112 -16.41902 -15.66183 -14.86350 -14.02738 -13.15630 -12.25269 -11.31864 -10.35601 -9.366436 -8.351369 -7.312117 -6.249855 -5.165651 -4.060476 -0.4230216 -1.119348 -1.640574 -2.131181 -2.579385 -2.962559 -3.240654 -3.440447 -3.715878 -3.970600 -4.198512 -4.325267 -4.443653 -4.641016 -4.822268 -4.959275 -4.985983 -5.097551 -5.048722 -4.184579 0.2140664 -0.5388954 -1.150443 -1.733628 -2.260803 -2.702155 -2.996150 -3.286732 -3.605315 -3.912427 -4.181101 -4.265307 -4.433641 -4.654480 -4.857042 -4.991243 -4.995548 -5.106801 -5.043099 -4.184579 0.5374810 -0.2446027 -0.9261547 -1.551853 -2.090215 -2.549949 -2.912623 -3.244696 -3.586254 -3.914144 -4.187560 -4.283549 -4.476962 -4.696857 -4.902046 -5.015153 -5.017714 -5.117984 -5.035918 -4.184579 0.6797090 -0.1137827 -0.8186445 -1.439567 -1.995236 -2.477910 -2.881634 -3.251433 -3.612669 -3.949499 -4.195400 -4.348221 -4.543977 -4.756347 -4.953703 -5.028280 -5.047685 -5.130250 -5.026972 -4.184579 0.6933519 -8.4899418E-02 -0.7708260 -1.396668 -1.959084 -2.453404 -2.890436 -3.293624 -3.668636 -3.998182 -4.239244 -4.430140 -4.624429 -4.824386 -5.008721 -5.055737 -5.082051 -5.142768 -5.016007 -4.184579 0.6126831 -0.1264744 -0.7953575 -1.412090 -1.968920 -2.476587 -2.942542 -3.364369 -3.742605 -4.052017 -4.311708 -4.519266 -4.712786 -4.899472 -5.064328 -5.097783 -5.118450 -5.154784 -5.002754 -4.184579 0.4596134 -0.2365364 -0.8802177 -1.476439 -2.031572 -2.552079 -3.028780 -3.457230 -3.816479 -4.127984 -4.397976 -4.616585 -4.804344 -4.978849 -5.114434 -5.147685 -5.155241 -5.165616 -4.986917 -4.184579 0.2483343 -0.4037998 -1.015727 -1.594983 -2.148135 -2.665425 -3.141766 -3.547112 -3.902131 -4.223101 -4.496523 -4.720460 -4.899321 -5.060032 -5.169062 -5.200754 -5.191380 -5.174574 -4.969305 -4.184579 -1.4871542E-02 -0.6217040 -1.201489 -1.764026 -2.301032 -2.806048 -3.251444 -3.649155 -4.012927 -4.334208 -4.608700 -4.823462 -4.999403 -5.139365 -5.231596 -5.253109 -5.225532 -5.180795 -4.950483 -4.184579 -0.3250519 -0.8864511 -1.431759 -1.971358 -2.481627 -2.950356 -3.382624 -3.782323 -4.142482 -4.465915 -4.727896 -4.934700 -5.102885 -5.217669 -5.295056 -5.303931 -5.256439 -5.183414 -4.930137 -4.184579 -0.6755922 -1.194117 -1.704520 -2.205224 -2.674997 -3.128936 -3.548662 -3.942832 -4.300372 -4.607226 -4.855892 -5.055130 -5.199275 -5.296468 -5.356672 -5.351722 -5.282637 -5.181418 -4.907875 -4.184579 -1.068967 -1.541847 -2.003711 -2.463923 -2.911494 -3.344383 -3.757407 -4.139359 -4.469759 -4.760894 -4.997791 -5.168556 -5.295261 -5.372231 -5.415474 -5.394066 -5.303145 -5.173929 -4.883193 -4.184579 -1.502147 -1.922174 -2.346412 -2.770947 -3.197289 -3.611767 -3.995775 -4.345225 -4.662093 -4.933204 -5.130372 -5.276348 -5.382962 -5.443795 -5.469091 -5.429047 -5.316612 -5.159579 -4.855605 -4.184579 -1.986147 -2.355883 -2.740485 -3.133828 -3.522090 -3.898304 -4.256907 -4.585864 -4.860671 -5.082295 -5.252054 -5.371974 -5.461949 -5.507586 -5.514425 -5.454827 -5.321035 -5.137170 -4.824481 -4.184579 -2.521852 -2.837020 -3.170138 -3.517223 -3.875497 -4.225826 -4.530669 -4.802453 -5.031286 -5.214045 -5.356952 -5.459115 -5.531167 -5.560123 -5.547482 -5.468744 -5.313477 -5.107077 -4.788934 -4.184579 -3.105117 -3.361345 -3.641244 -3.930574 -4.228271 -4.512544 -4.762808 -4.982566 -5.172362 -5.329968 -5.450301 -5.533878 -5.586284 -5.596391 -5.563087 -5.465456 -5.290513 -5.067505 -4.748871 -4.184579 -3.743293 -3.910724 -4.109613 -4.322953 -4.546071 -4.765293 -4.964193 -5.144207 -5.301013 -5.430062 -5.524110 -5.585800 -5.617563 -5.607191 -5.553771 -5.438662 -5.249250 -5.015579 -4.702232 -4.184579 -4.443494 -4.502816 -4.604010 -4.728483 -4.873557 -5.021766 -5.159192 -5.289806 -5.405919 -5.501669 -5.564159 -5.598952 -5.610396 -5.579930 -5.508897 -5.380654 -5.183563 -4.946080 -4.646122 -4.184579 -5.257560 -5.195275 -5.179610 -5.193483 -5.237734 -5.291456 -5.348502 -5.411743 -5.471591 -5.525564 -5.550266 -5.555599 -5.545677 -5.496554 -5.412165 -5.279827 -5.083090 -4.851321 -4.574382 -4.184579 -21.71970 -21.29344 -20.77230 -20.16842 -19.49317 -18.75489 -17.96050 -17.11561 -16.22481 -15.29192 -14.32016 -13.31230 -12.27072 -11.19751 -10.09476 -8.963615 -7.805547 -6.622364 -5.415011 -4.184579 -0.3288138 -1.086883 -1.658720 -2.147605 -2.612781 -3.020116 -3.331075 -3.522710 -3.809645 -4.070666 -4.304811 -4.449094 -4.553226 -4.757074 -4.943476 -5.089303 -5.113120 -5.235392 -5.200322 -4.301429 0.3906006 -0.4313976 -1.082647 -1.686906 -2.247815 -2.742777 -3.062860 -3.356359 -3.687920 -4.001194 -4.281377 -4.385034 -4.541412 -4.770199 -4.981012 -5.126310 -5.124284 -5.246897 -5.196145 -4.301429 0.7574173 -8.7842174E-02 -0.8142586 -1.480611 -2.085545 -2.581145 -2.969683 -3.321733 -3.663982 -3.999308 -4.288991 -4.404201 -4.591380 -4.816923 -5.030447 -5.154020 -5.150663 -5.261152 -5.190319 -4.301429 0.9230840 6.7196012E-02 -0.6914749 -1.384161 -1.984406 -2.500802 -2.942605 -3.319528 -3.685404 -4.033539 -4.304589 -4.473510 -4.666049 -4.882578 -5.087110 -5.169353 -5.186087 -5.276958 -5.182589 -4.301429 0.9475517 0.1023562 -0.6564519 -1.334886 -1.941151 -2.479035 -2.938075 -3.349471 -3.738290 -4.090825 -4.356042 -4.560170 -4.754326 -4.959303 -5.148646 -5.199906 -5.226534 -5.293497 -5.172688 -4.301429 0.8645586 5.4076847E-02 -0.6728789 -1.344935 -1.951226 -2.488525 -2.969010 -3.413301 -3.816120 -4.157654 -4.428959 -4.654007 -4.849646 -5.042668 -5.211428 -5.248093 -5.269528 -5.309875 -5.160265 -4.301429 0.7039961 -5.4667912E-02 -0.7550706 -1.408549 -2.001739 -2.542924 -3.047512 -3.505762 -3.907586 -4.237421 -4.519795 -4.752749 -4.950392 -5.128923 -5.270964 -5.304076 -5.313525 -5.325188 -5.144963 -4.301429 0.4830422 -0.2250953 -0.8933153 -1.517956 -2.103507 -2.652330 -3.161129 -3.618780 -4.000558 -4.333616 -4.618650 -4.860034 -5.053918 -5.218605 -5.332359 -5.362924 -5.356516 -5.338762 -5.127628 -4.301429 0.2064364 -0.4503463 -1.077164 -1.685775 -2.256784 -2.799292 -3.297066 -3.727298 -4.108463 -4.447113 -4.733825 -4.974794 -5.159659 -5.309326 -5.401974 -5.423282 -5.397123 -5.349589 -5.109153 -4.301429 -0.1180236 -0.7235774 -1.315212 -1.896297 -2.448579 -2.968592 -3.430824 -3.855819 -4.239424 -4.577902 -4.862261 -5.089876 -5.270942 -5.396304 -5.473261 -5.483164 -5.434369 -5.356621 -5.089071 -4.301429 -0.4848697 -1.046100 -1.597865 -2.145891 -2.665488 -3.143926 -3.598922 -4.014969 -4.396219 -4.730215 -4.994800 -5.215281 -5.381735 -5.485177 -5.544358 -5.538223 -5.467656 -5.358995 -5.066916 -4.301429 -0.8953866 -1.410716 -1.920887 -2.416008 -2.899852 -3.364271 -3.800580 -4.213646 -4.583662 -4.888342 -5.142303 -5.345404 -5.485709 -5.570403 -5.612797 -5.587998 -5.495472 -5.355476 -5.042229 -4.301429 -1.351801 -1.809107 -2.270532 -2.729650 -3.185917 -3.631453 -4.053788 -4.438036 -4.776519 -5.069216 -5.298276 -5.465243 -5.584256 -5.650198 -5.675198 -5.631079 -5.515587 -5.344717 -5.014471 -4.301429 -1.857380 -2.259536 -2.674135 -3.100079 -3.531399 -3.941759 -4.327559 -4.686938 -5.002459 -5.247178 -5.437832 -5.576223 -5.673451 -5.722784 -5.728499 -5.664799 -5.525503 -5.325344 -4.982948 -4.301429 -2.421503 -2.769190 -3.133796 -3.512307 -3.901168 -4.283645 -4.641976 -4.942731 -5.199240 -5.401441 -5.556465 -5.674238 -5.753449 -5.784106 -5.769281 -5.685222 -5.522421 -5.297891 -4.946736 -4.301429 -3.039548 -3.319633 -3.632402 -3.967207 -4.299092 -4.618330 -4.905465 -5.151533 -5.360587 -5.530671 -5.660747 -5.758108 -5.818065 -5.828213 -5.791862 -5.687387 -5.502657 -5.260255 -4.905180 -4.301429 -3.723449 -3.917203 -4.146913 -4.395663 -4.653399 -4.897645 -5.122183 -5.324958 -5.501626 -5.642957 -5.746081 -5.819688 -5.857403 -5.845674 -5.788357 -5.665082 -5.462967 -5.208941 -4.856994 -4.301429 -4.481218 -4.553402 -4.676911 -4.827532 -5.001159 -5.171387 -5.334075 -5.484236 -5.617801 -5.724101 -5.794871 -5.842447 -5.855607 -5.822304 -5.746730 -5.609373 -5.396667 -5.138125 -4.798690 -4.301429 -5.357701 -5.291421 -5.286441 -5.318681 -5.382315 -5.453094 -5.532650 -5.611998 -5.686800 -5.747461 -5.780555 -5.798262 -5.788881 -5.737185 -5.647982 -5.503867 -5.292032 -5.039013 -4.723835 -4.301429 -23.67435 -23.21119 -22.63891 -21.97325 -21.22701 -20.41031 -19.53118 -18.59605 -17.61014 -16.57778 -15.50261 -14.38772 -13.23579 -12.04916 -10.82989 -9.579789 -8.300498 -6.993477 -5.660052 -4.301429 -0.2441130 -1.065651 -1.685366 -2.188319 -2.655243 -3.073277 -3.410965 -3.601726 -3.898281 -4.167848 -4.407053 -4.566853 -4.657135 -4.867228 -5.058369 -5.212634 -5.232752 -5.364626 -5.344209 -4.411827 0.5508345 -0.3384484 -1.051675 -1.658771 -2.233405 -2.755008 -3.128787 -3.422465 -3.767337 -4.089092 -4.377768 -4.500018 -4.644952 -4.880544 -5.098533 -5.254471 -5.245300 -5.378519 -5.341842 -4.411827 0.9669197 4.8069950E-02 -0.7196993 -1.410041 -2.047601 -2.606627 -3.023731 -3.389568 -3.747394 -4.084108 -4.384463 -4.518911 -4.701652 -4.932178 -5.153033 -5.287068 -5.275912 -5.396022 -5.337771 -4.411827 1.155596 0.2387272 -0.5651758 -1.299886 -1.965846 -2.520204 -2.991522 -3.396533 -3.762978 -4.116220 -4.404284 -4.597585 -4.785461 -5.004250 -5.216321 -5.305668 -5.317087 -5.415501 -5.331706 -4.411827 1.193127 0.2885190 -0.5240190 -1.268830 -1.921118 -2.493904 -2.992387 -3.415470 -3.808573 -4.174476 -4.463135 -4.689041 -4.882352 -5.087868 -5.284781 -5.339919 -5.364093 -5.436095 -5.323261 -4.411827 1.115898 0.2422314 -0.5508814 -1.276817 -1.927000 -2.507350 -3.011877 -3.464350 -3.883004 -4.251021 -4.547644 -4.786790 -4.982860 -5.180061 -5.354284 -5.392671 -5.414038 -5.456924 -5.312089 -4.411827 0.9468552 0.1233355 -0.6326032 -1.335923 -1.979401 -2.550188 -3.069942 -3.550826 -3.981002 -4.345531 -4.636508 -4.889713 -5.090224 -5.274397 -5.420635 -5.455332 -5.465021 -5.476946 -5.297781 -4.411827 0.7147807 -5.0178945E-02 -0.7708427 -1.450495 -2.069246 -2.641858 -3.178693 -3.668110 -4.093452 -4.442977 -4.741668 -4.998473 -5.201932 -5.370460 -5.490919 -5.522320 -5.514733 -5.495382 -5.281175 -4.411827 0.4231873 -0.2826709 -0.9610494 -1.610875 -2.215069 -2.788070 -3.322417 -3.800399 -4.204029 -4.557312 -4.855921 -5.118876 -5.314168 -5.468343 -5.568677 -5.590351 -5.562480 -5.511320 -5.263482 -4.411827 9.0025365E-02 -0.5665942 -1.201408 -1.824450 -2.409884 -2.971165 -3.481812 -3.929292 -4.335678 -4.686656 -4.989012 -5.244366 -5.429384 -5.567522 -5.650530 -5.656156 -5.607576 -5.523674 -5.244171 -4.411827 -0.2957959 -0.9017413 -1.493709 -2.079221 -2.644290 -3.170269 -3.644744 -4.093535 -4.489097 -4.842724 -5.134946 -5.371166 -5.548704 -5.665400 -5.729970 -5.718776 -5.648261 -5.531261 -5.222720 -4.411827 -0.7269000 -1.279046 -1.829743 -2.372910 -2.889937 -3.384711 -3.852363 -4.285657 -4.679118 -5.015056 -5.285481 -5.511487 -5.665683 -5.762446 -5.804419 -5.776874 -5.683043 -5.532595 -5.198590 -4.411827 -1.203845 -1.700702 -2.196072 -2.691076 -3.180729 -3.650835 -4.106338 -4.526233 -4.888354 -5.198546 -5.456552 -5.648997 -5.778232 -5.850712 -5.872898 -5.828771 -5.709894 -5.526132 -5.171090 -4.411827 -1.731300 -2.165105 -2.609780 -3.067978 -3.530094 -3.980755 -4.399042 -4.782159 -5.123314 -5.405578 -5.613175 -5.775213 -5.876549 -5.930823 -5.934058 -5.871655 -5.726455 -5.510288 -5.139440 -4.411827 -2.320508 -2.694441 -3.091012 -3.508274 -3.925664 -4.335282 -4.724510 -5.074745 -5.356033 -5.582084 -5.751187 -5.883080 -5.964204 -6.000528 -5.983071 -5.900202 -5.729799 -5.485227 -5.102644 -4.411827 -2.972098 -3.275109 -3.613991 -3.983486 -4.366965 -4.715278 -5.036732 -5.314273 -5.545105 -5.726094 -5.866615 -5.978565 -6.037477 -6.054344 -6.014030 -5.909295 -5.715656 -5.448321 -5.059420 -4.411827 -3.699967 -3.912776 -4.174933 -4.462104 -4.756360 -5.030533 -5.282434 -5.504597 -5.697611 -5.850183 -5.962440 -6.050767 -6.086842 -6.081868 -6.018211 -5.891453 -5.679570 -5.396054 -5.009068 -4.411827 -4.506476 -4.594837 -4.741968 -4.923179 -5.122792 -5.320118 -5.508665 -5.678008 -5.824813 -5.940937 -6.021222 -6.081473 -6.093422 -6.065773 -5.981888 -5.836538 -5.613115 -5.322422 -4.947611 -4.411827 -5.445623 -5.384157 -5.386594 -5.440481 -5.519127 -5.612205 -5.714207 -5.812301 -5.899919 -5.966598 -6.012126 -6.042316 -6.028816 -5.980432 -5.882617 -5.726244 -5.501379 -5.219794 -4.868105 -4.411827 -25.66696 -25.16634 -24.54181 -23.81260 -22.99309 -22.09575 -21.12955 -20.10176 -19.01827 -17.88391 -16.70300 -15.47824 -14.21333 -12.91063 -11.57240 -10.20065 -8.797424 -7.363607 -5.901381 -4.411827 -0.1660423 -1.050596 -1.715804 -2.230201 -2.716701 -3.132348 -3.485220 -3.675392 -3.983357 -4.259604 -4.505982 -4.679206 -4.756032 -4.972067 -5.166857 -5.329665 -5.345551 -5.486483 -5.480212 -4.516449 0.7035908 -0.2572789 -1.017397 -1.668066 -2.236302 -2.766999 -3.175956 -3.487336 -3.841718 -4.175815 -4.472003 -4.611557 -4.743356 -4.985269 -5.207406 -5.377186 -5.359177 -5.503145 -5.479859 -4.516449 1.166219 0.1756459 -0.6597643 -1.361522 -2.010625 -2.600391 -3.076362 -3.455230 -3.825116 -4.170104 -4.478365 -4.628332 -4.809284 -5.041883 -5.265263 -5.415721 -5.394545 -5.523709 -5.477787 -4.516449 1.385633 0.3921291 -0.4550084 -1.216828 -1.917148 -2.533210 -3.037492 -3.462067 -3.848683 -4.200035 -4.500680 -4.714922 -4.902823 -5.120104 -5.333933 -5.438927 -5.441624 -5.547137 -5.473581 -4.516449 1.435898 0.4656016 -0.3919821 -1.179247 -1.894712 -2.505030 -3.033779 -3.490352 -3.884378 -4.256227 -4.562872 -4.815464 -5.007335 -5.211102 -5.409199 -5.477072 -5.495690 -5.572529 -5.466865 -4.516449 1.360704 0.4264691 -0.4172617 -1.206530 -1.900733 -2.515898 -3.060574 -3.525558 -3.949591 -4.334904 -4.656755 -4.916548 -5.115398 -5.309712 -5.485327 -5.536482 -5.553019 -5.598382 -5.457253 -4.516449 1.191382 0.3038811 -0.5145669 -1.264678 -1.950031 -2.565869 -3.105430 -3.597197 -4.046387 -4.440986 -4.755533 -5.022000 -5.226288 -5.412697 -5.560819 -5.606608 -5.610734 -5.623594 -5.444399 -4.516449 0.9429663 0.1212622 -0.6521086 -1.380500 -2.047329 -2.644237 -3.197495 -3.710777 -4.169147 -4.552027 -4.859450 -5.134180 -5.343750 -5.514756 -5.639653 -5.681556 -5.668373 -5.647415 -5.429022 -4.516449 0.6416422 -0.1186412 -0.8467079 -1.545593 -2.180567 -2.779296 -3.340394 -3.855758 -4.298246 -4.662926 -4.980223 -5.254133 -5.464602 -5.619521 -5.728167 -5.756456 -5.724360 -5.668591 -5.412522 -4.516449 0.2940926 -0.4148964 -1.093624 -1.753157 -2.373975 -2.964460 -3.517770 -4.008072 -4.425321 -4.800305 -5.111170 -5.384529 -5.582721 -5.728567 -5.817309 -5.829188 -5.777324 -5.686031 -5.394335 -4.516449 -0.1090379 -0.7595653 -1.392694 -2.014973 -2.613041 -3.184441 -3.699822 -4.163610 -4.586861 -4.951604 -5.263829 -5.520766 -5.708714 -5.837741 -5.906034 -5.899675 -5.825624 -5.698489 -5.373928 -4.516449 -0.5584735 -1.147784 -1.737442 -2.320821 -2.886155 -3.407350 -3.904609 -4.361397 -4.773035 -5.132461 -5.425673 -5.666695 -5.839983 -5.941612 -5.990815 -5.965527 -5.867816 -5.704591 -5.350589 -4.516449 -1.056881 -1.587504 -2.125411 -2.655198 -3.176072 -3.678528 -4.155080 -4.603277 -5.000196 -5.326187 -5.601373 -5.821980 -5.958849 -6.039548 -6.070026 -6.023055 -5.902562 -5.702400 -5.323572 -4.516449 -1.608059 -2.070242 -2.549276 -3.039322 -3.528440 -4.009000 -4.468093 -4.875849 -5.239141 -5.547562 -5.782604 -5.960415 -6.069795 -6.129232 -6.139454 -6.070555 -5.926594 -5.690181 -5.291977 -4.516449 -2.219351 -2.618665 -3.044240 -3.494843 -3.951025 -4.387427 -4.805391 -5.184350 -5.506565 -5.751286 -5.939591 -6.082527 -6.168590 -6.209751 -6.195900 -6.105700 -5.935727 -5.668131 -5.254875 -4.516449 -2.904447 -3.228983 -3.594354 -3.994570 -4.411019 -4.811777 -5.163176 -5.469446 -5.720005 -5.918566 -6.069252 -6.189135 -6.253676 -6.273883 -6.234797 -6.122317 -5.924815 -5.633753 -5.210583 -4.516449 -3.671280 -3.905419 -4.194981 -4.521564 -4.853346 -5.162578 -5.441454 -5.683718 -5.887942 -6.054838 -6.180639 -6.274692 -6.314924 -6.308572 -6.245905 -6.111733 -5.889933 -5.582910 -5.158899 -4.516449 -4.525082 -4.630687 -4.802063 -5.014576 -5.241230 -5.468193 -5.681986 -5.870558 -6.029643 -6.158405 -6.254855 -6.317718 -6.330080 -6.297162 -6.212819 -6.061130 -5.823236 -5.508891 -5.095368 -4.516449 -5.530510 -5.470297 -5.485444 -5.556892 -5.656199 -5.776595 -5.898002 -6.012365 -6.111695 -6.192814 -6.251344 -6.280753 -6.267303 -6.212496 -6.111542 -5.948578 -5.708806 -5.401794 -5.012452 -4.516449 -27.69572 -27.15708 -26.47899 -25.68402 -24.78976 -23.80970 -22.75422 -21.63150 -20.44809 -19.20936 -17.91979 -16.58319 -15.20284 -13.78156 -12.32186 -10.82594 -9.295758 -7.733084 -6.139503 -4.516449 -8.7734021E-02 -1.037988 -1.750170 -2.276189 -2.776659 -3.203466 -3.560487 -3.744237 -4.065260 -4.347282 -4.601388 -4.786565 -4.850790 -5.072108 -5.269943 -5.440611 -5.450755 -5.601946 -5.607641 -4.615869 0.8507864 -0.1800233 -0.9922040 -1.670145 -2.273284 -2.791177 -3.219974 -3.543007 -3.913260 -4.255763 -4.565220 -4.720395 -4.837636 -5.086303 -5.310603 -5.494418 -5.465798 -5.620757 -5.609071 -4.615869 1.357384 0.2957833 -0.5928044 -1.351321 -1.994463 -2.593089 -3.101525 -3.519431 -3.898257 -4.255239 -4.572346 -4.734551 -4.912590 -5.148041 -5.370627 -5.539726 -5.505428 -5.644888 -5.608603 -4.615869 1.605506 0.5404266 -0.3732086 -1.153305 -1.868006 -2.516140 -3.081350 -3.524491 -3.925456 -4.286068 -4.597023 -4.825190 -5.017350 -5.233932 -5.442975 -5.568100 -5.559205 -5.672753 -5.605924 -4.615869 1.670111 0.6291327 -0.2720170 -1.090259 -1.842147 -2.512241 -3.071331 -3.551006 -3.968978 -4.339200 -4.660018 -4.933008 -5.128319 -5.332791 -5.522405 -5.610552 -5.620756 -5.702391 -5.600691 -4.615869 1.595617 0.6029179 -0.2874967 -1.117335 -1.872515 -2.521506 -3.094515 -3.597871 -4.020870 -4.415901 -4.756635 -5.041979 -5.242513 -5.437004 -5.608047 -5.677530 -5.685871 -5.733094 -5.592304 -4.615869 1.430587 0.4808488 -0.3875615 -1.198168 -1.921880 -2.569823 -3.151117 -3.651172 -4.109931 -4.523038 -4.866880 -5.148194 -5.359952 -5.546082 -5.691287 -5.756389 -5.752502 -5.763468 -5.580177 -4.615869 1.171935 0.2895891 -0.5358671 -1.312691 -2.017634 -2.660181 -3.224867 -3.752450 -4.231627 -4.648710 -4.976177 -5.263145 -5.479483 -5.659739 -5.778190 -5.838366 -5.818361 -5.792139 -5.565216 -4.615869 0.8593740 4.2778127E-02 -0.7357527 -1.478106 -2.159131 -2.776294 -3.358703 -3.897998 -4.378071 -4.771911 -5.095263 -5.382618 -5.604272 -5.771966 -5.875754 -5.921328 -5.882107 -5.818377 -5.549374 -4.615869 0.4942448 -0.2641117 -0.9904963 -1.689609 -2.340266 -2.959571 -3.539163 -4.072087 -4.519174 -4.904843 -5.229943 -5.518702 -5.733098 -5.886058 -5.975820 -6.002483 -5.942239 -5.841115 -5.531929 -4.615869 7.5026140E-02 -0.6165851 -1.294929 -1.953277 -2.583221 -3.186282 -3.746448 -4.237992 -4.675535 -5.061134 -5.386808 -5.665294 -5.862958 -6.005119 -6.074607 -6.078901 -5.998298 -5.858797 -5.512186 -4.615869 -0.3916786 -1.021151 -1.649050 -2.266244 -2.871475 -3.438371 -3.953237 -4.439154 -4.865184 -5.246890 -5.561954 -5.812097 -6.001719 -6.118267 -6.167521 -6.150166 -6.048001 -5.869850 -5.489479 -4.615869 -0.9106280 -1.476717 -2.050269 -2.625536 -3.173755 -3.705611 -4.209573 -4.677248 -5.096149 -5.455265 -5.740894 -5.977842 -6.137822 -6.228129 -6.252638 -6.215813 -6.088785 -5.872513 -5.463020 -4.615869 -1.485018 -1.980626 -2.491361 -3.013977 -3.531048 -4.037580 -4.525209 -4.971989 -5.352047 -5.680387 -5.944634 -6.135561 -6.262949 -6.327899 -6.330082 -6.272427 -6.117474 -5.864340 -5.431773 -4.615869 -2.119161 -2.544636 -2.997992 -3.477817 -3.966996 -4.442013 -4.885149 -5.288455 -5.641808 -5.914769 -6.125768 -6.275312 -6.371834 -6.414810 -6.396511 -6.314673 -6.131903 -5.845570 -5.394574 -4.615869 -2.829890 -3.183567 -3.575580 -4.004442 -4.448811 -4.887427 -5.284620 -5.614436 -5.891284 -6.105053 -6.273370 -6.392390 -6.466856 -6.483860 -6.445861 -6.336104 -6.127324 -5.813095 -5.349705 -4.615869 -3.630254 -3.893890 -4.213369 -4.573062 -4.943686 -5.290676 -5.598084 -5.859051 -6.077836 -6.256360 -6.396269 -6.487041 -6.536585 -6.527821 -6.466633 -6.328109 -6.097172 -5.762338 -5.296731 -4.615869 -4.538910 -4.661325 -4.858583 -5.101107 -5.359384 -5.617388 -5.852132 -6.061046 -6.234768 -6.373862 -6.479548 -6.539452 -6.560940 -6.525324 -6.441465 -6.277023 -6.031660 -5.686303 -5.232152 -4.615869 -5.609985 -5.550379 -5.579541 -5.667562 -5.792233 -5.936909 -6.077846 -6.210771 -6.328040 -6.414535 -6.481583 -6.508108 -6.501216 -6.441323 -6.342662 -6.160829 -5.913361 -5.575658 -5.147710 -4.615869 -29.75901 -29.18181 -28.44890 -27.58675 -26.61563 -25.55083 -24.40399 -23.18418 -21.89863 -20.55326 -19.15300 -17.70201 -16.20387 -14.66167 -13.07813 -11.45565 -9.796374 -8.102201 -6.374849 -4.615869 -1.6703336E-02 -1.026488 -1.784471 -2.324940 -2.837867 -3.275152 -3.640485 -3.812813 -4.140978 -4.431562 -4.692302 -4.889335 -4.941638 -5.167752 -5.369963 -5.545795 -5.551153 -5.711462 -5.730553 -4.710580 1.000352 -0.1018368 -0.9719300 -1.679776 -2.300092 -2.840224 -3.269660 -3.592988 -3.982073 -4.331565 -4.655465 -4.827026 -4.928097 -5.183790 -5.415187 -5.605802 -5.567044 -5.733099 -5.734380 -4.710580 1.543249 0.4191378 -0.5335330 -1.328978 -2.018178 -2.600655 -3.123443 -3.569907 -3.969019 -4.333014 -4.666709 -4.838568 -5.011552 -5.252590 -5.480505 -5.657307 -5.611920 -5.760960 -5.736333 -4.710580 1.821140 0.6860234 -0.2854896 -1.124595 -1.836971 -2.496747 -3.094514 -3.584205 -3.996675 -4.372511 -4.693259 -4.932055 -5.125511 -5.346358 -5.558990 -5.690601 -5.672945 -5.792967 -5.736006 -4.710580 1.889348 0.7905900 -0.1774824 -1.015617 -1.787062 -2.490060 -3.106215 -3.607297 -4.044373 -4.424850 -4.755398 -5.042035 -5.246365 -5.452349 -5.646103 -5.736445 -5.742204 -5.827641 -5.732923 -4.710580 1.815839 0.7698666 -0.1675541 -1.028895 -1.820831 -2.527487 -3.125390 -3.652477 -4.102344 -4.496740 -4.852291 -5.157714 -5.365617 -5.563773 -5.738817 -5.809971 -5.815092 -5.863056 -5.726524 -4.710580 1.658106 0.6518617 -0.2619406 -1.116811 -1.893956 -2.572887 -3.180051 -3.715686 -4.176761 -4.601147 -4.969009 -5.271955 -5.487548 -5.681558 -5.830802 -5.894885 -5.888897 -5.898583 -5.716171 -4.710580 1.400442 0.4567162 -0.4191401 -1.244113 -1.989247 -2.661516 -3.266295 -3.797107 -4.292426 -4.729426 -5.089743 -5.384424 -5.610381 -5.802584 -5.924190 -5.983825 -5.961752 -5.932976 -5.702713 -4.710580 1.076416 0.1971207 -0.6259978 -1.412339 -2.131765 -2.786204 -3.379812 -3.937428 -4.441263 -4.870808 -5.210667 -5.509816 -5.738500 -5.922705 -6.028154 -6.073341 -6.032563 -5.964805 -5.688438 -4.710580 0.6916627 -0.1153309 -0.8882696 -1.632122 -2.315283 -2.954802 -3.558855 -4.116384 -4.604132 -5.007122 -5.351540 -5.642628 -5.874239 -6.041374 -6.136361 -6.160431 -6.099872 -5.993075 -5.672619 -4.710580 0.2535224 -0.4791887 -1.202209 -1.894867 -2.556352 -3.185531 -3.779206 -4.311030 -4.763912 -5.167806 -5.504636 -5.793220 -6.010765 -6.166243 -6.242103 -6.243325 -6.162103 -6.015929 -5.654413 -4.710580 -0.2320996 -0.8979946 -1.563020 -2.214834 -2.849232 -3.456220 -4.008801 -4.508708 -4.961541 -5.351179 -5.684940 -5.952274 -6.157647 -6.291883 -6.345145 -6.321992 -6.218091 -6.032075 -5.632975 -4.710580 -0.7716748 -1.368410 -1.976811 -2.587143 -3.178957 -3.732638 -4.266366 -4.752579 -5.192919 -5.573742 -5.878741 -6.125988 -6.305882 -6.409826 -6.439019 -6.393619 -6.266160 -6.039627 -5.607383 -4.710580 -1.361808 -1.893499 -2.437645 -2.988668 -3.538043 -4.070229 -4.582953 -5.053308 -5.464459 -5.808603 -6.093922 -6.302437 -6.441512 -6.516331 -6.524293 -6.456320 -6.302402 -6.036412 -5.576824 -4.710580 -2.018960 -2.472505 -2.953901 -3.460134 -3.977844 -4.491137 -4.964528 -5.389823 -5.764237 -6.071969 -6.298253 -6.457850 -6.560984 -6.613374 -6.597346 -6.506027 -6.322807 -6.022030 -5.539620 -4.710580 -2.756095 -3.131670 -3.558223 -4.013903 -4.485603 -4.955466 -5.389861 -5.755987 -6.051133 -6.286436 -6.464599 -6.586209 -6.663069 -6.695428 -6.653967 -6.535726 -6.322556 -5.993109 -5.494332 -4.710580 -3.586215 -3.870510 -4.227888 -4.622429 -5.027400 -5.414618 -5.749038 -6.033317 -6.264743 -6.453667 -6.598513 -6.692714 -6.742123 -6.747750 -6.683274 -6.536144 -6.295673 -5.944765 -5.439380 -4.710580 -4.546255 -4.688453 -4.912405 -5.184515 -5.476649 -5.763687 -6.023039 -6.245142 -6.436541 -6.583811 -6.694363 -6.757425 -6.775904 -6.752038 -6.662839 -6.491489 -6.231673 -5.869337 -5.371473 -4.710580 -5.683460 -5.626282 -5.668358 -5.776490 -5.929850 -6.097685 -6.259506 -6.405136 -6.532617 -6.632667 -6.704921 -6.732275 -6.719162 -6.674081 -6.561018 -6.374843 -6.110609 -5.753524 -5.281621 -4.710580 -31.85535 -31.23906 -30.45008 -29.51914 -28.46938 -27.31794 -26.07774 -24.75878 -23.36899 -21.91485 -20.40172 -18.83414 -17.21601 -15.55066 -13.84105 -12.08977 -10.29914 -8.471192 -6.607785 -4.710580 4.5111261E-02 -1.018616 -1.818128 -2.373081 -2.900216 -3.344943 -3.722815 -3.882534 -4.214909 -4.512494 -4.779474 -4.987450 -5.028415 -5.258995 -5.465909 -5.645999 -5.647845 -5.813904 -5.847542 -4.801008 1.141043 -2.1184700E-02 -0.9494331 -1.693584 -2.331816 -2.888089 -3.332629 -3.644664 -4.040728 -4.405164 -4.740510 -4.931480 -5.015000 -5.275779 -5.514942 -5.712080 -5.665037 -5.837424 -5.853874 -4.801008 1.728977 0.5531306 -0.4771470 -1.314561 -2.026520 -2.638551 -3.152304 -3.611001 -4.038157 -4.408549 -4.758159 -4.939726 -5.107731 -5.352475 -5.587223 -5.769585 -5.716364 -5.868231 -5.858402 -4.801008 2.030996 0.8429674 -0.2068256 -1.083290 -1.844474 -2.490409 -3.101104 -3.629829 -4.065909 -4.451812 -4.789678 -5.035216 -5.230078 -5.454334 -5.673135 -5.808852 -5.784399 -5.903779 -5.860719 -4.801008 2.086759 0.9498609 -7.7338226E-02 -0.9707618 -1.744354 -2.462584 -3.115107 -3.659312 -4.114047 -4.513637 -4.849240 -5.145725 -5.360789 -5.567148 -5.767856 -5.858895 -5.860333 -5.942575 -5.860171 -4.801008 2.013595 0.9345203 -6.4640634E-02 -0.9497254 -1.762972 -2.505555 -3.151881 -3.701242 -4.179414 -4.579733 -4.944446 -5.263912 -5.490179 -5.687787 -5.867003 -5.937113 -5.940004 -5.982824 -5.856152 -4.801008 1.866333 0.8154103 -0.1412520 -1.031583 -1.847656 -2.573316 -3.206470 -3.767484 -4.250520 -4.676661 -5.061018 -5.384848 -5.615620 -5.809654 -5.966436 -6.028056 -6.020729 -6.023302 -5.848037 -4.801008 1.625540 0.6190309 -0.3001938 -1.172707 -1.958141 -2.663884 -3.295540 -3.851722 -4.353191 -4.804116 -5.193743 -5.502325 -5.743376 -5.934403 -6.065109 -6.124857 -6.100119 -6.062844 -5.836523 -4.801008 1.287638 0.3521236 -0.5209930 -1.348362 -2.103127 -2.794875 -3.410429 -3.976193 -4.500553 -4.955853 -5.325825 -5.627570 -5.872469 -6.061870 -6.175180 -6.221345 -6.177488 -6.100149 -5.824288 -4.801008 0.8823917 2.7341688E-02 -0.7899230 -1.571880 -2.299096 -2.957908 -3.577643 -4.157009 -4.677418 -5.109822 -5.461216 -5.765200 -6.013546 -6.188819 -6.290720 -6.316325 -6.251758 -6.134281 -5.810475 -4.801008 0.4282079 -0.3489070 -1.113310 -1.844350 -2.531074 -3.186207 -3.802322 -4.372655 -4.856878 -5.265417 -5.620857 -5.920625 -6.159304 -6.320946 -6.403387 -6.406537 -6.320787 -6.163508 -5.794175 -4.801008 -7.4947372E-02 -0.7799430 -1.480919 -2.166982 -2.828929 -3.465182 -4.057339 -4.580780 -5.049822 -5.456029 -5.805953 -6.092870 -6.305545 -6.457526 -6.511432 -6.491652 -6.382524 -6.185922 -5.774470 -4.801008 -0.6337323 -1.265646 -1.906902 -2.547369 -3.174562 -3.766432 -4.318196 -4.833810 -5.283954 -5.683941 -6.011883 -6.269320 -6.465823 -6.585036 -6.613426 -6.570578 -6.436256 -6.199198 -5.750665 -4.801008 -1.241470 -1.804467 -2.383349 -2.968125 -3.542182 -4.108626 -4.640553 -5.136012 -5.571320 -5.932575 -6.231019 -6.465061 -6.612859 -6.704912 -6.708244 -6.640792 -6.479697 -6.200666 -5.720859 -4.801008 -1.919943 -2.401525 -2.912652 -3.445323 -3.988131 -4.530513 -5.043393 -5.491302 -5.880650 -6.211795 -6.460203 -6.634406 -6.743536 -6.808135 -6.791473 -6.696837 -6.508046 -6.189580 -5.684074 -4.801008 -2.682143 -3.080714 -3.532220 -4.023880 -4.523344 -5.020986 -5.484508 -5.893664 -6.204345 -6.459198 -6.647167 -6.775971 -6.859725 -6.895034 -6.853233 -6.731549 -6.515039 -6.162508 -5.638932 -4.801008 -3.540690 -3.845936 -4.229027 -4.667665 -5.109162 -5.528298 -5.899984 -6.199780 -6.443987 -6.644163 -6.794249 -6.894319 -6.949188 -6.957633 -6.884645 -6.735286 -6.492797 -6.114848 -5.582508 -4.801008 -4.547713 -4.709890 -4.963865 -5.267838 -5.593606 -5.910192 -6.189247 -6.429218 -6.624492 -6.788678 -6.902404 -6.968137 -6.990853 -6.973004 -6.868510 -6.693245 -6.429363 -6.038472 -5.511941 -4.801008 -5.750758 -5.697622 -5.752561 -5.883403 -6.062914 -6.257882 -6.439958 -6.605650 -6.732296 -6.848324 -6.922081 -6.948626 -6.942733 -6.896089 -6.768878 -6.577107 -6.303335 -5.920077 -5.417793 -4.801008 -33.98338 -33.32772 -32.48120 -31.47994 -30.34981 -29.10990 -27.77444 -26.35436 -24.85834 -23.29339 -21.66534 -19.97910 -18.23886 -16.44826 -14.61045 -12.72825 -10.80412 -8.840245 -6.838613 -4.801008 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 -0.5770304 -0.5959253 -0.6095533 -0.6195231 -0.6234690 -0.6193030 -0.6283075 -0.6323923 -0.6305821 -0.6216730 -0.6021214 -0.5748721 -0.5356383 -0.4880427 -0.4387530 -0.3738813 -0.2887706 -0.1767357 -2.2917895E-02 0.3118532 -0.5894323 -0.6040497 -0.6167663 -0.6240304 -0.6236544 -0.6179881 -0.6257681 -0.6285433 -0.6253706 -0.6127422 -0.5936750 -0.5648355 -0.5240179 -0.4755828 -0.4263625 -0.3618807 -0.2775116 -0.1671970 -1.6110031E-02 0.3118532 -0.6000811 -0.6133403 -0.6230134 -0.6255022 -0.6232123 -0.6166625 -0.6231386 -0.6243553 -0.6196325 -0.6051549 -0.5844357 -0.5539860 -0.5116001 -0.4628601 -0.4135047 -0.3496519 -0.2660380 -0.1579135 -9.1896206E-03 0.3118532 -0.6117975 -0.6216214 -0.6259824 -0.6263973 -0.6226615 -0.6154820 -0.6201804 -0.6197124 -0.6107689 -0.5968397 -0.5743617 -0.5422784 -0.4974341 -0.4498653 -0.4005510 -0.3371879 -0.2543708 -0.1480634 -2.1808068E-03 0.3118532 -0.6224245 -0.6262482 -0.6287522 -0.6270310 -0.6226357 -0.6141269 -0.6167875 -0.6119743 -0.6034352 -0.5877159 -0.5634438 -0.5296735 -0.4842482 -0.4366188 -0.3872715 -0.3241803 -0.2424916 -0.1380584 4.9821991E-03 0.3118532 -0.6290838 -0.6309763 -0.6309621 -0.6286319 -0.6225798 -0.6124522 -0.6129474 -0.6057900 -0.5952826 -0.5777177 -0.5516266 -0.5146486 -0.4708400 -0.4224939 -0.3738235 -0.3108649 -0.2305380 -0.1278980 1.2279859E-02 0.3118532 -0.6364567 -0.6351562 -0.6343588 -0.6303357 -0.6223837 -0.6103396 -0.6057915 -0.5987726 -0.5862563 -0.5668177 -0.5366087 -0.5012891 -0.4572509 -0.4087005 -0.3601671 -0.2973141 -0.2186188 -0.1175842 1.9724535E-02 0.3118532 -0.6433312 -0.6407322 -0.6378750 -0.6318393 -0.6196483 -0.6050804 -0.6002825 -0.5909319 -0.5763633 -0.5549694 -0.5235196 -0.4878283 -0.4423980 -0.3944590 -0.3458064 -0.2836767 -0.2062418 -0.1071184 2.7317677E-02 0.3118532 -0.6516917 -0.6465188 -0.6413009 -0.6307862 -0.6183069 -0.6013593 -0.5939286 -0.5822973 -0.5655563 -0.5398083 -0.5104256 -0.4743019 -0.4284544 -0.3803793 -0.3310473 -0.2697781 -0.1948781 -9.6512027E-02 3.5107993E-02 0.3118532 -0.6604465 -0.6505863 -0.6424991 -0.6312405 -0.6162878 -0.5970681 -0.5868961 -0.5728427 -0.5512310 -0.5276079 -0.4974656 -0.4591121 -0.4139907 -0.3655633 -0.3161764 -0.2561899 -0.1821696 -8.5769854E-02 4.3108843E-02 0.3118532 -0.6677822 -0.6565342 -0.6454967 -0.6314051 -0.6139283 -0.5923936 -0.5761611 -0.5599676 -0.5404626 -0.5158907 -0.4827259 -0.4449792 -0.4002126 -0.3503432 -0.3015982 -0.2429302 -0.1693864 -7.4907221E-02 5.1367052E-02 0.3118532 -0.6773545 -0.6628860 -0.6489431 -0.6320046 -0.6116744 -0.5847194 -0.5693988 -0.5514306 -0.5307179 -0.5025244 -0.4696532 -0.4320536 -0.3887516 -0.3394199 -0.2876860 -0.2310556 -0.1566047 -6.4308964E-02 5.9950653E-02 0.3118532 -0.6884915 -0.6709495 -0.6537566 -0.6310399 -0.6079270 -0.5819424 -0.5648516 -0.5420309 -0.5197890 -0.4918067 -0.4585903 -0.4209568 -0.3779712 -0.3301476 -0.2760888 -0.2172215 -0.1439625 -5.3222720E-02 6.8984382E-02 0.3118532 -0.7004070 -0.6796623 -0.6593538 -0.6365975 -0.6108706 -0.5799690 -0.5606717 -0.5370430 -0.5128387 -0.4840702 -0.4498778 -0.4123246 -0.3703811 -0.3224569 -0.2683502 -0.2039741 -0.1316306 -4.2221345E-02 7.8572966E-02 0.3118532 -0.7219107 -0.6983350 -0.6723505 -0.6462737 -0.6158980 -0.5846885 -0.5628811 -0.5370898 -0.5096651 -0.4789177 -0.4447934 -0.4072421 -0.3670935 -0.3181400 -0.2601502 -0.1949857 -0.1212186 -3.1191600E-02 9.0192914E-02 0.3118532 -0.7542159 -0.7257118 -0.6977106 -0.6673500 -0.6354772 -0.6038319 -0.5700591 -0.5428869 -0.5130499 -0.4824601 -0.4483212 -0.4119260 -0.3648739 -0.3125634 -0.2542373 -0.1902700 -0.1134306 -2.0834757E-02 0.1042846 0.3118532 -0.8060952 -0.7743022 -0.7422919 -0.7107001 -0.6765548 -0.6444003 -0.6120615 -0.5749043 -0.5408159 -0.4995761 -0.4593804 -0.4151565 -0.3666689 -0.3126285 -0.2544820 -0.1852590 -0.1045706 -7.8213103E-03 0.1202934 0.3118532 -0.9018916 -0.8627757 -0.8313025 -0.7954491 -0.7580232 -0.7198338 -0.6799174 -0.6376847 -0.5941203 -0.5477532 -0.4984087 -0.4506633 -0.3917594 -0.3300407 -0.2606164 -0.1831452 -9.3637735E-02 1.7175036E-02 0.1392875 0.3118532 -1.129589 -1.082975 -1.034944 -0.9907278 -0.9381325 -0.8838162 -0.8276059 -0.7715049 -0.7098201 -0.6457953 -0.5781005 -0.5061684 -0.4286702 -0.3439524 -0.2509423 -0.1534133 -5.2717805E-02 5.2178998E-02 0.1640260 0.3118532 -1.149407 -1.084508 -1.018205 -0.9505122 -0.8814400 -0.8110009 -0.7394510 -0.6660713 -0.5916098 -0.5158330 -0.4387487 -0.3603694 -0.2807073 -0.1997748 -0.1175841 -3.4145661E-02 5.0539941E-02 0.1364427 0.2235511 0.3118532 -0.6315644 -0.6874680 -0.7329320 -0.8107801 -0.8783569 -0.9428972 -0.9963307 -1.038335 -1.060333 -1.085087 -1.121919 -1.145857 -1.149903 -1.132477 -1.081929 -1.021810 -0.9366601 -0.7987650 -0.5777137 -7.9957083E-02 -0.6502152 -0.6986789 -0.7465495 -0.8219465 -0.8946239 -0.9590690 -1.009231 -1.046270 -1.059738 -1.085777 -1.121911 -1.141216 -1.144600 -1.122792 -1.067279 -1.005938 -0.9206851 -0.7839695 -0.5666017 -7.9957083E-02 -0.6684628 -0.7171105 -0.7704557 -0.8438653 -0.9149448 -0.9717511 -1.019358 -1.050660 -1.061254 -1.088026 -1.122094 -1.138149 -1.136155 -1.110922 -1.051255 -0.9895003 -0.9041870 -0.7687954 -0.5552907 -7.9957083E-02 -0.6947111 -0.7426624 -0.7959529 -0.8702023 -0.9305874 -0.9846315 -1.027512 -1.051270 -1.065128 -1.091030 -1.118842 -1.133789 -1.127280 -1.097100 -1.034769 -0.9724488 -0.8871535 -0.7532227 -0.5437819 -7.9957083E-02 -0.7282453 -0.7777667 -0.8303267 -0.8919847 -0.9477820 -0.9972579 -1.031458 -1.055604 -1.070272 -1.094095 -1.117371 -1.128015 -1.115431 -1.081005 -1.017710 -0.9547473 -0.8695729 -0.7370892 -0.5320693 -7.9957083E-02 -0.7710205 -0.8180257 -0.8604010 -0.9149225 -0.9655644 -1.005974 -1.038267 -1.061972 -1.075552 -1.092946 -1.114382 -1.117182 -1.102166 -1.063496 -0.9999926 -0.9363615 -0.8514451 -0.7205276 -0.5201718 -7.9957083E-02 -0.8140105 -0.8546457 -0.8905848 -0.9395434 -0.9802424 -1.017138 -1.047276 -1.068950 -1.077595 -1.093164 -1.106204 -1.105307 -1.086576 -1.045613 -0.9816103 -0.9172927 -0.8327832 -0.7035646 -0.5080990 -7.9957083E-02 -0.8596137 -0.8915272 -0.9222208 -0.9614065 -0.9977192 -1.030659 -1.057290 -1.073510 -1.080741 -1.091490 -1.098486 -1.092214 -1.069164 -1.027192 -0.9625665 -0.8976085 -0.8136061 -0.6862130 -0.4958470 -7.9957083E-02 -0.9068055 -0.9294176 -0.9520433 -0.9861573 -1.017505 -1.045164 -1.065457 -1.078926 -1.082086 -1.083930 -1.086217 -1.076317 -1.051209 -1.008191 -0.9428055 -0.8773151 -0.7939202 -0.6684867 -0.4834220 -7.9957083E-02 -0.9527012 -0.9683039 -0.9855593 -1.012865 -1.037962 -1.057962 -1.074315 -1.082918 -1.078220 -1.075240 -1.073025 -1.059338 -1.032559 -0.9886482 -0.9225027 -0.8564943 -0.7732173 -0.6504158 -0.4708275 -7.9957083E-02 -1.001098 -1.010422 -1.020772 -1.039102 -1.056751 -1.071212 -1.079856 -1.082587 -1.073137 -1.065589 -1.058399 -1.041847 -1.013443 -0.9686206 -0.9017833 -0.8352898 -0.7517949 -0.6320245 -0.4580808 -7.9957083E-02 -1.051786 -1.052886 -1.055707 -1.065767 -1.075409 -1.081717 -1.084629 -1.081284 -1.067324 -1.054759 -1.043736 -1.024331 -0.9941066 -0.9483550 -0.8808302 -0.8137472 -0.7301099 -0.6134000 -0.4452108 -7.9957083E-02 -1.102446 -1.095197 -1.088381 -1.090362 -1.091390 -1.092073 -1.089224 -1.079978 -1.061543 -1.044639 -1.029677 -1.007342 -0.9751912 -0.9282723 -0.8600217 -0.7908124 -0.7083464 -0.5947509 -0.4322633 -7.9957083E-02 -1.152239 -1.137122 -1.122707 -1.116549 -1.109925 -1.103516 -1.094625 -1.080280 -1.057709 -1.036333 -1.017267 -0.9919710 -0.9576590 -0.9092377 -0.8408741 -0.7683004 -0.6868293 -0.5763886 -0.4193290 -7.9957083E-02 -1.209014 -1.184197 -1.161306 -1.146604 -1.132101 -1.118944 -1.104417 -1.084981 -1.057959 -1.031949 -1.008486 -0.9798782 -0.9432364 -0.8927875 -0.8263171 -0.7471182 -0.6662314 -0.5587495 -0.4065533 -7.9957083E-02 -1.280024 -1.245000 -1.212403 -1.188542 -1.166077 -1.145352 -1.124196 -1.098889 -1.066590 -1.035275 -1.006903 -0.9738458 -0.9344336 -0.8825879 -0.8158609 -0.7310020 -0.6481377 -0.5426803 -0.3950892 -7.9957083E-02 -1.384614 -1.338007 -1.293347 -1.258705 -1.226465 -1.196342 -1.166512 -1.133099 -1.092844 -1.053399 -1.018694 -0.9812155 -0.9369218 -0.8821977 -0.8134222 -0.7297617 -0.6355127 -0.5299265 -0.3835509 -7.9957083E-02 -1.564066 -1.501165 -1.439419 -1.390119 -1.345709 -1.302755 -1.261510 -1.218472 -1.171552 -1.119813 -1.063178 -1.017739 -0.9668029 -0.9057986 -0.8333055 -0.7460710 -0.6424012 -0.5273138 -0.3748695 -7.9957083E-02 -1.937539 -1.861339 -1.787280 -1.714544 -1.648432 -1.580718 -1.516439 -1.457296 -1.395090 -1.329137 -1.257908 -1.180951 -1.096236 -1.005155 -0.9154274 -0.8146158 -0.6919239 -0.5509186 -0.3726006 -7.9957083E-02 -3.430635 -3.299433 -3.162668 -3.020435 -2.872838 -2.719976 -2.561935 -2.399056 -2.230688 -2.057677 -1.879890 -1.697421 -1.510570 -1.318744 -1.122774 -0.9224970 -0.7179586 -0.5093080 -0.2966218 -7.9957083E-02 -0.5548853 -0.6804110 -0.7956848 -0.8840709 -0.9583248 -1.070460 -1.177111 -1.270080 -1.349543 -1.397929 -1.436410 -1.508685 -1.560253 -1.588896 -1.580457 -1.518446 -1.454077 -1.311425 -1.041170 -0.4074402 -0.5523028 -0.6807514 -0.7972201 -0.8758916 -0.9618058 -1.080619 -1.187146 -1.284073 -1.361294 -1.399082 -1.438880 -1.510285 -1.561038 -1.587086 -1.571633 -1.502442 -1.436300 -1.292970 -1.025864 -0.4074402 -0.5709453 -0.6932604 -0.7976865 -0.8849967 -0.9789555 -1.096593 -1.203875 -1.298527 -1.368415 -1.398977 -1.446656 -1.516252 -1.562807 -1.583010 -1.559304 -1.486037 -1.417674 -1.273778 -1.010188 -0.4074402 -0.6024197 -0.7096135 -0.8138977 -0.9084838 -1.005064 -1.118958 -1.223984 -1.311810 -1.369412 -1.406746 -1.455233 -1.522621 -1.561889 -1.576136 -1.543104 -1.468899 -1.398071 -1.253823 -0.9941331 -0.4074402 -0.6371633 -0.7424496 -0.8471026 -0.9415012 -1.036719 -1.146216 -1.243423 -1.320179 -1.375354 -1.416965 -1.466915 -1.524983 -1.559945 -1.565933 -1.524636 -1.450684 -1.377379 -1.233073 -0.9776902 -0.4074402 -0.6863095 -0.7904337 -0.8897740 -0.9812891 -1.073699 -1.173759 -1.260182 -1.328986 -1.386660 -1.429888 -1.475359 -1.526536 -1.555331 -1.551966 -1.505745 -1.431266 -1.355411 -1.211505 -0.9609078 -0.4074402 -0.7522135 -0.8466128 -0.9387460 -1.026500 -1.111589 -1.200255 -1.276137 -1.343956 -1.399697 -1.442936 -1.483164 -1.526508 -1.546995 -1.533977 -1.485949 -1.410444 -1.332324 -1.188246 -0.9438187 -0.4074402 -0.8230945 -0.9091460 -0.9935639 -1.073523 -1.148690 -1.226730 -1.298128 -1.361354 -1.415199 -1.452216 -1.486294 -1.522636 -1.534162 -1.514279 -1.464844 -1.388086 -1.307976 -1.164900 -0.9264227 -0.4074402 -0.9038226 -0.9775249 -1.051987 -1.121115 -1.187387 -1.258779 -1.323492 -1.381236 -1.428310 -1.460064 -1.487525 -1.513961 -1.516428 -1.493423 -1.442205 -1.364132 -1.282364 -1.140633 -0.9091141 -0.4074402 -0.9896223 -1.050493 -1.113103 -1.172967 -1.231031 -1.294167 -1.351725 -1.400152 -1.440046 -1.466341 -1.484965 -1.500504 -1.496393 -1.470737 -1.417748 -1.338354 -1.255529 -1.115284 -0.8910969 -0.4074402 -1.080181 -1.128958 -1.179850 -1.228874 -1.278494 -1.331290 -1.379025 -1.418661 -1.450388 -1.468992 -1.477894 -1.483569 -1.474411 -1.445982 -1.391403 -1.310904 -1.227483 -1.089102 -0.8733218 -0.4074402 -1.176927 -1.212191 -1.250754 -1.289514 -1.327833 -1.368731 -1.405842 -1.436138 -1.457689 -1.466873 -1.467513 -1.465326 -1.450468 -1.419034 -1.363120 -1.281879 -1.198177 -1.062192 -0.8554082 -0.4074402 -1.279745 -1.300879 -1.326255 -1.352894 -1.378706 -1.406833 -1.432061 -1.450743 -1.461131 -1.461992 -1.455698 -1.445938 -1.424875 -1.390393 -1.333194 -1.251606 -1.167698 -1.034727 -0.8364637 -0.4074402 -1.387953 -1.394689 -1.406126 -1.418910 -1.430994 -1.444304 -1.455999 -1.463654 -1.463892 -1.456355 -1.443023 -1.425916 -1.398626 -1.360777 -1.302314 -1.220529 -1.135847 -1.007099 -0.8173149 -0.4074402 -1.503405 -1.494661 -1.488867 -1.485489 -1.483065 -1.483248 -1.482191 -1.478813 -1.468317 -1.451920 -1.431070 -1.407154 -1.373472 -1.331892 -1.271764 -1.188320 -1.103896 -0.9802473 -0.7981738 -0.4074402 -1.625280 -1.598655 -1.577837 -1.560293 -1.543810 -1.530428 -1.515878 -1.500961 -1.479111 -1.453381 -1.424399 -1.393351 -1.353097 -1.306650 -1.243620 -1.157153 -1.073227 -0.9545067 -0.7794393 -0.4074402 -1.778785 -1.732425 -1.692586 -1.657560 -1.625495 -1.597864 -1.569204 -1.541939 -1.507747 -1.471037 -1.432343 -1.392894 -1.343075 -1.290198 -1.226812 -1.140580 -1.046708 -0.9306715 -0.7620406 -0.4074402 -2.017926 -1.945278 -1.881423 -1.823218 -1.769042 -1.722307 -1.675623 -1.631842 -1.580969 -1.528125 -1.472882 -1.421480 -1.362496 -1.301619 -1.233981 -1.143860 -1.032833 -0.9146481 -0.7480642 -0.4074402 -2.495463 -2.385125 -2.286243 -2.193168 -2.103937 -2.013785 -1.942122 -1.874677 -1.807443 -1.737062 -1.658664 -1.574380 -1.491678 -1.409186 -1.317954 -1.210851 -1.077571 -0.9261583 -0.7468653 -0.4074402 -5.999882 -5.801231 -5.589682 -5.366308 -5.131182 -4.884620 -4.626924 -4.358483 -4.079573 -3.790549 -3.491744 -3.183389 -2.865869 -2.539397 -2.204276 -1.860775 -1.509080 -1.149503 -0.7824514 -0.4074402 -0.4369583 -0.6186031 -0.7902230 -0.9454202 -1.057536 -1.154271 -1.299346 -1.432933 -1.554721 -1.653120 -1.686682 -1.779727 -1.869967 -1.938009 -1.972528 -1.924095 -1.887822 -1.757206 -1.452262 -0.6887694 -0.3800701 -0.5747415 -0.7604474 -0.9199198 -1.020719 -1.137173 -1.295475 -1.439319 -1.567695 -1.663383 -1.682241 -1.784699 -1.876891 -1.944810 -1.973191 -1.910382 -1.871656 -1.737533 -1.433061 -0.6887694 -0.3732974 -0.5661217 -0.7499421 -0.8974364 -1.014325 -1.150188 -1.310453 -1.455153 -1.581312 -1.663022 -1.692908 -1.798170 -1.886783 -1.950618 -1.969578 -1.897643 -1.854727 -1.716755 -1.413184 -0.6887694 -0.3955325 -0.5771933 -0.7483732 -0.9004205 -1.040041 -1.178603 -1.334709 -1.476087 -1.591044 -1.662153 -1.711874 -1.814338 -1.897922 -1.953950 -1.961270 -1.884933 -1.836589 -1.694790 -1.392586 -0.6887694 -0.4385164 -0.6017128 -0.7709064 -0.9342324 -1.075229 -1.214627 -1.364254 -1.495295 -1.595144 -1.673932 -1.735329 -1.831159 -1.907581 -1.953956 -1.947276 -1.871987 -1.816997 -1.670972 -1.371621 -0.6887694 -0.4975910 -0.6521735 -0.8194056 -0.9805304 -1.121414 -1.256979 -1.395176 -1.511406 -1.607420 -1.691659 -1.757965 -1.846373 -1.914643 -1.949839 -1.931054 -1.857200 -1.795685 -1.646214 -1.350141 -0.6887694 -0.5801176 -0.7270359 -0.8841211 -1.035809 -1.174570 -1.302427 -1.424603 -1.532144 -1.628428 -1.712512 -1.778273 -1.858342 -1.917121 -1.940479 -1.914781 -1.840596 -1.773152 -1.619687 -1.328167 -0.6887694 -0.6815963 -0.8157770 -0.9581126 -1.100512 -1.230704 -1.346783 -1.457610 -1.561190 -1.654852 -1.733989 -1.796145 -1.866351 -1.914320 -1.925661 -1.897845 -1.821515 -1.747535 -1.591845 -1.305685 -0.6887694 -0.7921553 -0.9146769 -1.044043 -1.170910 -1.287592 -1.394520 -1.498446 -1.595271 -1.682407 -1.755211 -1.810926 -1.869611 -1.905685 -1.909035 -1.878250 -1.799545 -1.719623 -1.562365 -1.282662 -0.6887694 -0.9159268 -1.023364 -1.134826 -1.246254 -1.350619 -1.449232 -1.544182 -1.631440 -1.709391 -1.774876 -1.822409 -1.868057 -1.892095 -1.890289 -1.855525 -1.775185 -1.689979 -1.531195 -1.259097 -0.6887694 -1.049747 -1.137129 -1.231205 -1.329060 -1.421476 -1.508831 -1.592275 -1.667797 -1.735149 -1.791243 -1.829683 -1.861513 -1.875993 -1.867915 -1.828926 -1.745954 -1.656901 -1.498299 -1.234988 -0.6887694 -1.190999 -1.258659 -1.336747 -1.419488 -1.497551 -1.570452 -1.640867 -1.704173 -1.758461 -1.803499 -1.831556 -1.851728 -1.856771 -1.841584 -1.798692 -1.712960 -1.621601 -1.463444 -1.210338 -0.6887694 -1.343769 -1.391495 -1.450244 -1.514234 -1.576075 -1.633886 -1.689796 -1.738840 -1.778725 -1.811081 -1.828616 -1.838311 -1.833455 -1.810955 -1.763268 -1.676984 -1.583188 -1.426845 -1.185141 -0.6887694 -1.504668 -1.530449 -1.567779 -1.613658 -1.657812 -1.698561 -1.738569 -1.771752 -1.795820 -1.814132 -1.821165 -1.820521 -1.805934 -1.776321 -1.724440 -1.636854 -1.542273 -1.389070 -1.159459 -0.6887694 -1.675342 -1.678561 -1.693863 -1.718626 -1.743361 -1.765472 -1.787221 -1.802239 -1.810218 -1.814556 -1.810158 -1.799093 -1.775183 -1.738418 -1.682125 -1.593333 -1.498637 -1.350808 -1.133399 -0.6887694 -1.861022 -1.841458 -1.832222 -1.832208 -1.833899 -1.834669 -1.837991 -1.835494 -1.827088 -1.815490 -1.798532 -1.776507 -1.743872 -1.699425 -1.638570 -1.547859 -1.454074 -1.313042 -1.107291 -0.6887694 -2.072330 -2.023895 -1.986779 -1.963785 -1.942598 -1.921226 -1.904315 -1.881916 -1.855706 -1.826038 -1.795627 -1.761702 -1.718953 -1.665440 -1.598063 -1.510161 -1.411412 -1.277421 -1.081945 -0.6887694 -2.368062 -2.281842 -2.209524 -2.157266 -2.108850 -2.060825 -2.020116 -1.975141 -1.927060 -1.874898 -1.826053 -1.773771 -1.715812 -1.651303 -1.577859 -1.486742 -1.378653 -1.248093 -1.059746 -0.6887694 -2.950171 -2.808815 -2.676031 -2.569533 -2.471667 -2.378586 -2.304705 -2.231338 -2.153176 -2.071183 -1.988230 -1.904364 -1.822360 -1.731470 -1.630926 -1.522696 -1.386270 -1.243440 -1.049841 -0.6887694 -8.816086 -8.548119 -8.258288 -7.947386 -7.616139 -7.265341 -6.895776 -6.508225 -6.103409 -5.682073 -5.244838 -4.792400 -4.325284 -3.844129 -3.349381 -2.841614 -2.321222 -1.788698 -1.244411 -0.6887694 -0.3562007 -0.5468948 -0.7659273 -0.9707284 -1.146563 -1.235678 -1.403332 -1.567001 -1.721107 -1.858687 -1.941747 -2.003838 -2.123995 -2.220491 -2.290376 -2.278390 -2.252661 -2.146845 -1.822587 -0.9353619 -0.2202180 -0.4428361 -0.6804345 -0.9048451 -1.087489 -1.182555 -1.375062 -1.555818 -1.726095 -1.872795 -1.934867 -2.010503 -2.136175 -2.234877 -2.301323 -2.269435 -2.240590 -2.128270 -1.800588 -0.9353619 -0.1744100 -0.4049187 -0.6449121 -0.8651009 -1.038059 -1.185278 -1.379751 -1.566751 -1.740094 -1.880099 -1.934739 -2.032715 -2.155450 -2.250575 -2.307982 -2.259734 -2.228625 -2.108204 -1.777591 -0.9353619 -0.1772438 -0.4075672 -0.6399165 -0.8478421 -1.038590 -1.203795 -1.402408 -1.589153 -1.757776 -1.878883 -1.956787 -2.063819 -2.178644 -2.264951 -2.310288 -2.252110 -2.216712 -2.086610 -1.753552 -0.9353619 -0.2166765 -0.4359401 -0.6582577 -0.8711278 -1.064962 -1.242996 -1.436763 -1.619139 -1.772801 -1.891642 -1.986403 -2.094993 -2.200972 -2.277155 -2.306693 -2.245248 -2.202311 -2.063213 -1.728411 -0.9353619 -0.2821652 -0.4891404 -0.7080327 -0.9168608 -1.114117 -1.295516 -1.483599 -1.649671 -1.791535 -1.915735 -2.018419 -2.122623 -2.219596 -2.286170 -2.297099 -2.238100 -2.185703 -2.037798 -1.702145 -0.9353619 -0.3750098 -0.5696490 -0.7787315 -0.9840961 -1.179175 -1.359778 -1.530876 -1.685038 -1.823037 -1.945642 -2.048433 -2.146448 -2.234089 -2.289570 -2.288043 -2.229302 -2.166349 -2.010199 -1.675047 -0.9353619 -0.4913526 -0.6732813 -0.8723755 -1.069426 -1.256969 -1.423276 -1.583263 -1.729496 -1.859979 -1.977052 -2.076589 -2.166502 -2.243906 -2.285648 -2.278791 -2.218001 -2.144548 -1.980241 -1.647593 -0.9353619 -0.6318603 -0.7988718 -0.9846214 -1.167279 -1.336121 -1.493919 -1.641874 -1.776591 -1.898199 -2.008975 -2.102964 -2.183259 -2.248711 -2.278107 -2.266817 -2.201435 -2.118645 -1.947659 -1.619634 -0.9353619 -0.7921240 -0.9422607 -1.105535 -1.270031 -1.426494 -1.569362 -1.702118 -1.825653 -1.937938 -2.040087 -2.126367 -2.196538 -2.247960 -2.268337 -2.250581 -2.179780 -2.088005 -1.912417 -1.590888 -0.9353619 -0.9648359 -1.091756 -1.236243 -1.382637 -1.519645 -1.646928 -1.765881 -1.877272 -1.978356 -2.069408 -2.146049 -2.204794 -2.243685 -2.254688 -2.229097 -2.152762 -2.052922 -1.874401 -1.561314 -0.9353619 -1.150842 -1.255914 -1.375371 -1.498317 -1.616552 -1.729517 -1.834097 -1.930722 -2.017585 -2.096071 -2.160436 -2.207847 -2.235209 -2.235644 -2.200994 -2.118782 -2.013029 -1.833335 -1.530879 -0.9353619 -1.350613 -1.427881 -1.520615 -1.622093 -1.721842 -1.817332 -1.904106 -1.983587 -2.055227 -2.118839 -2.169328 -2.204867 -2.220309 -2.209425 -2.166229 -2.077589 -1.968043 -1.789165 -1.499617 -0.9353619 -1.560870 -1.612273 -1.679166 -1.756317 -1.832216 -1.906367 -1.974533 -2.035403 -2.089482 -2.136878 -2.171992 -2.193464 -2.197420 -2.175444 -2.123821 -2.029797 -1.918121 -1.742272 -1.467516 -0.9353619 -1.788701 -1.809068 -1.846199 -1.896546 -1.948167 -1.998514 -2.044607 -2.084971 -2.120342 -2.148121 -2.166515 -2.173477 -2.166156 -2.133401 -2.074171 -1.975795 -1.863260 -1.693839 -1.434661 -0.9353619 -2.031525 -2.020923 -2.027668 -2.048642 -2.072815 -2.096550 -2.116443 -2.131531 -2.145943 -2.153773 -2.155622 -2.146536 -2.127468 -2.084773 -2.018593 -1.916755 -1.803512 -1.643832 -1.401191 -0.9353619 -2.307943 -2.264070 -2.234261 -2.220509 -2.212365 -2.204975 -2.196374 -2.184743 -2.176522 -2.161508 -2.145177 -2.118452 -2.087290 -2.034510 -1.960946 -1.855268 -1.742279 -1.593982 -1.367627 -0.9353619 -2.667477 -2.575012 -2.503729 -2.452360 -2.407040 -2.363530 -2.320378 -2.275892 -2.238729 -2.197559 -2.158593 -2.110503 -2.062517 -1.994617 -1.912552 -1.807288 -1.687057 -1.547640 -1.335272 -0.9353619 -3.353912 -3.183978 -3.036297 -2.920173 -2.817685 -2.715837 -2.616602 -2.524106 -2.446362 -2.368668 -2.289725 -2.206511 -2.123082 -2.037120 -1.929837 -1.808127 -1.663687 -1.520025 -1.311875 -0.9353619 -11.84672 -11.50831 -11.13606 -10.73146 -10.29597 -9.831173 -9.338581 -8.819549 -8.275471 -7.707613 -7.117062 -6.504939 -5.872247 -5.219848 -4.548626 -3.859365 -3.152752 -2.429479 -1.690164 -0.9353619 -0.2857931 -0.4815780 -0.7496746 -0.9942310 -1.215886 -1.374670 -1.498568 -1.690456 -1.869761 -2.033559 -2.157911 -2.197667 -2.340394 -2.458870 -2.555752 -2.579563 -2.561852 -2.487529 -2.161026 -1.154860 -7.5052418E-02 -0.3118299 -0.6002376 -0.8743439 -1.120914 -1.268075 -1.447494 -1.660014 -1.860700 -2.042849 -2.161911 -2.203657 -2.356352 -2.478567 -2.576129 -2.579680 -2.555042 -2.471996 -2.137254 -1.154860 2.1028077E-02 -0.2382459 -0.5281615 -0.8043317 -1.037889 -1.231173 -1.441728 -1.664643 -1.866923 -2.053974 -2.150674 -2.236809 -2.386979 -2.502832 -2.592864 -2.572120 -2.550810 -2.455026 -2.112120 -1.154860 4.5350071E-02 -0.2247789 -0.5051954 -0.7695449 -1.011146 -1.236207 -1.460848 -1.678356 -1.885301 -2.062714 -2.171877 -2.284738 -2.422010 -2.528031 -2.606063 -2.569906 -2.545815 -2.436240 -2.085553 -1.154860 1.7667770E-02 -0.2501512 -0.5198259 -0.7799628 -1.032599 -1.268586 -1.489949 -1.706705 -1.911982 -2.078088 -2.207343 -2.331183 -2.455922 -2.551907 -2.613942 -2.571462 -2.539841 -2.415209 -2.057470 -1.154860 -4.9330790E-02 -0.3072006 -0.5735239 -0.8315549 -1.082638 -1.315030 -1.535405 -1.751109 -1.946108 -2.109953 -2.250894 -2.371412 -2.486415 -2.572955 -2.614042 -2.574252 -2.532713 -2.391500 -2.027784 -1.154860 -0.1513090 -0.3989091 -0.6584251 -0.9109622 -1.149358 -1.376617 -1.597433 -1.806898 -1.990254 -2.153761 -2.290596 -2.407048 -2.513092 -2.588599 -2.612796 -2.576170 -2.520906 -2.364812 -1.996825 -1.154860 -0.2856925 -0.5181949 -0.7682680 -1.004355 -1.233279 -1.456907 -1.672052 -1.868388 -2.042578 -2.199488 -2.329387 -2.440083 -2.536626 -2.597559 -2.612762 -2.573781 -2.505403 -2.334862 -1.964863 -1.154860 -0.4467095 -0.6601252 -0.8898867 -1.116972 -1.337395 -1.552572 -1.750318 -1.933969 -2.098397 -2.241719 -2.366288 -2.470406 -2.556353 -2.602133 -2.610638 -2.566297 -2.483974 -2.301337 -1.931764 -1.154860 -0.6287976 -0.8208662 -1.034359 -1.249066 -1.457074 -1.649883 -1.832930 -2.001964 -2.149735 -2.282395 -2.400601 -2.497500 -2.570616 -2.605670 -2.604907 -2.552776 -2.456799 -2.264045 -1.897837 -1.154860 -0.8351753 -1.006019 -1.200157 -1.391865 -1.576106 -1.754829 -1.917040 -2.065837 -2.200809 -2.323060 -2.431788 -2.518950 -2.579798 -2.605006 -2.593078 -2.531218 -2.423064 -2.222719 -1.863103 -1.154860 -1.064529 -1.207480 -1.371881 -1.541809 -1.704990 -1.857901 -1.998745 -2.131637 -2.253705 -2.363063 -2.457943 -2.533777 -2.583657 -2.597479 -2.573938 -2.500776 -2.382494 -2.177130 -1.827089 -1.154860 -1.304739 -1.421399 -1.557864 -1.698878 -1.833941 -1.963155 -2.085263 -2.200902 -2.305945 -2.400053 -2.478924 -2.541455 -2.579022 -2.580369 -2.545366 -2.461303 -2.334752 -2.127017 -1.789770 -1.154860 -1.566566 -1.648209 -1.750224 -1.861541 -1.972440 -2.077518 -2.176162 -2.269884 -2.355684 -2.432103 -2.493374 -2.539751 -2.563002 -2.551518 -2.505654 -2.412065 -2.279560 -2.072534 -1.751075 -1.154860 -1.844148 -1.890278 -1.959534 -2.038842 -2.119211 -2.195476 -2.268537 -2.337696 -2.401233 -2.456907 -2.499391 -2.525959 -2.533593 -2.509418 -2.453805 -2.352935 -2.216762 -2.013999 -1.710990 -1.154860 -2.146055 -2.151999 -2.182658 -2.226747 -2.274310 -2.318752 -2.362337 -2.403838 -2.441118 -2.471891 -2.493607 -2.500091 -2.491031 -2.454061 -2.389822 -2.284182 -2.146661 -1.952534 -1.669590 -1.154860 -2.481570 -2.445060 -2.433200 -2.437746 -2.447808 -2.453511 -2.460825 -2.470435 -2.477181 -2.481558 -2.480767 -2.465566 -2.438633 -2.388777 -2.316407 -2.207454 -2.069523 -1.888224 -1.627121 -1.154860 -2.910904 -2.817111 -2.750087 -2.706282 -2.670061 -2.632241 -2.595844 -2.567247 -2.536525 -2.507374 -2.479399 -2.439806 -2.391222 -2.325127 -2.240529 -2.129123 -1.990930 -1.823854 -1.584944 -1.154860 -3.701826 -3.513708 -3.349477 -3.228471 -3.121381 -3.012788 -2.907126 -2.816938 -2.724960 -2.640480 -2.573513 -2.495355 -2.410297 -2.321094 -2.212497 -2.087754 -1.930286 -1.771322 -1.549697 -1.154860 -15.06665 -14.65645 -14.19795 -13.69369 -13.14634 -12.55851 -11.93264 -11.27105 -10.57585 -9.848976 -9.092179 -8.307023 -7.494976 -6.657360 -5.795371 -4.910096 -4.002528 -3.073581 -2.124098 -1.154860 -0.1907821 -0.4432223 -0.7278120 -1.014647 -1.279486 -1.493702 -1.594708 -1.810311 -2.006533 -2.191251 -2.347334 -2.368444 -2.532610 -2.667405 -2.784960 -2.840154 -2.827683 -2.786197 -2.472047 -1.352634 9.8141745E-02 -0.1787365 -0.5120583 -0.8403770 -1.144624 -1.356404 -1.515962 -1.757905 -1.982439 -2.195470 -2.358407 -2.372415 -2.550420 -2.691539 -2.813514 -2.850386 -2.827374 -2.775121 -2.447649 -1.352634 0.2535759 -6.4536549E-02 -0.4101692 -0.7438557 -1.037819 -1.273967 -1.500750 -1.750700 -1.985010 -2.205537 -2.343750 -2.419623 -2.590451 -2.724090 -2.839954 -2.847764 -2.830076 -2.762813 -2.421484 -1.352634 0.2964105 -3.3217326E-02 -0.3730461 -0.6925784 -0.9828127 -1.254847 -1.506994 -1.763974 -2.004951 -2.215431 -2.361149 -2.485821 -2.635817 -2.759729 -2.863944 -2.850510 -2.834776 -2.748607 -2.393456 -1.352634 0.2717008 -5.5307791E-02 -0.3789019 -0.6886954 -0.9875299 -1.269621 -1.537038 -1.795167 -2.029041 -2.230899 -2.403882 -2.543682 -2.682288 -2.794415 -2.883490 -2.860829 -2.840748 -2.731780 -2.363455 -1.352634 0.2006046 -0.1131999 -0.4290726 -0.7334355 -1.027453 -1.315673 -1.586375 -1.838710 -2.066730 -2.274702 -2.456771 -2.598569 -2.724698 -2.826841 -2.895701 -2.874045 -2.843263 -2.711876 -2.331354 -1.352634 9.1234379E-02 -0.2097910 -0.5165186 -0.8123968 -1.102232 -1.384602 -1.648691 -1.895185 -2.123509 -2.336224 -2.509044 -2.650736 -2.765625 -2.855319 -2.904153 -2.886818 -2.840755 -2.688432 -2.297377 -1.352634 -5.5663772E-02 -0.3397580 -0.6343529 -0.9209384 -1.201225 -1.469067 -1.722983 -1.969452 -2.196938 -2.394299 -2.564449 -2.697358 -2.804513 -2.878884 -2.915614 -2.895999 -2.833214 -2.661036 -2.262143 -1.352634 -0.2360369 -0.4995987 -0.7781121 -1.053665 -1.312859 -1.568009 -1.817811 -2.058976 -2.267729 -2.454849 -2.612929 -2.738884 -2.838453 -2.898643 -2.926650 -2.900727 -2.819554 -2.629130 -2.225508 -1.352634 -0.4432105 -0.6850231 -0.9429890 -1.195767 -1.442615 -1.688352 -1.929228 -2.144444 -2.340530 -2.510110 -2.655814 -2.775778 -2.866076 -2.916842 -2.934015 -2.898035 -2.798814 -2.592376 -2.187301 -1.352634 -0.6774535 -0.8895634 -1.124832 -1.361667 -1.594255 -1.820107 -2.032714 -2.233421 -2.408518 -2.560637 -2.695735 -2.807225 -2.886984 -2.929907 -2.935294 -2.886166 -2.770574 -2.550356 -2.147275 -1.352634 -0.9345886 -1.119480 -1.332954 -1.548032 -1.751485 -1.950036 -2.141814 -2.315015 -2.471169 -2.611163 -2.732899 -2.832282 -2.901752 -2.934816 -2.927384 -2.864262 -2.734203 -2.502753 -2.106341 -1.352634 -1.220541 -1.373708 -1.552625 -1.736328 -1.915896 -2.083062 -2.243452 -2.394443 -2.534951 -2.660725 -2.766258 -2.851546 -2.908295 -2.928695 -2.907619 -2.830817 -2.688736 -2.448923 -2.063502 -1.352634 -1.523606 -1.641621 -1.785579 -1.935371 -2.078344 -2.215117 -2.350900 -2.478848 -2.598157 -2.705399 -2.793626 -2.861745 -2.903283 -2.908094 -2.873816 -2.784581 -2.633160 -2.388936 -2.018613 -1.352634 -1.855638 -1.927420 -2.028472 -2.141848 -2.253458 -2.358892 -2.463820 -2.564271 -2.658186 -2.743150 -2.810795 -2.859330 -2.882565 -2.870783 -2.823552 -2.723977 -2.566510 -2.323148 -1.971639 -1.352634 -2.213942 -2.240121 -2.295814 -2.366057 -2.438660 -2.508646 -2.579100 -2.648787 -2.712953 -2.770496 -2.813444 -2.839587 -2.843341 -2.814912 -2.755157 -2.648303 -2.488484 -2.251194 -1.922505 -1.352634 -2.609515 -2.583163 -2.588824 -2.611884 -2.640965 -2.669887 -2.700038 -2.731700 -2.761269 -2.785240 -2.800544 -2.802428 -2.785916 -2.741289 -2.669360 -2.558219 -2.399274 -2.174547 -1.871295 -1.352634 -3.103417 -3.010449 -2.954238 -2.918050 -2.891800 -2.868655 -2.847953 -2.832822 -2.822481 -2.806246 -2.787767 -2.759921 -2.721041 -2.658183 -2.572291 -2.457235 -2.303106 -2.094852 -1.818922 -1.352634 -3.971870 -3.773215 -3.618956 -3.489173 -3.375139 -3.268864 -3.168112 -3.076241 -3.002629 -2.923306 -2.845138 -2.774388 -2.700921 -2.610396 -2.500782 -2.377545 -2.215742 -2.021551 -1.771101 -1.352634 -18.45619 -17.97285 -17.42436 -16.81479 -16.14832 -15.42902 -14.66058 -13.84639 -12.98948 -12.09257 -11.15809 -10.18822 -9.184905 -8.149888 -7.084743 -5.990892 -4.869629 -3.722126 -2.549463 -1.352634 -8.9666069E-02 -0.4286312 -0.7119161 -1.034328 -1.332455 -1.592498 -1.687213 -1.928164 -2.139766 -2.338294 -2.515982 -2.524292 -2.705768 -2.854805 -2.988898 -3.070553 -3.061047 -3.049223 -2.758959 -1.532598 0.2924523 -5.8565792E-02 -0.4232842 -0.7920612 -1.145836 -1.438859 -1.589766 -1.860347 -2.101647 -2.334036 -2.533891 -2.526644 -2.725801 -2.883047 -3.025182 -3.091901 -3.064785 -3.043269 -2.735157 -1.532598 0.5012794 0.1114207 -0.2808742 -0.6622762 -1.027542 -1.321245 -1.569606 -1.845242 -2.096411 -2.344016 -2.529080 -2.586864 -2.775568 -2.924728 -3.061475 -3.097599 -3.076270 -3.036703 -2.709174 -1.532598 0.5641971 0.1740188 -0.2228190 -0.6075361 -0.9615667 -1.277829 -1.565739 -1.846719 -2.110770 -2.359510 -2.537220 -2.664474 -2.832464 -2.972145 -3.096429 -3.104507 -3.092956 -3.028456 -2.680874 -1.532598 0.5476337 0.1611756 -0.2306483 -0.6036913 -0.9496570 -1.278226 -1.581910 -1.870612 -2.141418 -2.380643 -2.579920 -2.735911 -2.890859 -3.019948 -3.127770 -3.123365 -3.108068 -3.017727 -2.650119 -1.532598 0.4701462 9.3696646E-02 -0.2860428 -0.6408209 -0.9813465 -1.310531 -1.620430 -1.918305 -2.189580 -2.422860 -2.638272 -2.808307 -2.948979 -3.066395 -3.153420 -3.147679 -3.121889 -3.003678 -2.616734 -1.532598 0.3460744 -1.3578938E-02 -0.3725530 -0.7168512 -1.049103 -1.372006 -1.686656 -1.983217 -2.241716 -2.485887 -2.706535 -2.874061 -3.007983 -3.108924 -3.174441 -3.171926 -3.130419 -2.985832 -2.580819 -1.532598 0.1851601 -0.1520014 -0.4949522 -0.8251441 -1.146843 -1.465792 -1.774007 -2.053875 -2.314939 -2.561827 -2.773344 -2.936468 -3.061018 -3.147578 -3.198796 -3.194683 -3.134142 -2.963531 -2.543321 -1.532598 -1.0138834E-02 -0.3247015 -0.6482280 -0.9644475 -1.274470 -1.583693 -1.868612 -2.144916 -2.405655 -2.640799 -2.836748 -2.990120 -3.106052 -3.181640 -3.223007 -3.212020 -3.131902 -2.935928 -2.504110 -1.532598 -0.2399804 -0.5275714 -0.8315560 -1.131721 -1.423215 -1.705307 -1.984204 -2.255030 -2.502666 -2.713718 -2.895986 -3.036197 -3.144317 -3.212588 -3.243371 -3.221196 -3.121779 -2.902655 -2.462967 -1.532598 -0.5005113 -0.7575347 -1.041682 -1.314901 -1.582753 -1.851653 -2.119667 -2.367624 -2.591411 -2.785490 -2.946069 -3.077617 -3.176289 -3.238122 -3.257300 -3.220760 -3.102718 -2.863078 -2.419660 -1.532598 -0.7895933 -1.012523 -1.265587 -1.517825 -1.768124 -2.016731 -2.251557 -2.475084 -2.675353 -2.845715 -2.992608 -3.114680 -3.203152 -3.255409 -3.261636 -3.208833 -3.073897 -2.816709 -2.373788 -1.532598 -1.104872 -1.295102 -1.518386 -1.745181 -1.961081 -2.174955 -2.384836 -2.575065 -2.748780 -2.903378 -3.036943 -3.146386 -3.223140 -3.260702 -3.253163 -3.183390 -3.033590 -2.762240 -2.326071 -1.532598 -1.456767 -1.603976 -1.785177 -1.975383 -2.159168 -2.336117 -2.507758 -2.671427 -2.823800 -2.959749 -3.075032 -3.168828 -3.231138 -3.251616 -3.228319 -3.142627 -2.979949 -2.699543 -2.275643 -1.532598 -1.831457 -1.933791 -2.071231 -2.216248 -2.357473 -2.498741 -2.638714 -2.773746 -2.898837 -3.010661 -3.103109 -3.177244 -3.222120 -3.223832 -3.183249 -3.083735 -2.911445 -2.628741 -2.222242 -1.532598 -2.241658 -2.290250 -2.377151 -2.475553 -2.574307 -2.673582 -2.774822 -2.874624 -2.969509 -3.051303 -3.116702 -3.166242 -3.190135 -3.172673 -3.114700 -3.004961 -2.827250 -2.548655 -2.165642 -1.532598 -2.698951 -2.685755 -2.714109 -2.757533 -2.806384 -2.859378 -2.917219 -2.974217 -3.031800 -3.076566 -3.109294 -3.130432 -3.131468 -3.094946 -3.021268 -2.905139 -2.727697 -2.461936 -2.105675 -1.532598 -3.252677 -3.164951 -3.124823 -3.100484 -3.084980 -3.078711 -3.081308 -3.085763 -3.094730 -3.096663 -3.088926 -3.077519 -3.050957 -2.994849 -2.906664 -2.785009 -2.614382 -2.369194 -2.042366 -1.532598 -4.200020 -3.984294 -3.836144 -3.710951 -3.595088 -3.492351 -3.405741 -3.327700 -3.261439 -3.196052 -3.123727 -3.059470 -2.991636 -2.908702 -2.799250 -2.672316 -2.501595 -2.278801 -1.978917 -1.532598 -21.99948 -21.44168 -20.79978 -20.07917 -19.28680 -18.42823 -17.50868 -16.53278 -15.50462 -14.42781 -13.30551 -12.14054 -10.93536 -9.692162 -8.412925 -7.099411 -5.753232 -4.375835 -2.968550 -1.532598 1.3767285E-02 -0.4025317 -0.7063063 -1.063299 -1.388026 -1.678372 -1.791541 -2.041182 -2.268568 -2.478802 -2.670854 -2.687720 -2.865591 -3.025158 -3.173405 -3.276773 -3.265871 -3.283022 -3.023678 -1.697697 0.4910059 5.7632569E-02 -0.3433367 -0.7514820 -1.140224 -1.487477 -1.663458 -1.964381 -2.219670 -2.469811 -2.692065 -2.681697 -2.888749 -3.058062 -3.217683 -3.309802 -3.274458 -3.282599 -3.001636 -1.697697 0.7461267 0.2830392 -0.1580784 -0.5818750 -0.9890219 -1.344728 -1.646549 -1.944045 -2.213362 -2.476944 -2.696590 -2.755109 -2.947648 -3.110389 -3.264067 -3.326222 -3.294612 -3.282471 -2.977059 -1.697697 0.8346142 0.3773946 -7.5722516E-02 -0.5054011 -0.9154737 -1.300844 -1.634176 -1.937936 -2.224457 -2.492314 -2.703860 -2.840614 -3.016732 -3.169748 -3.309690 -3.337043 -3.321190 -3.281172 -2.949733 -1.697697 0.8264765 0.3776008 -6.9121554E-02 -0.4973271 -0.9111498 -1.295300 -1.634010 -1.956517 -2.248350 -2.521157 -2.751408 -2.919429 -3.091241 -3.231261 -3.353611 -3.364775 -3.348332 -3.277932 -2.919460 -1.697697 0.7443106 0.3136227 -0.1232656 -0.5438898 -0.9444820 -1.312021 -1.664294 -1.989498 -2.294437 -2.570784 -2.808838 -3.000912 -3.165591 -3.293607 -3.393743 -3.400451 -3.372640 -3.271548 -2.886015 -1.697697 0.6121149 0.1973823 -0.2235430 -0.6253020 -1.002649 -1.369109 -1.716563 -2.048511 -2.356088 -2.631473 -2.877539 -3.081254 -3.237523 -3.351076 -3.428614 -3.437548 -3.394363 -3.261289 -2.849351 -1.697697 0.4347264 4.0558022E-02 -0.3552287 -0.7319974 -1.098240 -1.454025 -1.801491 -2.131008 -2.431891 -2.705139 -2.955855 -3.154100 -3.304847 -3.403671 -3.465554 -3.472628 -3.411754 -3.246200 -2.810679 -1.697697 0.2186093 -0.1453706 -0.5151151 -0.8746875 -1.224547 -1.573213 -1.912447 -2.229637 -2.520773 -2.795550 -3.038790 -3.221799 -3.362629 -3.450608 -3.501859 -3.502018 -3.421825 -3.225212 -2.770008 -1.697697 -2.9707950E-02 -0.3627203 -0.7094272 -1.049906 -1.385018 -1.718979 -2.036716 -2.339257 -2.630272 -2.896139 -3.113164 -3.285934 -3.411720 -3.493433 -3.534306 -3.523181 -3.422364 -3.197704 -2.726995 -1.697697 -0.3144621 -0.6130794 -0.9359310 -1.255152 -1.570249 -1.874072 -2.176175 -2.471322 -2.749451 -2.983286 -3.185863 -3.339903 -3.454812 -3.530081 -3.560652 -3.534210 -3.413016 -3.162667 -2.681317 -1.697697 -0.6308954 -0.8954402 -1.190401 -1.478722 -1.763487 -2.051183 -2.339787 -2.608871 -2.854675 -3.066296 -3.243577 -3.387392 -3.493425 -3.558479 -3.577405 -3.533498 -3.392675 -3.119124 -2.632622 -1.697697 -0.9795281 -1.204439 -1.461920 -1.723486 -1.985290 -2.246356 -2.497276 -2.739631 -2.952563 -3.134428 -3.295913 -3.429592 -3.524591 -3.576224 -3.580814 -3.518708 -3.359247 -3.065755 -2.580409 -1.697697 -1.361795 -1.545127 -1.767694 -1.990422 -2.211849 -2.437636 -2.652095 -2.854328 -3.037625 -3.200671 -3.344413 -3.462203 -3.544063 -3.580104 -3.566826 -3.486866 -3.310267 -3.002012 -2.525634 -1.697697 -1.783788 -1.913695 -2.086912 -2.267650 -2.444582 -2.622695 -2.798404 -2.968695 -3.125446 -3.263818 -3.384801 -3.481547 -3.546266 -3.563931 -3.531085 -3.433889 -3.243359 -2.927984 -2.466987 -1.697697 -2.246043 -2.316996 -2.431258 -2.557134 -2.685175 -2.819910 -2.955766 -3.087219 -3.210608 -3.318312 -3.410541 -3.481961 -3.524039 -3.519814 -3.468431 -3.356050 -3.157073 -2.842590 -2.404075 -1.697697 -2.760680 -2.763441 -2.812820 -2.877281 -2.948784 -3.030689 -3.118294 -3.204537 -3.286397 -3.357089 -3.412046 -3.453129 -3.467510 -3.441657 -3.374151 -3.250324 -3.050455 -2.745195 -2.336440 -1.697697 -3.373517 -3.288996 -3.263202 -3.256403 -3.258793 -3.272136 -3.297289 -3.326543 -3.355145 -3.378330 -3.390153 -3.394513 -3.376307 -3.328207 -3.247235 -3.116194 -2.923065 -2.638096 -2.263654 -1.697697 -4.391499 -4.169389 -4.022510 -3.898454 -3.786794 -3.694697 -3.623111 -3.564010 -3.510724 -3.458735 -3.405525 -3.352203 -3.281753 -3.205515 -3.106974 -2.970947 -2.789083 -2.525684 -2.186889 -1.697697 -25.68348 -25.04990 -24.31052 -23.47415 -22.54947 -21.54437 -20.46580 -19.31986 -18.11180 -16.84617 -15.52692 -14.15750 -12.74092 -11.27988 -9.776755 -8.233667 -6.652546 -5.035143 -3.383041 -1.697697 0.1216959 -0.3716854 -0.7056639 -1.101238 -1.454327 -1.764822 -1.939890 -2.144531 -2.387797 -2.612732 -2.814949 -2.873192 -3.013492 -3.182939 -3.342289 -3.462066 -3.450746 -3.493110 -3.267591 -1.850200 0.6960586 0.1824035 -0.2740492 -0.7318995 -1.148150 -1.529849 -1.747149 -2.054302 -2.334494 -2.599339 -2.839610 -2.847554 -3.041607 -3.220606 -3.395020 -3.507262 -3.464599 -3.498451 -3.248302 -1.850200 0.9923337 0.4544232 -4.7420241E-02 -0.5174358 -0.9572431 -1.355738 -1.704474 -2.039657 -2.332371 -2.607901 -2.849531 -2.924949 -3.113338 -3.283098 -3.451113 -3.533822 -3.495316 -3.505447 -3.226137 -1.850200 1.104131 0.5725538 6.2640674E-02 -0.4115781 -0.8642316 -1.293166 -1.689170 -2.036875 -2.338067 -2.627339 -2.856629 -3.019214 -3.195671 -3.355987 -3.507861 -3.550674 -3.532108 -3.512134 -3.200866 -1.850200 1.100898 0.5889952 8.6289600E-02 -0.3917201 -0.8483131 -1.289062 -1.691723 -2.041000 -2.362174 -2.654670 -2.909738 -3.105556 -3.281567 -3.433106 -3.566178 -3.590070 -3.570473 -3.517660 -3.172164 -1.850200 1.018743 0.5277451 3.8228225E-02 -0.4307636 -0.8856552 -1.317829 -1.708054 -2.067167 -2.399494 -2.703634 -2.974900 -3.187399 -3.367301 -3.508186 -3.621324 -3.638392 -3.607862 -3.520430 -3.139752 -1.850200 0.8764593 0.4089667 -6.3056849E-02 -0.5187222 -0.9590926 -1.369037 -1.754858 -2.118309 -2.455926 -2.770456 -3.041900 -3.268927 -3.453024 -3.580282 -3.669910 -3.688009 -3.642795 -3.519285 -3.103407 -1.850200 0.6866516 0.2429803 -0.2075221 -0.6416259 -1.053664 -1.451394 -1.833040 -2.194361 -2.537422 -2.848953 -3.119158 -3.352796 -3.529197 -3.647400 -3.718776 -3.734118 -3.672360 -3.513000 -3.064641 -1.850200 0.4534335 3.7415318E-02 -0.3836904 -0.7864156 -1.181409 -1.565471 -1.939086 -2.300391 -2.636351 -2.936210 -3.211615 -3.437608 -3.601158 -3.707530 -3.767360 -3.774335 -3.694171 -3.500478 -3.023586 -1.850200 0.1814644 -0.1964291 -0.5854698 -0.9674919 -1.341791 -1.713777 -2.077718 -2.424369 -2.741054 -3.044495 -3.312655 -3.515896 -3.665188 -3.761334 -3.812431 -3.807945 -3.706542 -3.480718 -2.979804 -1.850200 -0.1234801 -0.4632694 -0.8253129 -1.182278 -1.536908 -1.893075 -2.232066 -2.557717 -2.872720 -3.163721 -3.399859 -3.589324 -3.720388 -3.808823 -3.851149 -3.831714 -3.708903 -3.452261 -2.932847 -1.850200 -0.4656241 -0.7686670 -1.098286 -1.428929 -1.757113 -2.080410 -2.401189 -2.718615 -3.013206 -3.264896 -3.480580 -3.648339 -3.768824 -3.849196 -3.879617 -3.843883 -3.699312 -3.413934 -2.882268 -1.850200 -0.8429985 -1.106448 -1.400507 -1.693648 -1.988984 -2.293308 -2.597516 -2.878130 -3.137542 -3.358380 -3.544060 -3.699002 -3.809901 -3.880070 -3.895263 -3.841349 -3.675570 -3.364364 -2.827625 -1.850200 -1.257030 -1.471514 -1.726310 -1.986439 -2.251789 -2.516434 -2.778034 -3.026031 -3.244515 -3.434052 -3.602346 -3.741341 -3.840123 -3.896781 -3.894367 -3.820190 -3.634177 -3.302313 -2.768504 -1.850200 -1.718926 -1.880729 -2.083299 -2.296256 -2.514289 -2.734923 -2.949334 -3.153495 -3.341945 -3.509273 -3.654538 -3.772107 -3.854126 -3.892663 -3.871164 -3.775387 -3.571589 -3.227669 -2.705393 -1.850200 -2.224665 -2.322918 -2.468464 -2.621783 -2.780291 -2.950244 -3.121908 -3.287400 -3.440408 -3.577754 -3.694145 -3.784809 -3.842810 -3.858826 -3.817591 -3.701954 -3.484929 -3.138943 -2.636967 -1.850200 -2.795506 -2.815624 -2.890280 -2.977547 -3.074627 -3.186456 -3.305181 -3.421753 -3.530270 -3.627594 -3.709875 -3.764977 -3.793160 -3.785608 -3.725043 -3.594512 -3.372374 -3.033958 -2.562536 -1.850200 -3.472941 -3.396164 -3.381237 -3.388486 -3.412642 -3.452742 -3.502799 -3.556786 -3.607432 -3.651910 -3.690536 -3.703417 -3.698033 -3.665803 -3.587644 -3.449768 -3.230992 -2.915585 -2.481478 -1.850200 -4.555183 -4.332193 -4.180831 -4.058116 -3.957724 -3.883232 -3.831063 -3.789854 -3.751175 -3.714994 -3.685343 -3.635914 -3.580796 -3.513026 -3.415627 -3.279118 -3.076555 -2.785297 -2.394042 -1.850200 -29.49723 -28.78657 -27.94648 -26.98909 -25.92598 -24.76757 -23.52276 -22.19913 -20.80326 -19.34067 -17.81612 -16.23376 -14.59716 -12.90950 -11.17360 -9.391960 -7.566847 -5.700306 -3.794187 -1.850200 0.2420342 -0.3273337 -0.7091867 -1.139654 -1.517928 -1.855032 -2.078706 -2.245217 -2.498997 -2.736529 -2.950605 -3.045306 -3.151828 -3.329891 -3.498316 -3.631538 -3.619526 -3.683019 -3.492526 -1.991894 0.9116901 0.3057100 -0.2063071 -0.7128273 -1.172465 -1.587596 -1.833134 -2.137854 -2.435619 -2.723236 -2.977250 -3.009473 -3.185150 -3.373742 -3.559316 -3.688382 -3.639637 -3.693969 -3.476835 -1.991894 1.240230 0.6306550 5.9048809E-02 -0.4690119 -0.9534197 -1.377040 -1.754986 -2.113139 -2.441975 -2.738213 -2.994202 -3.089213 -3.272575 -3.448081 -3.626693 -3.726241 -3.680496 -3.708174 -3.458057 -1.991894 1.374270 0.7682779 0.1938067 -0.3387592 -0.8245193 -1.286598 -1.719239 -2.116112 -2.458714 -2.758269 -3.010198 -3.190041 -3.372267 -3.535003 -3.696928 -3.750966 -3.729832 -3.723241 -3.435874 -1.991894 1.376018 0.7957524 0.2315679 -0.2934197 -0.7904464 -1.268302 -1.721320 -2.130696 -2.475716 -2.792038 -3.061617 -3.281590 -3.468241 -3.624881 -3.769493 -3.800985 -3.781303 -3.737677 -3.409836 -1.991894 1.292330 0.7363469 0.1946927 -0.3234396 -0.8202513 -1.299352 -1.752149 -2.149762 -2.508582 -2.836646 -3.128134 -3.370874 -3.560513 -3.715136 -3.838527 -3.860196 -3.832182 -3.749778 -3.379568 -1.991894 1.141385 0.6166210 9.2993125E-02 -0.4084292 -0.8958734 -1.366535 -1.798794 -2.191522 -2.562750 -2.899611 -3.203112 -3.450058 -3.651977 -3.799880 -3.901103 -3.920589 -3.879512 -3.758317 -3.344711 -1.991894 0.9373705 0.4418541 -5.4770846E-02 -0.5365106 -1.007916 -1.453017 -1.867554 -2.266434 -2.635135 -2.982456 -3.283984 -3.536042 -3.742938 -3.880329 -3.963115 -3.979000 -3.920841 -3.761923 -3.306982 -1.991894 0.6875984 0.2258791 -0.2427939 -0.7010686 -1.141260 -1.564726 -1.972552 -2.362805 -2.736887 -3.080004 -3.374928 -3.632057 -3.826007 -3.955489 -4.024539 -4.033067 -3.954718 -3.759246 -3.266760 -1.991894 0.3964034 -2.6478026E-02 -0.4632093 -0.8868589 -1.303746 -1.711354 -2.107639 -2.494944 -2.856983 -3.183249 -3.483575 -3.729558 -3.907292 -4.021642 -4.081588 -4.080052 -3.979313 -3.748592 -3.223402 -1.991894 6.7579262E-02 -0.3124917 -0.7134305 -1.109017 -1.501128 -1.893847 -2.277832 -2.645718 -2.986017 -3.311953 -3.598712 -3.817734 -3.978685 -4.080517 -4.131493 -4.116049 -3.993579 -3.728158 -3.176283 -1.991894 -0.2957343 -0.6371267 -1.002844 -1.367134 -1.736024 -2.110055 -2.461550 -2.809580 -3.144638 -3.449111 -3.696877 -3.895520 -4.037804 -4.132670 -4.171582 -4.139958 -3.995963 -3.696570 -3.124837 -1.991894 -0.7009549 -0.9975575 -1.327660 -1.660451 -1.991612 -2.329538 -2.667363 -3.002879 -3.302545 -3.568149 -3.784594 -3.957325 -4.089678 -4.174700 -4.199621 -4.149125 -3.982992 -3.652315 -3.068540 -1.991894 -1.145202 -1.392818 -1.678829 -1.969234 -2.269062 -2.582994 -2.886689 -3.176906 -3.442077 -3.666138 -3.853863 -4.011284 -4.131660 -4.202107 -4.211063 -4.139561 -3.950102 -3.593496 -3.006601 -1.991894 -1.637183 -1.828340 -2.067276 -2.313417 -2.565532 -2.830878 -3.091356 -3.333206 -3.551761 -3.749791 -3.917066 -4.054947 -4.158014 -4.209688 -4.199271 -4.105343 -3.893182 -3.519732 -2.939194 -1.991894 -2.189085 -2.311176 -2.486868 -2.672470 -2.866941 -3.071795 -3.279323 -3.478450 -3.662076 -3.827945 -3.969299 -4.080256 -4.159806 -4.188765 -4.154326 -4.039018 -3.808600 -3.429043 -2.865612 -1.991894 -2.812361 -2.850276 -2.946275 -3.059125 -3.188282 -3.331516 -3.481385 -3.629524 -3.766061 -3.889427 -3.997066 -4.072293 -4.121664 -4.125439 -4.065726 -3.932798 -3.693366 -3.318632 -2.784587 -1.991894 -3.550805 -3.485729 -3.483690 -3.507625 -3.554890 -3.621197 -3.699804 -3.781011 -3.853984 -3.921077 -3.982105 -4.014096 -4.028102 -4.005620 -3.923411 -3.780245 -3.542692 -3.189642 -2.695078 -1.991894 -4.700948 -4.472172 -4.320408 -4.203146 -4.118421 -4.064520 -4.033076 -4.011338 -3.989600 -3.970139 -3.956470 -3.928455 -3.891584 -3.832905 -3.728909 -3.586533 -3.367752 -3.044386 -2.596226 -1.991894 -33.43137 -32.64234 -31.69816 -30.61488 -29.40769 -28.08959 -26.67175 -25.16341 -23.57243 -21.90539 -20.16790 -18.36479 -16.50024 -14.57795 -12.60116 -10.57278 -8.495420 -6.371429 -4.202934 -1.991894 0.2667059 -0.2128431 -0.7045342 -1.173731 -1.587425 -1.939972 -2.205684 -2.345844 -2.606952 -2.853239 -3.076994 -3.204508 -3.281554 -3.467091 -3.642710 -3.788512 -3.774515 -3.856369 -3.699852 -2.124210 1.135277 0.4532606 -0.1273985 -0.6951323 -1.193322 -1.645854 -1.935066 -2.226671 -2.532590 -2.836225 -3.108029 -3.166033 -3.321080 -3.517459 -3.711276 -3.857619 -3.800877 -3.872792 -3.688487 -2.124210 1.499043 0.8112341 0.1627192 -0.4204393 -0.9510088 -1.427988 -1.818282 -2.189870 -2.536660 -2.861626 -3.135504 -3.250078 -3.427051 -3.606538 -3.790103 -3.907702 -3.852394 -3.894339 -3.673932 -2.124210 1.644616 0.9632884 0.3240612 -0.2657731 -0.8100748 -1.298082 -1.752296 -2.179049 -2.562961 -2.896704 -3.159456 -3.354810 -3.542108 -3.708071 -3.874705 -3.941669 -3.914517 -3.918129 -3.655697 -2.124210 1.650640 1.000203 0.3752962 -0.2082468 -0.7456029 -1.253301 -1.738288 -2.194180 -2.594615 -2.928293 -3.217601 -3.449761 -3.651201 -3.809779 -3.961266 -4.000680 -3.980255 -3.941855 -3.633242 -2.124210 1.563890 0.9425876 0.3434477 -0.2238526 -0.7597995 -1.275198 -1.769579 -2.231304 -2.623446 -2.972802 -3.280831 -3.541563 -3.750540 -3.910424 -4.043463 -4.072031 -4.043899 -3.963712 -3.606133 -2.124210 1.405544 0.8194727 0.2448532 -0.3026683 -0.8323077 -1.342811 -1.835268 -2.274427 -2.668329 -3.034137 -3.357111 -3.630361 -3.846369 -4.009929 -4.122239 -4.145370 -4.102759 -3.982228 -3.573781 -2.124210 1.187144 0.6377714 9.3422748E-02 -0.4325599 -0.9469198 -1.446426 -1.911728 -2.335755 -2.743247 -3.111232 -3.444317 -3.718336 -3.943867 -4.103705 -4.199821 -4.216363 -4.154737 -3.996029 -3.537891 -2.124210 0.9202662 0.4094481 -0.1029548 -0.6032658 -1.097177 -1.567838 -2.009008 -2.435569 -2.833876 -3.211360 -3.541319 -3.816786 -4.043838 -4.191408 -4.273417 -4.281837 -4.199684 -4.003205 -3.499342 -2.124210 0.6112103 0.1440004 -0.3353829 -0.8091626 -1.267752 -1.712951 -2.143566 -2.559722 -2.959349 -3.324694 -3.647206 -3.926753 -4.137626 -4.272610 -4.339847 -4.338224 -4.236918 -4.002132 -3.457127 -2.124210 0.2643944 -0.1612435 -0.6039965 -1.037910 -1.470553 -1.894186 -2.313233 -2.722778 -3.103339 -3.452404 -3.774621 -4.035801 -4.226011 -4.342889 -4.399769 -4.384479 -4.263333 -3.990863 -3.410510 -2.124210 -0.1226201 -0.5015627 -0.9059465 -1.305094 -1.709950 -2.116129 -2.520786 -2.900506 -3.264195 -3.608859 -3.902341 -4.133388 -4.299858 -4.404291 -4.450495 -4.420157 -4.276886 -3.968019 -3.358957 -2.124210 -0.5509738 -0.8833038 -1.248514 -1.612792 -1.988267 -2.364022 -2.733624 -3.101380 -3.453864 -3.759072 -4.015084 -4.214325 -4.363609 -4.456142 -4.489598 -4.441421 -4.274420 -3.931406 -3.301795 -2.124210 -1.026231 -1.306112 -1.627073 -1.949857 -2.282377 -2.628454 -2.981942 -3.316278 -3.619623 -3.888199 -4.100318 -4.278557 -4.417779 -4.495516 -4.512552 -4.443820 -4.251110 -3.878500 -3.238286 -2.124210 -1.549336 -1.769439 -2.036254 -2.316626 -2.612212 -2.913103 -3.218468 -3.505506 -3.758707 -3.983670 -4.173697 -4.334320 -4.456712 -4.517186 -4.512786 -4.420776 -4.202238 -3.808086 -3.167495 -2.124210 -2.145571 -2.290748 -2.490054 -2.709302 -2.944016 -3.189791 -3.432279 -3.663624 -3.878615 -4.072865 -4.238656 -4.374351 -4.472444 -4.510179 -4.479906 -4.364040 -4.122507 -3.717300 -3.089679 -2.124210 -2.813470 -2.873335 -2.989576 -3.127560 -3.290747 -3.469290 -3.651742 -3.829857 -3.996695 -4.147635 -4.278602 -4.382161 -4.448310 -4.457304 -4.400580 -4.263585 -4.007023 -3.603130 -3.002936 -2.124210 -3.614092 -3.556583 -3.571372 -3.616472 -3.688880 -3.782094 -3.887992 -3.996267 -4.097875 -4.190616 -4.271109 -4.332548 -4.361266 -4.338515 -4.258738 -4.108470 -3.849221 -3.463449 -2.905898 -2.124210 -4.829698 -4.596440 -4.444401 -4.339082 -4.270918 -4.238123 -4.225534 -4.221737 -4.222793 -4.228003 -4.232546 -4.231549 -4.209544 -4.149844 -4.047536 -3.895823 -3.653938 -3.301703 -2.797034 -2.124210 -37.47786 -36.60915 -35.55754 -34.34384 -32.98705 -31.50338 -29.90618 -28.20658 -26.41373 -24.53530 -22.57779 -20.54672 -18.44693 -16.28260 -14.05746 -11.77482 -9.437626 -7.048552 -4.610014 -2.124210 0.2992614 -0.2940102 -0.7105388 -1.177732 -1.634743 -2.019489 -2.321452 -2.444405 -2.713496 -2.965820 -3.195710 -3.351661 -3.403401 -3.596936 -3.778239 -3.933106 -3.918518 -4.015550 -3.890533 -2.248313 1.332230 0.6120088 -3.3669952E-02 -0.6488884 -1.214728 -1.697291 -2.031541 -2.328421 -2.632542 -2.943818 -3.228317 -3.319407 -3.452891 -3.655262 -3.854897 -4.014237 -3.950163 -4.037524 -3.883778 -2.248313 1.756840 1.003377 0.2934310 -0.3739972 -0.9508207 -1.466654 -1.905454 -2.279975 -2.633337 -2.971642 -3.269763 -3.406277 -3.580016 -3.760069 -3.945056 -4.076483 -4.014130 -4.066619 -3.873694 -2.248313 1.916880 1.166676 0.4530160 -0.1961508 -0.7894219 -1.331565 -1.805293 -2.245317 -2.653108 -3.020921 -3.308166 -3.518208 -3.708507 -3.878617 -4.041180 -4.121333 -4.090600 -4.099183 -3.859795 -2.248313 1.925488 1.199975 0.5172183 -0.1201490 -0.7160990 -1.257638 -1.761544 -2.245791 -2.690223 -3.068512 -3.366625 -3.618564 -3.827104 -3.992224 -4.140121 -4.190701 -4.169674 -4.132460 -3.841506 -2.248313 1.833546 1.147946 0.4891163 -0.1305992 -0.7109311 -1.256466 -1.782746 -2.283339 -2.736997 -3.109745 -3.436002 -3.709522 -3.936795 -4.103884 -4.239127 -4.276186 -4.245801 -4.164066 -3.818202 -2.248313 1.666365 1.021217 0.3923194 -0.2017045 -0.7721295 -1.318713 -1.846887 -2.348772 -2.781685 -3.167258 -3.510350 -3.804046 -4.040077 -4.212483 -4.332358 -4.363734 -4.315822 -4.192721 -3.789247 -2.248313 1.435275 0.8311933 0.2381901 -0.3314608 -0.8864346 -1.423442 -1.945338 -2.416232 -2.843864 -3.245510 -3.598503 -3.904002 -4.140388 -4.317425 -4.422605 -4.446238 -4.379957 -4.216893 -3.756387 -2.248313 1.151520 0.5914899 3.5440795E-02 -0.5078576 -1.041083 -1.562228 -2.053032 -2.504636 -2.939606 -3.338896 -3.702187 -4.001754 -4.246212 -4.416692 -4.508600 -4.520758 -4.437359 -4.234579 -3.720740 -2.248313 0.8246875 0.3136550 -0.2073609 -0.7224334 -1.231493 -1.717610 -2.183597 -2.631912 -3.058424 -3.460659 -3.812590 -4.115003 -4.358375 -4.509299 -4.586045 -4.586726 -4.485575 -4.244070 -3.681268 -2.248313 0.4607612 -8.2785077E-03 -0.4921153 -0.9712657 -1.440241 -1.901578 -2.351378 -2.791922 -3.214734 -3.596947 -3.941093 -4.242728 -4.457721 -4.591984 -4.656165 -4.643398 -4.522676 -4.243249 -3.637053 -2.248313 4.9890779E-02 -0.3687048 -0.8086119 -1.245293 -1.685292 -2.123393 -2.562168 -2.991114 -3.383018 -3.753803 -4.091223 -4.359412 -4.552135 -4.663632 -4.717852 -4.689850 -4.547396 -4.230023 -3.587105 -2.248313 -0.4016054 -0.7678468 -1.164948 -1.565043 -1.973535 -2.390752 -2.801616 -3.196257 -3.580063 -3.938984 -4.227902 -4.465613 -4.628975 -4.727638 -4.769479 -4.722319 -4.556447 -4.201764 -3.530589 -2.248313 -0.9047242 -1.214925 -1.564523 -1.926325 -2.295479 -2.672921 -3.057921 -3.439024 -3.786618 -4.092592 -4.344527 -4.545375 -4.692743 -4.779906 -4.804789 -4.737264 -4.543737 -4.155306 -3.466487 -2.248313 -1.458576 -1.706843 -2.001066 -2.311328 -2.641639 -2.992646 -3.333872 -3.661510 -3.959334 -4.213435 -4.431190 -4.613994 -4.742908 -4.814590 -4.817368 -4.728192 -4.503550 -4.088696 -3.393684 -2.248313 -2.084154 -2.260624 -2.489368 -2.736140 -3.009388 -3.300166 -3.582047 -3.845673 -4.091662 -4.313431 -4.506402 -4.664097 -4.771569 -4.821089 -4.797228 -4.683171 -4.430008 -3.998460 -3.312357 -2.248313 -2.801335 -2.880855 -3.023921 -3.190087 -3.385087 -3.598425 -3.813684 -4.024035 -4.221971 -4.401793 -4.558560 -4.682308 -4.759489 -4.780130 -4.729116 -4.588749 -4.317147 -3.881083 -3.220749 -2.248313 -3.661483 -3.617940 -3.646381 -3.714988 -3.815424 -3.936902 -4.069588 -4.205556 -4.339139 -4.460397 -4.564443 -4.642059 -4.679694 -4.667141 -4.591156 -4.430877 -4.155840 -3.732949 -3.117048 -2.248313 -4.944994 -4.707774 -4.562686 -4.468984 -4.421588 -4.405912 -4.413491 -4.432600 -4.463367 -4.494930 -4.522791 -4.536177 -4.519636 -4.467900 -4.367420 -4.201488 -3.945341 -3.558655 -2.998705 -2.248313 -41.62963 -40.68000 -39.51798 -38.16915 -36.65767 -35.00276 -33.22034 -31.32333 -29.32231 -27.22604 -25.04190 -22.77620 -20.43438 -18.02117 -15.54101 -12.99714 -10.39286 -7.731661 -5.015991 -2.248313 0.3956833 -0.3618647 -0.9256624 -1.157639 -1.685436 -2.081901 -2.420992 -2.535285 -2.816187 -3.074742 -3.309085 -3.487130 -3.519093 -3.719741 -3.905765 -4.067956 -4.053120 -4.162188 -4.066399 -2.365163 1.526388 0.7207417 6.0848430E-02 -0.5862375 -1.202768 -1.749426 -2.122358 -2.425384 -2.738864 -3.050647 -3.340800 -3.466562 -3.581165 -3.786971 -3.992072 -4.160390 -4.091874 -4.189226 -4.064413 -2.365163 2.002593 1.190973 0.4298378 -0.2787769 -0.9442247 -1.506295 -1.979905 -2.391847 -2.738791 -3.081336 -3.389494 -3.561182 -3.731273 -3.908013 -4.094899 -4.233703 -4.169362 -4.225572 -4.059046 -2.365163 2.185897 1.372320 0.6076232 -0.1192024 -0.7694011 -1.355161 -1.879214 -2.329708 -2.745847 -3.130170 -3.447699 -3.679097 -3.872174 -4.041223 -4.205089 -4.289737 -4.260206 -4.266417 -4.049790 -2.365163 2.198819 1.406767 0.6603268 -3.5366584E-02 -0.6826229 -1.275416 -1.808221 -2.302387 -2.772690 -3.190812 -3.519720 -3.783847 -3.997936 -4.171004 -4.317678 -4.368287 -4.351673 -4.308680 -4.036047 -2.365163 2.102123 1.348386 0.6338294 -3.7098698E-02 -0.6707777 -1.255096 -1.801290 -2.329615 -2.824550 -3.248216 -3.586335 -3.879148 -4.115617 -4.295164 -4.428574 -4.467947 -4.439009 -4.350227 -4.017079 -2.365163 1.925002 1.220926 0.5379230 -0.1058829 -0.7197536 -1.298526 -1.858658 -2.395144 -2.891112 -3.302153 -3.667002 -3.972360 -4.226068 -4.408684 -4.535761 -4.567633 -4.521479 -4.389827 -3.991979 -2.365163 1.680853 1.022171 0.3805105 -0.2355105 -0.8280416 -1.401156 -1.958046 -2.487675 -2.953264 -3.375579 -3.751197 -4.076990 -4.331687 -4.519190 -4.636189 -4.658509 -4.597283 -4.425217 -3.962555 -2.365163 1.381210 0.7716032 0.1710782 -0.4162257 -0.9857529 -1.544770 -2.087973 -2.582301 -3.042925 -3.470048 -3.857367 -4.188528 -4.438605 -4.631418 -4.733388 -4.744347 -4.665453 -4.453936 -3.930403 -2.365163 1.035996 0.4806394 -8.2494974E-02 -0.6387431 -1.183877 -1.720842 -2.226538 -2.705396 -3.163359 -3.590610 -3.978754 -4.299519 -4.558040 -4.735628 -4.822388 -4.823283 -4.724310 -4.474491 -3.894112 -2.365163 0.6532786 0.1423148 -0.3776177 -0.8972248 -1.415411 -1.910309 -2.396406 -2.863014 -3.319011 -3.739463 -4.108036 -4.432473 -4.679903 -4.833752 -4.904477 -4.891369 -4.772841 -4.484741 -3.852389 -2.365163 0.2232920 -0.2334656 -0.7129789 -1.188657 -1.665058 -2.137106 -2.602950 -3.065104 -3.507773 -3.898688 -4.267031 -4.575902 -4.787965 -4.918368 -4.977841 -4.950233 -4.809043 -4.481859 -3.804146 -2.365163 -0.2533802 -0.6517150 -1.082751 -1.518401 -1.959894 -2.409352 -2.859992 -3.292889 -3.703629 -4.094194 -4.438240 -4.698140 -4.881002 -4.992584 -5.038594 -4.995316 -4.829348 -4.462306 -3.748344 -2.365163 -0.7784044 -1.120106 -1.500657 -1.892827 -2.302951 -2.718671 -3.131452 -3.543565 -3.941965 -4.285649 -4.579130 -4.798145 -4.954910 -5.055663 -5.083402 -5.022158 -4.827559 -4.422589 -3.683879 -2.365163 -1.361659 -1.639096 -1.963582 -2.304569 -2.667585 -3.050301 -3.442127 -3.806516 -4.148099 -4.439829 -4.681578 -4.875240 -5.016261 -5.102374 -5.107885 -5.023134 -4.798056 -4.359962 -3.609597 -2.365163 -2.018338 -2.219743 -2.477024 -2.761750 -3.067758 -3.397095 -3.724017 -4.027595 -4.305433 -4.554549 -4.769348 -4.940166 -5.059049 -5.122075 -5.100282 -4.987093 -4.732965 -4.270855 -3.524807 -2.365163 -2.778491 -2.878955 -3.047403 -3.248057 -3.476663 -3.723524 -3.973389 -4.217347 -4.450216 -4.658828 -4.839140 -4.978174 -5.065635 -5.095216 -5.042404 -4.900004 -4.623133 -4.151592 -3.429067 -2.365163 -3.696371 -3.665657 -3.715285 -3.805561 -3.934325 -4.086641 -4.248988 -4.414558 -4.581926 -4.733858 -4.861578 -4.955214 -5.001516 -4.992776 -4.908364 -4.743711 -4.457632 -3.996938 -3.319696 -2.365163 -5.052259 -4.808399 -4.669296 -4.588944 -4.563462 -4.571183 -4.597873 -4.645936 -4.708916 -4.771016 -4.819529 -4.845897 -4.839902 -4.789606 -4.674787 -4.502862 -4.232894 -3.812045 -3.193439 -2.365163 -45.88049 -44.84866 -43.57263 -42.08488 -40.41378 -38.58239 -36.60921 -34.50904 -32.29393 -29.97376 -27.55686 -25.05027 -22.46010 -19.79163 -17.04954 -14.23795 -11.36057 -8.420688 -5.421311 -2.365163 0.4946381 -0.3262431 -1.016964 -1.519854 -1.678252 -2.141448 -2.526530 -2.618439 -2.913993 -3.179142 -3.418311 -3.612982 -3.628866 -3.835397 -4.025853 -4.195188 -4.178693 -4.299279 -4.230482 -2.475562 1.736492 0.8565015 6.3181907E-02 -0.5507547 -1.152349 -1.754518 -2.201710 -2.515809 -2.843828 -3.158306 -3.451579 -3.607022 -3.707033 -3.912096 -4.121093 -4.299201 -4.224899 -4.332085 -4.233731 -2.475562 2.251670 1.357000 0.5578167 -0.1884100 -0.8873802 -1.542238 -2.050198 -2.486907 -2.858411 -3.193281 -3.504122 -3.707768 -3.878103 -4.050024 -4.239319 -4.384753 -4.316487 -4.376387 -4.233779 -2.475562 2.450248 1.574100 0.7580312 -1.4176847E-02 -0.7399666 -1.378869 -1.938281 -2.433953 -2.849282 -3.238807 -3.575251 -3.836828 -4.031959 -4.200601 -4.365679 -4.453086 -4.420334 -4.426136 -4.230051 -2.475562 2.469398 1.613967 0.8175613 5.2806433E-02 -0.6488932 -1.287177 -1.868819 -2.379452 -2.856970 -3.297243 -3.662555 -3.944445 -4.169140 -4.344341 -4.490923 -4.545337 -4.524337 -4.478394 -4.221638 -2.475562 2.369481 1.554217 0.7774518 5.2864667E-02 -0.6283234 -1.262438 -1.839984 -2.380240 -2.901592 -3.369083 -3.743252 -4.041491 -4.287030 -4.478218 -4.611311 -4.655865 -4.625092 -4.530895 -4.207763 -2.475562 2.181815 1.416558 0.6817229 -1.3937109E-02 -0.6738749 -1.291955 -1.874228 -2.439118 -2.975279 -3.438928 -3.815639 -4.139207 -4.402302 -4.597663 -4.728175 -4.766086 -4.719391 -4.581093 -4.187337 -2.475562 1.923427 1.210921 0.5204048 -0.1453488 -0.7768388 -1.382944 -1.971382 -2.537594 -3.061806 -3.505503 -3.907373 -4.242297 -4.516150 -4.712548 -4.843052 -4.871249 -4.805937 -4.626510 -4.161980 -2.475562 1.607234 0.9483495 0.3033318 -0.3278189 -0.9357117 -1.528804 -2.107630 -2.657477 -3.149012 -3.602498 -4.007316 -4.358763 -4.627386 -4.833519 -4.951569 -4.968946 -4.883278 -4.664938 -4.133731 -2.475562 1.246525 0.6426976 4.0204126E-02 -0.5569974 -1.139016 -1.712796 -2.269517 -2.780408 -3.270808 -3.718893 -4.135731 -4.481303 -4.751267 -4.954422 -5.055075 -5.055919 -4.949725 -4.694963 -4.100948 -2.475562 0.8455607 0.2939406 -0.2667812 -0.8249366 -1.380051 -1.926239 -2.439999 -2.943884 -3.420813 -3.875904 -4.280171 -4.611537 -4.885902 -5.060358 -5.146926 -5.133584 -5.006098 -4.713926 -4.062216 -2.475562 0.3965391 -9.7389676E-02 -0.6138057 -1.134974 -1.647021 -2.153692 -2.651386 -3.139491 -3.614043 -4.050722 -4.433717 -4.764101 -5.011487 -5.160018 -5.226087 -5.200216 -5.051812 -4.719423 -4.016218 -2.475562 -0.1027229 -0.5358983 -1.002698 -1.472996 -1.948056 -2.427886 -2.910478 -3.387410 -3.828870 -4.245321 -4.621378 -4.911837 -5.126225 -5.244297 -5.294618 -5.252936 -5.082229 -4.708488 -3.961721 -2.475562 -0.6512012 -1.022368 -1.434901 -1.859817 -2.302068 -2.757665 -3.206479 -3.647432 -4.076526 -4.475404 -4.792413 -5.039891 -5.213383 -5.315594 -5.349235 -5.289017 -5.091052 -4.677292 -3.897432 -2.475562 -1.262988 -1.567775 -1.919991 -2.297571 -2.693204 -3.106359 -3.530471 -3.950954 -4.324769 -4.663332 -4.929513 -5.135592 -5.286150 -5.371554 -5.384421 -5.300563 -5.071370 -4.622357 -3.822140 -2.475562 -1.950954 -2.174809 -2.458017 -2.775757 -3.125527 -3.488469 -3.855494 -4.206561 -4.520490 -4.797273 -5.030325 -5.214304 -5.342810 -5.403471 -5.388615 -5.276338 -5.014015 -4.537885 -3.734155 -2.475562 -2.750954 -2.868227 -3.063413 -3.297853 -3.566306 -3.847985 -4.130191 -4.410170 -4.677407 -4.914982 -5.111362 -5.263196 -5.361465 -5.389945 -5.342216 -5.199033 -4.908214 -4.418589 -3.633787 -2.475562 -3.717382 -3.698779 -3.770230 -3.889728 -4.048966 -4.231738 -4.424232 -4.626841 -4.824901 -5.005374 -5.150247 -5.252679 -5.308134 -5.298229 -5.215467 -5.045631 -4.740588 -4.257455 -3.517830 -2.475562 -5.139886 -4.898439 -4.771121 -4.707629 -4.702658 -4.733490 -4.789754 -4.872842 -4.963464 -5.049009 -5.111525 -5.144477 -5.147850 -5.092178 -4.978693 -4.794106 -4.504373 -4.061584 -3.383182 -2.475562 -50.22493 -49.10967 -47.71679 -46.08607 -44.25046 -42.23758 -40.06838 -37.75964 -35.32486 -32.77512 -30.11991 -27.36634 -24.52190 -21.59220 -18.58240 -15.49705 -12.34047 -9.115559 -5.826340 -2.475562 0.5930040 -0.2934325 -1.040147 -1.602540 -2.120103 -2.187432 -2.608436 -2.686616 -2.999860 -3.277365 -3.524760 -3.730925 -3.733016 -3.945360 -4.139202 -4.315031 -4.296829 -4.427438 -4.381976 -2.580184 1.943362 0.9951471 0.1412868 -0.6124804 -1.190180 -1.751097 -2.251709 -2.606581 -2.943661 -3.266652 -3.561624 -3.742829 -3.827446 -4.032888 -4.240484 -4.430867 -4.350984 -4.466347 -4.390327 -2.580184 2.498831 1.542001 0.6540619 -0.1206911 -0.8364743 -1.517617 -2.124088 -2.581660 -2.973428 -3.311108 -3.620018 -3.843962 -4.021634 -4.190586 -4.369887 -4.529079 -4.456140 -4.517972 -4.395588 -2.580184 2.714279 1.771307 0.8976247 8.7242715E-02 -0.6745636 -1.392618 -1.996434 -2.521399 -2.972257 -3.351403 -3.697852 -3.982409 -4.190932 -4.358405 -4.510654 -4.610268 -4.572526 -4.577477 -4.397038 -2.580184 2.738082 1.816223 0.9709958 0.1586920 -0.6076278 -1.299084 -1.917830 -2.476848 -2.952636 -3.402261 -3.788521 -4.101936 -4.334147 -4.510953 -4.652494 -4.713816 -4.690518 -4.640421 -4.393939 -2.580184 2.633556 1.758281 0.9296300 0.1437357 -0.5875410 -1.265844 -1.891395 -2.449319 -2.979197 -3.471980 -3.886385 -4.198164 -4.456217 -4.649579 -4.785053 -4.837246 -4.803504 -4.702764 -4.385371 -2.580184 2.436500 1.613937 0.8224390 7.4297182E-02 -0.6305825 -1.294838 -1.905032 -2.487335 -3.048147 -3.559891 -3.969234 -4.298456 -4.571820 -4.779083 -4.916262 -4.958990 -4.908435 -4.761768 -4.370466 -2.580184 2.163535 1.396889 0.6571632 -5.6180641E-02 -0.7339821 -1.374051 -1.986838 -2.583766 -3.150786 -3.643263 -4.052782 -4.405325 -4.692373 -4.900930 -5.042271 -5.073487 -5.004543 -4.816614 -4.350510 -2.580184 1.830647 1.125886 0.4327958 -0.2425493 -0.8898427 -1.515553 -2.124111 -2.716720 -3.259934 -3.730628 -4.162295 -4.522471 -4.814926 -5.026342 -5.162624 -5.180558 -5.091742 -4.865357 -4.327693 -2.580184 1.459122 0.8046480 0.1606296 -0.4791036 -1.098728 -1.703114 -2.298785 -2.863699 -3.374417 -3.859939 -4.281538 -4.651982 -4.937209 -5.153160 -5.271504 -5.277740 -5.170003 -4.905902 -4.300263 -2.580184 1.031754 0.4400440 -0.1584173 -0.7563185 -1.345510 -1.929038 -2.491092 -3.019793 -3.533702 -4.004730 -4.431261 -4.787106 -5.076688 -5.274762 -5.373459 -5.362782 -5.237525 -4.936078 -4.266724 -2.580184 0.5631170 3.3843316E-02 -0.5177490 -1.075042 -1.631655 -2.171967 -2.702101 -3.220720 -3.722440 -4.190962 -4.594856 -4.944180 -5.224818 -5.386498 -5.461920 -5.437956 -5.292807 -4.952987 -4.225227 -2.580184 4.6487752E-02 -0.4215657 -0.9259077 -1.430202 -1.940194 -2.450745 -2.960521 -3.471752 -3.961082 -4.395458 -4.792101 -5.122299 -5.352141 -5.482616 -5.539427 -5.499380 -5.333621 -4.952070 -4.174121 -2.580184 -0.5242237 -0.9258026 -1.368715 -1.827264 -2.302043 -2.787135 -3.281268 -3.754609 -4.211450 -4.641397 -4.999783 -5.271577 -5.458472 -5.561419 -5.603757 -5.545492 -5.352494 -4.928852 -4.111707 -2.580184 -1.163006 -1.493997 -1.873393 -2.284352 -2.719389 -3.163421 -3.617993 -4.073603 -4.502042 -4.867794 -5.163702 -5.383267 -5.541582 -5.627316 -5.650185 -5.569048 -5.341911 -4.879798 -4.036667 -2.580184 -1.880825 -2.126747 -2.437450 -2.785647 -3.169207 -3.580063 -3.982056 -4.377366 -4.734624 -5.035884 -5.279715 -5.471086 -5.607060 -5.672004 -5.667891 -5.556573 -5.293516 -4.799383 -3.946699 -2.580184 -2.719409 -2.854125 -3.072560 -3.341288 -3.650172 -3.973972 -4.293354 -4.612904 -4.908433 -5.167507 -5.375826 -5.534035 -5.640975 -5.674054 -5.635776 -5.489503 -5.195584 -4.681413 -3.842136 -2.580184 -3.730037 -3.721808 -3.817873 -3.968174 -4.160782 -4.375793 -4.606130 -4.845953 -5.073800 -5.275764 -5.432359 -5.538835 -5.604032 -5.596001 -5.519914 -5.342085 -5.030364 -4.516703 -3.719579 -2.580184 -5.218355 -4.977730 -4.866283 -4.824267 -4.841131 -4.898417 -4.985469 -5.100934 -5.219056 -5.329284 -5.402657 -5.438344 -5.443446 -5.393202 -5.283133 -5.084263 -4.783802 -4.309786 -3.575520 -2.580184 -54.65804 -53.45810 -51.94537 -50.16724 -48.16318 -45.96407 -43.59392 -41.07148 -38.41179 -35.62711 -32.72766 -29.72209 -26.61781 -23.42127 -20.13812 -16.77333 -13.33136 -9.816176 -6.231373 -2.580184 0.6873940 -0.2641063 -1.070569 -1.649905 -2.202705 -2.658675 -2.598196 -2.763449 -3.098882 -3.368733 -3.626121 -3.842266 -3.832551 -4.050407 -4.247586 -4.428078 -4.406727 -4.549118 -4.523188 -2.679603 2.150855 1.126536 0.2055962 -0.5921262 -1.300151 -1.807808 -2.265904 -2.682397 -3.036044 -3.369261 -3.672401 -3.874377 -3.944335 -4.150742 -4.356955 -4.556264 -4.467655 -4.593379 -4.536241 -2.679603 2.741355 1.713550 0.7653920 -9.0897925E-02 -0.8161757 -1.499017 -2.126002 -2.665596 -3.075129 -3.430003 -3.737662 -3.974063 -4.160655 -4.328772 -4.495593 -4.666631 -4.584685 -4.653394 -4.546095 -2.679603 2.978878 1.967242 1.021480 0.1755021 -0.6010154 -1.363221 -2.050437 -2.602536 -3.079392 -3.472583 -3.817897 -4.117220 -4.347074 -4.510053 -4.652239 -4.762184 -4.716965 -4.721878 -4.552159 -2.679603 3.010043 2.013699 1.115185 0.2665132 -0.5374317 -1.306043 -1.965231 -2.554727 -3.068574 -3.509060 -3.907246 -4.246825 -4.490433 -4.671135 -4.805705 -4.876445 -4.849927 -4.793890 -4.553933 -2.679603 2.896169 1.957862 1.078888 0.2472139 -0.5465263 -1.271961 -1.931689 -2.538867 -3.065332 -3.570850 -4.009827 -4.354483 -4.615578 -4.819108 -4.954237 -5.009330 -4.975409 -4.866097 -4.550102 -2.679603 2.686309 1.808313 0.9697338 0.1597974 -0.5902625 -1.294612 -1.952286 -2.547909 -3.121646 -3.659178 -4.111780 -4.452028 -4.737134 -4.958289 -5.092079 -5.140764 -5.091961 -4.936748 -4.539539 -2.679603 2.401117 1.579602 0.7901245 2.9123507E-02 -0.6917468 -1.376283 -2.011531 -2.631247 -3.224820 -3.767936 -4.198243 -4.563317 -4.858168 -5.089149 -5.225278 -5.265805 -5.199358 -5.002812 -4.523746 -2.679603 2.052230 1.300635 0.5591286 -0.1604655 -0.8491617 -1.505517 -2.142823 -2.765717 -3.359358 -3.865079 -4.301803 -4.678158 -4.984267 -5.212617 -5.354168 -5.384199 -5.296671 -5.061862 -4.505787 -2.679603 1.662966 0.9653364 0.2775706 -0.4030836 -1.058781 -1.696255 -2.320724 -2.934365 -3.487291 -3.980879 -4.425248 -4.815291 -5.116642 -5.342458 -5.472721 -5.491159 -5.382505 -5.111961 -4.483272 -2.679603 1.217740 0.5878272 -5.4376982E-02 -0.6905178 -1.311948 -1.927464 -2.531920 -3.102561 -3.639341 -4.133847 -4.580398 -4.964020 -5.255677 -5.476499 -5.585754 -5.586343 -5.459216 -5.150793 -4.453993 -2.679603 0.7298675 0.1645405 -0.4267190 -1.017689 -1.607154 -2.194302 -2.752814 -3.307133 -3.831825 -4.327376 -4.761329 -5.119494 -5.411335 -5.598998 -5.686483 -5.671721 -5.524314 -5.175937 -4.416406 -2.679603 0.1940123 -0.3080817 -0.8449325 -1.389553 -1.933967 -2.476250 -3.017234 -3.556468 -4.076164 -4.544987 -4.954311 -5.309073 -5.558221 -5.712205 -5.773542 -5.744009 -5.573925 -5.183327 -4.368741 -2.679603 -0.3989661 -0.8314319 -1.305256 -1.796552 -2.302995 -2.817401 -3.342525 -3.867385 -4.346346 -4.794501 -5.189229 -5.482988 -5.685454 -5.803935 -5.848456 -5.801095 -5.602340 -5.167715 -4.308985 -2.679603 -1.062552 -1.416547 -1.826919 -2.267468 -2.738029 -3.221528 -3.706974 -4.196147 -4.665327 -5.062135 -5.381511 -5.622407 -5.782740 -5.882807 -5.907229 -5.835389 -5.603085 -5.124266 -4.235192 -2.679603 -1.805691 -2.078284 -2.416222 -2.794141 -3.210258 -3.657507 -4.111152 -4.545799 -4.945975 -5.268322 -5.520848 -5.722718 -5.864593 -5.942461 -5.939130 -5.833273 -5.565075 -5.045906 -4.144870 -2.679603 -2.674518 -2.835412 -3.080516 -3.379378 -3.728602 -4.096057 -4.460375 -4.814375 -5.137908 -5.416960 -5.633435 -5.802712 -5.914705 -5.962911 -5.923069 -5.775413 -5.472500 -4.926121 -4.037846 -2.679603 -3.738288 -3.741169 -3.857530 -4.039375 -4.266442 -4.519277 -4.787133 -5.061326 -5.318731 -5.539375 -5.707388 -5.831542 -5.896847 -5.903278 -5.821132 -5.633255 -5.306158 -4.755589 -3.912438 -2.679603 -5.289793 -5.051144 -4.950267 -4.937537 -4.981881 -5.066030 -5.183750 -5.326197 -5.476222 -5.599716 -5.689331 -5.744777 -5.753600 -5.709875 -5.587776 -5.373506 -5.048689 -4.538109 -3.763719 -2.679603 -59.17545 -57.88960 -56.25412 -54.32507 -52.14806 -49.75821 -47.18238 -44.44139 -41.55181 -38.52712 -35.37853 -32.11551 -28.74615 -25.27748 -21.71565 -18.06608 -14.33359 -10.52250 -6.636673 -2.679603 0.7789056 -0.2471925 -1.097904 -1.694968 -2.272497 -2.757273 -3.105866 -2.698251 -3.181229 -3.469380 -3.718970 -3.946611 -3.928154 -4.150065 -4.351816 -4.535633 -4.511069 -4.663566 -4.657330 -2.774314 2.349775 1.247710 0.2754439 -0.5709050 -1.317865 -1.941256 -2.352509 -2.720558 -3.130657 -3.456907 -3.778908 -4.001881 -4.058055 -4.264307 -4.474312 -4.674957 -4.578135 -4.714165 -4.675933 -2.774314 2.984074 1.885846 0.8762746 -3.0906251E-02 -0.8405380 -1.486287 -2.149307 -2.720201 -3.177679 -3.540246 -3.855345 -4.103834 -4.293653 -4.464438 -4.629292 -4.796319 -4.709642 -4.783440 -4.691577 -2.774314 3.244364 2.156750 1.153198 0.2454840 -0.5525277 -1.319230 -2.055440 -2.680249 -3.179751 -3.597463 -3.937483 -4.247427 -4.489677 -4.659111 -4.798489 -4.904108 -4.859013 -4.861714 -4.703685 -2.774314 3.279326 2.210027 1.247632 0.3651006 -0.4699893 -1.273574 -2.009986 -2.627461 -3.171100 -3.624118 -4.022614 -4.377417 -4.641702 -4.832645 -4.964231 -5.029229 -5.005514 -4.944044 -4.711418 -2.774314 3.155483 2.153354 1.226466 0.3508753 -0.4821004 -1.277974 -1.973216 -2.607563 -3.170696 -3.668282 -4.123184 -4.498982 -4.770638 -4.985494 -5.119456 -5.175363 -5.142323 -5.025970 -4.713605 -2.774314 2.933882 1.999492 1.112188 0.2587338 -0.5522137 -1.297956 -1.987529 -2.628038 -3.200718 -3.750785 -4.235516 -4.606388 -4.895993 -5.124627 -5.266194 -5.318520 -5.269677 -5.105233 -4.708638 -2.774314 2.634001 1.761861 0.9244062 0.1129002 -0.6540779 -1.375096 -2.053604 -2.684316 -3.298195 -3.864124 -4.339400 -4.710300 -5.017709 -5.256973 -5.404086 -5.453176 -5.386194 -5.179665 -4.697931 -2.774314 2.268852 1.465540 0.6852180 -8.3262451E-02 -0.8102809 -1.503418 -2.165281 -2.815400 -3.436215 -3.986492 -4.438254 -4.832668 -5.146860 -5.389225 -5.539301 -5.580853 -5.492298 -5.246633 -4.685063 -2.774314 1.860671 1.123677 0.3910851 -0.3309630 -1.021585 -1.689072 -2.344754 -2.988879 -3.590344 -4.104917 -4.569197 -4.962537 -5.287179 -5.521399 -5.671417 -5.698818 -5.586211 -5.304575 -4.667640 -2.774314 1.405804 0.7333053 4.6977744E-02 -0.6253573 -1.280097 -1.925766 -2.566111 -3.185368 -3.744945 -4.266395 -4.719229 -5.119433 -5.428395 -5.662234 -5.794091 -5.803412 -5.667802 -5.351166 -4.643223 -2.774314 0.8953694 0.2924628 -0.3362860 -0.9602483 -1.583405 -2.203534 -2.811553 -3.389689 -3.948345 -4.451939 -4.907380 -5.285411 -5.587523 -5.803519 -5.907763 -5.896971 -5.738040 -5.384301 -4.609463 -2.774314 0.3390115 -0.1956189 -0.7647355 -1.343519 -1.931156 -2.503120 -3.078813 -3.645977 -4.191217 -4.686858 -5.112565 -5.478425 -5.758757 -5.934192 -6.003777 -5.976152 -5.796107 -5.400605 -4.564294 -2.774314 -0.2746084 -0.7378220 -1.244304 -1.767738 -2.306075 -2.850678 -3.408483 -3.965770 -4.481693 -4.942546 -5.354323 -5.681612 -5.909636 -6.043511 -6.087985 -6.039570 -5.833667 -5.394260 -4.505841 -2.774314 -0.9611900 -1.339795 -1.779385 -2.251040 -2.752142 -3.274440 -3.800874 -4.318851 -4.812157 -5.249059 -5.586167 -5.848448 -6.027319 -6.136010 -6.157419 -6.080183 -5.842725 -5.359574 -4.431959 -2.774314 -1.729420 -2.025245 -2.393068 -2.801652 -3.250792 -3.731510 -4.231010 -4.708660 -5.136692 -5.491251 -5.760581 -5.970634 -6.123581 -6.208761 -6.200461 -6.087109 -5.813060 -5.288390 -4.340583 -2.774314 -2.625632 -2.809669 -3.084751 -3.416440 -3.800663 -4.213660 -4.624760 -5.014116 -5.363061 -5.654710 -5.890846 -6.069057 -6.191383 -6.241448 -6.194706 -6.039960 -5.728117 -5.172154 -4.230059 -2.774314 -3.739363 -3.756931 -3.894266 -4.107810 -4.373722 -4.664769 -4.970648 -5.275441 -5.559265 -5.793518 -5.984100 -6.115767 -6.192315 -6.195249 -6.101383 -5.905280 -5.564535 -5.000159 -4.099537 -2.774314 -5.352550 -5.115551 -5.028383 -5.041916 -5.119966 -5.235391 -5.386783 -5.564415 -5.732391 -5.873357 -5.981356 -6.048565 -6.064714 -6.010855 -5.870151 -5.643288 -5.298604 -4.772388 -3.943689 -2.774314 -63.77322 -62.40026 -60.63921 -58.55555 -56.20155 -53.61666 -50.83067 -47.86650 -44.74229 -41.47278 -38.07018 -34.54478 -30.90538 -27.15958 -23.31404 -19.37463 -15.34655 -11.23444 -7.042445 -2.774314 0.8625646 -0.2322620 -1.122413 -1.746998 -2.334268 -2.833689 -3.245745 -2.829486 -3.250762 -3.560398 -3.813343 -4.046554 -4.019320 -4.244506 -4.450768 -4.638147 -4.611035 -4.770289 -4.782035 -2.864743 2.544971 1.374141 0.3377959 -0.5572605 -1.337324 -2.011322 -2.479749 -2.757169 -3.204274 -3.555593 -3.879523 -4.127805 -4.166499 -4.369941 -4.583765 -4.789037 -4.684383 -4.825650 -4.805604 -2.864743 3.225832 2.049913 0.9778777 1.5365087E-02 -0.8333126 -1.560119 -2.127155 -2.764212 -3.272215 -3.642113 -3.972918 -4.229960 -4.420960 -4.590039 -4.755283 -4.921929 -4.834479 -4.902128 -4.826611 -2.864743 3.516547 2.334568 1.274997 0.3239353 -0.5558740 -1.283818 -2.056939 -2.728841 -3.274088 -3.705189 -4.061462 -4.368669 -4.624278 -4.802017 -4.939536 -5.044852 -4.998230 -4.989103 -4.844521 -2.864743 3.557174 2.401443 1.380792 0.4345696 -0.4090268 -1.241930 -2.016636 -2.698110 -3.262035 -3.748822 -4.137167 -4.498652 -4.788834 -4.981081 -5.117714 -5.182272 -5.156251 -5.080116 -4.858084 -2.864743 3.410720 2.346311 1.365292 0.4510773 -0.4199133 -1.249964 -2.010836 -2.676373 -3.271407 -3.772236 -4.231285 -4.626095 -4.925822 -5.139177 -5.284930 -5.335697 -5.303395 -5.171272 -4.866065 -2.864743 3.176047 2.186687 1.252866 0.3551970 -0.5001124 -1.298118 -2.025270 -2.696573 -3.292837 -3.839640 -4.342822 -4.746594 -5.045007 -5.280604 -5.441053 -5.487520 -5.437664 -5.260084 -4.867011 -2.864743 2.860376 1.939772 1.055707 0.1993252 -0.6181263 -1.376886 -2.089657 -2.751541 -3.369663 -3.951391 -4.466609 -4.854693 -5.173164 -5.418735 -5.586939 -5.632113 -5.559579 -5.343989 -4.861822 -2.864743 2.488362 1.633000 0.8055331 -6.3449140E-03 -0.7756627 -1.505401 -2.198798 -2.864954 -3.506844 -4.094469 -4.578131 -4.974748 -5.299878 -5.559286 -5.727539 -5.764219 -5.671477 -5.421089 -4.854531 -2.864743 2.060499 1.276324 0.4998370 -0.2610582 -0.9882977 -1.686531 -2.370805 -3.041898 -3.680103 -4.236185 -4.701028 -5.107978 -5.444988 -5.696057 -5.865148 -5.889542 -5.771761 -5.489238 -4.842334 -2.864743 1.582413 0.8706353 0.1450465 -0.5615963 -1.249351 -1.927570 -2.597279 -3.258305 -3.856611 -4.385190 -4.858448 -5.268054 -5.597721 -5.841395 -5.996026 -6.000547 -5.863553 -5.544362 -4.822835 -2.864743 1.055117 0.4145544 -0.2494093 -0.9068778 -1.562006 -2.211904 -2.860787 -3.477243 -4.054974 -4.578250 -5.050315 -5.446836 -5.761839 -6.000842 -6.115820 -6.098785 -5.943021 -5.584720 -4.793592 -2.864743 0.4817473 -8.5429162E-02 -0.6874758 -1.301033 -1.919374 -2.534958 -3.140714 -3.742125 -4.301194 -4.819563 -5.268635 -5.642029 -5.954594 -6.145333 -6.220704 -6.185395 -6.008374 -5.607983 -4.752334 -2.864743 -0.1523597 -0.6436693 -1.183988 -1.741180 -2.310179 -2.888344 -3.477791 -4.062891 -4.613343 -5.091060 -5.517523 -5.875703 -6.127252 -6.270799 -6.311164 -6.256619 -6.053292 -5.608920 -4.696315 -2.864743 -0.8590512 -1.265854 -1.732726 -2.234407 -2.765805 -3.320757 -3.897033 -4.436896 -4.951992 -5.411817 -5.786944 -6.073438 -6.267013 -6.369280 -6.387532 -6.306730 -6.069381 -5.580894 -4.623562 -2.864743 -1.652567 -1.971226 -2.366287 -2.808872 -3.291394 -3.807777 -4.340842 -4.865782 -5.318699 -5.701483 -5.996749 -6.215534 -6.374485 -6.451968 -6.439299 -6.324703 -6.047323 -5.514565 -4.531681 -2.864743 -2.575451 -2.781833 -3.082198 -3.452119 -3.875798 -4.328491 -4.790946 -5.215050 -5.583259 -5.892615 -6.143666 -6.329376 -6.456680 -6.500121 -6.447141 -6.290488 -5.970389 -5.400774 -4.417278 -2.864743 -3.731922 -3.765799 -3.928197 -4.173619 -4.478052 -4.811497 -5.156426 -5.497266 -5.795137 -6.050729 -6.252786 -6.393342 -6.472330 -6.470453 -6.369288 -6.166324 -5.811606 -5.227577 -4.280267 -2.864743 -5.409108 -5.172362 -5.099545 -5.138669 -5.249609 -5.405621 -5.595749 -5.798508 -5.985423 -6.149101 -6.267306 -6.336278 -6.348214 -6.293932 -6.146776 -5.905793 -5.541643 -4.990352 -4.115504 -2.864743 -68.44775 -66.98673 -65.09707 -62.85530 -60.32043 -57.53639 -54.53596 -51.34419 -47.98087 -44.46197 -40.80072 -37.00827 -33.09410 -29.06643 -24.93242 -20.69838 -16.36989 -11.95190 -7.448840 -2.864743 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -1.367644 -1.388117 -1.404856 -1.417868 -1.426264 -1.429193 -1.437357 -1.440946 -1.439267 -1.431553 -1.416318 -1.393715 -1.361832 -1.322295 -1.277093 -1.218745 -1.143729 -1.046420 -0.9134871 -0.6128114 -1.376221 -1.394349 -1.409486 -1.420302 -1.425954 -1.427052 -1.433828 -1.435955 -1.432783 -1.422950 -1.406760 -1.382750 -1.349607 -1.309380 -1.264112 -1.206118 -1.131952 -1.036372 -0.9062846 -0.6128114 -1.384316 -1.400605 -1.413363 -1.421237 -1.424747 -1.424479 -1.429736 -1.430253 -1.425483 -1.413988 -1.396282 -1.370882 -1.336529 -1.295910 -1.250593 -1.193079 -1.119837 -1.026164 -0.8989167 -0.6128114 -1.392341 -1.406016 -1.415591 -1.421152 -1.423040 -1.421361 -1.424876 -1.423693 -1.416543 -1.404046 -1.384802 -1.358038 -1.322424 -1.281852 -1.236596 -1.179600 -1.107369 -1.015605 -0.8913783 -0.6128114 -1.399365 -1.409521 -1.416782 -1.420445 -1.420822 -1.417451 -1.419083 -1.415399 -1.407140 -1.393008 -1.372241 -1.344141 -1.307928 -1.267177 -1.222041 -1.165529 -1.094526 -1.004768 -0.8836416 -0.6128114 -1.404176 -1.411944 -1.417165 -1.419251 -1.417760 -1.412542 -1.412211 -1.406553 -1.396520 -1.380757 -1.358500 -1.328866 -1.292712 -1.251705 -1.206933 -1.150938 -1.081314 -0.9936329 -0.8756960 -0.6128114 -1.408066 -1.413457 -1.416975 -1.417131 -1.413620 -1.406419 -1.403229 -1.396343 -1.384546 -1.367182 -1.342934 -1.313211 -1.276738 -1.235676 -1.191226 -1.135824 -1.067733 -0.9821798 -0.8675211 -0.6128114 -1.410895 -1.414289 -1.415663 -1.413731 -1.407406 -1.398031 -1.393449 -1.384622 -1.371089 -1.352153 -1.326898 -1.296682 -1.259702 -1.218870 -1.174655 -1.120188 -1.053648 -0.9703817 -0.8590932 -0.6128114 -1.412839 -1.413807 -1.412870 -1.407988 -1.400137 -1.388627 -1.381944 -1.371240 -1.355985 -1.335090 -1.309860 -1.279224 -1.242059 -1.201372 -1.157305 -1.103950 -1.039348 -0.9582122 -0.8503759 -0.6128114 -1.413238 -1.410992 -1.407544 -1.400980 -1.390906 -1.377336 -1.368568 -1.356004 -1.338542 -1.317622 -1.291774 -1.260378 -1.223413 -1.182750 -1.139232 -1.087192 -1.024270 -0.9456335 -0.8413307 -0.6128114 -1.411024 -1.406729 -1.400738 -1.391817 -1.379560 -1.363979 -1.352242 -1.338211 -1.320679 -1.299007 -1.272076 -1.240727 -1.203968 -1.163068 -1.120469 -1.069866 -1.008645 -0.9326025 -0.8319038 -0.6128114 -1.407054 -1.400100 -1.391637 -1.380417 -1.365939 -1.347594 -1.335267 -1.320019 -1.301598 -1.278590 -1.251530 -1.220190 -1.184650 -1.144430 -1.101028 -1.052146 -0.9924292 -0.9191414 -0.8220180 -0.6128114 -1.400593 -1.391113 -1.380142 -1.365860 -1.349518 -1.330638 -1.317052 -1.299855 -1.280587 -1.257365 -1.230062 -1.199208 -1.164331 -1.125247 -1.081213 -1.033203 -0.9755746 -0.9050112 -0.8115583 -0.6128114 -1.390876 -1.379082 -1.366011 -1.350762 -1.332763 -1.311722 -1.296903 -1.279011 -1.258869 -1.235153 -1.207844 -1.177438 -1.143471 -1.105268 -1.062380 -1.013511 -0.9580139 -0.8902234 -0.8003964 -0.6128114 -1.380872 -1.367109 -1.351284 -1.334149 -1.314064 -1.292377 -1.276330 -1.257114 -1.235700 -1.211604 -1.184742 -1.154932 -1.122172 -1.084754 -1.042276 -0.9945384 -0.9400370 -0.8746327 -0.7877532 -0.6128114 -1.370758 -1.354513 -1.337218 -1.317970 -1.297400 -1.276108 -1.253207 -1.233582 -1.211754 -1.188090 -1.161734 -1.132906 -1.099430 -1.062400 -1.021239 -0.9753776 -0.9220819 -0.8582634 -0.7732536 -0.6128114 -1.362758 -1.344902 -1.326201 -1.306845 -1.285830 -1.264514 -1.242164 -1.217581 -1.192813 -1.165445 -1.138259 -1.108401 -1.075634 -1.039414 -0.9996524 -0.9542108 -0.9018382 -0.8391685 -0.7568446 -0.6128114 -1.364605 -1.342796 -1.323657 -1.303054 -1.281235 -1.258420 -1.234319 -1.208762 -1.181911 -1.153372 -1.123034 -1.091780 -1.056567 -1.018973 -0.9774564 -0.9311031 -0.8776867 -0.8123467 -0.7374582 -0.6128114 -1.409878 -1.384936 -1.359222 -1.333888 -1.306070 -1.277290 -1.247451 -1.216917 -1.184332 -1.150301 -1.114366 -1.076127 -1.034955 -0.9900607 -0.9408757 -0.8889205 -0.8344935 -0.7765499 -0.7123347 -0.6128114 -1.268719 -1.239622 -1.209886 -1.179519 -1.148526 -1.116913 -1.084932 -1.051856 -1.018419 -0.9843846 -0.9497650 -0.9145661 -0.8787942 -0.8424551 -0.8055548 -0.7680979 -0.7300811 -0.6915240 -0.6524323 -0.6128114 -1.420013 -1.484451 -1.541524 -1.614283 -1.680460 -1.741548 -1.794541 -1.838246 -1.868719 -1.899074 -1.932129 -1.953586 -1.959552 -1.946757 -1.908300 -1.855363 -1.775557 -1.650143 -1.455184 -1.004622 -1.433561 -1.494580 -1.552591 -1.625507 -1.693412 -1.754070 -1.805115 -1.845452 -1.870532 -1.900066 -1.931642 -1.950074 -1.953561 -1.937044 -1.894588 -1.839951 -1.759566 -1.635102 -1.443787 -1.004622 -1.450666 -1.511218 -1.571426 -1.643406 -1.710055 -1.767291 -1.815554 -1.851338 -1.873245 -1.901710 -1.930986 -1.946343 -1.945916 -1.925726 -1.879581 -1.823699 -1.742870 -1.619563 -1.432117 -1.004622 -1.474589 -1.534627 -1.594244 -1.665290 -1.727096 -1.781313 -1.825179 -1.855469 -1.877022 -1.903493 -1.928862 -1.941411 -1.937043 -1.912685 -1.863630 -1.806538 -1.725430 -1.603494 -1.420162 -1.004622 -1.505347 -1.564694 -1.622595 -1.687548 -1.745391 -1.795026 -1.832564 -1.861228 -1.881203 -1.904909 -1.926431 -1.935015 -1.926114 -1.897660 -1.846622 -1.788400 -1.707208 -1.586809 -1.407902 -1.004622 -1.542704 -1.599165 -1.651218 -1.710769 -1.763513 -1.806387 -1.841134 -1.867686 -1.885086 -1.904220 -1.922445 -1.925916 -1.913262 -1.880938 -1.828446 -1.769210 -1.688158 -1.569531 -1.395327 -1.004622 -1.582444 -1.633792 -1.680174 -1.734027 -1.779361 -1.818637 -1.850456 -1.873967 -1.887067 -1.902827 -1.915534 -1.914838 -1.898010 -1.862938 -1.809004 -1.748906 -1.668237 -1.551635 -1.382420 -1.004622 -1.624217 -1.668498 -1.708776 -1.754962 -1.796226 -1.831625 -1.859664 -1.878456 -1.888211 -1.899276 -1.906877 -1.901384 -1.880449 -1.843470 -1.788192 -1.727436 -1.647398 -1.533087 -1.369151 -1.004622 -1.666037 -1.702089 -1.735389 -1.777045 -1.813640 -1.844288 -1.867026 -1.881864 -1.886997 -1.891799 -1.894637 -1.884791 -1.861157 -1.822377 -1.765877 -1.704721 -1.625576 -1.513847 -1.355493 -1.004622 -1.705497 -1.735295 -1.763399 -1.799210 -1.830272 -1.854707 -1.872939 -1.882737 -1.881635 -1.881399 -1.879379 -1.865784 -1.839882 -1.799505 -1.741997 -1.680692 -1.602458 -1.493870 -1.341405 -1.004622 -1.745385 -1.769149 -1.790829 -1.819396 -1.844053 -1.863167 -1.874992 -1.879182 -1.872850 -1.867499 -1.860976 -1.844475 -1.816484 -1.774690 -1.716456 -1.655283 -1.578088 -1.473099 -1.326846 -1.004622 -1.784364 -1.800774 -1.815467 -1.837129 -1.854949 -1.867184 -1.873186 -1.871567 -1.860039 -1.849993 -1.839988 -1.820731 -1.790772 -1.747821 -1.689147 -1.628348 -1.552540 -1.451481 -1.311765 -1.004622 -1.819504 -1.828636 -1.835158 -1.849685 -1.860083 -1.866559 -1.866696 -1.859422 -1.843560 -1.829620 -1.816220 -1.794380 -1.762684 -1.718807 -1.659999 -1.599109 -1.525746 -1.428972 -1.296094 -1.004622 -1.848409 -1.850139 -1.849451 -1.856882 -1.860335 -1.860597 -1.855306 -1.843509 -1.823815 -1.806132 -1.789535 -1.765401 -1.732216 -1.687648 -1.629603 -1.568190 -1.497646 -1.405550 -1.279758 -1.004622 -1.871696 -1.865166 -1.857088 -1.857696 -1.854927 -1.849998 -1.840057 -1.823974 -1.800668 -1.779588 -1.760062 -1.733889 -1.699541 -1.654641 -1.599186 -1.535647 -1.468227 -1.381161 -1.262651 -1.004622 -1.889704 -1.875577 -1.860447 -1.854733 -1.846307 -1.836196 -1.821655 -1.801448 -1.774646 -1.750464 -1.728355 -1.700145 -1.664927 -1.620974 -1.567415 -1.502977 -1.437680 -1.355796 -1.244829 -1.004622 -1.909113 -1.887355 -1.864777 -1.852724 -1.838554 -1.822963 -1.803532 -1.778820 -1.748000 -1.719647 -1.694469 -1.664950 -1.629439 -1.586609 -1.534961 -1.474110 -1.406489 -1.329581 -1.225709 -1.004622 -1.943866 -1.913276 -1.882253 -1.863082 -1.842495 -1.820139 -1.796030 -1.768482 -1.736972 -1.701587 -1.663301 -1.633012 -1.597307 -1.554929 -1.505449 -1.447390 -1.379851 -1.303715 -1.205403 -1.004622 -2.046066 -2.012097 -1.977548 -1.941857 -1.906480 -1.868802 -1.834024 -1.802273 -1.767473 -1.729615 -1.688001 -1.642712 -1.593430 -1.541248 -1.490203 -1.431944 -1.363499 -1.283979 -1.183586 -1.004622 -2.506804 -2.447971 -2.386611 -2.322773 -2.256504 -2.187850 -2.116880 -2.043885 -1.968167 -1.890518 -1.810752 -1.728914 -1.645272 -1.559161 -1.471359 -1.381658 -1.290082 -1.196695 -1.101533 -1.004622 -1.348398 -1.473348 -1.587371 -1.683720 -1.771336 -1.878406 -1.978326 -2.067834 -2.145019 -2.201575 -2.251578 -2.316252 -2.364620 -2.392456 -2.389468 -2.345986 -2.284281 -2.153121 -1.912245 -1.332105 -1.338073 -1.468049 -1.584690 -1.677047 -1.771457 -1.884438 -1.987087 -2.078976 -2.154663 -2.204561 -2.254073 -2.318532 -2.365427 -2.389836 -2.380879 -2.331305 -2.267109 -2.134849 -1.896987 -1.332105 -1.350534 -1.478585 -1.589119 -1.685399 -1.785302 -1.899616 -2.003062 -2.093261 -2.163812 -2.207855 -2.259913 -2.322796 -2.366341 -2.385771 -2.369943 -2.315674 -2.248862 -2.115740 -1.881299 -1.332105 -1.378026 -1.497150 -1.607314 -1.707920 -1.809566 -1.922183 -2.023441 -2.108591 -2.170445 -2.215870 -2.267206 -2.327523 -2.366055 -2.379740 -2.356234 -2.298875 -2.229435 -2.095750 -1.865161 -1.332105 -1.412083 -1.529762 -1.640338 -1.740921 -1.841061 -1.949877 -2.045255 -2.121929 -2.180232 -2.226150 -2.276225 -2.330960 -2.364466 -2.371158 -2.340376 -2.280688 -2.208721 -2.074826 -1.848545 -1.332105 -1.459631 -1.576191 -1.683549 -1.781402 -1.877752 -1.979362 -2.065977 -2.135608 -2.193706 -2.238332 -2.284379 -2.333411 -2.360656 -2.359448 -2.323211 -2.260937 -2.186638 -2.052913 -1.831451 -1.332105 -1.521927 -1.631886 -1.733736 -1.826839 -1.916236 -2.008262 -2.085888 -2.153500 -2.208790 -2.250960 -2.291681 -2.333957 -2.353687 -2.344092 -2.304372 -2.239422 -2.163027 -2.029757 -1.813868 -1.332105 -1.591119 -1.694001 -1.788732 -1.874062 -1.953703 -2.036419 -2.110038 -2.173285 -2.225310 -2.261681 -2.296179 -2.331258 -2.342692 -2.326343 -2.283506 -2.215934 -2.137804 -2.005665 -1.795763 -1.332105 -1.667897 -1.760104 -1.845657 -1.920270 -1.991405 -2.068532 -2.136450 -2.194392 -2.240188 -2.270586 -2.297925 -2.324147 -2.326935 -2.306342 -2.260292 -2.190338 -2.110858 -1.980360 -1.777182 -1.332105 -1.747571 -1.827725 -1.902154 -1.968407 -2.032711 -2.102615 -2.164113 -2.214057 -2.252868 -2.276695 -2.295351 -2.311796 -2.307966 -2.283489 -2.234365 -2.162262 -2.082080 -1.953671 -1.757900 -1.332105 -1.828012 -1.897521 -1.961954 -2.019234 -2.075913 -2.136663 -2.189518 -2.231398 -2.262206 -2.277908 -2.287069 -2.294677 -2.285656 -2.257331 -2.205405 -2.131602 -2.051330 -1.925625 -1.738072 -1.332105 -1.911937 -1.969618 -2.023461 -2.071721 -2.118093 -2.168191 -2.211520 -2.244642 -2.265910 -2.272255 -2.273206 -2.273947 -2.259432 -2.227377 -2.173101 -2.098155 -2.018495 -1.896144 -1.717535 -1.332105 -1.997689 -2.042915 -2.085181 -2.122261 -2.157022 -2.195773 -2.228279 -2.250992 -2.261809 -2.260253 -2.254773 -2.248877 -2.228813 -2.193323 -2.137108 -2.061745 -1.983167 -1.865146 -1.695995 -1.332105 -2.082232 -2.114624 -2.143748 -2.168185 -2.190297 -2.216349 -2.236620 -2.249285 -2.251385 -2.242620 -2.230856 -2.218709 -2.193480 -2.154815 -2.097262 -2.022242 -1.944872 -1.832621 -1.673514 -1.332105 -2.161712 -2.180298 -2.194587 -2.204997 -2.214082 -2.228258 -2.237437 -2.241068 -2.234644 -2.218545 -2.200653 -2.183097 -2.153197 -2.111844 -2.053534 -1.978647 -1.903961 -1.798559 -1.649971 -1.332105 -2.228654 -2.232771 -2.234062 -2.232208 -2.229673 -2.232872 -2.231172 -2.226025 -2.211392 -2.188060 -2.164443 -2.142103 -2.108365 -2.064649 -2.006109 -1.930974 -1.860481 -1.762686 -1.625219 -1.332105 -2.287465 -2.277710 -2.265738 -2.251520 -2.237849 -2.231077 -2.219547 -2.205898 -2.183600 -2.153129 -2.124003 -2.097424 -2.059597 -2.014097 -1.958660 -1.887383 -1.814585 -1.724917 -1.599111 -1.332105 -2.353256 -2.328269 -2.302177 -2.274253 -2.248371 -2.231746 -2.210880 -2.188630 -2.158595 -2.120782 -2.081607 -2.050576 -2.011476 -1.965645 -1.912728 -1.845437 -1.768046 -1.686018 -1.571575 -1.332105 -2.485636 -2.442917 -2.402084 -2.360466 -2.317241 -2.273418 -2.242409 -2.210030 -2.175860 -2.136040 -2.088832 -2.034691 -1.986625 -1.939118 -1.883763 -1.818278 -1.738661 -1.650490 -1.544013 -1.332105 -3.835547 -3.746591 -3.651516 -3.551213 -3.445622 -3.334926 -3.219260 -3.098832 -2.973771 -2.844242 -2.710400 -2.572355 -2.430275 -2.284261 -2.134446 -1.980947 -1.823851 -1.663290 -1.499584 -1.332105 -1.238693 -1.418680 -1.585031 -1.735172 -1.856640 -1.969283 -2.106879 -2.233743 -2.347980 -2.443214 -2.498731 -2.587816 -2.670646 -2.733958 -2.767265 -2.741566 -2.706793 -2.586892 -2.315313 -1.613434 -1.174046 -1.370017 -1.549806 -1.705780 -1.823770 -1.950287 -2.100435 -2.236404 -2.356067 -2.449738 -2.495552 -2.590791 -2.675453 -2.737762 -2.765592 -2.729048 -2.690928 -2.567372 -2.296596 -1.613434 -1.159862 -1.360150 -1.541106 -1.689998 -1.817041 -1.957040 -2.111956 -2.250221 -2.369321 -2.453495 -2.501747 -2.599281 -2.682645 -2.741354 -2.761518 -2.716165 -2.673884 -2.546663 -2.277210 -1.613434 -1.178813 -1.373884 -1.546709 -1.698033 -1.837457 -1.981292 -2.134816 -2.271545 -2.382899 -2.457848 -2.514740 -2.611222 -2.691061 -2.743741 -2.754321 -2.702497 -2.655407 -2.524676 -2.257111 -1.613434 -1.219723 -1.402319 -1.574010 -1.732996 -1.874088 -2.016118 -2.165942 -2.294932 -2.393267 -2.470955 -2.532454 -2.624990 -2.699220 -2.743989 -2.743045 -2.687883 -2.635294 -2.501183 -2.236452 -1.613434 -1.276286 -1.453140 -1.624754 -1.783552 -1.922324 -2.060246 -2.200919 -2.316175 -2.409840 -2.489766 -2.552220 -2.638958 -2.706006 -2.741111 -2.729250 -2.671348 -2.613317 -2.476310 -2.215127 -1.613434 -1.354765 -1.525799 -1.691148 -1.843118 -1.979417 -2.109144 -2.234312 -2.340614 -2.433811 -2.512389 -2.572366 -2.651732 -2.709839 -2.733804 -2.714263 -2.652754 -2.589589 -2.449783 -2.193119 -1.613434 -1.452108 -1.611977 -1.766301 -1.911611 -2.039429 -2.155720 -2.269512 -2.372486 -2.462757 -2.536746 -2.591853 -2.662033 -2.709476 -2.721414 -2.697630 -2.631600 -2.563119 -2.421606 -2.170379 -1.613434 -1.558188 -1.707669 -1.851276 -1.983194 -2.097120 -2.203877 -2.311708 -2.409027 -2.493474 -2.561264 -2.609288 -2.668380 -2.703499 -2.706553 -2.678040 -2.607440 -2.534066 -2.391595 -2.146857 -1.613434 -1.675601 -1.810376 -1.937435 -2.054879 -2.158669 -2.258179 -2.358110 -2.447153 -2.523505 -2.583967 -2.623292 -2.669381 -2.691861 -2.688981 -2.654947 -2.580267 -2.502496 -2.359612 -2.122488 -1.613434 -1.797458 -1.913254 -2.025459 -2.131964 -2.226329 -2.315774 -2.405405 -2.484206 -2.551039 -2.602173 -2.631632 -2.663562 -2.676900 -2.667116 -2.627543 -2.548512 -2.467438 -2.325496 -2.097201 -1.613434 -1.921265 -2.020948 -2.120020 -2.213965 -2.296326 -2.372918 -2.450797 -2.518377 -2.573421 -2.613425 -2.631766 -2.652915 -2.657509 -2.640202 -2.595484 -2.512279 -2.429144 -2.288956 -2.070906 -1.613434 -2.052601 -2.135426 -2.217864 -2.296642 -2.365248 -2.427598 -2.492029 -2.546525 -2.588016 -2.615440 -2.624702 -2.636569 -2.631864 -2.607187 -2.557080 -2.471518 -2.386908 -2.249873 -2.043486 -1.613434 -2.187195 -2.250068 -2.314572 -2.377597 -2.430115 -2.476699 -2.525784 -2.565737 -2.593253 -2.609178 -2.609463 -2.612063 -2.598588 -2.567219 -2.512538 -2.424998 -2.340578 -2.208395 -2.014801 -1.613434 -2.319953 -2.362617 -2.408371 -2.452133 -2.486702 -2.516603 -2.549005 -2.574648 -2.589054 -2.593138 -2.583766 -2.577803 -2.556570 -2.519058 -2.460628 -2.372285 -2.289286 -2.164421 -1.984666 -1.613434 -2.446917 -2.468385 -2.493494 -2.516679 -2.532143 -2.544708 -2.560510 -2.572238 -2.573598 -2.565490 -2.546092 -2.531937 -2.504650 -2.461849 -2.400990 -2.312920 -2.233012 -2.117765 -1.952862 -1.613434 -2.560012 -2.559393 -2.564909 -2.569333 -2.565926 -2.560640 -2.559995 -2.557296 -2.545877 -2.525635 -2.496522 -2.475410 -2.442832 -2.395978 -2.333918 -2.252496 -2.172260 -2.068218 -1.919112 -1.613434 -2.665000 -2.642036 -2.628539 -2.614655 -2.592812 -2.569920 -2.553882 -2.536948 -2.512805 -2.480373 -2.440656 -2.411362 -2.374088 -2.324924 -2.265179 -2.189441 -2.108025 -2.015861 -1.883213 -1.613434 -2.828414 -2.780648 -2.742893 -2.703111 -2.657571 -2.612079 -2.581001 -2.548815 -2.512060 -2.468182 -2.419208 -2.364068 -2.323680 -2.272148 -2.208770 -2.137198 -2.047758 -1.963881 -1.845909 -1.613434 -5.247004 -5.126811 -4.996704 -4.857080 -4.708366 -4.550952 -4.385228 -4.211558 -4.030282 -3.841732 -3.646195 -3.443975 -3.235309 -3.020472 -2.799665 -2.573133 -2.341052 -2.103631 -1.861033 -1.613434 -1.146012 -1.354363 -1.567769 -1.763934 -1.935258 -2.052750 -2.215252 -2.371085 -2.515305 -2.642916 -2.731881 -2.811449 -2.920877 -3.011201 -3.075139 -3.078143 -3.060952 -2.963981 -2.676951 -1.860027 -1.006609 -1.243976 -1.479212 -1.694979 -1.875633 -1.997930 -2.182120 -2.355219 -2.513710 -2.648476 -2.724320 -2.810977 -2.926605 -3.019253 -3.080040 -3.068895 -3.047740 -2.944960 -2.655597 -1.860027 -0.9515541 -1.201361 -1.444075 -1.660401 -1.835692 -1.987715 -2.179991 -2.361484 -2.525478 -2.655614 -2.722684 -2.821515 -2.938112 -3.029120 -3.083103 -3.058422 -3.033696 -2.924445 -2.633314 -1.860027 -0.9507590 -1.202999 -1.442044 -1.648473 -1.835612 -2.001926 -2.199266 -2.382896 -2.544086 -2.658710 -2.736470 -2.840506 -2.953706 -3.039269 -3.083368 -3.048191 -3.018749 -2.902310 -2.610053 -1.860027 -0.9895670 -1.234028 -1.463198 -1.673357 -1.862898 -2.038501 -2.234640 -2.414764 -2.562234 -2.671916 -2.759093 -2.863612 -2.970821 -3.048576 -3.079362 -3.037643 -3.001725 -2.878370 -2.585749 -1.860027 -1.055187 -1.288565 -1.515227 -1.722554 -1.915681 -2.092698 -2.283782 -2.448400 -2.582473 -2.696476 -2.787881 -2.888175 -2.987547 -3.055668 -3.070300 -3.026129 -2.982587 -2.852443 -2.560356 -1.860027 -1.145588 -1.369528 -1.589125 -1.794409 -1.986300 -2.161121 -2.334477 -2.484052 -2.615398 -2.728888 -2.819192 -2.912935 -3.002576 -3.058486 -3.060565 -3.012868 -2.960909 -2.824347 -2.533975 -1.860027 -1.257695 -1.471899 -1.684864 -1.884831 -2.069724 -2.228935 -2.387077 -2.529729 -2.655741 -2.765209 -2.851622 -2.936465 -3.014341 -3.054956 -3.049809 -2.997320 -2.936604 -2.793889 -2.506820 -1.860027 -1.392639 -1.594917 -1.797957 -1.985893 -2.152157 -2.300364 -2.447136 -2.580023 -2.698958 -2.802960 -2.883659 -2.957652 -3.021286 -3.047655 -3.036723 -2.977684 -2.908661 -2.760823 -2.478762 -1.860027 -1.547021 -1.733784 -1.916021 -2.087100 -2.242271 -2.377029 -2.510241 -2.632538 -2.743507 -2.839740 -2.912945 -2.974759 -3.021505 -3.038239 -3.019998 -2.953686 -2.876523 -2.724958 -2.449594 -1.860027 -1.711133 -1.873218 -2.038701 -2.194885 -2.333889 -2.455107 -2.575854 -2.686723 -2.787449 -2.873492 -2.937114 -2.984703 -3.017958 -3.025194 -2.998513 -2.924711 -2.839955 -2.686066 -2.419220 -1.860027 -1.882198 -2.021802 -2.165932 -2.302776 -2.426538 -2.534913 -2.642992 -2.740402 -2.828048 -2.901982 -2.952795 -2.987902 -3.009864 -3.006901 -2.970486 -2.889221 -2.798366 -2.643805 -2.387522 -1.860027 -2.058476 -2.172284 -2.294745 -2.413632 -2.521997 -2.615165 -2.707641 -2.790218 -2.862822 -2.921941 -2.959984 -2.984019 -2.994545 -2.980638 -2.935108 -2.846284 -2.751142 -2.597856 -2.354376 -1.860027 -2.237628 -2.327794 -2.428576 -2.526864 -2.615518 -2.691263 -2.766223 -2.832068 -2.887978 -2.933146 -2.958171 -2.969747 -2.968768 -2.944644 -2.890349 -2.795308 -2.697796 -2.548204 -2.319596 -1.860027 -2.423432 -2.485317 -2.561218 -2.636673 -2.703849 -2.759479 -2.814018 -2.862344 -2.902406 -2.932268 -2.943336 -2.941676 -2.929765 -2.896240 -2.834790 -2.735414 -2.637563 -2.495141 -2.282958 -1.860027 -2.605251 -2.639374 -2.688998 -2.738726 -2.782095 -2.815884 -2.848391 -2.876804 -2.899726 -2.914405 -2.911569 -2.896784 -2.874531 -2.833522 -2.767148 -2.665724 -2.569456 -2.438029 -2.244139 -1.860027 -2.780187 -2.785100 -2.805813 -2.827783 -2.844748 -2.853576 -2.863134 -2.870967 -2.876197 -2.875492 -2.859404 -2.832340 -2.801498 -2.755329 -2.686391 -2.585935 -2.493520 -2.376448 -2.202713 -1.860027 -2.938447 -2.912537 -2.906894 -2.901851 -2.891791 -2.874497 -2.859990 -2.846103 -2.832891 -2.817273 -2.788678 -2.750422 -2.711994 -2.661664 -2.594200 -2.503324 -2.410440 -2.309804 -2.158003 -1.860027 -3.133971 -3.071912 -3.036654 -3.003442 -2.966109 -2.919896 -2.876712 -2.838088 -2.803643 -2.768921 -2.727706 -2.672312 -2.624522 -2.572322 -2.507129 -2.423973 -2.324723 -2.239380 -2.109994 -1.860027 -6.733509 -6.581703 -6.414555 -6.232888 -6.037457 -5.829043 -5.608362 -5.376038 -5.132699 -4.878909 -4.615152 -4.341916 -4.059637 -3.768695 -3.469470 -3.162301 -2.847489 -2.525331 -2.196096 -1.860027 -1.062793 -1.294834 -1.556228 -1.792946 -2.004500 -2.168542 -2.314353 -2.496100 -2.664291 -2.816049 -2.934495 -3.004826 -3.135185 -3.246301 -3.334727 -3.364696 -3.361802 -3.293190 -3.004958 -2.079525 -0.8487500 -1.118066 -1.407716 -1.674362 -1.909887 -2.069929 -2.251296 -2.457444 -2.647099 -2.814444 -2.928277 -2.997222 -3.138933 -3.255989 -3.344987 -3.360328 -3.351548 -3.276006 -2.981742 -2.079525 -0.7493320 -1.039621 -1.338281 -1.612554 -1.841614 -2.029149 -2.235193 -2.453564 -2.650598 -2.822113 -2.916918 -3.008661 -3.153541 -3.270119 -3.354437 -3.351216 -3.341645 -3.257216 -2.957304 -2.079525 -0.7237854 -1.022552 -1.317887 -1.582013 -1.817788 -2.031918 -2.249643 -2.467450 -2.668519 -2.830109 -2.927610 -3.034458 -3.174765 -3.286590 -3.361842 -3.343966 -3.330663 -3.236563 -2.931568 -2.079525 -0.7519827 -1.046507 -1.329218 -1.591337 -1.839244 -2.064889 -2.281637 -2.498187 -2.694906 -2.841898 -2.953518 -3.066889 -3.199128 -3.303590 -3.365281 -3.338186 -3.318391 -3.213768 -2.904450 -2.079525 -0.8180876 -1.101190 -1.378447 -1.641047 -1.890988 -2.115575 -2.331242 -2.543403 -2.724162 -2.871137 -2.991678 -3.101684 -3.224983 -3.319391 -3.362226 -3.332735 -3.304620 -3.188511 -2.875859 -2.079525 -0.9154537 -1.190998 -1.462668 -1.721014 -1.960129 -2.182652 -2.396251 -2.595246 -2.765839 -2.914790 -3.033054 -3.137978 -3.250447 -3.331796 -3.357107 -3.326664 -3.287677 -3.160514 -2.845914 -2.079525 -1.045962 -1.311602 -1.574958 -1.816860 -2.048004 -2.267568 -2.469862 -2.654344 -2.819708 -2.964636 -3.077547 -3.175031 -3.274607 -3.338270 -3.352811 -3.317790 -3.267586 -3.129479 -2.814701 -2.079525 -1.204558 -1.454179 -1.699308 -1.933166 -2.156679 -2.364928 -2.549050 -2.722557 -2.880318 -3.014620 -3.122192 -3.210972 -3.295556 -3.339441 -3.347366 -3.305341 -3.242992 -3.095064 -2.782104 -2.079525 -1.380309 -1.611875 -1.845263 -2.067611 -2.277981 -2.464750 -2.636341 -2.796412 -2.939595 -3.063925 -3.164685 -3.243496 -3.309780 -3.340479 -3.339420 -3.288373 -3.213503 -3.056947 -2.748254 -2.079525 -1.578378 -1.790788 -2.008557 -2.208857 -2.397350 -2.572541 -2.725466 -2.867678 -2.998009 -3.112225 -3.202784 -3.268773 -3.318665 -3.338861 -3.326486 -3.264967 -3.178219 -3.014785 -2.713088 -2.079525 -1.797851 -1.980923 -2.171278 -2.354140 -2.523880 -2.675369 -2.809870 -2.937843 -3.055472 -3.157349 -3.233568 -3.285301 -3.323181 -3.331589 -3.307137 -3.233769 -3.136354 -2.968172 -2.676229 -2.079525 -2.020061 -2.177010 -2.341571 -2.498598 -2.643553 -2.774932 -2.893384 -3.006120 -3.108341 -3.195027 -3.255710 -3.294903 -3.319881 -3.315497 -3.278522 -3.193738 -3.087089 -2.916615 -2.637513 -2.079525 -2.252088 -2.373414 -2.507568 -2.639652 -2.764096 -2.875793 -2.974180 -3.067761 -3.152404 -3.223183 -3.269351 -3.294112 -3.304782 -3.286559 -3.237833 -3.143219 -3.029570 -2.859989 -2.596715 -2.079525 -2.483701 -2.572662 -2.678193 -2.783297 -2.882182 -2.970597 -3.046825 -3.119391 -3.185221 -3.238727 -3.269391 -3.277998 -3.273201 -3.241241 -3.182348 -3.080692 -2.962743 -2.798198 -2.553540 -2.079525 -2.722011 -2.774034 -2.846297 -2.920764 -2.991493 -3.054280 -3.106311 -3.155873 -3.200175 -3.234141 -3.247937 -3.240542 -3.220891 -3.176286 -3.109369 -3.004321 -2.885675 -2.731411 -2.507599 -2.079525 -2.956450 -2.971146 -3.006903 -3.046453 -3.085438 -3.118055 -3.142452 -3.166648 -3.187625 -3.201405 -3.198014 -3.175632 -3.143222 -3.088488 -3.016506 -2.912189 -2.797150 -2.658231 -2.458305 -2.079525 -3.179948 -3.153790 -3.150519 -3.151759 -3.154739 -3.154664 -3.148690 -3.145751 -3.142563 -3.135955 -3.115842 -3.080329 -3.037824 -2.976198 -2.901937 -2.805728 -2.696343 -2.577269 -2.404838 -2.079525 -3.427771 -3.352662 -3.308249 -3.270797 -3.236874 -3.198274 -3.154737 -3.118892 -3.086653 -3.055241 -3.017443 -2.966052 -2.914960 -2.853525 -2.780864 -2.693432 -2.583344 -2.488236 -2.346537 -2.079525 -8.288466 -8.104436 -7.898542 -7.672180 -7.426690 -7.163320 -6.883195 -6.587366 -6.276771 -5.952260 -5.614595 -5.264462 -4.902496 -4.529267 -4.145296 -3.751054 -3.346973 -2.933451 -2.510855 -2.079525 -0.9707541 -1.256314 -1.543472 -1.820709 -2.070404 -2.275361 -2.411882 -2.615388 -2.801166 -2.972514 -3.115607 -3.176248 -3.324933 -3.452559 -3.560491 -3.613972 -3.621248 -3.582044 -3.304403 -2.277299 -0.6814927 -0.9965839 -1.331933 -1.652244 -1.938842 -2.145941 -2.316116 -2.550344 -2.765713 -2.962056 -3.108877 -3.158711 -3.324293 -3.462238 -3.574913 -3.614681 -3.613921 -3.567510 -3.280154 -2.277299 -0.5296177 -0.8804554 -1.235429 -1.567689 -1.851805 -2.071489 -2.286129 -2.532792 -2.762036 -2.967244 -3.091518 -3.171197 -3.340054 -3.479314 -3.590082 -3.607788 -3.607428 -3.551417 -3.254362 -2.277299 -0.4841908 -0.8466225 -1.203097 -1.523491 -1.804527 -2.056747 -2.291509 -2.544414 -2.779853 -2.976166 -3.096090 -3.204265 -3.365162 -3.501020 -3.604325 -3.602519 -3.601335 -3.533378 -3.226925 -2.277299 -0.5074292 -0.8668275 -1.205462 -1.517339 -1.811442 -2.077891 -2.325547 -2.577945 -2.806041 -2.984923 -3.125176 -3.244084 -3.396536 -3.524600 -3.615323 -3.601157 -3.595233 -3.512959 -3.197725 -2.277299 -0.5762401 -0.9191588 -1.246765 -1.556730 -1.852273 -2.128472 -2.379903 -2.624874 -2.838491 -3.019944 -3.170533 -3.289966 -3.430528 -3.548379 -3.619715 -3.601801 -3.587104 -3.489772 -3.166637 -2.277299 -0.6786868 -1.009520 -1.326512 -1.631244 -1.926316 -2.200758 -2.446809 -2.679780 -2.887822 -3.075791 -3.222423 -3.340411 -3.466763 -3.570254 -3.619488 -3.602857 -3.576036 -3.463417 -3.133711 -2.277299 -0.8187130 -1.135484 -1.441158 -1.737847 -2.025192 -2.288123 -2.523520 -2.749796 -2.958432 -3.135839 -3.281148 -3.391403 -3.503587 -3.587443 -3.622144 -3.602103 -3.561466 -3.433474 -3.099221 -2.277299 -0.9923518 -1.293332 -1.586310 -1.870971 -2.137128 -2.388939 -2.619396 -2.841114 -3.033731 -3.201690 -3.338042 -3.440495 -3.537388 -3.598732 -3.625871 -3.598737 -3.542274 -3.399432 -3.063047 -2.277299 -1.195623 -1.478708 -1.752532 -2.012815 -2.267422 -2.512179 -2.735524 -2.934140 -3.114186 -3.267274 -3.392184 -3.485705 -3.564067 -3.610032 -3.627849 -3.590426 -3.517483 -3.360832 -3.025032 -2.277299 -1.423304 -1.678477 -1.932554 -2.179406 -2.422353 -2.649207 -2.845953 -3.031545 -3.191960 -3.329884 -3.443118 -3.524237 -3.583337 -3.619057 -3.625813 -3.575304 -3.486209 -3.317179 -2.984962 -2.277299 -1.668335 -1.900713 -2.137225 -2.366038 -2.580165 -2.782099 -2.960133 -3.121171 -3.263958 -3.389385 -3.488611 -3.554255 -3.599614 -3.622461 -3.616355 -3.551970 -3.447385 -3.267901 -2.943331 -2.277299 -1.941252 -2.143249 -2.346657 -2.546099 -2.738820 -2.911743 -3.063067 -3.204453 -3.332407 -3.442400 -3.525910 -3.579268 -3.609734 -3.617162 -3.596267 -3.518262 -3.399689 -3.212227 -2.899361 -2.277299 -2.219680 -2.386467 -2.558069 -2.724926 -2.883703 -3.031569 -3.162695 -3.284590 -3.393600 -3.485826 -3.555115 -3.594347 -3.608910 -3.598273 -3.562350 -3.471766 -3.341647 -3.149927 -2.852783 -2.277299 -2.506071 -2.627973 -2.762006 -2.896814 -3.028274 -3.150081 -3.256763 -3.356080 -3.444513 -3.517601 -3.569693 -3.592747 -3.590302 -3.561389 -3.510802 -3.409741 -3.271558 -3.081034 -2.803262 -2.277299 -2.796062 -2.875629 -2.970723 -3.069196 -3.167689 -3.259330 -3.339135 -3.413214 -3.477561 -3.529039 -3.561013 -3.565762 -3.546382 -3.500966 -3.437489 -3.329147 -3.187844 -3.004766 -2.750316 -2.277299 -3.089814 -3.123197 -3.174558 -3.232429 -3.293745 -3.350749 -3.398632 -3.442919 -3.479974 -3.507187 -3.517939 -3.504039 -3.468765 -3.410874 -3.337916 -3.227046 -3.089359 -2.920857 -2.693235 -2.277299 -3.380094 -3.362192 -3.363934 -3.374132 -3.391724 -3.408336 -3.419070 -3.430460 -3.438542 -3.440295 -3.430082 -3.398613 -3.350067 -3.284768 -3.208178 -3.101903 -2.974623 -2.827038 -2.630979 -2.277299 -3.684105 -3.609533 -3.558000 -3.516564 -3.484062 -3.451949 -3.416809 -3.387952 -3.362314 -3.335488 -3.301278 -3.253839 -3.195816 -3.127017 -3.048955 -2.958407 -2.840985 -2.721987 -2.562213 -2.277299 -9.906311 -9.689448 -9.443147 -9.169597 -8.870865 -8.548840 -8.205210 -7.841475 -7.458972 -7.058885 -6.642272 -6.210076 -5.763140 -5.302222 -4.828006 -4.341109 -3.842098 -3.331484 -2.809739 -2.277299 -0.8737825 -1.232305 -1.535751 -1.848129 -2.129071 -2.370664 -2.506032 -2.730531 -2.931829 -3.117527 -3.279549 -3.332320 -3.496227 -3.637924 -3.761403 -3.835089 -3.849230 -3.837491 -3.578960 -2.457263 -0.4996783 -0.8872195 -1.255018 -1.618549 -1.951991 -2.219736 -2.380607 -2.641305 -2.877162 -3.094976 -3.272204 -3.303371 -3.489984 -3.646498 -3.779202 -3.841058 -3.843369 -3.825994 -3.554514 -2.457263 -0.3043410 -0.7292797 -1.123223 -1.506292 -1.855457 -2.118507 -2.341966 -2.613395 -2.863577 -3.097163 -3.257276 -3.315764 -3.506378 -3.666026 -3.799553 -3.837604 -3.840523 -3.813207 -3.528196 -2.457263 -0.2391586 -0.6695241 -1.073909 -1.462258 -1.799003 -2.087536 -2.343357 -2.617762 -2.876749 -3.109968 -3.252292 -3.353304 -3.535811 -3.692812 -3.820380 -3.833109 -3.839863 -3.798590 -3.499867 -2.457263 -0.2508069 -0.6765779 -1.081761 -1.454400 -1.792041 -2.099658 -2.371764 -2.648471 -2.908497 -3.121798 -3.280928 -3.401893 -3.573309 -3.723561 -3.838728 -3.835495 -3.838756 -3.781632 -3.469371 -2.457263 -0.3221052 -0.7377710 -1.127063 -1.484541 -1.825913 -2.140062 -2.421131 -2.700542 -2.951356 -3.154998 -3.330915 -3.460971 -3.616785 -3.756202 -3.850983 -3.842196 -3.837015 -3.761763 -3.436540 -2.457263 -0.4389254 -0.8349895 -1.202431 -1.554731 -1.891524 -2.205834 -2.493507 -2.766185 -2.998145 -3.212241 -3.395146 -3.523671 -3.664917 -3.787957 -3.856576 -3.850224 -3.832717 -3.738508 -3.401332 -2.457263 -0.5898209 -0.9632648 -1.317308 -1.655746 -1.986366 -2.300213 -2.583250 -2.836456 -3.070637 -3.285657 -3.463952 -3.588387 -3.712552 -3.816381 -3.866436 -3.858723 -3.825287 -3.711277 -3.364213 -2.457263 -0.7758777 -1.128244 -1.463157 -1.790206 -2.110772 -2.415720 -2.678950 -2.930851 -3.162830 -3.368044 -3.534464 -3.649516 -3.756001 -3.837503 -3.879133 -3.864756 -3.813570 -3.679355 -3.325073 -2.457263 -0.9964091 -1.325469 -1.642857 -1.954347 -2.256521 -2.537290 -2.799364 -3.046196 -3.264672 -3.450474 -3.605044 -3.706253 -3.793694 -3.858099 -3.891238 -3.866108 -3.796134 -3.642179 -3.283725 -2.457263 -1.249063 -1.553604 -1.851624 -2.134790 -2.415919 -2.688908 -2.942122 -3.166830 -3.362855 -3.533005 -3.669192 -3.758611 -3.825432 -3.878272 -3.899851 -3.861025 -3.771649 -3.599022 -3.239956 -2.457263 -1.529341 -1.801563 -2.070798 -2.337681 -2.604333 -2.860422 -3.081804 -3.284009 -3.457628 -3.605396 -3.727123 -3.803944 -3.855730 -3.894652 -3.901513 -3.846955 -3.738556 -3.549096 -3.193430 -2.457263 -1.826827 -2.072728 -2.319775 -2.564006 -2.796271 -3.019086 -3.218511 -3.390803 -3.540560 -3.671391 -3.778052 -3.843389 -3.881071 -3.902681 -3.892680 -3.821164 -3.694913 -3.491222 -3.144592 -2.457263 -2.157661 -2.364122 -2.572373 -2.780669 -2.982679 -3.169843 -3.336303 -3.485686 -3.617188 -3.730548 -3.821351 -3.872193 -3.894809 -3.897239 -3.869268 -3.780749 -3.638511 -3.424970 -3.092631 -2.457263 -2.492795 -2.656122 -2.824013 -2.989140 -3.151935 -3.307400 -3.448972 -3.575054 -3.684877 -3.778734 -3.851249 -3.884683 -3.889194 -3.872166 -3.826118 -3.721939 -3.566970 -3.350401 -3.037071 -2.457263 -2.835274 -2.945788 -3.068699 -3.194999 -3.320794 -3.441226 -3.552304 -3.651182 -3.735983 -3.806711 -3.857933 -3.871732 -3.855636 -3.819672 -3.757090 -3.640650 -3.477942 -3.266030 -2.977338 -2.457263 -3.188239 -3.243093 -3.315117 -3.394885 -3.477979 -3.559628 -3.634614 -3.700366 -3.755658 -3.799164 -3.825822 -3.819089 -3.782823 -3.730125 -3.654986 -3.532288 -3.370193 -3.172379 -2.912570 -2.457263 -3.541641 -3.537660 -3.549879 -3.573135 -3.605707 -3.641746 -3.674399 -3.700880 -3.721971 -3.736132 -3.737085 -3.710489 -3.657464 -3.592972 -3.512856 -3.392440 -3.241622 -3.066620 -2.841286 -2.457263 -3.908117 -3.836979 -3.780000 -3.738320 -3.709783 -3.689008 -3.669564 -3.649027 -3.629600 -3.611330 -3.585771 -3.537234 -3.473765 -3.402751 -3.325859 -3.223760 -3.088944 -2.946857 -2.760990 -2.457263 -11.58230 -11.33200 -11.04391 -10.72052 -10.36558 -9.981492 -9.570606 -9.134963 -8.676349 -8.196331 -7.696281 -7.177416 -6.640808 -6.087412 -5.518089 -4.933609 -4.334677 -3.721928 -3.095944 -2.457263 -0.7818444 -1.206600 -1.536491 -1.881777 -2.188688 -2.457755 -2.605051 -2.840214 -3.056580 -3.254432 -3.430719 -3.487333 -3.653948 -3.806683 -3.942989 -4.034113 -4.051505 -4.065172 -3.831301 -2.622362 -0.3184676 -0.7797396 -1.187620 -1.589799 -1.959257 -2.273647 -2.443811 -2.729117 -2.983184 -3.220517 -3.420681 -3.443459 -3.641587 -3.813577 -3.963554 -4.045522 -4.046821 -4.056754 -3.807431 -2.622362 -7.7694923E-02 -0.5764834 -1.018035 -1.444235 -1.837043 -2.150636 -2.403410 -2.694081 -2.963648 -3.218240 -3.409336 -3.456162 -3.657940 -3.835669 -3.988737 -4.046670 -4.047131 -4.047486 -3.781387 -2.622362 1.0620856E-02 -0.4939957 -0.9483796 -1.382053 -1.774136 -2.119754 -2.405131 -2.695930 -2.974991 -3.231372 -3.398723 -3.497301 -3.692006 -3.867177 -4.015653 -4.042293 -4.050854 -4.036669 -3.752968 -2.622362 7.5010555E-03 -0.4914344 -0.9453138 -1.373242 -1.775156 -2.129909 -2.428185 -2.726626 -3.005258 -3.249457 -3.430062 -3.552326 -3.738020 -3.904860 -4.041429 -4.048066 -4.055559 -4.023777 -3.721968 -2.622362 -6.5509133E-02 -0.5461777 -0.9903568 -1.416472 -1.810755 -2.159220 -2.475442 -2.772861 -3.050746 -3.287704 -3.482322 -3.619875 -3.791646 -3.946774 -4.062349 -4.060513 -4.059781 -4.008070 -3.688159 -2.622362 -0.1876964 -0.6487126 -1.081383 -1.488190 -1.866198 -2.222116 -2.539786 -2.838924 -3.107059 -3.346440 -3.549105 -3.693408 -3.848506 -3.988767 -4.074869 -4.076317 -4.062867 -3.988909 -3.651412 -2.622362 -0.3553445 -0.7940500 -1.200159 -1.585241 -1.958676 -2.307005 -2.628540 -2.920890 -3.184417 -3.421373 -3.627210 -3.766866 -3.906942 -4.027966 -4.091836 -4.093202 -4.063464 -3.965524 -3.612347 -2.622362 -0.5600659 -0.9658135 -1.347735 -1.719000 -2.077400 -2.422839 -2.737506 -3.021071 -3.276605 -3.513522 -3.713072 -3.840634 -3.962579 -4.059432 -4.112760 -4.108259 -4.059664 -3.937034 -3.570914 -2.622362 -0.7947244 -1.172816 -1.530635 -1.883376 -2.232175 -2.564219 -2.863045 -3.135802 -3.389100 -3.616958 -3.796251 -3.914408 -4.013909 -4.090497 -4.134356 -4.119175 -4.049807 -3.902632 -3.526882 -2.622362 -1.066400 -1.413244 -1.749631 -2.083507 -2.412188 -2.718663 -3.008358 -3.274700 -3.513857 -3.713495 -3.878998 -3.980350 -4.058659 -4.122492 -4.153492 -4.123784 -4.032557 -3.861310 -3.479979 -2.622362 -1.371070 -1.688250 -2.001482 -2.303236 -2.604182 -2.901091 -3.179475 -3.419914 -3.629352 -3.808610 -3.950642 -4.037002 -4.101837 -4.151066 -4.166626 -4.119556 -4.006036 -3.811889 -3.429875 -2.622362 -1.704336 -1.986598 -2.265895 -2.546900 -2.830099 -3.101297 -3.342969 -3.557074 -3.736982 -3.889707 -4.014440 -4.088755 -4.139503 -4.171797 -4.169362 -4.103642 -3.967760 -3.753036 -3.376128 -2.622362 -2.063779 -2.312893 -2.564723 -2.809742 -3.052207 -3.287785 -3.495574 -3.673414 -3.827624 -3.962083 -4.071759 -4.132510 -4.165963 -4.179527 -4.156909 -4.072059 -3.914970 -3.683961 -3.319287 -2.622362 -2.452533 -2.651674 -2.858322 -3.062397 -3.262005 -3.452088 -3.625708 -3.777922 -3.911387 -4.025242 -4.115690 -4.161036 -4.174092 -4.167285 -4.123519 -4.019780 -3.844246 -3.604849 -3.258128 -2.622362 -2.850206 -2.992213 -3.143223 -3.297848 -3.454222 -3.608096 -3.749786 -3.872548 -3.979678 -4.069761 -4.137073 -4.163304 -4.153898 -4.125186 -4.061349 -3.940862 -3.752628 -3.514132 -3.191962 -2.622362 -3.258929 -3.336818 -3.431361 -3.533394 -3.641052 -3.751322 -3.854372 -3.941834 -4.016768 -4.078900 -4.119121 -4.122171 -4.090610 -4.040151 -3.960493 -3.828832 -3.638249 -3.409847 -3.119790 -2.622362 -3.674643 -3.683277 -3.711369 -3.751392 -3.802356 -3.859091 -3.914377 -3.958816 -3.995025 -4.023784 -4.035559 -4.014923 -3.964041 -3.896594 -3.809975 -3.677798 -3.497403 -3.290698 -3.039901 -2.622362 -4.105251 -4.036402 -3.982788 -3.944427 -3.923906 -3.915499 -3.910328 -3.901506 -3.891764 -3.882393 -3.865082 -3.821777 -3.755152 -3.680970 -3.600286 -3.483797 -3.329061 -3.153571 -2.949001 -2.622362 -13.31235 -13.02802 -12.69606 -12.32105 -11.90708 -11.45775 -10.97614 -10.46492 -9.926380 -9.362480 -8.774938 -8.165252 -7.534739 -6.884567 -6.215779 -5.529305 -4.825993 -4.106610 -3.371852 -2.622362 -0.6921525 -1.181712 -1.541026 -1.919877 -2.253578 -2.543233 -2.729008 -2.942776 -3.173400 -3.384058 -3.571287 -3.651599 -3.800060 -3.962569 -4.109059 -4.214699 -4.234072 -4.270208 -4.063670 -2.774865 -0.1412940 -0.6804677 -1.129954 -1.575698 -1.973858 -2.322686 -2.517788 -2.806398 -3.083405 -3.338253 -3.557975 -3.588680 -3.781780 -3.967242 -4.132119 -4.231779 -4.230164 -4.264819 -4.041065 -2.774865 0.1372510 -0.4308761 -0.9318919 -1.397289 -1.822766 -2.175693 -2.459873 -2.769825 -3.061489 -3.333265 -3.548822 -3.597767 -3.799959 -3.991227 -4.161520 -4.237489 -4.233891 -4.259213 -4.015995 -2.774865 0.2527568 -0.3223191 -0.8342119 -1.310343 -1.744146 -2.129899 -2.462178 -2.777362 -3.071249 -3.348920 -3.533168 -3.643549 -3.839647 -4.028116 -4.194297 -4.233498 -4.241673 -4.252527 -3.988225 -2.774865 0.2605738 -0.3063121 -0.8145449 -1.290163 -1.734414 -2.142574 -2.492280 -2.804363 -3.104316 -3.370342 -3.567244 -3.705795 -3.892327 -4.073750 -4.228030 -4.242943 -4.251629 -4.244199 -3.957463 -2.774865 0.1898048 -0.3562298 -0.8554168 -1.327987 -1.777599 -2.184834 -2.533113 -2.850700 -3.150070 -3.408235 -3.625945 -3.777144 -3.953837 -4.123376 -4.257801 -4.261274 -4.262404 -4.233369 -3.923431 -2.774865 6.1340518E-02 -0.4608765 -0.9448272 -1.410735 -1.848815 -2.241325 -2.594359 -2.915726 -3.207918 -3.474228 -3.694854 -3.854178 -4.021795 -4.175264 -4.277289 -4.284497 -4.272607 -4.219181 -3.885867 -2.774865 -0.1155771 -0.6108531 -1.077810 -1.523516 -1.935063 -2.323743 -2.678252 -2.995534 -3.291217 -3.556898 -3.775949 -3.937241 -4.090101 -4.225320 -4.300571 -4.308852 -4.280392 -4.200709 -3.845561 -2.774865 -0.3360433 -0.8024512 -1.238129 -1.651785 -2.055494 -2.433791 -2.783003 -3.101852 -3.392498 -3.648086 -3.869119 -4.024661 -4.159330 -4.267988 -4.329969 -4.332032 -4.284298 -4.176969 -3.802562 -2.774865 -0.5946593 -1.020086 -1.423910 -1.820835 -2.204349 -2.574712 -2.918364 -3.226461 -3.502219 -3.756691 -3.969548 -4.109499 -4.223921 -4.309081 -4.361817 -4.352396 -4.282352 -4.146859 -3.756575 -2.774865 -0.8825331 -1.271049 -1.649221 -2.022087 -2.391210 -2.748200 -3.070970 -3.363513 -3.635923 -3.877995 -4.064054 -4.190150 -4.280596 -4.351884 -4.391975 -4.367316 -4.273352 -4.109038 -3.707256 -2.774865 -1.208389 -1.561548 -1.914053 -2.262665 -2.606247 -2.934101 -3.244935 -3.528939 -3.780190 -3.989048 -4.156813 -4.259376 -4.335286 -4.392020 -4.415573 -4.374001 -4.254716 -4.062076 -3.654214 -2.774865 -1.570059 -1.890686 -2.209775 -2.522419 -2.839420 -3.152792 -3.447899 -3.694638 -3.913264 -4.093523 -4.234796 -4.323558 -4.384424 -4.425143 -4.428923 -4.368419 -4.223621 -4.004386 -3.597013 -2.774865 -1.962944 -2.241510 -2.526509 -2.814281 -3.106775 -3.378759 -3.629961 -3.846149 -4.027685 -4.180205 -4.304276 -4.380609 -4.422757 -4.445755 -4.428027 -4.346075 -4.176421 -3.934698 -3.535274 -2.774865 -2.392451 -2.629225 -2.867946 -3.108792 -3.354609 -3.584309 -3.791125 -3.967982 -4.124605 -4.257832 -4.363449 -4.423168 -4.444909 -4.446404 -4.406152 -4.301317 -4.108856 -3.853164 -3.469063 -2.774865 -2.840475 -3.016004 -3.201868 -3.386913 -3.575314 -3.760403 -3.932056 -4.079867 -4.208601 -4.317925 -4.401388 -4.440397 -4.439928 -4.415930 -4.353199 -4.227644 -4.016709 -3.757787 -3.396946 -2.774865 -3.303478 -3.406382 -3.528507 -3.656023 -3.791099 -3.928454 -4.057209 -4.168232 -4.263606 -4.343026 -4.398515 -4.413294 -4.389231 -4.338929 -4.256366 -4.115644 -3.896991 -3.645483 -3.317764 -2.774865 -3.784428 -3.806270 -3.852563 -3.911559 -3.983654 -4.063538 -4.138922 -4.203187 -4.257049 -4.300052 -4.322813 -4.311857 -4.265701 -4.194689 -4.100495 -3.956478 -3.743568 -3.514257 -3.229548 -2.774865 -4.278531 -4.211401 -4.164012 -4.135029 -4.125671 -4.130906 -4.138890 -4.143612 -4.146841 -4.148410 -4.137735 -4.101784 -4.039010 -3.959464 -3.868448 -3.742332 -3.556587 -3.358876 -3.128351 -2.774865 -15.09291 -14.77395 -14.39686 -13.96776 -13.49210 -12.97455 -12.41904 -11.82887 -11.20689 -10.55550 -9.876757 -9.172474 -8.444216 -7.693366 -6.921161 -6.128703 -5.316983 -4.486903 -3.639279 -2.774865 -0.6017007 -1.150716 -1.545746 -1.957643 -2.315720 -2.628510 -2.846795 -3.041841 -3.283873 -3.505289 -3.703274 -3.805968 -3.936609 -4.107651 -4.262385 -4.380257 -4.400887 -4.456279 -4.277996 -2.916559 3.7475374E-02 -0.5832211 -1.074584 -1.560288 -1.996377 -2.376738 -2.592443 -2.878473 -3.173831 -3.448838 -3.685318 -3.728606 -3.911825 -4.110287 -4.287427 -4.402801 -4.397743 -4.453726 -4.257210 -2.916559 0.3509764 -0.2937554 -0.8499580 -1.363899 -1.828626 -2.207250 -2.512477 -2.833293 -3.150401 -3.443109 -3.679007 -3.733543 -3.933281 -4.136758 -4.321264 -4.413569 -4.404465 -4.451708 -4.233737 -2.916559 0.4940459 -0.1600639 -0.7340926 -1.262425 -1.725517 -2.140894 -2.503861 -2.845146 -3.167194 -3.459734 -3.664197 -3.783437 -3.980860 -4.179013 -4.360443 -4.410037 -4.417177 -4.449266 -4.207271 -2.916559 0.5095056 -0.1275869 -0.6987062 -1.217560 -1.698309 -2.142301 -2.534482 -2.883137 -3.201152 -3.488283 -3.696384 -3.851937 -4.040441 -4.230907 -4.401528 -4.421875 -4.433386 -4.445637 -4.177440 -2.916559 0.4418658 -0.1710806 -0.7248339 -1.243107 -1.733249 -2.187979 -2.589456 -2.932195 -3.250318 -3.526002 -3.756837 -3.931469 -4.108024 -4.289411 -4.439200 -4.444704 -4.451356 -4.439878 -4.143878 -2.916559 0.3077877 -0.2744391 -0.8121054 -1.322868 -1.810784 -2.261619 -2.652150 -2.994228 -3.311256 -3.593627 -3.834719 -4.011897 -4.183224 -4.350367 -4.466366 -4.473963 -4.469008 -4.431081 -4.106203 -2.916559 0.1219276 -0.4300244 -0.9457330 -1.442882 -1.916715 -2.345481 -2.728551 -3.076466 -3.391597 -3.681699 -3.921617 -4.099034 -4.263760 -4.411089 -4.497384 -4.507253 -4.484530 -4.418214 -4.065332 -2.916559 -0.1116162 -0.6293305 -1.118817 -1.591348 -2.036213 -2.451454 -2.833817 -3.176907 -3.497451 -3.782887 -4.014254 -4.194424 -4.343451 -4.465955 -4.536246 -4.540369 -4.496652 -4.400127 -4.021493 -2.916559 -0.3877272 -0.8674753 -1.322271 -1.760059 -2.186335 -2.589093 -2.963360 -3.307252 -3.619039 -3.889590 -4.120606 -4.292440 -4.421837 -4.517290 -4.577450 -4.570360 -4.503180 -4.375414 -3.974280 -2.916559 -0.6997800 -1.130784 -1.553424 -1.967507 -2.369921 -2.761943 -3.127119 -3.454830 -3.749096 -4.016946 -4.236289 -4.384500 -4.492465 -4.570788 -4.616688 -4.594276 -4.502551 -4.342469 -3.923267 -2.916559 -1.041696 -1.434632 -1.825938 -2.212100 -2.596436 -2.971105 -3.307435 -3.619883 -3.907686 -4.154006 -4.344018 -4.470706 -4.557359 -4.622373 -4.650611 -4.609954 -4.492388 -4.299630 -3.867964 -2.916559 -1.427917 -1.782649 -2.140859 -2.499951 -2.848864 -3.191287 -3.517924 -3.816411 -4.068276 -4.281075 -4.443373 -4.547827 -4.617304 -4.666759 -4.675906 -4.614341 -4.469206 -4.244936 -3.807863 -2.916559 -1.853859 -2.166979 -2.483925 -2.802398 -3.129827 -3.453809 -3.743452 -3.995992 -4.213085 -4.389207 -4.526946 -4.616725 -4.669204 -4.698800 -4.687012 -4.603339 -4.428930 -4.176600 -3.742249 -2.916559 -2.313549 -2.579791 -2.861463 -3.142494 -3.422930 -3.697333 -3.943045 -4.149729 -4.327349 -4.479091 -4.598760 -4.671021 -4.706302 -4.712116 -4.676510 -4.569522 -4.366633 -4.094573 -3.671161 -2.916559 -2.811279 -3.017493 -3.241995 -3.463687 -3.688874 -3.905198 -4.102765 -4.276453 -4.427246 -4.554048 -4.649946 -4.701197 -4.715384 -4.696166 -4.633881 -4.502923 -4.276838 -3.996374 -3.593503 -2.916559 -3.330055 -3.456224 -3.605345 -3.764416 -3.929586 -4.095336 -4.248065 -4.383064 -4.499457 -4.595643 -4.662393 -4.688445 -4.676151 -4.632790 -4.544693 -4.391863 -4.155060 -3.878371 -3.507623 -2.916559 -3.873939 -3.910255 -3.975601 -4.056300 -4.152232 -4.255464 -4.352778 -4.436983 -4.509840 -4.567794 -4.599107 -4.596415 -4.556916 -4.494295 -4.388636 -4.225659 -3.993338 -3.736810 -3.411316 -2.916559 -4.432511 -4.368555 -4.328825 -4.311913 -4.319128 -4.338550 -4.361707 -4.380236 -4.398240 -4.410550 -4.405074 -4.374905 -4.315779 -4.245294 -4.140405 -3.993031 -3.788054 -3.565084 -3.299935 -2.916559 -16.92084 -16.56669 -16.14295 -15.65765 -15.11781 -14.52925 -13.89684 -13.22461 -12.51596 -11.77374 -11.00041 -10.19806 -9.368533 -8.513438 -7.634208 -6.732120 -5.808321 -4.863848 -3.899639 -2.916559 -0.5150688 -1.117788 -1.546046 -1.992781 -2.377039 -2.708349 -2.957775 -3.138699 -3.390166 -3.620141 -3.826950 -3.950820 -4.064908 -4.243202 -4.404670 -4.533715 -4.554557 -4.626456 -4.476121 -3.048875 0.2167018 -0.4674377 -1.013488 -1.547038 -2.014496 -2.427714 -2.673224 -2.950807 -3.259590 -3.550521 -3.804728 -3.862855 -4.033693 -4.243540 -4.431072 -4.562116 -4.551893 -4.626489 -4.457635 -3.048875 0.5689571 -0.1515198 -0.7712561 -1.328257 -1.832281 -2.254885 -2.571654 -2.898562 -3.230303 -3.544311 -3.802465 -3.864302 -4.059845 -4.273364 -4.468499 -4.578600 -4.561764 -4.627928 -4.436310 -3.048875 0.7307960 -1.3125208E-03 -0.6359839 -1.212840 -1.728333 -2.164608 -2.547273 -2.905173 -3.250929 -3.568592 -3.789338 -3.917204 -4.114694 -4.320664 -4.513628 -4.576787 -4.579748 -4.629694 -4.411734 -3.048875 0.7602206 4.5153420E-02 -0.5860032 -1.165389 -1.678136 -2.146695 -2.567029 -2.946284 -3.296227 -3.600674 -3.822871 -3.991045 -4.182975 -4.378248 -4.561748 -4.590762 -4.602777 -4.630778 -4.383462 -3.048875 0.6910251 1.0139622E-02 -0.6076474 -1.170140 -1.694581 -2.183501 -2.622190 -3.011207 -3.351701 -3.642518 -3.885307 -4.075416 -4.258636 -4.443608 -4.607140 -4.618866 -4.627791 -4.630186 -4.351038 -3.048875 0.5521623 -9.3083158E-02 -0.6838956 -1.240090 -1.766683 -2.258590 -2.703256 -3.079806 -3.412436 -3.712448 -3.966656 -4.164479 -4.340078 -4.514893 -4.643747 -4.655790 -4.652923 -4.626961 -4.313930 -3.048875 0.3565137 -0.2493220 -0.8182483 -1.358343 -1.878984 -2.362955 -2.786736 -3.155365 -3.497749 -3.799674 -4.058956 -4.255639 -4.427027 -4.585499 -4.683850 -4.697540 -4.676286 -4.619987 -4.273112 -3.048875 0.1110635 -0.4573178 -0.9944673 -1.517111 -2.018483 -2.474018 -2.883517 -3.260437 -3.598242 -3.905668 -4.158473 -4.354169 -4.519013 -4.650969 -4.731748 -4.738891 -4.696466 -4.607896 -4.229084 -3.048875 -0.1802812 -0.7066271 -1.211803 -1.708555 -2.169895 -2.608713 -3.014091 -3.384366 -3.724583 -4.023706 -4.266277 -4.459941 -4.608306 -4.715524 -4.781837 -4.776904 -4.712141 -4.589227 -4.181302 -3.048875 -0.5094746 -0.9920093 -1.459817 -1.915509 -2.358471 -2.777868 -3.174731 -3.540543 -3.866263 -4.151324 -4.391096 -4.567324 -4.693277 -4.780371 -4.830991 -4.810166 -4.720527 -4.562061 -4.129216 -3.048875 -0.8747312 -1.310804 -1.740128 -2.165244 -2.582726 -2.990148 -3.372970 -3.711774 -4.023711 -4.302253 -4.518774 -4.669528 -4.771614 -4.841302 -4.875365 -4.836317 -4.718755 -4.524456 -4.072275 -3.048875 -1.282798 -1.674638 -2.065997 -2.460639 -2.855275 -3.231338 -3.583786 -3.913027 -4.210271 -4.451714 -4.637520 -4.761079 -4.843913 -4.896218 -4.911012 -4.851537 -4.703655 -4.473970 -4.009857 -3.048875 -1.735459 -2.082302 -2.439831 -2.790705 -3.148021 -3.502584 -3.838499 -4.130834 -4.380084 -4.585373 -4.737077 -4.838905 -4.908584 -4.941013 -4.933484 -4.850065 -4.671197 -4.408192 -3.941245 -3.048875 -2.229963 -2.523457 -2.834130 -3.154975 -3.484907 -3.792529 -4.076199 -4.320031 -4.524047 -4.690210 -4.820939 -4.904833 -4.955931 -4.968627 -4.935436 -4.824433 -4.616232 -4.326735 -3.865608 -3.048875 -2.773561 -3.006114 -3.259415 -3.523765 -3.790787 -4.043354 -4.267938 -4.465350 -4.638114 -4.779946 -4.886419 -4.949333 -4.975782 -4.966720 -4.905383 -4.765531 -4.531404 -4.226505 -3.782788 -3.048875 -3.343021 -3.494285 -3.670483 -3.860613 -4.058699 -4.253198 -4.432740 -4.589777 -4.727139 -4.838048 -4.915009 -4.951973 -4.950416 -4.914420 -4.825454 -4.660488 -4.410199 -4.103298 -3.690546 -3.048875 -3.946383 -3.996809 -4.083514 -4.189124 -4.310830 -4.439013 -4.558757 -4.664098 -4.756103 -4.826333 -4.866611 -4.872432 -4.841302 -4.779831 -4.670037 -4.493133 -4.242200 -3.951916 -3.586395 -3.048875 -4.568722 -4.507771 -4.480724 -4.478929 -4.501534 -4.540181 -4.577687 -4.613078 -4.646050 -4.668800 -4.668779 -4.644519 -4.592372 -4.518388 -4.405900 -4.244115 -4.017378 -3.765474 -3.465101 -3.048875 -18.79339 -18.40347 -17.93162 -17.38812 -16.78170 -16.11952 -15.40742 -14.65022 -13.85190 -13.01578 -12.14470 -11.24108 -10.30704 -9.344409 -8.354836 -7.339768 -6.300516 -5.238254 -4.154050 -3.048875 -0.4332941 -1.093455 -1.574353 -2.021601 -2.432405 -2.785457 -3.059878 -3.232034 -3.492965 -3.730062 -3.943661 -4.086753 -4.185808 -4.370911 -4.538039 -4.676194 -4.697057 -4.783376 -4.659530 -3.172978 0.3957274 -0.3508615 -0.9439958 -1.516023 -2.033073 -2.472158 -2.749363 -3.026332 -3.343752 -3.646470 -3.915153 -3.992996 -4.149420 -4.369002 -4.565827 -4.710647 -4.694254 -4.785879 -4.643654 -3.172978 0.7898958 5.6359200E-03 -0.6743143 -1.297039 -1.834295 -2.292675 -2.641717 -2.969400 -3.309366 -3.635997 -3.917263 -3.990820 -4.181448 -4.402030 -4.606653 -4.733280 -4.707786 -4.790727 -4.624812 -3.172978 0.9697243 0.1682774 -0.5413454 -1.164133 -1.721918 -2.202013 -2.602246 -2.968238 -3.327381 -3.664885 -3.911067 -4.048780 -4.243134 -4.456026 -4.656216 -4.734266 -4.731369 -4.796687 -4.602540 -3.172978 1.006190 0.2168248 -0.4759276 -1.107067 -1.672124 -2.167922 -2.603667 -3.004137 -3.377227 -3.709329 -3.944933 -4.128018 -4.320063 -4.520256 -4.710055 -4.750766 -4.760647 -4.802596 -4.576314 -3.172978 0.9386244 0.1883712 -0.4888710 -1.111332 -1.672805 -2.183084 -2.649084 -3.069229 -3.447062 -3.756155 -4.012313 -4.215112 -4.405849 -4.593074 -4.764852 -4.785584 -4.792530 -4.807342 -4.545541 -3.172978 0.7939665 8.7016322E-02 -0.5646587 -1.168115 -1.727249 -2.251185 -2.728936 -3.156774 -3.516534 -3.827216 -4.095451 -4.310014 -4.494647 -4.671197 -4.810619 -4.830837 -4.824792 -4.809926 -4.509587 -3.172978 0.5892318 -7.3085852E-02 -0.6937497 -1.278630 -1.837457 -2.357846 -2.835863 -3.242148 -3.597841 -3.917619 -4.190071 -4.410890 -4.587767 -4.751299 -4.859281 -4.880238 -4.856023 -4.809164 -4.469463 -3.172978 0.3308324 -0.2851735 -0.8729149 -1.441537 -1.983833 -2.492090 -2.940230 -3.339530 -3.703263 -4.023945 -4.297214 -4.510723 -4.686722 -4.829406 -4.918109 -4.928660 -4.884482 -4.803521 -4.425908 -3.172978 2.4721663E-02 -0.5449754 -1.096912 -1.642883 -2.157717 -2.630499 -3.065642 -3.466523 -3.827157 -4.149765 -4.411467 -4.619649 -4.789821 -4.905261 -4.978179 -4.975064 -4.908174 -4.791256 -4.378316 -3.172978 -0.3220011 -0.8472049 -1.363881 -1.870500 -2.345119 -2.802355 -3.224397 -3.619772 -3.977287 -4.284862 -4.536835 -4.740024 -4.885663 -4.981589 -5.035447 -5.017269 -4.924654 -4.770293 -4.326029 -3.172978 -0.7100441 -1.189782 -1.657384 -2.123221 -2.574196 -3.009694 -3.424429 -3.806886 -4.139392 -4.435961 -4.678805 -4.854528 -4.981232 -5.053601 -5.088613 -5.051898 -4.931710 -4.738472 -4.268255 -3.172978 -1.138317 -1.564612 -1.993839 -2.422470 -2.851426 -3.267404 -3.653001 -4.006955 -4.330776 -4.610457 -4.814113 -4.962714 -5.066177 -5.119836 -5.134534 -5.075354 -4.926363 -4.692750 -4.204261 -3.172978 -1.616255 -1.991446 -2.380497 -2.776861 -3.167839 -3.547753 -3.912436 -4.250133 -4.534632 -4.764264 -4.936703 -5.053998 -5.138777 -5.175162 -5.168061 -5.083380 -4.903982 -4.630100 -4.133172 -3.172978 -2.144437 -2.465379 -2.803603 -3.155565 -3.519884 -3.877954 -4.192991 -4.474798 -4.709970 -4.893826 -5.034808 -5.132021 -5.196562 -5.213273 -5.181627 -5.069870 -4.857647 -4.549857 -4.053865 -3.172978 -2.718664 -2.982509 -3.270058 -3.568501 -3.876651 -4.170720 -4.427904 -4.650729 -4.841275 -4.997318 -5.114093 -5.190310 -5.231050 -5.223619 -5.163292 -5.022437 -4.778742 -4.448417 -3.966340 -3.172978 -3.342597 -3.519398 -3.727406 -3.949121 -4.179625 -4.404996 -4.608670 -4.790468 -4.946197 -5.070901 -5.157856 -5.207726 -5.220745 -5.184299 -5.093369 -4.924421 -4.658978 -4.321050 -3.868351 -3.172978 -4.004678 -4.071284 -4.179457 -4.310268 -4.460414 -4.612695 -4.751729 -4.880788 -4.991836 -5.077463 -5.125890 -5.140494 -5.124189 -5.058235 -4.941364 -4.755248 -4.486178 -4.161117 -3.756912 -3.172978 -4.696100 -4.634503 -4.619565 -4.634468 -4.678133 -4.730130 -4.783026 -4.838774 -4.887325 -4.925210 -4.930204 -4.911119 -4.872008 -4.788960 -4.665428 -4.490060 -4.245477 -3.960775 -3.625892 -3.172978 -20.70810 -20.28184 -19.76070 -19.15682 -18.48157 -17.74329 -16.94890 -16.10401 -15.21321 -14.28032 -13.30856 -12.30070 -11.25912 -10.18591 -9.083157 -7.952014 -6.793946 -5.610763 -4.403410 -3.172978 -0.3675331 -1.085094 -1.612674 -2.056533 -2.484451 -2.855610 -3.155569 -3.320767 -3.591905 -3.835693 -4.054796 -4.214272 -4.300354 -4.491707 -4.663702 -4.809232 -4.830080 -4.928710 -4.829414 -3.289828 0.5622742 -0.2560816 -0.8860914 -1.478450 -2.028265 -2.515386 -2.821292 -3.097319 -3.428159 -3.739031 -4.018672 -4.118140 -4.259446 -4.487949 -4.693433 -4.849289 -4.827557 -4.933412 -4.816261 -3.289828 1.005619 0.1559635 -0.5695604 -1.231902 -1.833840 -2.327956 -2.702629 -3.047956 -3.390260 -3.725148 -4.021194 -4.114517 -4.298294 -4.525126 -4.738366 -4.877405 -4.845040 -4.941492 -4.800070 -3.289828 1.208950 0.3435303 -0.4195557 -1.113743 -1.715062 -2.228600 -2.666237 -3.039934 -3.404445 -3.752655 -4.024113 -4.177776 -4.367699 -4.585609 -4.792449 -4.881002 -4.874359 -4.951341 -4.780302 -3.289828 1.255534 0.3989644 -0.3673101 -1.049587 -1.658248 -2.197161 -2.655773 -3.064843 -3.451859 -3.805496 -4.065093 -4.262295 -4.453488 -4.658374 -4.852633 -4.899421 -4.910060 -4.961807 -4.756356 -3.289828 1.186705 0.3642906 -0.3709643 -1.048501 -1.659097 -2.199490 -2.680571 -3.123554 -3.525213 -3.865360 -4.133846 -4.354465 -4.546810 -4.739513 -4.915081 -4.940725 -4.948890 -4.971758 -4.727503 -3.289828 1.034347 0.2643892 -0.4437035 -1.104721 -1.702574 -2.247161 -2.753120 -3.210733 -3.611642 -3.940841 -4.222052 -4.451530 -4.645104 -4.824256 -4.971204 -4.992574 -4.989087 -4.979997 -4.692948 -3.289828 0.8196638 0.1011414 -0.5761107 -1.206592 -1.797991 -2.350130 -2.860789 -3.318538 -3.700572 -4.033099 -4.317394 -4.556178 -4.746501 -4.913058 -5.027021 -5.047375 -5.028131 -4.985320 -4.653727 -3.289828 0.5478966 -0.1187973 -0.7536518 -1.368557 -1.945050 -2.491041 -2.991005 -3.422782 -3.804470 -4.142833 -4.428865 -4.666876 -4.850536 -5.003012 -5.093215 -5.104278 -5.063912 -4.985986 -4.610993 -3.289828 0.2265708 -0.3866851 -0.9856998 -1.573701 -2.130522 -2.654105 -3.119361 -3.546073 -3.930474 -4.268749 -4.551839 -4.779096 -4.961287 -5.087828 -5.161248 -5.160982 -5.094841 -4.980100 -4.563935 -3.289828 -0.1361238 -0.7045745 -1.263021 -1.817294 -2.340971 -2.823577 -3.281139 -3.698478 -4.080630 -4.414135 -4.679695 -4.903514 -5.072134 -5.175289 -5.228733 -5.211514 -5.119970 -4.965766 -4.511708 -3.289828 -0.5424977 -1.064803 -1.580229 -2.081437 -2.569099 -3.036479 -3.474652 -3.888846 -4.259009 -4.566666 -4.825408 -5.033632 -5.176232 -5.258132 -5.292992 -5.254590 -5.136800 -4.940322 -4.453507 -3.289828 -0.9932767 -1.457512 -1.924605 -2.387866 -2.847022 -3.294658 -3.717646 -4.103571 -4.447116 -4.747317 -4.983284 -5.155061 -5.273372 -5.333505 -5.349308 -5.288107 -5.141129 -4.900486 -4.388456 -3.289828 -1.493213 -1.901338 -2.320808 -2.749759 -3.182719 -3.594682 -3.984670 -4.351425 -4.676138 -4.930063 -5.126886 -5.264677 -5.357355 -5.399144 -5.392842 -5.307183 -5.127558 -4.842767 -4.315540 -3.289828 -2.050246 -2.403419 -2.772090 -3.154577 -3.547783 -3.936392 -4.303989 -4.615607 -4.880992 -5.087252 -5.241789 -5.355666 -5.428169 -5.448553 -5.417142 -5.303734 -5.089122 -4.766381 -4.233533 -3.289828 -2.659152 -2.946299 -3.265264 -3.607702 -3.949099 -4.279765 -4.576819 -4.828152 -5.038013 -5.206954 -5.334138 -5.425507 -5.475654 -5.470596 -5.410009 -5.265820 -5.016257 -4.666838 -4.141631 -3.289828 -3.328985 -3.533174 -3.772579 -4.031228 -4.296830 -4.547877 -4.777163 -4.982487 -5.158877 -5.296853 -5.393978 -5.456872 -5.478797 -5.443432 -5.351041 -5.176023 -4.899045 -4.538060 -4.038539 -3.289828 -4.051935 -4.133114 -4.264698 -4.422774 -4.602833 -4.778114 -4.943322 -5.093092 -5.222836 -5.320862 -5.378736 -5.407366 -5.394412 -5.326550 -5.205707 -5.009813 -4.722981 -4.371957 -3.920563 -3.289828 -4.814472 -4.750566 -4.747556 -4.781768 -4.846212 -4.916610 -4.992768 -5.065597 -5.129389 -5.174548 -5.187453 -5.180194 -5.140291 -5.053076 -4.922950 -4.732563 -4.469552 -4.159451 -3.781281 -3.289828 -22.66275 -22.19959 -21.62731 -20.96165 -20.21541 -19.39871 -18.51958 -17.58445 -16.59854 -15.56618 -14.49100 -13.37612 -12.22419 -11.03756 -9.818288 -8.568188 -7.288898 -5.981876 -4.648451 -3.289828 -0.3111334 -1.083217 -1.657134 -2.106240 -2.539774 -2.922794 -3.242739 -3.405729 -3.686105 -3.937125 -4.161215 -4.334326 -4.408988 -4.606145 -4.782480 -4.934460 -4.954729 -5.064297 -4.988027 -3.400226 0.7150205 -0.1722528 -0.8657261 -1.459918 -2.021472 -2.534209 -2.892256 -3.165056 -3.509124 -3.829363 -4.118009 -4.238601 -4.364664 -4.601007 -4.813960 -4.980263 -4.952401 -5.071236 -4.977859 -3.400226 1.209482 0.2834918 -0.4802590 -1.167654 -1.801777 -2.357706 -2.760489 -3.118499 -3.475227 -3.813098 -4.119019 -4.232299 -4.410525 -4.643026 -4.863735 -5.014593 -4.974056 -5.082538 -4.964687 -3.400226 1.437069 0.5083159 -0.2982849 -1.034611 -1.700870 -2.251785 -2.718829 -3.119192 -3.485407 -3.838758 -4.127887 -4.304861 -4.489425 -4.710234 -4.923865 -5.021903 -5.009091 -5.096204 -4.947901 -3.400226 1.496974 0.5804187 -0.2402922 -0.9882312 -1.642214 -2.215540 -2.713097 -3.134676 -3.526476 -3.892937 -4.175569 -4.394879 -4.584899 -4.790187 -4.991336 -5.043517 -5.051420 -5.111129 -4.926728 -3.400226 1.434222 0.5478602 -0.2535382 -0.9849322 -1.638553 -2.221665 -2.727510 -3.179326 -3.596559 -3.962466 -4.256299 -4.491482 -4.683744 -4.880160 -5.060843 -5.089413 -5.097809 -5.126196 -4.900371 -3.400226 1.273816 0.4380205 -0.3254133 -1.035495 -1.684222 -2.258625 -2.780241 -3.260699 -3.689427 -4.052531 -4.342834 -4.592885 -4.789606 -4.973047 -5.124193 -5.147632 -5.145547 -5.139967 -4.867877 -3.400226 1.047406 0.2719340 -0.4576142 -1.143248 -1.768179 -2.344404 -2.883320 -3.372913 -3.797369 -4.147265 -4.444816 -4.698906 -4.899054 -5.068219 -5.188535 -5.211463 -5.191605 -5.151141 -4.830212 -3.400226 0.7600386 4.4709731E-02 -0.6419888 -1.298573 -1.908196 -2.484883 -3.021357 -3.500142 -3.904799 -4.258070 -4.555663 -4.816633 -5.009418 -5.165075 -5.263093 -5.276983 -5.235105 -5.158281 -4.789028 -3.400226 0.4299378 -0.2342340 -0.8767003 -1.506908 -2.097180 -2.661901 -3.174954 -3.624442 -4.031936 -4.382715 -4.684441 -4.938546 -5.123596 -5.261935 -5.343341 -5.339598 -5.275029 -5.159595 -4.743343 -3.400226 4.8850972E-02 -0.5654163 -1.164114 -1.756406 -2.325227 -2.854787 -3.332501 -3.782693 -4.179281 -4.533262 -4.824399 -5.062339 -5.241815 -5.358885 -5.420737 -5.397866 -5.309004 -5.152823 -4.692186 -3.400226 -0.3793038 -0.9387484 -1.495046 -2.043457 -2.564899 -3.063109 -3.532581 -3.967315 -4.361405 -4.698041 -4.971061 -5.201694 -5.358845 -5.455370 -5.491611 -5.450260 -5.334543 -5.134855 -4.634562 -3.400226 -0.8509532 -1.354354 -1.856088 -2.355400 -2.848254 -3.320451 -3.777493 -4.197983 -4.562287 -4.878158 -5.143202 -5.340993 -5.472446 -5.540631 -5.554332 -5.494021 -5.347716 -5.102078 -4.569312 -3.400226 -1.372776 -1.812650 -2.262563 -2.723886 -3.188045 -3.639480 -4.059669 -4.448102 -4.796868 -5.088192 -5.303973 -5.468880 -5.567458 -5.614484 -5.606948 -5.524800 -5.343650 -5.050427 -4.495214 -3.400226 -1.955066 -2.334672 -2.734984 -3.154936 -3.574952 -3.989198 -4.385961 -4.746477 -5.037748 -5.271801 -5.442657 -5.571116 -5.647006 -5.673693 -5.641788 -5.533099 -5.315190 -4.978260 -4.410882 -3.400226 -2.597131 -2.907164 -3.251247 -3.626677 -4.017616 -4.376739 -4.709520 -4.995512 -5.229809 -5.410007 -5.548347 -5.654817 -5.705117 -5.708213 -5.646729 -5.506659 -5.251633 -4.879870 -4.314686 -3.400226 -3.311166 -3.534079 -3.806519 -4.104379 -4.408621 -4.689808 -4.946534 -5.171499 -5.365264 -5.515110 -5.622129 -5.701313 -5.722893 -5.696437 -5.600645 -5.425790 -5.140349 -4.748456 -4.206044 -3.400226 -4.085574 -4.184025 -4.340592 -4.530175 -4.737606 -4.940947 -5.132758 -5.302329 -5.446111 -5.555626 -5.623466 -5.666043 -5.653818 -5.593332 -5.465075 -5.261787 -4.962565 -4.574983 -4.080654 -3.400226 -4.919185 -4.860876 -4.867221 -4.923580 -5.005030 -5.098572 -5.198305 -5.290401 -5.367512 -5.418941 -5.443922 -5.448360 -5.403992 -5.319125 -5.178442 -4.973224 -4.694075 -4.351298 -3.931567 -3.400226 -24.65536 -24.15474 -23.53021 -22.80100 -21.98149 -21.08415 -20.11794 -19.09016 -18.00666 -16.87231 -15.69140 -14.46663 -13.20173 -11.89903 -10.56079 -9.189045 -7.785823 -6.352006 -4.889780 -3.400226 -0.2582211 -1.085216 -1.700606 -2.158165 -2.608668 -2.992461 -3.324309 -3.486219 -3.776536 -4.033598 -4.263398 -4.447760 -4.512322 -4.714937 -4.894907 -5.052647 -5.071968 -5.191449 -5.135988 -3.504848 0.8588329 -9.4733737E-02 -0.8314982 -1.471038 -2.031805 -2.552014 -2.947327 -3.231558 -3.585388 -3.917625 -4.214376 -4.355356 -4.464774 -4.708433 -4.926608 -5.104516 -5.069699 -5.200728 -5.128899 -3.504848 1.403023 0.4117638 -0.4248355 -1.124796 -1.770027 -2.356950 -2.817605 -3.186907 -3.554925 -3.900971 -4.214859 -4.344935 -4.519394 -4.755204 -4.978874 -5.145825 -5.095670 -5.214998 -5.118874 -3.504848 1.661352 0.6590567 -0.1933596 -0.9573916 -1.657428 -2.269087 -2.768672 -3.187954 -3.573147 -3.925457 -4.227779 -4.425446 -4.608947 -4.828477 -5.044133 -5.158701 -5.136389 -5.232832 -5.105181 -3.504848 1.734856 0.7525044 -0.1125018 -0.9037942 -1.620477 -2.230449 -2.757980 -3.212106 -3.605844 -3.977921 -4.279251 -4.524531 -4.712841 -4.916589 -5.118268 -5.183755 -5.186215 -5.252950 -5.087040 -3.504848 1.674241 0.7281267 -0.1241556 -0.9193822 -1.616314 -2.233494 -2.779143 -3.244226 -3.667162 -4.050351 -4.369172 -4.625286 -4.819962 -5.013483 -5.193142 -5.236092 -5.240224 -5.273525 -5.063538 -3.504848 1.515679 0.6143143 -0.2124113 -0.9676207 -1.658149 -2.277297 -2.819530 -3.311462 -3.759278 -4.152119 -4.465268 -4.729229 -4.929593 -5.115027 -5.266648 -5.302359 -5.294794 -5.293174 -5.033712 -3.504848 1.272184 0.4391130 -0.3424446 -1.077075 -1.749572 -2.350958 -2.906453 -3.420145 -3.877499 -4.260063 -4.566772 -4.839726 -5.045886 -5.215436 -5.339748 -5.374958 -5.349234 -5.310814 -4.998312 -3.504848 0.9736243 0.2048106 -0.5315213 -1.237499 -1.878240 -2.480600 -3.043869 -3.559748 -4.002764 -4.367850 -4.684436 -4.957450 -5.164339 -5.318652 -5.425969 -5.447643 -5.401760 -5.324581 -4.959319 -3.504848 0.6308885 -8.6480059E-02 -0.7734392 -1.440265 -2.066139 -2.660060 -3.215340 -3.707167 -4.126117 -4.500839 -4.811463 -5.083169 -5.280174 -5.426126 -5.513344 -5.517518 -5.450540 -5.332551 -4.915625 -3.504848 0.2309245 -0.4285051 -1.067875 -1.697073 -2.299187 -2.873770 -3.391813 -3.857906 -4.281959 -4.647451 -4.958405 -5.215141 -5.404708 -5.535063 -5.600324 -5.584744 -5.493131 -5.332499 -4.866174 -3.504848 -0.2152350 -0.8119714 -1.408409 -1.996740 -2.565984 -3.090948 -3.590472 -4.048651 -4.461432 -4.821031 -5.114991 -5.359374 -5.536551 -5.638627 -5.682186 -5.646410 -5.527351 -5.321576 -4.809663 -3.504848 -0.7091146 -1.246541 -1.790246 -2.324906 -2.849394 -3.354265 -3.832433 -4.281766 -4.678877 -5.007843 -5.289312 -5.515887 -5.656338 -5.734311 -5.757562 -5.697215 -5.550752 -5.295593 -4.744751 -3.504848 -1.254740 -1.723218 -2.207499 -2.701290 -3.192472 -3.674157 -4.133704 -4.544320 -4.913352 -5.230456 -5.474255 -5.657083 -5.765441 -5.818491 -5.819999 -5.733355 -5.557501 -5.249907 -4.670006 -3.504848 -1.859428 -2.264411 -2.694198 -3.146918 -3.603939 -4.042992 -4.466562 -4.854694 -5.187799 -5.441681 -5.634989 -5.776211 -5.857284 -5.890162 -5.864077 -5.750299 -5.538700 -5.182677 -4.583941 -3.504848 -2.534780 -2.865911 -3.235873 -3.640389 -4.062703 -4.472398 -4.835413 -5.152470 -5.409504 -5.608724 -5.756722 -5.872122 -5.929293 -5.938488 -5.880338 -5.734996 -5.481840 -5.087881 -4.484358 -3.504848 -3.287537 -3.531309 -3.830550 -4.168377 -4.511733 -4.829896 -5.113622 -5.358686 -5.563653 -5.728648 -5.848916 -5.935345 -5.963325 -5.938652 -5.846444 -5.666183 -5.373794 -4.957175 -4.371183 -3.504848 -4.111414 -4.227993 -4.409944 -4.631979 -4.867272 -5.100564 -5.318509 -5.508111 -5.664823 -5.787339 -5.872725 -5.919984 -5.909801 -5.845810 -5.718801 -5.509415 -5.194836 -4.779704 -4.239591 -3.504848 -5.018183 -4.963008 -4.983276 -5.058990 -5.161920 -5.283603 -5.404336 -5.512961 -5.602341 -5.668352 -5.706404 -5.710038 -5.664907 -5.572820 -5.427747 -5.213676 -4.916503 -4.544321 -4.081982 -3.504848 -26.68411 -26.14548 -25.46739 -24.67242 -23.77816 -22.79810 -21.74262 -20.61990 -19.43649 -18.19776 -16.90819 -15.57159 -14.19124 -12.76996 -11.31026 -9.814337 -8.284158 -6.721483 -5.127902 -3.504848 -0.2062544 -1.088387 -1.750437 -2.210900 -2.672429 -3.068598 -3.405827 -3.562893 -3.863487 -4.126023 -4.361462 -4.555253 -4.611126 -4.818648 -5.001878 -5.164519 -5.181802 -5.311528 -5.274209 -3.604268 0.9994668 -2.2602035E-02 -0.8164591 -1.477443 -2.070637 -2.580509 -2.998772 -3.290450 -3.658672 -3.999999 -4.308905 -4.469161 -4.560847 -4.811547 -5.034089 -5.222631 -5.179166 -5.322758 -5.269969 -3.604268 1.586132 0.5224836 -0.3628341 -1.121631 -1.760343 -2.355965 -2.847938 -3.254021 -3.630494 -3.987465 -4.310112 -4.454257 -4.624343 -4.863476 -5.087428 -5.271358 -5.208492 -5.340508 -5.262756 -3.604268 1.877503 0.8032927 -0.1185081 -0.9000422 -1.612554 -2.257223 -2.816819 -3.253805 -3.652532 -4.013309 -4.327142 -4.539485 -4.725808 -4.944035 -5.156759 -5.290724 -5.255911 -5.362807 -5.251845 -3.604268 1.968567 0.9126595 2.2739524E-03 -0.8190411 -1.573051 -2.241872 -2.799426 -3.275925 -3.692957 -4.063677 -4.380362 -4.645828 -4.836404 -5.041263 -5.232860 -5.319638 -5.313389 -5.387512 -5.236453 -3.604268 1.904949 0.9006945 1.4162759E-03 -0.8344499 -1.592381 -2.242547 -2.816020 -3.319146 -3.741773 -4.135061 -4.472770 -4.754009 -4.950099 -5.143796 -5.317982 -5.379572 -5.375510 -5.413472 -5.215375 -3.604268 1.749859 0.7873554 -9.0004951E-02 -0.9054028 -1.633387 -2.284238 -2.867846 -3.369318 -3.826912 -4.238231 -4.580291 -4.859476 -5.067176 -5.251388 -5.399097 -5.454949 -5.439581 -5.438879 -5.187323 -3.604268 1.498276 0.6033640 -0.2302553 -1.012988 -1.723230 -2.369891 -2.937417 -3.465687 -3.944200 -4.360018 -4.687346 -4.973022 -5.185951 -5.362973 -5.480915 -5.534928 -5.503004 -5.461967 -5.153201 -3.604268 1.187459 0.3624783 -0.4241479 -1.173506 -1.860271 -2.481639 -3.066152 -3.606210 -4.086234 -4.479946 -4.803664 -5.089718 -5.308210 -5.474569 -5.575531 -5.616309 -5.563875 -5.481742 -5.115754 -3.604268 0.8275973 5.9534147E-02 -0.6741892 -1.380990 -2.036884 -2.659445 -3.241044 -3.774846 -4.223469 -4.609710 -4.934176 -5.222423 -5.434301 -5.586859 -5.674438 -5.695783 -5.620426 -5.496380 -5.073694 -3.604268 0.4104963 -0.2896681 -0.9747114 -1.639951 -2.274158 -2.880262 -3.442574 -3.936155 -4.375109 -4.761409 -5.086819 -5.364285 -5.562137 -5.704947 -5.772915 -5.769605 -5.671984 -5.503258 -5.025602 -3.604268 -5.2176725E-02 -0.6896200 -1.324738 -1.946957 -2.556197 -3.126269 -3.643944 -4.131222 -4.558350 -4.940720 -5.254904 -5.507363 -5.699439 -5.817755 -5.864428 -5.836275 -5.715526 -5.499403 -4.970186 -3.604268 -0.5675454 -1.140903 -1.720266 -2.299996 -2.852161 -3.386683 -3.892223 -4.361425 -4.780560 -5.140815 -5.430158 -5.672741 -5.836902 -5.926962 -5.945468 -5.895951 -5.746751 -5.480820 -4.905938 -3.604268 -1.136321 -1.638534 -2.154865 -2.681465 -3.200913 -3.708302 -4.196613 -4.644436 -5.028383 -5.363805 -5.635409 -5.833482 -5.962862 -6.023403 -6.016143 -5.943683 -5.759765 -5.441934 -4.831108 -3.604268 -1.764576 -2.195934 -2.653515 -3.135542 -3.625069 -4.100451 -4.547460 -4.958163 -5.321978 -5.605022 -5.822937 -5.973864 -6.066137 -6.103058 -6.071656 -5.970804 -5.748755 -5.380494 -4.743819 -3.604268 -2.465664 -2.825256 -3.221229 -3.653179 -4.101650 -4.547398 -4.955254 -5.296797 -5.583432 -5.800256 -5.966655 -6.082406 -6.150274 -6.157140 -6.101279 -5.964172 -5.701975 -5.289190 -4.641737 -3.604268 -3.251937 -3.524122 -3.852192 -4.222268 -4.605308 -4.962655 -5.277244 -5.540799 -5.760335 -5.937241 -6.073261 -6.157213 -6.195650 -6.170048 -6.081650 -5.902285 -5.602092 -5.158242 -4.524194 -3.604268 -4.131814 -4.266122 -4.474647 -4.728087 -4.995451 -5.260244 -5.499629 -5.709956 -5.881363 -6.015608 -6.111423 -6.156911 -6.157588 -6.093027 -5.967524 -5.747614 -5.424469 -4.975532 -4.387561 -3.604268 -5.110407 -5.057364 -5.093200 -5.187176 -5.316485 -5.463889 -5.604241 -5.732641 -5.839346 -5.911694 -5.958154 -5.959113 -5.920681 -5.822757 -5.678611 -5.444047 -5.135856 -4.729300 -4.223372 -3.604268 -28.74740 -28.17021 -27.43730 -26.57515 -25.60403 -24.53923 -23.39239 -22.17258 -20.88703 -19.54166 -18.14140 -16.69041 -15.19226 -13.65007 -12.06653 -10.44405 -8.784773 -7.090600 -5.363248 -3.604268 -0.1562609 -1.100142 -1.795584 -2.262018 -2.740571 -3.144618 -3.488096 -3.637719 -3.945812 -4.214957 -4.455261 -4.657380 -4.705703 -4.917681 -5.104449 -5.270813 -5.286108 -5.425048 -5.404999 -3.698979 1.137504 4.0525395E-02 -0.7965555 -1.487893 -2.099912 -2.631880 -3.054857 -3.344974 -3.729762 -4.078070 -4.400154 -4.580444 -4.652912 -4.910599 -5.140111 -5.335131 -5.282599 -5.438639 -5.403984 -3.698979 1.764287 0.6439701 -0.3031584 -1.100833 -1.786709 -2.365661 -2.875930 -3.308491 -3.703873 -4.067276 -4.405205 -4.561127 -4.725478 -4.969363 -5.199461 -5.390868 -5.316626 -5.460124 -5.400165 -3.698979 2.089196 0.9461353 -3.2894809E-02 -0.8729103 -1.585210 -2.243569 -2.835097 -3.317247 -3.726655 -4.101024 -4.426080 -4.650079 -4.836578 -5.058843 -5.274223 -5.416530 -5.371660 -5.486785 -5.392757 -3.698979 2.184738 1.071545 9.2587225E-02 -0.7479496 -1.521414 -2.224339 -2.838118 -3.335637 -3.770794 -4.151503 -4.479324 -4.759052 -4.956821 -5.162589 -5.359057 -5.448106 -5.437166 -5.516677 -5.380756 -3.698979 2.118582 1.063742 0.1179512 -0.7501783 -1.545298 -2.252659 -2.850236 -3.376897 -3.825880 -4.219376 -4.571983 -4.873207 -5.076375 -5.272555 -5.450683 -5.514971 -5.507473 -5.547553 -5.362981 -3.698979 1.972568 0.9544947 3.1398460E-02 -0.8285291 -1.609228 -2.290350 -2.899555 -3.436498 -3.897336 -4.320004 -4.686289 -4.986877 -5.198308 -5.389353 -5.541108 -5.596803 -5.579280 -5.578510 -5.337926 -3.698979 1.722795 0.7662935 -0.1175480 -0.9482455 -1.697884 -2.373980 -2.981470 -3.513844 -4.008770 -4.444436 -4.803851 -5.097962 -5.320438 -5.509692 -5.629845 -5.683769 -5.650136 -5.608109 -5.306389 -3.698979 1.402403 0.5128875 -0.3181196 -1.111030 -1.835713 -2.494629 -3.090963 -3.649230 -4.153271 -4.582180 -4.922266 -5.221007 -5.446701 -5.628712 -5.731299 -5.772238 -5.718601 -5.634351 -5.271693 -3.698979 1.021076 0.2043829 -0.5755686 -1.326709 -2.015479 -2.658655 -3.264653 -3.822953 -4.311590 -4.715789 -5.059850 -5.350744 -5.579332 -5.745367 -5.838009 -5.858082 -5.783064 -5.655559 -5.232427 -3.698979 0.5848179 -0.1558423 -0.8862849 -1.585904 -2.251861 -2.883929 -3.479321 -4.012406 -4.467181 -4.871704 -5.208693 -5.496413 -5.712397 -5.868656 -5.943065 -5.938448 -5.841302 -5.668991 -5.186992 -3.698979 0.1031436 -0.5708601 -1.243113 -1.900216 -2.538739 -3.148287 -3.703040 -4.205208 -4.658733 -5.049329 -5.382285 -5.650030 -5.858398 -5.994468 -6.045643 -6.013699 -5.891581 -5.671961 -5.133705 -3.698979 -0.4332015 -1.036765 -1.651626 -2.266499 -2.861593 -3.418325 -3.953532 -4.441422 -4.882609 -5.263451 -5.569634 -5.822535 -6.007404 -6.113084 -6.136667 -6.079941 -5.931494 -5.660368 -5.070776 -3.698979 -1.018214 -1.556261 -2.106023 -2.661310 -3.213058 -3.746334 -4.259825 -4.731093 -5.143915 -5.493098 -5.785528 -6.001522 -6.144749 -6.216202 -6.216539 -6.134295 -5.954668 -5.628906 -4.996496 -3.698979 -1.669018 -2.128864 -2.614683 -3.122997 -3.641497 -4.154155 -4.629350 -5.059963 -5.443537 -5.761371 -5.996412 -6.159994 -6.261137 -6.306006 -6.279766 -6.170324 -5.952695 -5.574461 -4.908390 -3.698979 -2.397192 -2.778614 -3.208038 -3.665767 -4.139729 -4.615212 -5.058853 -5.436594 -5.742932 -5.984697 -6.163215 -6.281636 -6.353091 -6.376155 -6.318495 -6.174857 -5.913574 -5.488706 -4.804215 -3.698979 -3.213125 -3.505485 -3.869770 -4.273227 -4.689689 -5.089373 -5.432269 -5.721686 -5.953101 -6.141107 -6.282427 -6.370419 -6.410378 -6.401144 -6.312010 -6.125927 -5.820089 -5.360678 -4.681906 -3.698979 -4.145188 -4.300012 -4.536008 -4.819952 -5.121515 -5.415975 -5.680165 -5.904305 -6.093938 -6.236490 -6.337970 -6.388023 -6.387866 -6.335872 -6.208602 -5.982245 -5.644836 -5.176322 -4.538095 -3.698979 -5.195486 -5.146212 -5.196448 -5.311852 -5.470875 -5.641870 -5.803926 -5.945391 -6.064422 -6.149432 -6.201508 -6.203754 -6.158999 -6.074897 -5.916373 -5.675800 -5.347851 -4.918234 -4.363475 -3.698979 -30.84375 -30.22746 -29.43848 -28.50754 -27.45778 -26.30634 -25.06614 -23.74718 -22.35739 -20.90325 -19.39012 -17.82254 -16.20440 -14.53906 -12.82945 -11.07817 -9.287535 -7.459592 -5.596184 -3.698979 -0.1182113 -1.115374 -1.835912 -2.316825 -2.803000 -3.216193 -3.569019 -3.711581 -4.026018 -4.300628 -4.545300 -4.754488 -4.796010 -5.012222 -5.202497 -5.371998 -5.386006 -5.531747 -5.528183 -3.789407 1.268752 0.1153765 -0.7816879 -1.507775 -2.133314 -2.682859 -3.122188 -3.399967 -3.791101 -4.153917 -4.486808 -4.689256 -4.740808 -5.004297 -5.241074 -5.442279 -5.382173 -5.546921 -5.530344 -3.789407 1.947185 0.7667904 -0.2541817 -1.099029 -1.801073 -2.404766 -2.909862 -3.354696 -3.775889 -4.144894 -4.497438 -4.665021 -4.823432 -5.070754 -5.307450 -5.504748 -5.422915 -5.571188 -5.529940 -3.789407 2.296543 1.095194 3.4952253E-02 -0.8341807 -1.599870 -2.240796 -2.847487 -3.367179 -3.798760 -4.182837 -4.524508 -4.756633 -4.943394 -5.168651 -5.389805 -5.537618 -5.485291 -5.601272 -5.526158 -3.789407 2.387016 1.228843 0.1873940 -0.7097244 -1.482273 -2.202354 -2.852158 -3.391747 -3.843177 -4.242025 -4.576161 -4.866546 -5.073629 -5.279399 -5.482998 -5.573310 -5.557897 -5.635242 -5.517830 -3.789407 2.309734 1.225312 0.2178309 -0.6747396 -1.492588 -2.235075 -2.880461 -3.428773 -3.905662 -4.305559 -4.668022 -4.983570 -5.203508 -5.399237 -5.581572 -5.645025 -5.635324 -5.671121 -5.503657 -3.789407 2.174698 1.114599 0.1480347 -0.7481421 -1.567591 -2.294377 -2.928680 -3.490557 -3.974061 -4.399207 -4.781747 -5.103318 -5.329568 -5.521111 -5.679675 -5.732373 -5.714265 -5.707347 -5.482081 -3.789407 1.942294 0.9250463 -2.6647756E-03 -0.8810201 -1.670299 -2.379036 -3.013121 -3.571330 -4.073009 -4.522659 -4.911131 -5.219056 -5.456952 -5.644970 -5.773445 -5.827561 -5.791939 -5.742342 -5.453615 -3.789407 1.611463 0.6639422 -0.2166633 -1.049951 -1.809862 -2.505900 -3.124540 -3.691396 -4.216057 -4.670726 -5.040644 -5.342167 -5.583881 -5.770427 -5.881185 -5.922971 -5.867323 -5.774404 -5.422202 -3.789407 1.208747 0.3432505 -0.4803672 -1.269544 -2.001918 -2.665200 -3.287045 -3.867054 -4.388005 -4.821164 -5.172900 -5.476409 -5.722468 -5.894978 -5.995889 -6.017344 -5.939320 -5.802240 -5.386246 -3.789407 0.7562820 -2.9111853E-02 -0.8009574 -1.539045 -2.230500 -2.888417 -3.506143 -4.077260 -4.563138 -4.972711 -5.328111 -5.627480 -5.865455 -6.025971 -6.108306 -6.105699 -6.005210 -5.823463 -5.343978 -3.789407 0.2560170 -0.4568067 -1.164725 -1.856624 -2.522804 -3.161322 -3.755010 -4.280614 -4.751004 -5.157634 -5.507864 -5.794166 -6.008726 -6.161993 -6.215307 -6.187776 -6.061832 -5.834721 -5.293523 -3.789407 -0.2990735 -0.9381614 -1.586673 -2.231455 -2.861716 -3.456116 -4.009590 -4.526452 -4.978018 -5.378380 -5.706470 -5.967403 -6.169055 -6.290093 -6.314693 -6.262032 -6.107721 -5.831406 -5.233096 -3.789407 -0.9029301 -1.472287 -2.056105 -2.645494 -3.222107 -3.789343 -4.322468 -4.818912 -5.255171 -5.618854 -5.923275 -6.165119 -6.318856 -6.409502 -6.404795 -6.325413 -6.139425 -5.807465 -5.159888 -3.789407 -1.573714 -2.062416 -2.578138 -3.113331 -3.656661 -4.198676 -4.711804 -5.162710 -5.559906 -5.900435 -6.158138 -6.339258 -6.447316 -6.507319 -6.481155 -6.369852 -6.148193 -5.758999 -5.071775 -3.789407 -2.328673 -2.732821 -3.187027 -3.679183 -4.179369 -4.680868 -5.151978 -5.572907 -5.895190 -6.159131 -6.349859 -6.476036 -6.554946 -6.582112 -6.527788 -6.382299 -6.120380 -5.677133 -4.966386 -3.789407 -3.172298 -3.485367 -3.874403 -4.319448 -4.771191 -5.202751 -5.587282 -5.893061 -6.138640 -6.337093 -6.484323 -6.579229 -6.625834 -6.619573 -6.525878 -6.340322 -6.035640 -5.550399 -4.840050 -3.789407 -4.152356 -4.327677 -4.594512 -4.910715 -5.246348 -5.570602 -5.854524 -6.095804 -6.291085 -6.450562 -6.556241 -6.610747 -6.615353 -6.572296 -6.431331 -6.202792 -5.862398 -5.362994 -4.689819 -3.789407 -5.273131 -5.229131 -5.293815 -5.433490 -5.619688 -5.818519 -6.001198 -6.162651 -6.281156 -6.382768 -6.437106 -6.438672 -6.401465 -6.316504 -6.142662 -5.895140 -5.555294 -5.095879 -4.505878 -3.789407 -32.97178 -32.31612 -31.46960 -30.46834 -29.33821 -28.09830 -26.76284 -25.34277 -23.84674 -22.28179 -20.65374 -18.96750 -17.22726 -15.43666 -13.59886 -11.71665 -9.792514 -7.828644 -5.827012 -3.789407 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -1.656388 -1.667504 -1.675453 -1.680320 -1.681457 -1.678389 -1.681513 -1.681284 -1.677275 -1.668998 -1.655230 -1.636636 -1.611644 -1.582271 -1.550587 -1.509530 -1.455972 -1.384700 -1.282732 -1.018276 -1.660035 -1.669379 -1.676383 -1.679858 -1.679257 -1.675241 -1.677713 -1.676805 -1.672114 -1.662473 -1.648599 -1.629315 -1.603670 -1.573974 -1.542312 -1.501426 -1.448210 -1.377773 -1.277323 -1.018276 -1.663318 -1.671515 -1.676961 -1.678529 -1.676713 -1.672073 -1.673809 -1.672111 -1.666651 -1.656173 -1.641545 -1.621551 -1.595246 -1.565413 -1.533730 -1.493065 -1.440203 -1.370728 -1.271761 -1.018276 -1.666811 -1.673254 -1.676584 -1.676796 -1.674150 -1.668851 -1.669688 -1.667132 -1.660064 -1.649455 -1.634025 -1.613297 -1.586195 -1.556563 -1.524892 -1.484426 -1.431939 -1.363379 -1.266039 -1.018276 -1.669830 -1.673880 -1.675835 -1.675003 -1.671608 -1.665449 -1.665275 -1.660994 -1.653729 -1.642259 -1.625995 -1.604505 -1.577116 -1.547406 -1.515733 -1.475356 -1.423396 -1.355794 -1.260130 -1.018276 -1.671562 -1.674165 -1.674947 -1.673308 -1.668906 -1.661767 -1.660518 -1.655123 -1.646888 -1.634519 -1.617398 -1.594860 -1.567715 -1.537789 -1.506257 -1.465929 -1.414578 -1.347956 -1.254024 -1.018276 -1.673156 -1.674317 -1.674175 -1.671465 -1.665943 -1.657715 -1.654411 -1.648710 -1.639472 -1.626176 -1.607655 -1.585299 -1.557968 -1.527925 -1.496425 -1.456143 -1.405487 -1.339844 -1.247698 -1.018276 -1.674600 -1.674608 -1.673217 -1.669308 -1.661803 -1.652295 -1.648543 -1.641693 -1.631419 -1.617154 -1.598023 -1.575383 -1.547616 -1.517628 -1.485981 -1.445996 -1.395991 -1.331430 -1.241132 -1.018276 -1.676159 -1.674696 -1.671919 -1.665897 -1.657830 -1.647056 -1.642014 -1.634006 -1.622641 -1.606911 -1.588026 -1.565076 -1.537067 -1.506973 -1.475004 -1.435419 -1.386371 -1.322688 -1.234287 -1.018276 -1.677499 -1.673723 -1.669367 -1.662632 -1.653200 -1.641163 -1.634779 -1.625553 -1.612498 -1.596991 -1.577647 -1.553990 -1.525986 -1.495553 -1.463557 -1.424483 -1.376074 -1.313580 -1.227126 -1.018276 -1.677759 -1.672965 -1.666979 -1.658734 -1.647899 -1.634564 -1.625915 -1.615688 -1.602812 -1.586731 -1.566412 -1.542656 -1.514565 -1.483420 -1.451668 -1.413146 -1.365327 -1.304063 -1.219594 -1.018276 -1.678242 -1.671695 -1.664062 -1.654271 -1.641920 -1.626450 -1.617599 -1.606470 -1.592878 -1.575589 -1.555022 -1.531014 -1.503707 -1.472649 -1.439354 -1.401580 -1.354085 -1.294155 -1.211616 -1.018276 -1.678413 -1.670123 -1.660719 -1.648534 -1.634830 -1.619164 -1.609327 -1.596517 -1.582112 -1.564479 -1.543435 -1.519516 -1.492327 -1.461683 -1.426914 -1.388968 -1.342297 -1.283626 -1.203077 -1.018276 -1.677815 -1.667822 -1.656834 -1.644065 -1.629045 -1.611535 -1.600578 -1.587049 -1.571663 -1.553264 -1.531820 -1.507816 -1.480850 -1.450288 -1.415689 -1.375772 -1.329898 -1.272479 -1.193848 -1.018276 -1.679429 -1.667853 -1.654529 -1.640135 -1.623252 -1.605065 -1.592822 -1.577764 -1.560824 -1.541613 -1.520059 -1.495991 -1.469427 -1.438719 -1.403450 -1.363427 -1.317161 -1.260574 -1.183164 -1.018276 -1.683705 -1.669890 -1.655167 -1.638754 -1.621287 -1.603294 -1.583979 -1.568085 -1.550272 -1.530883 -1.509136 -1.485248 -1.457068 -1.425683 -1.390526 -1.351030 -1.304525 -1.247928 -1.170648 -1.018276 -1.693103 -1.677561 -1.661299 -1.644491 -1.626232 -1.607769 -1.588458 -1.567120 -1.545753 -1.521986 -1.498562 -1.472685 -1.444125 -1.412358 -1.377281 -1.336820 -1.289719 -1.232627 -1.156235 -1.018276 -1.715269 -1.695466 -1.678316 -1.659761 -1.640082 -1.619488 -1.597712 -1.574586 -1.550265 -1.524376 -1.496813 -1.468415 -1.436265 -1.401856 -1.363693 -1.320857 -1.271146 -1.209740 -1.138859 -1.018276 -1.783447 -1.759788 -1.735386 -1.711343 -1.684920 -1.657568 -1.629196 -1.600148 -1.569127 -1.536702 -1.502431 -1.465916 -1.426540 -1.383520 -1.336286 -1.286314 -1.233884 -1.177951 -1.115761 -1.018276 -1.674184 -1.645087 -1.615351 -1.584984 -1.553991 -1.522378 -1.490397 -1.457321 -1.423884 -1.389850 -1.355230 -1.320031 -1.284259 -1.247920 -1.211020 -1.173563 -1.135546 -1.096989 -1.057897 -1.018276 -1.809452 -1.860289 -1.904301 -1.962264 -2.012500 -2.056573 -2.091686 -2.117047 -2.129926 -2.143846 -2.160920 -2.168004 -2.162518 -2.143073 -2.105467 -2.063631 -2.006930 -1.919952 -1.782115 -1.410087 -1.819075 -1.866838 -1.911175 -1.968049 -2.018960 -2.061915 -2.094990 -2.117559 -2.126394 -2.140276 -2.156607 -2.161888 -2.155542 -2.134408 -2.095029 -2.052982 -1.996534 -1.910309 -1.774396 -1.410087 -1.831672 -1.878450 -1.923659 -1.978715 -2.027778 -2.067337 -2.097977 -2.117135 -2.123918 -2.137254 -2.152335 -2.155982 -2.147655 -2.124920 -2.083984 -2.041983 -1.985784 -1.900353 -1.766456 -1.410087 -1.849515 -1.894596 -1.938212 -1.991932 -2.036331 -2.073150 -2.100271 -2.115271 -2.122281 -2.134476 -2.147005 -2.149504 -2.139263 -2.114575 -2.072613 -2.030595 -1.974653 -1.890059 -1.758282 -1.410087 -1.871879 -1.915503 -1.956822 -2.004802 -2.045565 -2.078565 -2.100757 -2.114964 -2.121078 -2.131670 -2.141930 -2.142363 -2.129815 -2.103232 -2.060859 -2.018780 -1.963109 -1.879342 -1.749854 -1.410087 -1.898869 -1.939235 -1.974954 -2.018008 -2.054412 -2.082067 -2.102482 -2.115314 -2.119901 -2.127385 -2.136138 -2.133683 -2.119480 -2.091153 -2.048663 -2.006494 -1.951122 -1.868225 -1.741162 -1.410087 -1.926916 -1.962281 -1.992838 -2.030950 -2.061407 -2.086569 -2.104925 -2.115797 -2.117453 -2.123269 -2.128696 -2.124197 -2.107994 -2.078690 -2.035982 -1.993696 -1.938658 -1.856685 -1.732187 -1.410087 -1.955784 -1.984852 -2.010156 -2.041985 -2.069493 -2.091806 -2.107585 -2.115166 -2.115119 -2.118206 -2.120707 -2.113678 -2.095505 -2.065740 -2.022766 -1.980358 -1.925677 -1.844689 -1.722901 -1.410087 -1.984031 -2.006138 -2.025813 -2.054234 -2.078226 -2.097172 -2.109169 -2.114528 -2.111795 -2.110967 -2.110939 -2.101694 -2.082513 -2.052238 -2.008938 -1.966426 -1.912126 -1.832198 -1.713276 -1.410087 -2.010113 -2.027270 -2.042868 -2.066878 -2.086847 -2.101301 -2.110600 -2.112923 -2.106295 -2.102672 -2.099978 -2.088910 -2.068903 -2.038127 -1.994477 -1.951853 -1.897706 -1.819167 -1.703271 -1.410087 -2.036723 -2.049209 -2.059970 -2.078542 -2.093972 -2.105107 -2.110245 -2.109162 -2.099584 -2.093054 -2.087912 -2.075517 -2.054665 -2.023336 -1.979330 -1.936595 -1.882446 -1.805542 -1.692846 -1.410087 -2.063298 -2.070137 -2.075776 -2.089625 -2.100406 -2.107021 -2.108623 -2.104039 -2.091482 -2.082306 -2.075339 -2.061557 -2.039756 -2.007831 -1.963444 -1.920545 -1.866436 -1.791266 -1.681946 -1.410087 -2.088216 -2.089862 -2.089659 -2.098687 -2.104516 -2.107601 -2.105609 -2.097612 -2.082632 -2.071252 -2.062324 -2.047065 -2.024224 -1.991593 -1.946789 -1.902901 -1.849610 -1.776298 -1.670508 -1.410087 -2.110982 -2.107471 -2.102384 -2.106670 -2.107938 -2.107057 -2.101693 -2.090964 -2.073724 -2.060022 -2.049023 -2.032198 -2.008175 -1.974700 -1.930024 -1.884311 -1.831912 -1.760608 -1.658452 -1.410087 -2.133754 -2.124459 -2.114286 -2.113976 -2.111089 -2.106786 -2.098378 -2.084809 -2.065161 -2.049065 -2.035825 -2.017226 -1.991898 -1.957554 -1.914326 -1.864847 -1.813326 -1.744143 -1.645673 -1.410087 -2.158808 -2.144057 -2.128830 -2.124028 -2.117098 -2.109014 -2.097189 -2.080446 -2.057991 -2.039242 -2.023550 -2.002697 -1.975799 -1.941289 -1.898421 -1.846001 -1.794030 -1.726888 -1.632223 -1.410087 -2.194165 -2.173479 -2.152403 -2.142586 -2.130993 -2.118275 -2.102147 -2.081262 -2.054928 -2.031837 -2.012470 -1.989339 -1.960905 -1.925929 -1.882964 -1.831667 -1.774498 -1.708965 -1.617524 -1.410087 -2.255777 -2.227334 -2.198715 -2.182340 -2.164559 -2.145133 -2.124167 -2.100042 -2.072300 -2.041059 -2.007313 -1.981890 -1.951446 -1.914784 -1.871505 -1.820163 -1.759884 -1.691555 -1.601679 -1.410087 -2.397988 -2.365898 -2.333227 -2.299445 -2.265955 -2.230267 -2.197554 -2.167933 -2.135394 -2.099945 -2.060905 -2.018365 -1.972029 -1.922987 -1.875253 -1.820529 -1.755879 -1.680410 -1.584367 -1.410087 -2.912270 -2.853436 -2.792076 -2.728239 -2.661969 -2.593315 -2.522345 -2.449349 -2.373632 -2.295983 -2.216218 -2.134379 -2.050737 -1.964626 -1.876824 -1.787123 -1.695547 -1.602160 -1.506998 -1.410087 -1.765498 -1.880128 -1.983238 -2.068630 -2.146777 -2.240965 -2.325614 -2.397066 -2.453169 -2.487622 -2.516967 -2.557497 -2.580212 -2.583034 -2.559746 -2.508656 -2.456344 -2.360801 -2.194116 -1.737570 -1.760234 -1.877651 -1.982033 -2.064566 -2.147776 -2.245041 -2.330110 -2.401900 -2.455575 -2.484741 -2.513606 -2.553235 -2.574814 -2.575644 -2.549331 -2.495921 -2.443775 -2.348835 -2.184237 -1.737570 -1.773749 -1.888378 -1.987579 -2.072791 -2.158538 -2.255473 -2.339532 -2.408352 -2.457219 -2.482175 -2.512342 -2.550297 -2.569386 -2.567317 -2.537578 -2.482885 -2.430760 -2.336438 -2.174056 -1.737570 -1.799887 -1.906722 -2.004681 -2.091360 -2.177119 -2.270953 -2.351498 -2.415043 -2.457034 -2.482711 -2.511551 -2.547408 -2.563081 -2.557786 -2.524297 -2.469440 -2.417240 -2.323578 -2.163551 -1.737570 -1.832111 -1.936710 -2.032780 -2.117837 -2.200686 -2.289485 -2.363790 -2.420056 -2.458987 -2.484266 -2.511842 -2.543340 -2.555907 -2.546753 -2.509993 -2.455468 -2.403152 -2.310215 -2.152697 -1.737570 -1.875125 -1.976939 -2.068486 -2.149486 -2.227229 -2.308492 -2.374815 -2.425224 -2.463211 -2.486913 -2.511182 -2.538615 -2.547364 -2.533976 -2.495313 -2.440897 -2.388468 -2.296307 -2.141491 -1.737570 -1.929590 -2.023950 -2.108913 -2.183919 -2.254141 -2.326438 -2.385087 -2.432961 -2.467952 -2.489597 -2.509789 -2.532658 -2.536942 -2.519274 -2.480081 -2.425629 -2.373064 -2.281616 -2.129920 -1.737570 -1.988670 -2.074888 -2.151856 -2.218654 -2.279581 -2.343502 -2.397963 -2.441433 -2.473509 -2.490633 -2.506542 -2.524745 -2.524280 -2.503629 -2.464144 -2.409565 -2.356907 -2.266448 -2.117951 -1.737570 -2.052357 -2.127428 -2.195052 -2.251803 -2.304653 -2.362892 -2.411773 -2.450592 -2.477564 -2.490488 -2.501661 -2.514287 -2.509123 -2.487281 -2.447361 -2.392682 -2.339926 -2.250551 -2.105629 -1.737570 -2.116558 -2.179840 -2.236972 -2.285523 -2.331555 -2.382954 -2.426089 -2.458401 -2.480160 -2.488700 -2.494358 -2.501118 -2.492799 -2.469965 -2.429574 -2.374689 -2.322052 -2.233765 -2.092735 -1.737570 -2.179816 -2.232919 -2.280251 -2.320182 -2.359159 -2.402509 -2.438443 -2.464736 -2.480868 -2.484186 -2.484099 -2.485911 -2.475451 -2.451532 -2.410650 -2.355594 -2.303182 -2.216100 -2.079420 -1.737570 -2.244106 -2.285968 -2.323440 -2.355360 -2.385530 -2.420169 -2.448748 -2.468869 -2.478607 -2.476149 -2.471547 -2.469857 -2.456934 -2.431815 -2.390481 -2.335290 -2.283242 -2.197494 -2.065525 -1.737570 -2.307864 -2.338707 -2.366214 -2.388888 -2.409779 -2.435762 -2.456460 -2.469613 -2.472666 -2.465749 -2.457926 -2.452846 -2.437213 -2.410798 -2.368890 -2.313688 -2.261894 -2.177867 -2.050747 -1.737570 -2.369878 -2.390116 -2.407100 -2.419930 -2.431370 -2.448279 -2.460564 -2.467351 -2.465187 -2.454281 -2.443213 -2.434792 -2.416412 -2.388409 -2.345890 -2.290745 -2.238591 -2.157196 -2.035153 -1.737570 -2.429492 -2.438898 -2.444605 -2.447137 -2.449444 -2.458410 -2.463387 -2.464621 -2.457322 -2.442094 -2.427554 -2.416017 -2.394718 -2.364917 -2.321608 -2.265577 -2.213754 -2.135467 -2.018621 -1.737570 -2.484625 -2.483258 -2.479679 -2.473593 -2.467968 -2.469648 -2.467353 -2.462971 -2.450405 -2.430414 -2.412097 -2.397238 -2.372944 -2.340824 -2.296441 -2.238085 -2.187415 -2.112407 -2.001003 -1.737570 -2.545286 -2.533660 -2.520369 -2.505186 -2.491473 -2.486110 -2.476759 -2.466213 -2.447962 -2.422374 -2.399478 -2.380758 -2.352275 -2.317241 -2.273909 -2.216572 -2.159703 -2.087923 -1.982149 -1.737570 -2.632677 -2.608858 -2.584194 -2.557685 -2.533764 -2.520126 -2.502748 -2.484547 -2.459101 -2.426412 -2.392922 -2.368654 -2.337065 -2.299485 -2.255631 -2.198468 -2.132366 -2.062772 -1.961982 -1.737570 -2.814175 -2.773699 -2.735034 -2.695525 -2.654467 -2.613069 -2.584791 -2.555247 -2.524106 -2.487568 -2.443947 -2.393735 -2.350025 -2.307197 -2.256873 -2.196839 -2.123157 -2.041419 -1.941890 -1.737570 -4.241012 -4.152056 -4.056981 -3.956678 -3.851087 -3.740391 -3.624726 -3.504297 -3.379236 -3.249707 -3.115865 -2.977820 -2.835740 -2.689727 -2.539911 -2.386412 -2.229317 -2.068755 -1.905049 -1.737570 -1.642180 -1.816233 -1.976008 -2.118046 -2.231285 -2.340047 -2.469482 -2.585239 -2.683795 -2.758852 -2.795109 -2.862684 -2.917276 -2.947265 -2.944473 -2.890550 -2.844499 -2.744460 -2.552364 -2.018899 -1.593729 -1.780297 -1.950493 -2.095898 -2.208481 -2.328184 -2.466323 -2.587240 -2.687632 -2.759701 -2.789643 -2.860227 -2.914537 -2.942733 -2.935970 -2.876422 -2.830498 -2.730667 -2.540335 -2.018899 -1.587753 -1.777076 -1.946593 -2.087515 -2.207842 -2.337062 -2.476917 -2.596912 -2.694649 -2.758748 -2.790580 -2.861046 -2.912917 -2.937572 -2.925721 -2.862311 -2.816042 -2.716326 -2.527880 -2.018899 -1.610683 -1.793594 -1.956733 -2.100072 -2.229275 -2.359660 -2.495286 -2.611496 -2.701437 -2.758692 -2.795711 -2.863581 -2.911484 -2.931153 -2.913431 -2.847988 -2.800992 -2.701388 -2.514962 -2.018899 -1.652512 -1.824570 -1.986299 -2.134539 -2.263550 -2.389314 -2.519212 -2.627004 -2.706172 -2.764445 -2.803487 -2.866587 -2.909173 -2.922953 -2.898657 -2.833611 -2.785265 -2.685682 -2.501735 -2.018899 -1.709792 -1.875508 -2.035353 -2.181345 -2.305408 -2.425349 -2.545211 -2.640778 -2.715255 -2.773417 -2.811758 -2.868878 -2.905330 -2.912537 -2.882574 -2.818192 -2.768759 -2.669333 -2.488084 -2.018899 -1.786266 -1.944846 -2.096803 -2.233795 -2.353146 -2.463947 -2.569544 -2.656698 -2.728846 -2.784238 -2.819267 -2.869552 -2.899014 -2.899241 -2.866152 -2.801952 -2.751694 -2.652134 -2.473982 -2.018899 -1.878663 -2.024624 -2.163783 -2.292315 -2.402048 -2.499946 -2.594779 -2.677064 -2.744883 -2.795174 -2.825339 -2.867880 -2.889677 -2.882961 -2.849391 -2.784648 -2.733227 -2.634097 -2.459388 -2.018899 -1.976613 -2.110533 -2.237392 -2.352145 -2.448349 -2.536370 -2.623958 -2.699513 -2.760857 -2.804989 -2.829114 -2.863074 -2.876748 -2.865634 -2.831220 -2.766094 -2.713620 -2.615087 -2.444246 -2.018899 -2.082355 -2.200529 -2.310630 -2.410983 -2.496413 -2.575831 -2.654675 -2.721640 -2.774933 -2.812455 -2.829895 -2.854659 -2.860667 -2.847511 -2.811645 -2.746546 -2.693004 -2.594996 -2.428499 -2.018899 -2.189857 -2.288947 -2.383821 -2.472145 -2.547124 -2.615852 -2.684238 -2.741411 -2.786124 -2.816038 -2.826584 -2.842211 -2.843349 -2.827503 -2.790347 -2.724736 -2.670646 -2.573695 -2.412076 -2.018899 -2.296260 -2.378633 -2.459555 -2.534652 -2.597346 -2.653447 -2.710686 -2.758024 -2.793108 -2.814760 -2.818257 -2.827650 -2.824584 -2.805620 -2.767456 -2.701027 -2.646811 -2.550950 -2.394888 -2.018899 -2.405058 -2.470414 -2.534866 -2.595109 -2.644563 -2.687646 -2.733205 -2.770047 -2.795011 -2.808138 -2.806465 -2.811122 -2.803483 -2.781559 -2.741797 -2.675570 -2.620984 -2.526583 -2.376819 -2.018899 -2.512457 -2.558634 -2.606346 -2.652211 -2.687419 -2.717299 -2.750679 -2.776875 -2.792235 -2.798107 -2.791650 -2.791631 -2.779871 -2.755274 -2.713986 -2.647490 -2.593071 -2.500741 -2.357731 -2.018899 -2.614559 -2.642736 -2.674475 -2.704237 -2.724892 -2.741981 -2.763160 -2.779592 -2.786541 -2.785188 -2.773493 -2.769303 -2.753825 -2.726297 -2.683357 -2.616601 -2.562333 -2.473340 -2.337439 -2.018899 -2.712121 -2.722872 -2.738359 -2.752287 -2.758719 -2.763347 -2.773078 -2.780455 -2.779248 -2.770392 -2.752809 -2.744030 -2.725389 -2.694629 -2.649982 -2.582689 -2.528568 -2.444193 -2.315719 -2.018899 -2.806562 -2.800288 -2.801341 -2.801788 -2.794680 -2.786747 -2.785301 -2.782979 -2.773283 -2.756166 -2.731907 -2.718358 -2.695766 -2.661351 -2.614594 -2.551185 -2.492387 -2.413095 -2.292295 -2.018899 -2.918362 -2.894969 -2.881590 -2.868109 -2.846851 -2.825448 -2.812432 -2.799111 -2.779344 -2.752167 -2.718547 -2.697240 -2.669058 -2.630359 -2.582631 -2.520569 -2.454760 -2.380122 -2.266957 -2.018899 -3.131611 -3.086751 -3.051734 -3.014783 -2.971404 -2.928233 -2.900331 -2.871612 -2.838723 -2.799109 -2.754675 -2.704427 -2.669800 -2.624589 -2.568161 -2.504187 -2.423091 -2.348413 -2.240433 -2.018899 -5.652469 -5.532276 -5.402169 -5.262545 -5.113832 -4.956417 -4.790693 -4.617023 -4.435747 -4.247197 -4.051660 -3.849440 -3.640774 -3.425937 -3.205130 -2.978598 -2.746516 -2.509095 -2.266498 -2.018899 -1.520059 -1.726021 -1.935228 -2.126406 -2.291723 -2.409220 -2.571467 -2.722674 -2.858849 -2.972765 -3.043493 -3.109562 -3.195298 -3.253277 -3.274798 -3.233161 -3.185748 -3.085636 -2.871438 -2.265492 -1.408934 -1.639101 -1.865738 -2.071777 -2.245279 -2.371905 -2.549515 -2.713105 -2.858484 -2.975500 -3.036531 -3.107957 -3.195551 -3.252684 -3.269922 -3.219085 -3.171151 -3.070543 -2.857577 -2.265492 -1.368618 -1.609235 -1.841270 -2.047756 -2.220515 -2.370206 -2.552472 -2.720959 -2.868263 -2.979065 -3.035025 -3.113493 -3.199066 -3.252409 -3.263106 -3.204535 -3.156246 -3.054778 -2.843180 -2.265492 -1.376383 -1.618072 -1.846578 -2.047338 -2.228990 -2.388487 -2.572911 -2.740612 -2.882550 -2.980827 -3.044561 -3.124254 -3.204438 -3.251313 -3.253905 -3.190005 -3.141154 -3.038285 -2.828206 -2.265492 -1.419563 -1.653811 -1.875443 -2.078267 -2.259881 -2.425335 -2.606314 -2.768008 -2.896109 -2.990449 -3.059417 -3.136729 -3.209599 -3.248654 -3.241595 -3.175401 -3.124931 -3.020967 -2.812601 -2.265492 -1.487882 -1.713005 -1.930894 -2.129087 -2.311846 -2.476423 -2.650067 -2.795350 -2.912113 -3.007771 -3.077681 -3.148925 -3.213142 -3.243623 -3.226037 -3.160390 -3.107763 -3.002724 -2.796323 -2.265492 -1.580652 -1.794989 -2.004575 -2.199153 -2.378286 -2.538236 -2.692934 -2.824369 -2.936851 -3.029560 -3.096218 -3.159763 -3.214295 -3.234998 -3.210246 -3.144561 -3.089453 -2.983458 -2.779453 -2.265492 -1.691879 -1.895294 -2.096880 -2.284446 -2.454446 -2.596982 -2.736817 -2.860068 -2.965544 -3.052481 -3.113800 -3.168090 -3.212065 -3.221878 -3.193848 -3.127814 -3.070062 -2.963057 -2.762193 -2.265492 -1.823358 -2.013330 -2.203321 -2.376780 -2.526968 -2.657779 -2.785324 -2.897588 -2.994554 -3.074443 -3.129071 -3.173236 -3.205733 -3.206472 -3.176295 -3.108849 -3.048946 -2.941353 -2.744416 -2.265492 -1.971429 -2.144042 -2.311440 -2.466622 -2.604528 -2.721059 -2.834285 -2.934821 -3.022302 -3.093497 -3.140392 -3.174232 -3.194572 -3.189820 -3.156994 -3.087875 -3.025868 -2.918234 -2.725926 -2.265492 -2.125697 -2.271980 -2.421127 -2.560111 -2.681141 -2.783022 -2.882723 -2.970782 -3.047190 -3.108221 -3.146429 -3.169452 -3.181050 -3.171381 -3.135583 -3.064726 -3.000774 -2.893544 -2.706631 -2.265492 -2.282749 -2.405317 -2.532241 -2.651062 -2.755636 -2.843321 -2.929196 -3.003564 -3.067203 -3.117408 -3.145536 -3.160043 -3.164979 -3.150625 -3.111123 -3.038567 -2.973348 -2.867023 -2.686422 -2.265492 -2.440640 -2.536656 -2.640996 -2.740715 -2.828624 -2.900444 -2.970508 -3.030748 -3.081238 -3.119741 -3.138853 -3.146420 -3.145383 -3.126174 -3.083675 -3.009060 -2.943221 -2.838420 -2.665171 -2.265492 -2.595305 -2.666899 -2.748957 -2.827806 -2.896105 -2.950952 -3.004738 -3.050564 -3.088005 -3.116480 -3.127201 -3.127607 -3.120996 -3.097780 -3.052315 -2.976066 -2.910141 -2.807709 -2.642701 -2.265492 -2.748613 -2.792684 -2.850929 -2.908175 -2.956739 -2.993907 -3.030666 -3.062723 -3.088746 -3.107195 -3.109725 -3.102884 -3.091358 -3.064497 -3.016678 -2.939232 -2.873578 -2.775054 -2.618786 -2.265492 -2.892092 -2.911081 -2.946395 -2.981602 -3.010461 -3.030205 -3.050053 -3.067712 -3.082377 -3.091674 -3.086435 -3.072461 -3.056000 -3.026124 -2.976468 -2.898180 -2.832722 -2.739938 -2.593105 -2.265492 -3.030730 -3.025529 -3.037708 -3.051367 -3.060283 -3.061584 -3.065073 -3.068657 -3.071873 -3.071699 -3.058603 -3.037197 -3.015828 -2.983103 -2.931628 -2.853133 -2.787273 -2.701949 -2.565228 -2.265492 -3.174962 -3.145719 -3.138239 -3.131870 -3.120911 -3.102933 -3.088780 -3.076484 -3.066325 -3.055336 -3.032906 -3.002569 -2.974560 -2.937133 -2.884483 -2.810975 -2.738178 -2.660501 -2.534476 -2.265492 -3.412631 -3.352954 -3.320280 -3.289771 -3.255316 -3.211996 -3.172644 -3.138039 -3.107710 -3.077663 -3.041770 -2.992327 -2.951579 -2.907394 -2.851200 -2.778078 -2.689917 -2.616844 -2.500813 -2.265492 -7.138974 -6.987168 -6.820020 -6.638353 -6.442922 -6.234509 -6.013827 -5.781503 -5.538165 -5.284374 -5.020617 -4.747381 -4.465102 -4.174160 -3.874935 -3.567766 -3.252954 -2.930796 -2.601561 -2.265492 -1.404591 -1.636757 -1.896714 -2.131825 -2.339545 -2.500320 -2.652523 -2.835350 -3.003053 -3.148030 -3.251174 -3.314002 -3.427366 -3.511512 -3.559477 -3.536652 -3.489477 -3.392756 -3.160669 -2.484990 -1.229445 -1.495133 -1.776714 -2.034237 -2.261199 -2.425135 -2.607924 -2.809906 -2.992877 -3.147327 -3.246007 -3.310839 -3.429290 -3.514413 -3.559240 -3.524876 -3.475159 -3.376969 -3.145189 -2.484990 -1.151631 -1.434044 -1.721624 -1.985351 -2.209684 -2.399290 -2.602113 -2.813222 -2.998827 -3.153880 -3.240383 -3.321079 -3.438398 -3.519463 -3.557235 -3.510107 -3.461212 -3.360434 -3.129052 -2.484990 -1.137752 -1.426048 -1.710494 -1.966940 -2.199323 -2.410919 -2.622909 -2.829906 -3.016140 -3.162028 -3.251666 -3.341107 -3.451229 -3.524848 -3.552758 -3.496422 -3.446490 -3.343036 -3.112203 -2.484990 -1.171744 -1.456261 -1.730615 -1.986376 -2.228483 -2.449325 -2.657573 -2.860616 -3.040463 -3.175455 -3.273241 -3.364670 -3.464813 -3.529033 -3.544728 -3.483524 -3.431096 -3.324638 -3.094578 -2.484990 -1.242022 -1.517082 -1.786607 -2.042094 -2.285075 -2.502193 -2.706296 -2.902744 -3.068680 -3.200907 -3.302835 -3.388557 -3.477808 -3.530767 -3.532044 -3.470690 -3.415019 -3.305077 -3.076105 -2.484990 -1.343409 -1.610975 -1.874635 -2.125534 -2.356034 -2.568074 -2.767300 -2.950635 -3.105393 -3.235781 -3.333243 -3.411701 -3.488680 -3.528839 -3.517818 -3.457471 -3.397193 -3.284227 -3.056873 -2.484990 -1.475832 -1.733266 -1.988493 -2.221375 -2.442134 -2.648493 -2.835415 -3.003055 -3.149556 -3.273362 -3.363761 -3.433148 -3.496702 -3.521898 -3.503819 -3.442265 -3.377812 -3.261946 -3.036947 -2.484990 -1.634894 -1.875215 -2.110762 -2.333955 -2.545063 -2.738784 -2.905945 -3.059975 -3.196674 -3.308790 -3.391701 -3.451117 -3.500507 -3.510828 -3.488797 -3.424999 -3.356140 -3.238036 -3.016229 -2.484990 -1.808682 -2.029247 -2.251408 -2.461266 -2.657426 -2.827484 -2.979658 -3.118869 -3.240329 -3.341139 -3.415061 -3.463980 -3.498163 -3.499007 -3.472224 -3.405348 -3.332128 -3.212329 -2.994854 -2.484990 -2.001767 -2.201449 -2.405977 -2.591664 -2.763459 -2.919158 -3.051949 -3.173014 -3.280390 -3.369506 -3.432270 -3.469421 -3.491032 -3.485031 -3.452589 -3.382300 -3.305356 -3.184627 -2.972750 -2.484990 -2.212681 -2.380870 -2.555338 -2.720894 -2.872137 -3.003849 -3.117407 -3.222779 -3.316019 -3.392161 -3.441610 -3.467202 -3.480188 -3.467353 -3.429602 -3.355418 -3.275501 -3.154677 -2.949571 -2.484990 -2.420754 -2.560146 -2.707160 -2.845841 -2.971693 -3.082300 -3.177989 -3.266781 -3.344364 -3.406365 -3.443073 -3.459246 -3.464047 -3.444566 -3.401950 -3.324496 -3.242203 -3.122127 -2.925162 -2.484990 -2.632220 -2.735133 -2.850758 -2.963192 -3.066693 -3.156467 -3.231663 -3.301704 -3.363185 -3.411806 -3.437753 -3.444427 -3.441131 -3.415141 -3.368641 -3.288891 -3.205058 -3.086884 -2.899300 -2.484990 -2.835480 -2.905140 -2.991069 -3.075794 -3.153574 -3.220570 -3.275136 -3.326642 -3.372556 -3.408264 -3.424103 -3.421356 -3.410123 -3.378206 -3.328830 -3.248105 -3.163465 -3.048882 -2.871699 -2.484990 -3.034148 -3.067885 -3.121860 -3.177481 -3.229496 -3.273871 -3.308110 -3.341388 -3.371434 -3.394079 -3.400061 -3.388922 -3.370652 -3.333345 -3.281760 -3.201353 -3.116861 -3.008181 -2.841973 -2.484990 -3.222101 -3.222422 -3.244624 -3.270623 -3.296740 -3.317086 -3.330276 -3.345403 -3.359802 -3.369901 -3.366144 -3.347152 -3.322611 -3.280408 -3.226905 -3.147721 -3.064077 -2.963539 -2.809535 -2.484990 -3.411832 -3.378197 -3.369558 -3.366081 -3.365138 -3.361161 -3.352137 -3.347981 -3.345723 -3.342093 -3.327353 -3.299706 -3.268312 -3.220745 -3.164214 -3.088988 -3.004181 -2.913599 -2.773561 -2.484990 -3.687870 -3.612186 -3.569215 -3.533985 -3.502956 -3.466979 -3.426243 -3.394113 -3.366752 -3.340747 -3.308744 -3.264225 -3.221558 -3.169855 -3.108365 -3.033587 -2.937590 -2.858080 -2.733373 -2.484990 -8.693932 -8.509901 -8.304007 -8.077645 -7.832155 -7.568785 -7.288660 -6.992831 -6.682236 -6.357724 -6.020060 -5.669927 -5.307961 -4.934732 -4.550761 -4.156519 -3.752438 -3.338916 -2.916320 -2.484990 -1.282623 -1.566218 -1.855000 -2.134242 -2.385630 -2.587196 -2.731757 -2.938709 -3.127474 -3.298808 -3.431583 -3.487175 -3.625158 -3.733168 -3.807337 -3.805942 -3.761000 -3.671548 -3.426126 -2.682764 -1.041593 -1.354349 -1.683074 -1.996749 -2.275945 -2.481570 -2.660762 -2.891557 -3.103973 -3.293488 -3.425960 -3.479960 -3.626883 -3.738943 -3.812168 -3.797762 -3.747997 -3.655667 -3.409281 -2.682764 -0.9171535 -1.259944 -1.605454 -1.928207 -2.203857 -2.427382 -2.642596 -2.883833 -3.106907 -3.300179 -3.416698 -3.495233 -3.640398 -3.749119 -3.816066 -3.784658 -3.735161 -3.638984 -3.391643 -2.682764 -0.8855150 -1.237938 -1.584345 -1.894587 -2.172354 -2.423371 -2.655489 -2.901663 -3.128098 -3.310414 -3.427150 -3.525364 -3.659831 -3.761470 -3.817847 -3.772487 -3.722434 -3.621312 -3.373148 -2.682764 -0.9164175 -1.265974 -1.594368 -1.899410 -2.188317 -2.451006 -2.694313 -2.939196 -3.155020 -3.324528 -3.455974 -3.559295 -3.682696 -3.773251 -3.816003 -3.762451 -3.709642 -3.602433 -3.353716 -2.682764 -0.9903609 -1.323549 -1.642960 -1.946182 -2.235472 -2.506237 -2.751971 -2.986902 -3.188810 -3.359846 -3.496237 -3.596424 -3.705743 -3.783156 -3.808813 -3.753222 -3.695326 -3.582179 -3.333260 -2.682764 -1.096371 -1.418741 -1.728141 -2.025794 -2.314011 -2.582350 -2.819986 -3.041244 -3.237554 -3.410272 -3.539273 -3.634797 -3.728230 -3.789912 -3.798232 -3.743797 -3.679173 -3.560388 -3.311817 -2.682764 -1.239417 -1.548219 -1.846575 -2.135818 -2.416117 -2.670795 -2.895496 -3.109128 -3.302100 -3.460743 -3.584994 -3.670738 -3.748461 -3.791565 -3.788763 -3.732529 -3.660970 -3.536884 -3.289593 -2.682764 -1.415148 -1.708055 -1.993636 -2.270920 -2.528098 -2.769419 -2.987121 -3.192750 -3.366634 -3.513284 -3.626454 -3.702263 -3.763556 -3.787960 -3.779154 -3.719268 -3.640193 -3.511404 -3.266493 -2.682764 -1.619115 -1.894009 -2.159639 -2.410777 -2.654815 -2.886264 -3.093319 -3.273037 -3.431783 -3.562587 -3.662681 -3.727403 -3.771120 -3.782842 -3.767364 -3.702630 -3.616481 -3.483752 -3.242392 -2.682764 -1.846002 -2.091494 -2.335540 -2.571378 -2.800979 -3.011201 -3.188726 -3.352732 -3.491386 -3.606070 -3.692726 -3.744357 -3.771578 -3.774653 -3.752297 -3.681844 -3.589543 -3.453686 -3.217117 -2.682764 -2.086887 -2.307797 -2.531708 -2.746395 -2.943907 -3.126265 -3.283145 -3.422512 -3.542621 -3.642778 -3.714763 -3.752393 -3.767864 -3.761402 -3.732176 -3.656534 -3.559012 -3.420892 -3.191097 -2.682764 -2.351400 -2.538989 -2.726480 -2.908422 -3.081600 -3.234415 -3.364578 -3.483019 -3.586155 -3.669957 -3.727212 -3.754028 -3.758335 -3.741945 -3.705714 -3.625924 -3.524344 -3.384875 -3.163634 -2.682764 -2.614166 -2.763163 -2.916695 -3.064519 -3.203467 -3.329784 -3.437759 -3.535235 -3.619007 -3.685920 -3.730618 -3.746695 -3.740686 -3.714222 -3.671933 -3.589199 -3.484900 -3.345523 -3.134470 -2.682764 -2.876633 -2.979795 -3.094257 -3.208314 -3.317955 -3.416809 -3.499818 -3.575193 -3.639840 -3.690433 -3.722095 -3.727694 -3.712356 -3.677149 -3.629777 -3.545388 -3.439829 -3.302897 -3.103282 -2.682764 -3.130711 -3.190745 -3.265555 -3.342837 -3.419870 -3.489723 -3.547813 -3.601080 -3.646185 -3.680847 -3.699422 -3.694766 -3.671476 -3.629579 -3.578170 -3.493314 -3.388289 -3.256351 -3.069597 -2.682764 -3.373601 -3.389853 -3.423907 -3.464057 -3.508186 -3.548430 -3.580343 -3.610601 -3.636291 -3.655177 -3.661486 -3.647213 -3.616803 -3.570437 -3.515911 -3.431783 -3.329653 -3.205538 -3.032707 -2.682764 -3.613553 -3.585670 -3.578292 -3.579838 -3.589349 -3.598394 -3.602451 -3.609205 -3.615301 -3.617807 -3.611514 -3.586950 -3.549020 -3.498991 -3.442276 -3.360490 -3.262107 -3.148450 -2.991570 -2.682764 -3.927362 -3.851093 -3.799426 -3.759228 -3.728742 -3.698461 -3.664971 -3.638829 -3.617412 -3.596319 -3.569602 -3.529735 -3.481087 -3.423733 -3.359082 -3.283927 -3.183719 -3.083786 -2.944838 -2.682764 -10.31178 -10.09491 -9.848612 -9.575062 -9.276330 -8.954305 -8.610675 -8.246941 -7.864437 -7.464350 -7.047738 -6.615541 -6.168605 -5.707687 -5.233471 -4.746574 -4.247563 -3.736949 -3.215204 -2.682764 -1.157289 -1.510916 -1.820487 -2.135881 -2.421659 -2.663745 -2.809720 -3.038996 -3.245228 -3.434736 -3.591046 -3.639393 -3.797963 -3.927508 -4.025215 -4.046171 -4.005318 -3.926644 -3.672116 -2.862728 -0.8438147 -1.227327 -1.589953 -1.946400 -2.274293 -2.538322 -2.715956 -2.972084 -3.206348 -3.420240 -3.585552 -3.626344 -3.798172 -3.935596 -4.035342 -4.042499 -3.993354 -3.911310 -3.654207 -2.862728 -0.6802472 -1.095119 -1.480285 -1.853983 -2.195132 -2.462474 -2.689041 -2.955506 -3.201047 -3.426038 -3.578758 -3.644602 -3.815813 -3.951092 -4.045686 -4.032619 -3.982986 -3.895192 -3.635358 -2.862728 -0.6294618 -1.048776 -1.443469 -1.821837 -2.155254 -2.442393 -2.697701 -2.966912 -3.218963 -3.441767 -3.584170 -3.682190 -3.842599 -3.970810 -4.054677 -4.022220 -3.973661 -3.878008 -3.615491 -2.862728 -0.6493932 -1.064620 -1.459519 -1.825338 -2.157327 -2.461062 -2.730978 -3.001956 -3.253725 -3.460709 -3.615981 -3.727980 -3.874102 -3.991562 -4.060163 -4.015902 -3.963556 -3.859495 -3.594512 -2.862728 -0.7259327 -1.131313 -1.512557 -1.862400 -2.197428 -2.507118 -2.784129 -3.056793 -3.300010 -3.497595 -3.664212 -3.780418 -3.908639 -4.011609 -4.060143 -4.011787 -3.952583 -3.839394 -3.572319 -2.862728 -0.8466937 -1.233801 -1.592837 -1.937598 -2.268362 -2.577312 -2.859612 -3.125387 -3.350172 -3.553377 -3.722496 -3.832747 -3.944086 -4.028704 -4.055254 -4.007349 -3.939606 -3.817547 -3.548891 -2.862728 -1.000943 -1.365472 -1.711644 -2.043301 -2.367378 -2.675072 -2.952337 -3.197965 -3.421039 -3.621281 -3.781418 -3.883639 -3.976049 -4.041007 -4.052117 -4.002225 -3.924386 -3.793715 -3.524571 -2.862728 -1.189140 -1.533397 -1.861158 -2.181331 -2.495277 -2.793695 -3.048993 -3.289504 -3.506654 -3.693339 -3.838251 -3.928768 -4.002035 -4.046427 -4.049401 -3.994339 -3.906391 -3.767546 -3.499281 -2.862728 -1.411650 -1.732903 -2.043350 -2.347962 -2.642943 -2.914658 -3.165023 -3.396451 -3.596298 -3.760637 -3.891443 -3.967037 -4.020731 -4.049477 -4.044446 -3.982482 -3.884977 -3.738861 -3.472883 -2.862728 -1.665242 -1.962058 -2.252925 -2.527804 -2.799056 -3.059666 -3.297117 -3.502714 -3.677068 -3.823774 -3.935634 -3.997837 -4.032495 -4.049753 -4.035519 -3.965888 -3.859664 -3.707321 -3.445212 -2.862728 -1.945101 -2.208552 -2.468268 -2.724444 -2.977913 -3.217362 -3.419418 -3.599516 -3.750487 -3.874663 -3.970513 -4.019403 -4.039856 -4.044840 -4.020667 -3.943459 -3.829903 -3.672558 -3.415998 -2.862728 -2.238587 -2.473428 -2.708076 -2.937826 -3.152767 -3.355107 -3.532684 -3.682932 -3.809694 -3.915400 -3.995192 -4.032114 -4.040144 -4.032224 -3.998337 -3.914226 -3.794918 -3.633880 -3.385613 -2.862728 -2.560340 -2.751705 -2.943537 -3.133217 -3.314951 -3.480834 -3.625540 -3.751267 -3.857665 -3.944947 -4.008939 -4.033062 -4.029597 -4.009568 -3.967116 -3.877392 -3.753796 -3.591141 -3.353331 -2.862728 -2.876080 -3.021114 -3.170062 -3.315396 -3.456860 -3.589359 -3.706634 -3.807473 -3.891801 -3.960378 -4.008565 -4.019922 -4.004966 -3.974859 -3.925399 -3.831678 -3.705528 -3.544447 -3.318713 -2.862728 -3.187913 -3.278780 -3.380717 -3.484961 -3.587869 -3.684806 -3.771615 -3.846264 -3.908126 -3.957750 -3.990477 -3.989973 -3.964131 -3.926082 -3.871518 -3.775784 -3.649038 -3.492727 -3.281197 -2.862728 -3.490242 -3.526530 -3.578159 -3.637087 -3.699724 -3.761420 -3.816610 -3.863712 -3.902850 -3.933523 -3.951147 -3.940221 -3.905221 -3.861101 -3.803448 -3.708016 -3.583839 -3.436288 -3.239933 -2.862728 -3.781453 -3.765365 -3.764516 -3.775140 -3.795676 -3.820675 -3.843156 -3.861352 -3.876853 -3.888975 -3.891530 -3.870222 -3.827148 -3.778095 -3.719475 -3.626525 -3.508444 -3.372741 -3.193440 -2.862728 -4.138028 -4.064501 -4.005507 -3.963267 -3.934919 -3.914665 -3.895699 -3.876836 -3.860789 -3.847947 -3.829716 -3.790313 -3.737353 -3.679417 -3.618258 -3.534234 -3.419731 -3.300290 -3.139213 -2.862728 -11.98777 -11.73747 -11.44937 -11.12599 -10.77104 -10.38696 -9.976071 -9.540428 -9.081814 -8.601795 -8.101747 -7.582881 -7.046273 -6.492877 -5.923554 -5.339074 -4.740142 -4.127393 -3.501409 -2.862728 -1.039490 -1.458669 -1.798964 -2.148111 -2.461068 -2.733040 -2.889280 -3.134603 -3.358463 -3.562546 -3.736774 -3.785336 -3.953635 -4.100094 -4.218596 -4.261705 -4.224333 -4.160564 -3.901546 -3.027827 -0.6499068 -1.104187 -1.509016 -1.904030 -2.268009 -2.576502 -2.768810 -3.051512 -3.304178 -3.539610 -3.728870 -3.763527 -3.951715 -4.109913 -4.233844 -4.263185 -4.214062 -4.146297 -3.882897 -3.027827 -0.4436765 -0.9305901 -1.363824 -1.780458 -2.164768 -2.481726 -2.742298 -3.028589 -3.294177 -3.542045 -3.723287 -3.785345 -3.972126 -4.130843 -4.250889 -4.257771 -4.206546 -4.131319 -3.863156 -3.027827 -0.3709863 -0.8632160 -1.307618 -1.730902 -2.118480 -2.464233 -2.751114 -3.037093 -3.310971 -3.558065 -3.727006 -3.828587 -4.005952 -4.157800 -4.267332 -4.249440 -4.200759 -4.115229 -3.842224 -3.027827 -0.3831014 -0.8694202 -1.312801 -1.733039 -2.130083 -2.481641 -2.777900 -3.071936 -3.344064 -3.582541 -3.764501 -3.882693 -4.048354 -4.187686 -4.280931 -4.247484 -4.194906 -4.097782 -3.819991 -3.027827 -0.4604203 -0.9298990 -1.365247 -1.783728 -2.172235 -2.515853 -2.828865 -3.121323 -3.392597 -3.627439 -3.817255 -3.945471 -4.095007 -4.218711 -4.289539 -4.249030 -4.187918 -4.078610 -3.796332 -3.027827 -0.5861940 -1.037316 -1.461498 -1.861069 -2.232312 -2.583137 -2.896916 -3.190460 -3.454785 -3.688278 -3.881209 -4.011467 -4.141478 -4.247232 -4.291935 -4.251379 -4.179405 -4.057461 -3.771184 -3.027827 -0.7569311 -1.186569 -1.584273 -1.962172 -2.329375 -2.672373 -2.988922 -3.276983 -3.534642 -3.761446 -3.953168 -4.074604 -4.186316 -4.270935 -4.296105 -4.252889 -4.168546 -4.034012 -3.744997 -3.027827 -0.9644169 -1.361236 -1.735411 -2.100031 -2.452472 -2.791967 -3.102108 -3.379337 -3.624722 -3.847104 -4.028408 -4.134493 -4.225919 -4.287067 -4.300987 -4.251410 -4.154204 -4.007875 -3.717749 -3.027827 -1.200918 -1.570789 -1.921936 -2.268234 -2.610566 -2.937191 -3.229117 -3.491143 -3.729865 -3.938788 -4.096331 -4.190181 -4.258679 -4.300521 -4.303937 -4.245518 -4.135685 -3.978758 -3.689282 -3.027827 -1.474334 -1.813846 -2.143646 -2.471063 -2.793114 -3.091173 -3.369558 -3.620708 -3.840719 -4.018179 -4.159339 -4.235303 -4.283249 -4.311214 -4.302568 -4.234060 -4.112581 -3.946241 -3.659404 -3.027827 -1.780057 -2.090341 -2.396670 -2.690145 -2.981401 -3.265743 -3.528119 -3.748950 -3.935731 -4.091236 -4.208872 -4.268950 -4.302256 -4.315766 -4.294617 -4.215889 -4.084196 -3.909793 -3.627861 -3.027827 -2.113294 -2.386689 -2.656547 -2.926484 -3.195824 -3.449465 -3.670613 -3.861547 -4.018566 -4.147749 -4.246770 -4.293475 -4.312225 -4.311263 -4.277791 -4.190020 -4.049544 -3.868774 -3.594303 -3.027827 -2.468042 -2.705244 -2.943944 -3.173060 -3.396582 -3.610322 -3.796088 -3.951234 -4.081872 -4.190717 -4.272826 -4.306018 -4.309634 -4.295017 -4.250193 -4.155031 -4.007669 -3.822888 -3.559144 -3.027827 -2.843991 -3.026619 -3.215102 -3.399400 -3.577719 -3.746034 -3.896409 -4.023589 -4.131046 -4.218518 -4.281966 -4.302159 -4.291066 -4.264336 -4.210084 -4.109272 -3.957185 -3.772431 -3.521333 -3.027827 -3.215488 -3.338312 -3.469224 -3.602000 -3.734972 -3.864408 -3.980832 -4.077722 -4.159288 -4.225317 -4.270172 -4.277382 -4.253381 -4.216167 -4.155257 -4.050844 -3.897009 -3.716368 -3.480210 -3.027827 -3.577693 -3.635925 -3.708973 -3.788400 -3.873229 -3.960375 -4.040429 -4.105834 -4.160591 -4.205604 -4.232632 -4.227170 -4.193213 -4.147283 -4.083030 -3.977601 -3.826588 -3.653079 -3.434792 -3.027827 -3.923614 -3.918194 -3.930338 -3.954132 -3.989636 -4.031572 -4.072821 -4.105355 -4.132518 -4.155859 -4.166605 -4.149283 -4.107319 -4.054668 -3.990479 -3.887542 -3.743788 -3.581311 -3.383378 -3.027827 -4.323686 -4.252128 -4.195302 -4.154303 -4.131685 -4.121786 -4.115747 -4.107348 -4.100117 -4.095457 -4.085227 -4.051233 -3.997245 -3.937622 -3.874871 -3.778990 -3.647670 -3.498355 -3.322667 -3.027827 -13.71782 -13.43348 -13.10153 -12.72651 -12.31254 -11.86322 -11.38161 -10.87039 -10.33185 -9.767945 -9.180404 -8.570717 -7.940204 -7.290032 -6.621244 -5.934771 -5.231458 -4.512074 -3.777317 -3.027827 -0.9242664 -1.411042 -1.783385 -2.168581 -2.511434 -2.804866 -2.991755 -3.222070 -3.462944 -3.683697 -3.871513 -3.938385 -4.095190 -4.256451 -4.392209 -4.455729 -4.422314 -4.376557 -4.116615 -3.180330 -0.4610752 -0.9913306 -1.440782 -1.880617 -2.272959 -2.614010 -2.829539 -3.119286 -3.397340 -3.651290 -3.861436 -3.902408 -4.091388 -4.267023 -4.412363 -4.462932 -4.414032 -4.363946 -4.097565 -3.180330 -0.2189093 -0.7749156 -1.267772 -1.724234 -2.141232 -2.494771 -2.788059 -3.097304 -3.386316 -3.652170 -3.856239 -3.923222 -4.115817 -4.292265 -4.435634 -4.462139 -4.410359 -4.350833 -4.077256 -3.180330 -0.1209400 -0.6826360 -1.183962 -1.650188 -2.077909 -2.463519 -2.798686 -3.111785 -3.401010 -3.671044 -3.855798 -3.973032 -4.156938 -4.326862 -4.459641 -4.456272 -4.408582 -4.336665 -4.055583 -3.180330 -0.1222151 -0.6755028 -1.173139 -1.640180 -2.079115 -2.484411 -2.833345 -3.142004 -3.436994 -3.696839 -3.896686 -4.035744 -4.207751 -4.366947 -4.482196 -4.459352 -4.407338 -4.321189 -4.032405 -3.180330 -0.1975009 -0.7315421 -1.220901 -1.685283 -2.129064 -2.532304 -2.877643 -3.191427 -3.485377 -3.741885 -3.958084 -4.104378 -4.264609 -4.407734 -4.500086 -4.467244 -4.405520 -4.303945 -4.007585 -3.180330 -0.3291591 -0.8404995 -1.315465 -1.773718 -2.205541 -2.593031 -2.942151 -3.259416 -3.548142 -3.811741 -4.027379 -4.176795 -4.324793 -4.447721 -4.510277 -4.477027 -4.402117 -4.284501 -3.981000 -3.180330 -0.5086092 -0.9941929 -1.452456 -1.891042 -2.296300 -2.679499 -3.029649 -3.343208 -3.635290 -3.895810 -4.105301 -4.252697 -4.381826 -4.483430 -4.522003 -4.485563 -4.395866 -4.262454 -3.953217 -3.180330 -0.7315289 -1.188656 -1.616767 -2.023336 -2.420696 -2.793844 -3.138736 -3.453461 -3.738981 -3.984598 -4.191229 -4.328662 -4.436193 -4.511418 -4.535784 -4.491061 -4.386003 -4.237404 -3.924294 -3.180330 -0.9925683 -1.408963 -1.805949 -2.196352 -2.573798 -2.939060 -3.278182 -3.580607 -3.846405 -4.086040 -4.280022 -4.397498 -4.483082 -4.535738 -4.548234 -4.492248 -4.371395 -4.208926 -3.894049 -3.180330 -1.282005 -1.663034 -2.034780 -2.401298 -2.764555 -3.116275 -3.432276 -3.714185 -3.971369 -4.193743 -4.357459 -4.458304 -4.520371 -4.557312 -4.555970 -4.487512 -4.351807 -4.176467 -3.862258 -3.180330 -1.609832 -1.956393 -2.302338 -2.644725 -2.981894 -3.300939 -3.600017 -3.868050 -4.098971 -4.284580 -4.427800 -4.505708 -4.551159 -4.572363 -4.555556 -4.475398 -4.326011 -4.139465 -3.828644 -3.180330 -1.973075 -2.286821 -2.598480 -2.902644 -3.209348 -3.509223 -3.786851 -4.012432 -4.207126 -4.363606 -4.480685 -4.543171 -4.571815 -4.577386 -4.545023 -4.453858 -4.292997 -4.097272 -3.792875 -3.180330 -2.364876 -2.634046 -2.908697 -3.184043 -3.460711 -3.713358 -3.942258 -4.134663 -4.293016 -4.421835 -4.519569 -4.567726 -4.578518 -4.569013 -4.522679 -4.421465 -4.251445 -4.049412 -3.754652 -3.180330 -2.787167 -3.010494 -3.233539 -3.456100 -3.680066 -3.887817 -4.071864 -4.225222 -4.356472 -4.463387 -4.541523 -4.573824 -4.568241 -4.543826 -4.486035 -4.376410 -4.199814 -3.996297 -3.713947 -3.180330 -3.214717 -3.371792 -3.538055 -3.701959 -3.867653 -4.028441 -4.174290 -4.295833 -4.397931 -4.481104 -4.539337 -4.555952 -4.536424 -4.497926 -4.431809 -4.317045 -4.136629 -3.936733 -3.669519 -3.180330 -3.637088 -3.719558 -3.819591 -3.923677 -4.034359 -4.146637 -4.249915 -4.336270 -4.408488 -4.467292 -4.505407 -4.507907 -4.477328 -4.427541 -4.356554 -4.240195 -4.061083 -3.868474 -3.620239 -3.180330 -4.044051 -4.049950 -4.077883 -4.117969 -4.171385 -4.232918 -4.290884 -4.339712 -4.381154 -4.415590 -4.434284 -4.424397 -4.385371 -4.328444 -4.256347 -4.142942 -3.969639 -3.789334 -3.564161 -3.180330 -4.488418 -4.417608 -4.365567 -4.331584 -4.317850 -4.319476 -4.324944 -4.328643 -4.333019 -4.338397 -4.334553 -4.308405 -4.258924 -4.196408 -4.125146 -4.022183 -3.862756 -3.694839 -3.497324 -3.180330 -15.49837 -15.17942 -14.80232 -14.37323 -13.89756 -13.38002 -12.82450 -12.23433 -11.61235 -10.96096 -10.28222 -9.577939 -8.849681 -8.098831 -7.326626 -6.534167 -5.722448 -4.892368 -4.044744 -3.180330 -0.8078253 -1.355791 -1.768800 -2.189277 -2.559107 -2.880723 -3.094461 -3.308249 -3.561071 -3.795185 -3.998065 -4.083310 -4.226161 -4.399883 -4.549815 -4.631508 -4.603145 -4.575953 -4.318894 -3.322024 -0.2714059 -0.8812709 -1.375792 -1.856549 -2.289061 -2.661466 -2.893119 -3.182678 -3.479614 -3.756197 -3.984601 -4.035996 -4.219094 -4.411072 -4.574044 -4.644083 -4.597402 -4.565450 -4.299781 -3.322024 4.1281492E-03 -0.6283132 -1.176994 -1.683586 -2.140403 -2.516884 -2.830935 -3.152557 -3.469081 -3.757849 -3.981108 -4.054913 -4.248431 -4.440760 -4.603856 -4.648491 -4.597858 -4.554744 -4.279247 -3.322024 0.1280500 -0.5120177 -1.075633 -1.594398 -2.050599 -2.465142 -2.830491 -3.171780 -3.491794 -3.777234 -3.980989 -4.109187 -4.298822 -4.482429 -4.636019 -4.645025 -4.601408 -4.543210 -4.257168 -3.322024 0.1339109 -0.4889639 -1.049020 -1.558873 -2.034115 -2.474825 -2.866669 -3.214289 -3.528398 -3.809016 -4.020449 -4.178758 -4.357718 -4.530723 -4.667317 -4.652446 -4.606213 -4.530414 -4.233377 -3.322024 6.1121419E-02 -0.5385091 -1.081877 -1.591867 -2.075798 -2.526389 -2.926061 -3.266178 -3.579370 -3.853875 -4.084294 -4.257427 -4.422548 -4.582633 -4.694023 -4.666536 -4.610878 -4.515807 -4.207706 -3.322024 -7.5436771E-02 -0.6461930 -1.174345 -1.676863 -2.158580 -2.605011 -2.991941 -3.330287 -3.644622 -3.924963 -4.163574 -4.335283 -4.492210 -4.633750 -4.712911 -4.683449 -4.613704 -4.498896 -4.179986 -3.322024 -0.2637809 -0.8051865 -1.311679 -1.801178 -2.269305 -2.692898 -3.071519 -3.416424 -3.728517 -4.015306 -4.249954 -4.417815 -4.564078 -4.681587 -4.733723 -4.700877 -4.613342 -4.479181 -4.150880 -3.322024 -0.4992596 -1.007207 -1.488665 -1.954681 -2.392694 -2.802669 -3.181004 -3.520594 -3.837347 -4.117718 -4.339311 -4.504911 -4.631292 -4.722492 -4.757566 -4.715217 -4.609134 -4.456182 -4.120575 -3.322024 -0.7773020 -1.247768 -1.696212 -2.126898 -2.547012 -2.944791 -3.314829 -3.654763 -3.961274 -4.221718 -4.438150 -4.590000 -4.693156 -4.758366 -4.779636 -4.724468 -4.599724 -4.429318 -4.088846 -3.322024 -1.091206 -1.514385 -1.930529 -2.338193 -2.735217 -3.122139 -3.483003 -3.804752 -4.088388 -4.340478 -4.540049 -4.664487 -4.744872 -4.791531 -4.796314 -4.726566 -4.584473 -4.397940 -4.055433 -3.322024 -1.435469 -1.821720 -2.206509 -2.586622 -2.965780 -3.335219 -3.663886 -3.964525 -4.235604 -4.461053 -4.627365 -4.729131 -4.787324 -4.817918 -4.804826 -4.720327 -4.562292 -4.361459 -4.020018 -3.322024 -1.824160 -2.172203 -2.524274 -2.877118 -3.218607 -3.551441 -3.864690 -4.144898 -4.374498 -4.562958 -4.701197 -4.780335 -4.819654 -4.833029 -4.802833 -4.704122 -4.531845 -4.319137 -3.982239 -3.322024 -2.251612 -2.556800 -2.865457 -3.174537 -3.489789 -3.798006 -4.067482 -4.296464 -4.489046 -4.641713 -4.754725 -4.816712 -4.838367 -4.833348 -4.787250 -4.676633 -4.491737 -4.270351 -3.941555 -3.322024 -2.707728 -2.963045 -3.232104 -3.497805 -3.759108 -4.011071 -4.232975 -4.416373 -4.570400 -4.696652 -4.788722 -4.832481 -4.838293 -4.815561 -4.755080 -4.634764 -4.440282 -4.215550 -3.897946 -3.322024 -3.191827 -3.380921 -3.586002 -3.787208 -3.989722 -4.182786 -4.355371 -4.503039 -4.627040 -4.726939 -4.795882 -4.821860 -4.812431 -4.775728 -4.702895 -4.575225 -4.375746 -4.153407 -3.850421 -3.322024 -3.675674 -3.781512 -3.908512 -4.043471 -4.183497 -4.323018 -4.449154 -4.557423 -4.648642 -4.721675 -4.767746 -4.777586 -4.753941 -4.708364 -4.627097 -4.494502 -4.296924 -4.081557 -3.797470 -3.322024 -4.145343 -4.164071 -4.209141 -4.268590 -4.343332 -4.424954 -4.501884 -4.567306 -4.624580 -4.670834 -4.695158 -4.690869 -4.656039 -4.606637 -4.522236 -4.389863 -4.199638 -3.996413 -3.736909 -3.322024 -4.635400 -4.567508 -4.521520 -4.497334 -4.497851 -4.511666 -4.530190 -4.545736 -4.563453 -4.578599 -4.579607 -4.559530 -4.514443 -4.462701 -4.379663 -4.257516 -4.081787 -3.892090 -3.664099 -3.322024 -17.32631 -16.97215 -16.54842 -16.06312 -15.52328 -14.93471 -14.30230 -13.63007 -12.92142 -12.17921 -11.40587 -10.60353 -9.773998 -8.918903 -8.039673 -7.137585 -6.213786 -5.269313 -4.305104 -3.322024 -0.6927370 -1.295888 -1.743175 -2.205993 -2.606739 -2.950354 -3.195274 -3.395517 -3.656853 -3.900357 -4.115703 -4.220410 -4.348868 -4.532039 -4.693594 -4.793180 -4.768830 -4.760128 -4.509735 -3.454340 -8.0109470E-02 -0.7526895 -1.303968 -1.835067 -2.300545 -2.707931 -2.966583 -3.248989 -3.558041 -3.851195 -4.100524 -4.163536 -4.338494 -4.543184 -4.721279 -4.811827 -4.765580 -4.752015 -4.490925 -3.454340 0.2315288 -0.4766199 -1.089548 -1.641070 -2.138365 -2.558240 -2.882548 -3.210722 -3.542017 -3.854383 -4.100388 -4.181334 -4.373334 -4.578188 -4.756679 -4.821860 -4.770453 -4.744153 -4.470545 -3.454340 0.3720614 -0.3450903 -0.9699858 -1.538029 -2.046862 -2.481400 -2.865373 -3.224081 -3.569401 -3.882285 -4.100397 -4.239100 -4.431109 -4.626253 -4.796520 -4.821696 -4.780173 -4.735778 -4.448420 -3.454340 0.3915083 -0.3088662 -0.9291868 -1.499343 -2.006209 -2.471195 -2.890732 -3.270168 -3.618562 -3.916579 -4.142244 -4.313860 -4.499996 -4.681916 -4.836679 -4.833390 -4.792082 -4.726201 -4.424359 -3.454340 0.3167666 -0.3503029 -0.9570835 -1.511141 -2.029342 -2.513676 -2.950448 -3.338734 -3.675558 -3.964728 -4.207815 -4.397640 -4.574182 -4.742657 -4.872514 -4.854309 -4.803590 -4.714821 -4.398175 -3.454340 0.1752379 -0.4574167 -1.038481 -1.586222 -2.106610 -2.593726 -3.035864 -3.409685 -3.739400 -4.038076 -4.290277 -4.486017 -4.651871 -4.806005 -4.901537 -4.879701 -4.813361 -4.701076 -4.369640 -3.454340 -2.2295540E-02 -0.6172812 -1.176402 -1.708881 -2.223274 -2.702791 -3.122595 -3.488031 -3.828044 -4.127512 -4.383501 -4.574772 -4.732577 -4.865793 -4.932536 -4.905877 -4.819886 -4.684370 -4.339469 -3.454340 -0.2695238 -0.8278754 -1.356274 -1.872212 -2.367169 -2.817647 -3.222782 -3.596881 -3.931422 -4.235654 -4.482989 -4.667774 -4.814775 -4.918840 -4.966499 -4.928731 -4.822046 -4.664029 -4.308057 -3.454340 -0.5620995 -1.079137 -1.577741 -2.067675 -2.522797 -2.956364 -3.357761 -3.724518 -4.061021 -4.354983 -4.587030 -4.764397 -4.889838 -4.968616 -4.998475 -4.945864 -4.819098 -4.639488 -4.275103 -3.454340 -0.8932092 -1.368322 -1.829225 -2.278104 -2.715617 -3.130435 -3.522948 -3.884730 -4.204609 -4.478616 -4.701982 -4.857003 -4.957069 -5.013939 -5.025356 -4.955996 -4.809328 -4.609919 -4.240299 -3.454340 -1.261537 -1.690278 -2.113047 -2.532015 -2.944537 -3.347419 -3.725831 -4.057231 -4.356637 -4.617434 -4.812295 -4.938292 -5.013908 -5.050858 -5.043652 -4.957394 -4.791424 -4.574666 -4.203312 -3.454340 -1.671811 -2.056910 -2.442696 -2.831483 -3.221239 -3.591218 -3.934178 -4.248957 -4.526778 -4.744882 -4.905873 -5.004178 -5.059344 -5.076833 -5.050290 -4.947850 -4.764333 -4.532818 -4.163737 -3.454340 -2.127312 -2.467135 -2.818365 -3.161874 -3.510481 -3.853066 -4.172245 -4.443010 -4.668008 -4.848300 -4.975933 -5.051234 -5.089806 -5.088027 -5.042495 -4.924545 -4.726630 -4.483577 -4.121066 -3.454340 -2.621586 -2.905819 -3.206379 -3.515114 -3.829261 -4.116862 -4.376692 -4.596115 -4.776646 -4.919125 -5.023077 -5.078392 -5.097805 -5.079731 -5.016690 -4.884826 -4.676816 -4.427344 -4.074643 -3.454340 -3.157264 -3.374768 -3.611050 -3.855197 -4.099555 -4.328346 -4.529557 -4.701905 -4.848371 -4.963600 -5.042253 -5.077950 -5.077692 -5.045948 -4.968600 -4.826194 -4.612381 -4.362656 -4.024177 -3.454340 -3.697426 -3.828690 -3.983457 -4.149725 -4.322317 -4.490458 -4.642667 -4.772202 -4.882903 -4.968792 -5.022464 -5.039839 -5.023216 -4.979505 -4.892928 -4.745154 -4.531520 -4.286978 -3.967726 -3.454340 -4.229569 -4.261346 -4.326363 -4.408849 -4.506815 -4.611179 -4.707383 -4.791269 -4.864709 -4.920842 -4.951029 -4.952455 -4.923782 -4.872766 -4.782820 -4.636871 -4.429207 -4.196050 -3.902857 -3.454340 -4.766425 -4.700834 -4.666465 -4.655375 -4.669003 -4.699217 -4.729638 -4.760221 -4.791280 -4.816394 -4.822360 -4.808194 -4.770789 -4.716240 -4.627799 -4.493531 -4.298646 -4.083409 -3.824355 -3.454340 -19.19886 -18.80894 -18.33708 -17.79359 -17.18716 -16.52499 -15.81289 -15.05569 -14.25737 -13.42125 -12.55017 -11.64655 -10.71250 -9.749874 -8.760301 -7.745234 -6.705981 -5.643719 -4.559515 -3.454340 -0.5856939 -1.247488 -1.741729 -2.212069 -2.645251 -3.017424 -3.288437 -3.480876 -3.751358 -4.001710 -4.225972 -4.350284 -4.464216 -4.655852 -4.826637 -4.941975 -4.920915 -4.930992 -4.689988 -3.578443 0.1095835 -0.6258487 -1.222145 -1.794292 -2.312894 -2.748012 -3.035675 -3.321412 -3.636657 -3.940684 -4.206754 -4.287540 -4.451787 -4.666677 -4.857572 -4.967314 -4.919831 -4.925577 -4.671810 -3.578443 0.4603087 -0.3111050 -0.9837995 -1.602236 -2.134904 -2.589839 -2.947752 -3.276340 -3.615037 -3.940381 -4.211636 -4.303679 -4.493016 -4.706120 -4.897936 -4.983304 -4.929854 -4.920925 -4.651874 -3.578443 0.6190748 -0.1677967 -0.8669553 -1.482958 -2.034502 -2.513393 -2.913806 -3.280704 -3.639437 -3.974057 -4.217486 -4.366637 -4.557783 -4.762105 -4.943874 -4.987057 -4.946020 -4.916150 -4.630007 -3.578443 0.6437024 -0.1302977 -0.8123162 -1.434736 -1.994045 -2.485598 -2.920040 -3.320813 -3.693627 -4.021151 -4.259508 -4.446706 -4.635500 -4.825781 -4.991771 -5.003439 -4.964739 -4.910399 -4.605994 -3.578443 0.5706912 -0.1655507 -0.8317127 -1.445927 -2.000462 -2.505992 -2.969870 -3.389660 -3.765957 -4.073251 -4.330136 -4.533540 -4.720353 -4.895308 -5.038492 -5.032366 -4.983477 -4.902907 -4.579606 -3.578443 0.4233017 -0.2707973 -0.9124945 -1.506889 -2.060224 -2.579048 -3.054046 -3.480729 -3.838154 -4.147412 -4.414252 -4.627840 -4.807281 -4.967465 -5.077569 -5.066725 -5.000409 -4.892983 -4.550595 -3.578443 0.2164560 -0.4342097 -1.044724 -1.622521 -2.174341 -2.690230 -3.165111 -3.568865 -3.922001 -4.240380 -4.509957 -4.727589 -4.896066 -5.039182 -5.118535 -5.101440 -5.014314 -4.879949 -4.519724 -3.578443 -4.3227099E-02 -0.6489763 -1.227684 -1.789121 -2.325033 -2.828848 -3.272924 -3.669025 -4.030597 -4.348698 -4.618186 -4.824879 -4.987661 -5.106184 -5.164151 -5.132203 -5.023705 -4.862988 -4.487518 -3.578443 -0.3505084 -0.9110881 -1.455529 -1.994266 -2.503560 -2.971189 -3.402077 -3.799864 -4.157259 -4.476433 -4.731737 -4.927953 -5.079396 -5.168445 -5.206758 -5.157743 -5.027201 -4.841315 -4.453700 -3.578443 -0.6985770 -1.216426 -1.726117 -2.226041 -2.694867 -3.147559 -3.565557 -3.957182 -4.310839 -4.611804 -4.851344 -5.036503 -5.159814 -5.226460 -5.242793 -5.176150 -5.023279 -4.814038 -4.417922 -3.578443 -1.089694 -1.562008 -2.023171 -2.482524 -2.928885 -3.360080 -3.770600 -4.148741 -4.473499 -4.756166 -4.980304 -5.132863 -5.233946 -5.275531 -5.270425 -5.184644 -5.010966 -4.780426 -4.379729 -3.578443 -1.520647 -1.940009 -2.363330 -2.786584 -3.211082 -3.622830 -4.002823 -4.346388 -4.654581 -4.913211 -5.093355 -5.216178 -5.292288 -5.313043 -5.286455 -5.181052 -4.988986 -4.739313 -4.338682 -3.578443 -2.001777 -2.370411 -2.753436 -3.144500 -3.529494 -3.901011 -4.252789 -4.572036 -4.833756 -5.038231 -5.185771 -5.277561 -5.332209 -5.333981 -5.287083 -5.163488 -4.955588 -4.689742 -4.294198 -3.578443 -2.532222 -2.845144 -3.175098 -3.517737 -3.869761 -4.211410 -4.504842 -4.761750 -4.972035 -5.132458 -5.248019 -5.317264 -5.350358 -5.333614 -5.267964 -5.129420 -4.908279 -4.632198 -4.245451 -3.578443 -3.102396 -3.353669 -3.626950 -3.907585 -4.193834 -4.463699 -4.696455 -4.895561 -5.061383 -5.191518 -5.280232 -5.328009 -5.340480 -5.306221 -5.224173 -5.074216 -4.844277 -4.565156 -4.192324 -3.578443 -3.703172 -3.860924 -4.047680 -4.246200 -4.451701 -4.650503 -4.826159 -4.980497 -5.109421 -5.208621 -5.270095 -5.297029 -5.292278 -5.243270 -5.149440 -4.992821 -4.761410 -4.486074 -4.132835 -3.578443 -4.299502 -4.345987 -4.431725 -4.538072 -4.662599 -4.788285 -4.901784 -5.007297 -5.097466 -5.167036 -5.202354 -5.209627 -5.193388 -5.134811 -5.035563 -4.879291 -4.654542 -4.390054 -4.064146 -3.578443 -4.891584 -4.822830 -4.799425 -4.803278 -4.835905 -4.876839 -4.920262 -4.969182 -5.014591 -5.054199 -5.064243 -5.055301 -5.031295 -4.968219 -4.870215 -4.724345 -4.514299 -4.269587 -3.980148 -3.578443 -21.11357 -20.68730 -20.16617 -19.56228 -18.88704 -18.14875 -17.35437 -16.50948 -15.61868 -14.68578 -13.71403 -12.70616 -11.66458 -10.59137 -9.488622 -8.357479 -7.199411 -6.016228 -4.808876 -3.578443 -0.4968795 -1.216706 -1.760038 -2.227777 -2.677692 -3.073421 -3.376865 -3.561287 -3.843349 -4.100238 -4.330939 -4.473101 -4.573412 -4.772732 -4.950933 -5.079237 -5.061714 -5.089304 -4.859751 -3.695293 0.2861437 -0.5174520 -1.153114 -1.746024 -2.298174 -2.786498 -3.100576 -3.389141 -3.717511 -4.027987 -4.305772 -4.406519 -4.559428 -4.783676 -4.985390 -5.110744 -5.063322 -5.086615 -4.842361 -3.695293 0.6815945 -0.1528300 -0.8702229 -1.529233 -2.128291 -2.619174 -3.003072 -3.351603 -3.691230 -4.024221 -4.311952 -4.423757 -4.607700 -4.828075 -5.031103 -5.131746 -5.078676 -5.085398 -4.823062 -3.695293 0.8641104 1.4884136E-02 -0.7380233 -1.425744 -2.021853 -2.534525 -2.973083 -3.347259 -3.710817 -4.056902 -4.325817 -4.491685 -4.680618 -4.891004 -5.083146 -5.138953 -5.101413 -5.084419 -4.801637 -3.695293 0.8996152 5.8695555E-02 -0.6962664 -1.371212 -1.974406 -2.509581 -2.966166 -3.375294 -3.762078 -4.112759 -4.375683 -4.576911 -4.766829 -4.964294 -5.138860 -5.159821 -5.127313 -5.082801 -4.777858 -3.695293 0.8243055 1.6683934E-02 -0.7075720 -1.377144 -1.981181 -2.516428 -2.994960 -3.437367 -3.838400 -4.178073 -4.447147 -4.668998 -4.859474 -5.043254 -5.194250 -5.196382 -5.153678 -5.079607 -4.751428 -3.695293 0.6693193 -8.7341726E-02 -0.7857757 -1.437483 -2.028958 -2.568528 -3.071535 -3.528180 -3.928359 -4.256364 -4.536314 -4.765462 -4.956633 -5.123708 -5.244361 -5.238368 -5.178730 -5.073898 -4.722042 -3.695293 0.4526962 -0.2540142 -0.9208669 -1.544101 -2.128382 -2.675900 -3.183379 -3.639609 -4.019823 -4.350882 -4.633005 -4.869600 -5.055280 -5.205642 -5.293900 -5.280438 -5.200232 -5.064996 -4.690511 -3.695293 0.1795103 -0.4762431 -1.102022 -1.709597 -2.279590 -2.821020 -3.317629 -3.746539 -4.126014 -4.462259 -4.745203 -4.979876 -5.154242 -5.285948 -5.348536 -5.320708 -5.216594 -5.051928 -4.657658 -3.695293 -0.1421936 -0.7469258 -1.337772 -1.918083 -2.469492 -2.988550 -3.449669 -3.873210 -4.254754 -4.590050 -4.869258 -5.088552 -5.255914 -5.359073 -5.400961 -5.356640 -5.226656 -5.033716 -4.623071 -3.695293 -0.5066655 -1.067281 -1.618418 -2.165780 -2.684564 -3.162049 -3.615746 -4.029910 -4.408308 -4.737776 -4.995227 -5.204370 -5.353062 -5.429492 -5.448413 -5.383379 -5.229638 -5.009584 -4.586332 -3.695293 -0.9151081 -1.429951 -1.939530 -2.433990 -2.916927 -3.380101 -3.814581 -4.224859 -4.590541 -4.888659 -5.132375 -5.320010 -5.437943 -5.490368 -5.487379 -5.399960 -5.223937 -4.978458 -4.547039 -3.695293 -1.369523 -1.826341 -2.287107 -2.745290 -3.200223 -3.643798 -4.063136 -4.442895 -4.774681 -5.057314 -5.271775 -5.418547 -5.509883 -5.538338 -5.513405 -5.404484 -5.207388 -4.939218 -4.504706 -3.695293 -1.872795 -2.274178 -2.687667 -3.111976 -3.540877 -3.947711 -4.328316 -4.680074 -4.984682 -5.214675 -5.385542 -5.498350 -5.562660 -5.569720 -5.522489 -5.394041 -5.177729 -4.890749 -4.458700 -3.695293 -2.432973 -2.779033 -3.141315 -3.516518 -3.900606 -4.276270 -4.624968 -4.913134 -5.153395 -5.335243 -5.464960 -5.551791 -5.593420 -5.578778 -5.510504 -5.364788 -5.132594 -4.833711 -4.408169 -3.695293 -3.041146 -3.317426 -3.624952 -3.952565 -4.274938 -4.581672 -4.852965 -5.080177 -5.267194 -5.411271 -5.510864 -5.573251 -5.593367 -5.558317 -5.471721 -5.312376 -5.068991 -4.766326 -4.352491 -3.695293 -3.694622 -3.880014 -4.099052 -4.334288 -4.575728 -4.800686 -5.003098 -5.181087 -5.330676 -5.442241 -5.512607 -5.551090 -5.551157 -5.499050 -5.399267 -5.231830 -4.984513 -4.685537 -4.290403 -3.695293 -4.357901 -4.417704 -4.525947 -4.658536 -4.811515 -4.958733 -5.097054 -5.221529 -5.328592 -5.407553 -5.449975 -5.468732 -5.452638 -5.389394 -5.283738 -5.116241 -4.873655 -4.585998 -4.218520 -3.695293 -5.008113 -4.935591 -4.922590 -4.944255 -4.995599 -5.052442 -5.117306 -5.181335 -5.240720 -5.286010 -5.303412 -5.305737 -5.281281 -5.214614 -5.110790 -4.952210 -4.726061 -4.459098 -4.130466 -3.695293 -23.06822 -22.60505 -22.03277 -21.36712 -20.62088 -19.80418 -18.92505 -17.98991 -17.00400 -15.97164 -14.89647 -13.78158 -12.62966 -11.44303 -10.22375 -8.973653 -7.694362 -6.387341 -5.053916 -3.695293 -0.4171887 -1.196660 -1.786313 -2.266726 -2.718860 -3.125313 -3.455101 -3.638588 -3.930403 -4.195925 -4.431882 -4.589760 -4.676715 -4.883135 -5.067799 -5.207946 -5.192565 -5.236839 -5.021496 -3.805691 0.4462812 -0.4234780 -1.120601 -1.716255 -2.282227 -2.797089 -3.164852 -3.453542 -3.795321 -4.114456 -4.400927 -4.520668 -4.662510 -4.894600 -5.105486 -5.245256 -5.196589 -5.237123 -5.005346 -3.805691 0.8922879 -1.5396559E-02 -0.7740423 -1.457036 -2.088714 -2.642976 -3.055532 -3.417896 -3.773143 -4.107735 -4.406302 -4.537743 -4.717817 -4.944376 -5.157007 -5.272225 -5.217268 -5.239673 -4.987165 -3.805691 1.098149 0.1880774 -0.6100532 -1.339854 -2.001660 -2.552340 -3.020501 -3.422786 -3.787081 -4.138421 -4.424605 -4.615248 -4.800249 -5.014317 -5.216563 -5.283859 -5.246898 -5.242778 -4.966698 -3.805691 1.146801 0.2464662 -0.5622767 -1.303589 -1.952829 -2.522941 -3.019029 -3.439981 -3.831191 -4.195386 -4.482028 -4.705569 -4.895558 -5.095246 -5.280296 -5.309674 -5.280509 -5.245505 -4.943609 -3.805691 1.077256 0.2063903 -0.5840569 -1.307556 -1.955491 -2.533838 -3.036518 -3.487238 -3.904230 -4.270570 -4.565326 -4.801960 -4.994017 -5.183945 -5.343699 -5.352202 -5.314953 -5.246881 -4.917603 -3.805691 0.9137064 9.2123218E-02 -0.6618717 -1.363420 -2.005268 -2.574504 -3.092779 -3.572180 -4.000860 -4.363807 -4.652856 -4.903127 -5.098629 -5.273635 -5.402114 -5.402386 -5.348049 -5.245828 -4.888340 -3.805691 0.6858320 -7.7726163E-02 -0.7970414 -1.475342 -2.092874 -2.664256 -3.199872 -3.688013 -4.111970 -4.459917 -4.756331 -5.009480 -5.206495 -5.363401 -5.462151 -5.454148 -5.377230 -5.241534 -4.856623 -3.805691 0.3975341 -0.3072886 -0.9846725 -1.633518 -2.236743 -2.808749 -3.342049 -3.818870 -4.221156 -4.572577 -4.868307 -5.126454 -5.313319 -5.452630 -5.526795 -5.503654 -5.401496 -5.233074 -4.823578 -3.805691 6.7045860E-02 -0.5887668 -1.222840 -1.845165 -2.429802 -2.990229 -3.499917 -3.946244 -4.351046 -4.699615 -4.998052 -5.246853 -5.420723 -5.539896 -5.591709 -5.547033 -5.419883 -5.219398 -4.788730 -3.805691 -0.3164721 -0.9218783 -1.513261 -2.098193 -2.662544 -3.187720 -3.661191 -4.108556 -4.501983 -4.852198 -5.138793 -5.365959 -5.528579 -5.621634 -5.649483 -5.582669 -5.430377 -5.199399 -4.751621 -3.805691 -0.7456561 -1.297372 -1.847569 -2.390160 -2.906487 -3.400319 -3.866600 -4.297838 -4.688047 -5.018828 -5.281098 -5.494308 -5.628974 -5.696701 -5.696383 -5.608512 -5.431337 -5.171751 -4.711769 -3.805691 -1.220777 -1.717234 -2.212119 -2.706422 -3.195086 -3.663745 -4.117054 -4.533525 -4.890432 -5.192606 -5.438419 -5.613369 -5.717630 -5.755513 -5.730120 -5.622253 -5.420712 -5.135158 -4.668557 -3.805691 -1.746292 -2.179539 -2.623419 -3.080425 -3.540779 -3.988776 -4.403079 -4.780261 -5.112640 -5.382193 -5.572609 -5.711568 -5.782277 -5.796509 -5.748047 -5.620585 -5.396271 -5.088316 -4.621281 -3.805691 -2.332458 -2.705224 -3.100087 -3.514847 -3.928607 -4.332909 -4.714435 -5.053871 -5.321191 -5.528861 -5.674793 -5.778033 -5.823013 -5.815183 -5.744196 -5.598110 -5.355461 -5.031569 -4.569035 -3.805691 -2.976557 -3.276671 -3.611469 -3.975187 -4.350642 -4.688328 -4.995939 -5.256311 -5.466821 -5.623477 -5.735010 -5.813266 -5.832683 -5.804145 -5.712266 -5.550183 -5.294733 -4.962714 -4.510616 -3.805691 -3.679820 -3.885628 -4.138446 -4.413521 -4.692716 -4.948898 -5.179991 -5.378593 -5.545344 -5.668578 -5.748448 -5.801599 -5.799119 -5.752447 -5.644323 -5.470625 -5.210618 -4.878722 -4.445299 -3.805691 -4.401641 -4.478137 -4.610186 -4.773608 -4.952508 -5.126787 -5.290686 -5.434184 -5.553974 -5.641694 -5.693030 -5.723447 -5.704428 -5.645161 -5.529306 -5.351613 -5.096177 -4.774199 -4.369253 -3.805691 -5.112136 -5.045191 -5.039116 -5.081896 -5.146927 -5.225247 -5.311465 -5.393658 -5.464727 -5.514709 -5.543767 -5.557838 -5.527990 -5.463675 -5.350229 -5.178432 -4.938241 -4.641712 -4.275600 -3.805691 -25.06082 -24.56020 -23.93568 -23.20647 -22.38695 -21.48961 -20.52341 -19.49562 -18.41213 -17.27778 -16.09686 -14.87210 -13.60720 -12.30449 -10.96626 -9.594510 -8.191288 -6.757472 -5.295245 -3.805691 -0.3439079 -1.182601 -1.816082 -2.306925 -2.778253 -3.182933 -3.527895 -3.710761 -4.014030 -4.286347 -4.529558 -4.700988 -4.774900 -4.987870 -5.177501 -5.328920 -5.314523 -5.375008 -5.174933 -3.910313 0.5990795 -0.3412201 -1.084885 -1.723658 -2.283502 -2.807587 -3.210712 -3.516866 -3.868265 -4.199822 -4.493961 -4.631346 -4.760308 -4.999473 -5.216044 -5.372743 -5.320581 -5.378726 -5.160332 -3.910313 1.092820 0.1136636 -0.7125678 -1.406941 -2.050239 -2.635314 -3.106728 -3.482167 -3.849521 -4.192479 -4.499108 -4.646392 -4.825036 -5.054571 -5.271502 -5.406600 -5.347068 -5.384946 -5.143600 -3.910313 1.329727 0.3430319 -0.4983551 -1.255298 -1.951512 -2.563921 -3.065121 -3.487024 -3.871519 -4.221117 -4.520079 -4.731966 -4.917488 -5.131104 -5.337164 -5.423874 -5.383721 -5.392524 -5.124369 -3.910313 1.391103 0.4250659 -0.4287534 -1.212587 -1.925040 -2.532711 -3.059125 -3.513604 -3.905877 -4.276135 -4.581001 -4.831560 -5.020783 -5.220008 -5.408589 -5.454739 -5.425550 -5.400452 -5.102310 -3.910313 1.323460 0.3920642 -0.4490365 -1.235924 -1.927906 -2.541091 -3.083973 -3.547317 -3.969804 -4.353593 -4.673818 -4.931583 -5.127268 -5.315870 -5.479695 -5.505210 -5.468553 -5.407146 -5.077100 -3.910313 1.159675 0.2740130 -0.5425552 -1.290869 -1.974631 -2.588966 -3.127138 -3.617536 -4.065357 -4.458549 -4.771479 -5.035661 -5.236032 -5.415128 -5.548567 -5.564294 -5.509543 -5.411412 -5.048458 -3.910313 0.9153166 9.4961725E-02 -0.6770613 -1.404151 -2.069779 -2.665543 -3.217655 -3.729770 -4.186911 -4.568436 -4.874069 -5.145994 -5.350508 -5.512073 -5.618672 -5.625535 -5.547712 -5.412414 -5.017091 -3.910313 0.6171337 -0.1420893 -0.8691862 -1.567138 -2.201192 -2.798980 -3.359117 -3.873445 -4.314779 -4.677992 -4.993065 -5.263299 -5.467013 -5.609697 -5.695728 -5.683486 -5.581128 -5.408879 -4.984287 -3.910313 0.2722625 -0.4359916 -1.114018 -1.772867 -2.392946 -2.982650 -3.535102 -4.024429 -4.440441 -4.813561 -5.121439 -5.389663 -5.578811 -5.708684 -5.769867 -5.735358 -5.608064 -5.399728 -4.949548 -3.910313 -0.1287186 -0.7787493 -1.411307 -2.033052 -2.630485 -3.201178 -3.715723 -4.178419 -4.600027 -4.962196 -5.270052 -5.519730 -5.695316 -5.803775 -5.838912 -5.780283 -5.626570 -5.383759 -4.912414 -3.910313 -0.5763117 -1.165232 -1.754468 -2.337341 -2.902076 -3.422536 -3.918758 -4.373987 -4.783182 -5.138607 -5.425308 -5.655863 -5.812251 -5.888039 -5.898129 -5.815025 -5.634915 -5.359730 -4.872243 -3.910313 -1.073045 -1.603334 -2.140833 -2.670082 -3.190211 -3.691587 -4.166505 -4.612132 -5.004949 -5.324583 -5.589787 -5.795278 -5.910002 -5.958913 -5.944339 -5.835130 -5.631577 -5.325950 -4.828377 -3.910313 -1.622525 -2.084296 -2.562742 -3.051918 -3.539732 -4.018301 -4.474321 -4.877458 -5.233726 -5.531582 -5.751620 -5.908854 -5.990032 -6.011769 -5.971760 -5.838245 -5.613329 -5.281003 -4.780005 -3.910313 -2.231402 -2.629872 -3.054196 -3.502911 -3.956306 -4.388574 -4.800438 -5.170585 -5.480549 -5.709126 -5.876334 -5.992661 -6.044550 -6.042836 -5.975718 -5.821583 -5.576394 -5.225286 -4.726308 -3.910313 -2.910761 -3.233097 -3.595294 -3.990947 -4.400857 -4.792487 -5.131987 -5.423017 -5.654795 -5.830750 -5.954358 -6.041702 -6.067509 -6.042263 -5.950735 -5.779213 -5.516428 -5.156744 -4.665711 -3.910313 -3.657769 -3.886101 -4.167668 -4.483597 -4.801602 -5.094185 -5.353570 -5.573756 -5.752628 -5.891018 -5.985314 -6.043998 -6.045070 -5.995875 -5.886927 -5.703668 -5.430554 -5.071838 -4.597986 -3.910313 -4.436397 -4.530944 -4.687663 -4.882596 -5.088691 -5.292853 -5.481803 -5.644640 -5.776293 -5.876156 -5.943056 -5.974768 -5.955017 -5.889024 -5.770668 -5.584706 -5.312524 -4.964633 -4.518838 -3.910313 -5.212859 -5.147857 -5.154448 -5.213652 -5.298615 -5.403250 -5.507582 -5.605192 -5.687208 -5.750692 -5.791903 -5.804079 -5.773531 -5.701816 -5.584082 -5.404686 -5.148558 -4.825550 -4.420817 -3.910313 -27.08958 -26.55094 -25.87286 -25.07788 -24.18363 -23.20356 -22.14809 -21.02537 -19.84196 -18.60322 -17.31366 -15.97706 -14.59670 -13.17542 -11.71573 -10.21980 -8.689623 -7.126948 -5.533367 -3.910313 -0.2705570 -1.170999 -1.849480 -2.351082 -2.836329 -3.252157 -3.601640 -3.778317 -4.094601 -4.372814 -4.623786 -4.807248 -4.868900 -5.087594 -5.281280 -5.442735 -5.427171 -5.504915 -5.319041 -4.009733 0.7464703 -0.2628731 -1.058174 -1.724035 -2.318609 -2.830248 -3.253551 -3.571219 -3.938507 -4.278576 -4.586033 -4.739333 -4.853923 -5.100361 -5.320313 -5.493528 -5.435531 -5.511489 -5.305817 -4.009733 1.285221 0.2352625 -0.6440812 -1.395197 -2.032631 -2.626687 -3.130707 -3.545117 -3.921468 -4.276449 -4.592029 -4.751837 -4.927823 -5.160855 -5.378380 -5.534971 -5.467277 -5.521953 -5.290215 -4.009733 1.551104 0.4928509 -0.4151241 -1.190371 -1.901024 -2.545620 -3.107757 -3.548280 -3.947164 -4.306070 -4.615519 -4.841588 -5.031699 -5.245387 -5.448312 -5.558325 -5.511699 -5.534583 -5.271960 -4.009733 1.626827 0.5900460 -0.3073950 -1.122276 -1.871233 -2.538698 -3.095515 -3.573140 -3.989400 -4.358141 -4.677378 -4.948592 -5.141707 -5.342621 -5.524587 -5.594523 -5.562148 -5.547291 -5.250766 -4.009733 1.559699 0.5698374 -0.3179587 -1.145482 -1.898488 -2.545525 -3.116785 -3.618552 -4.040112 -4.433750 -4.773041 -5.056668 -5.254675 -5.444666 -5.606121 -5.653751 -5.614095 -5.559248 -5.226094 -4.009733 1.400131 0.4522213 -0.4143838 -1.223203 -1.945327 -2.591807 -3.171750 -3.670547 -4.128037 -4.539876 -4.882327 -5.161808 -5.370477 -5.550783 -5.683852 -5.722883 -5.665156 -5.568947 -5.197453 -4.009733 1.145490 0.2644348 -0.5597017 -1.335249 -2.039015 -2.680445 -3.244056 -3.770560 -4.248631 -4.664506 -4.990533 -5.275307 -5.487682 -5.660279 -5.763356 -5.792629 -5.712673 -5.574917 -5.165717 -4.009733 0.8359566 2.0399880E-02 -0.7571786 -1.498623 -2.178759 -2.795042 -3.376550 -3.914912 -4.393966 -4.786578 -5.108216 -5.392702 -5.609032 -5.766662 -5.851024 -5.860178 -5.754883 -5.576324 -5.132702 -4.009733 0.4734291 -0.2842609 -1.009929 -1.708392 -2.358350 -2.976919 -3.555740 -4.087795 -4.533864 -4.918102 -5.240880 -5.525647 -5.732722 -5.872307 -5.937847 -5.922053 -5.789851 -5.572078 -5.097757 -4.009733 5.6254212E-02 -0.6348587 -1.312672 -1.970514 -2.599877 -3.202310 -3.761749 -4.252400 -4.688681 -5.072305 -5.394616 -5.667265 -5.854771 -5.979154 -6.018896 -5.974463 -5.816671 -5.560659 -5.060271 -4.009733 -0.4086588 -1.037778 -1.665298 -2.282040 -2.886755 -3.453028 -3.967090 -4.451809 -4.875971 -5.254602 -5.564466 -5.806076 -5.981373 -6.074953 -6.088256 -6.016042 -5.832686 -5.540584 -5.019667 -4.009733 -0.9260573 -1.491860 -2.065061 -2.639881 -3.187522 -3.718553 -4.221275 -4.687016 -5.102755 -5.456770 -5.734322 -5.958437 -6.098885 -6.160147 -6.142393 -6.045236 -5.835118 -5.510312 -4.975239 -4.009733 -1.498909 -1.994205 -2.504507 -3.026472 -3.542562 -4.047593 -4.532896 -4.976030 -5.350489 -5.670181 -5.921529 -6.094197 -6.195864 -6.225413 -6.179488 -6.057703 -5.820749 -5.467736 -4.926075 -4.009733 -2.131100 -2.555955 -3.008381 -3.486796 -3.973826 -4.445612 -4.883944 -5.280112 -5.622946 -5.881812 -6.073913 -6.198716 -6.263202 -6.264734 -6.194300 -6.047496 -5.787592 -5.413339 -4.871120 -4.009733 -2.837389 -3.189377 -3.578920 -4.004191 -4.443297 -4.874363 -5.261232 -5.577728 -5.837290 -6.030360 -6.173306 -6.261125 -6.298007 -6.269947 -6.179215 -6.008192 -5.731585 -5.344526 -4.808801 -4.009733 -3.621915 -3.880666 -4.193340 -4.543770 -4.902061 -5.233824 -5.523035 -5.763234 -5.957823 -6.109053 -6.218060 -6.273612 -6.283956 -6.231549 -6.122708 -5.932305 -5.647377 -5.257438 -4.738716 -4.009733 -4.464295 -4.576444 -4.759683 -4.984858 -5.223097 -5.458506 -5.668689 -5.851685 -5.997896 -6.107982 -6.183514 -6.211339 -6.199663 -6.129433 -6.010064 -5.808938 -5.527139 -5.145946 -4.657473 -4.009733 -5.307722 -5.243899 -5.264153 -5.339230 -5.448643 -5.576221 -5.699671 -5.814676 -5.914038 -5.982088 -6.030912 -6.039284 -6.014321 -5.936542 -5.820302 -5.620845 -5.356014 -5.001265 -4.556951 -4.009733 -29.15287 -28.57568 -27.84276 -26.98061 -26.00950 -24.94469 -23.79785 -22.57804 -21.29250 -19.94713 -18.54687 -17.09587 -15.59773 -14.05553 -12.47199 -10.84952 -9.190238 -7.496064 -5.768713 -4.009733 -0.2041426 -1.160606 -1.882744 -2.397954 -2.895674 -3.322024 -3.679942 -3.845636 -4.169197 -4.455988 -4.713637 -4.908960 -4.958986 -5.182803 -5.381594 -5.549983 -5.533607 -5.627200 -5.458305 -4.104444 0.8962898 -0.1837406 -1.036345 -1.731969 -2.343791 -2.877612 -3.302057 -3.620061 -4.006133 -4.353281 -4.675212 -4.845150 -4.943700 -5.197532 -5.425465 -5.607544 -5.543617 -5.637346 -5.447187 -4.104444 1.472339 0.3600311 -0.5832555 -1.371397 -2.054868 -2.632956 -3.151555 -3.594511 -3.991151 -4.353187 -4.685393 -4.855093 -5.026235 -5.265280 -5.489207 -5.655864 -5.581508 -5.652253 -5.433625 -4.104444 1.768154 0.6398578 -0.3260145 -1.160335 -1.868734 -2.525091 -3.119869 -3.606944 -4.017361 -4.391504 -4.710893 -4.947802 -5.139448 -5.357971 -5.565741 -5.684923 -5.634176 -5.669712 -5.417261 -4.104444 1.847677 0.7529126 -0.2115909 -1.046398 -1.814984 -2.515435 -3.129340 -3.628428 -4.063812 -4.442875 -4.772007 -5.057079 -5.259514 -5.462657 -5.650321 -5.725411 -5.693411 -5.688080 -5.397658 -4.104444 1.781067 0.7380562 -0.1968323 -1.055879 -1.845734 -2.550446 -3.146639 -3.672196 -4.120670 -4.513785 -4.868033 -5.171977 -5.377814 -5.572378 -5.739662 -5.792254 -5.754274 -5.705288 -5.374346 -4.104444 1.628742 0.6243697 -0.2876714 -1.140808 -1.916373 -2.593851 -3.199710 -3.734132 -4.194043 -4.617268 -4.983913 -5.285331 -5.498458 -5.687819 -5.827080 -5.868658 -5.813680 -5.720553 -5.346770 -4.104444 1.375054 0.4326084 -0.4419554 -1.265673 -2.009637 -2.680820 -3.284563 -3.814382 -4.308686 -4.744615 -5.103697 -5.396647 -5.619469 -5.805518 -5.914240 -5.946718 -5.869350 -5.732482 -5.315763 -4.104444 1.054067 0.1757181 -0.6464657 -1.431907 -2.150467 -2.804069 -3.396838 -3.953584 -4.456518 -4.885014 -5.223494 -5.520404 -5.744872 -5.920822 -6.009728 -6.022339 -5.919738 -5.739542 -5.283458 -4.104444 0.6717635 -0.1345785 -0.9068109 -1.650023 -2.332526 -2.971362 -3.574701 -4.131453 -4.618321 -5.020174 -5.362783 -5.650754 -5.876448 -6.032447 -6.106295 -6.091702 -5.962870 -5.740657 -5.249188 -4.104444 0.2355944 -0.4966097 -1.219152 -1.911324 -2.572272 -3.200867 -3.793893 -4.324949 -4.776843 -5.179194 -5.513433 -5.797387 -6.006550 -6.146901 -6.196195 -6.152167 -5.996663 -5.733949 -5.212219 -4.104444 -0.2483114 -0.9138699 -1.578539 -2.229944 -2.863885 -3.470324 -4.022226 -4.521217 -4.972598 -5.359880 -5.689560 -5.949907 -6.143227 -6.257218 -6.277641 -6.202611 -6.019446 -5.718193 -5.171795 -4.104444 -0.7864158 -1.382886 -1.990992 -2.600939 -3.192269 -3.745309 -4.278070 -4.762808 -5.200727 -5.577503 -5.875965 -6.112441 -6.275133 -6.352823 -6.342505 -6.239007 -6.029116 -5.691689 -5.127104 -4.104444 -1.375146 -1.906581 -2.450387 -3.000911 -3.549537 -4.080585 -4.591531 -5.059052 -5.465699 -5.802852 -6.077329 -6.269616 -6.385370 -6.427263 -6.389153 -6.258299 -6.021594 -5.652582 -5.077481 -4.104444 -2.030641 -2.483737 -2.964433 -3.469595 -3.985672 -4.496443 -4.966030 -5.385520 -5.751201 -6.046606 -6.256129 -6.392945 -6.466048 -6.478959 -6.411659 -6.255447 -5.993027 -5.600721 -5.021355 -4.104444 -2.764304 -3.138592 -3.563213 -4.016047 -4.483548 -4.947277 -5.372903 -5.727158 -6.006986 -6.223253 -6.377623 -6.469656 -6.510189 -6.498291 -6.403783 -6.223145 -5.939259 -5.533331 -4.957451 -4.104444 -3.581797 -3.862080 -4.213598 -4.600096 -4.994296 -5.367603 -5.685301 -5.949786 -6.158578 -6.321471 -6.436202 -6.495696 -6.505975 -6.467455 -6.353824 -6.152967 -5.855529 -5.446323 -4.884293 -4.104444 -4.483860 -4.616413 -4.826990 -5.082364 -5.354806 -5.619584 -5.855095 -6.051246 -6.215161 -6.333657 -6.413620 -6.443896 -6.428213 -6.368627 -6.241753 -6.031932 -5.733473 -5.333036 -4.798650 -4.104444 -5.395982 -5.335215 -5.368073 -5.462772 -5.599753 -5.749856 -5.893493 -6.020334 -6.128644 -6.209941 -6.263037 -6.271393 -6.239442 -6.175592 -6.043543 -5.838773 -5.556213 -5.181011 -4.691743 -4.104444 -31.24921 -30.63293 -29.84394 -28.91301 -27.86324 -26.71180 -25.47160 -24.15264 -22.76286 -21.30871 -19.79559 -18.22801 -16.60987 -14.94452 -13.23491 -11.48364 -9.693000 -7.865057 -6.001649 -4.104444 -0.1468794 -1.154111 -1.915423 -2.444345 -2.956198 -3.390155 -3.760526 -3.914077 -4.242074 -4.535914 -4.799839 -5.006073 -5.045023 -5.273554 -5.477581 -5.651640 -5.635175 -5.740850 -5.591082 -4.194872 1.037318 -0.1025379 -1.012386 -1.744115 -2.373918 -2.923953 -3.363775 -3.670659 -4.063782 -4.425878 -4.759307 -4.948829 -5.029907 -5.289122 -5.525474 -5.715746 -5.647200 -5.753630 -5.582267 -4.194872 1.659363 0.4950861 -0.5252630 -1.355565 -2.061872 -2.669534 -3.179381 -3.634664 -4.059298 -4.427781 -4.775915 -4.955521 -5.121830 -5.364908 -5.596481 -5.770643 -5.692370 -5.772237 -5.570996 -4.194872 1.979689 0.7981805 -0.2459907 -1.117751 -1.875016 -2.517671 -3.125504 -3.651636 -4.085674 -4.469925 -4.806490 -5.050315 -5.243541 -5.465891 -5.680825 -5.806348 -5.752965 -5.793963 -5.556892 -4.194872 2.046702 0.9135314 -0.1102066 -1.000386 -1.771188 -2.486962 -3.137292 -3.679542 -4.132602 -4.530805 -4.865118 -5.160205 -5.373601 -5.577666 -5.773516 -5.851816 -5.819884 -5.817159 -5.539354 -4.194872 1.979857 0.9039346 -9.2838190E-02 -0.9756604 -1.786886 -2.527577 -3.172207 -3.720072 -4.196898 -4.596020 -4.959551 -5.277723 -5.502223 -5.696962 -5.869923 -5.924293 -5.888628 -5.839826 -5.517858 -4.194872 1.837919 0.7889898 -0.1659594 -1.054631 -1.869147 -2.593363 -3.225231 -3.785071 -4.267023 -4.692097 -5.075359 -5.397892 -5.626658 -5.816978 -5.965567 -6.007836 -5.956112 -5.860572 -5.491875 -4.194872 1.601113 0.5959077 -0.3220721 -1.193367 -1.977635 -2.682307 -3.312961 -3.868207 -4.368743 -4.818696 -5.207253 -5.514420 -5.752975 -5.939050 -6.059007 -6.095017 -6.019503 -5.878047 -5.462093 -4.194872 1.266283 0.3315964 -0.5405736 -1.367053 -2.120974 -2.811915 -3.426680 -3.991637 -4.515179 -4.969559 -5.338389 -5.638364 -5.879914 -6.062554 -6.161847 -6.179040 -6.077614 -5.890805 -5.431001 -4.194872 0.8633638 8.9242412E-03 -0.8076382 -1.588972 -2.315545 -2.973725 -3.592792 -4.171446 -4.691081 -5.122533 -5.472512 -5.774044 -6.017667 -6.183640 -6.267258 -6.257827 -6.128789 -5.897749 -5.397829 -4.194872 0.4110769 -0.3655611 -1.129498 -1.860074 -2.546291 -3.200876 -3.816404 -4.386063 -4.869469 -5.276801 -5.630213 -5.926324 -6.158133 -6.306932 -6.365767 -6.327186 -6.170276 -5.897073 -5.361765 -4.194872 -9.0454727E-02 -0.7951116 -1.495741 -2.181439 -2.842969 -3.478732 -4.070301 -4.593000 -5.060929 -5.465296 -5.812028 -6.093225 -6.295793 -6.430037 -6.454152 -6.385614 -6.199455 -5.886876 -5.321997 -4.194872 -0.6478243 -1.279497 -1.920506 -2.560625 -3.187403 -3.778740 -4.329749 -4.844205 -5.292499 -5.689328 -6.011921 -6.260386 -6.441906 -6.537506 -6.529158 -6.430624 -6.215075 -5.865024 -5.277973 -4.194872 -1.254277 -1.817060 -2.395645 -2.980037 -3.553511 -4.119074 -4.649641 -5.142886 -5.574607 -5.930192 -6.219546 -6.439339 -6.566184 -6.627672 -6.587263 -6.458236 -6.214409 -5.829164 -5.227914 -4.194872 -1.931278 -2.412542 -2.923148 -3.455006 -3.996555 -4.536994 -5.046814 -5.490008 -5.872210 -6.192847 -6.426243 -6.579653 -6.660816 -6.687815 -6.621140 -6.461754 -6.192632 -5.778864 -5.171021 -4.194872 -2.690746 -3.088331 -3.538331 -4.027724 -4.523829 -5.016497 -5.472643 -5.871312 -6.168550 -6.406058 -6.571827 -6.672678 -6.721527 -6.713587 -6.618500 -6.433443 -6.144070 -5.711298 -5.106079 -4.194872 -3.539197 -3.841159 -4.219354 -4.650980 -5.083030 -5.489821 -5.845918 -6.127313 -6.350242 -6.525784 -6.646612 -6.712711 -6.728718 -6.692764 -6.569255 -6.364268 -6.062170 -5.622739 -5.030325 -4.194872 -4.495782 -4.649123 -4.890243 -5.178224 -5.485026 -5.780055 -6.035600 -6.250046 -6.418045 -6.553642 -6.636547 -6.668911 -6.656691 -6.601587 -6.457915 -6.242199 -5.937376 -5.506180 -4.940966 -4.194872 -5.477818 -5.421648 -5.467169 -5.583571 -5.745859 -5.922383 -6.085606 -6.231546 -6.338810 -6.435358 -6.489109 -6.495983 -6.470144 -6.403553 -6.256501 -6.045017 -5.751824 -5.349438 -4.828789 -4.194872 -33.37725 -32.72158 -31.87506 -30.87380 -29.74368 -28.50376 -27.16830 -25.74823 -24.25221 -22.68726 -21.05920 -19.37296 -17.63273 -15.84212 -14.00432 -12.12212 -10.19798 -8.234110 -6.232477 -4.194872 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -1.122820 -1.144765 -1.162528 -1.177710 -1.188211 -1.192387 -1.210651 -1.225447 -1.236011 -1.241335 -1.237911 -1.229458 -1.211823 -1.188957 -1.167415 -1.133672 -1.083394 -1.010257 -0.8996979 -0.6128114 -1.142023 -1.160079 -1.177372 -1.190387 -1.197374 -1.200494 -1.217726 -1.231388 -1.240746 -1.242244 -1.239552 -1.229446 -1.210027 -1.185842 -1.163587 -1.129190 -1.078310 -1.005209 -0.8953255 -0.6128114 -1.160219 -1.177404 -1.192210 -1.201307 -1.206842 -1.209267 -1.225368 -1.237641 -1.245578 -1.245306 -1.240946 -1.229101 -1.207840 -1.182728 -1.159502 -1.124611 -1.073087 -1.000445 -0.8908490 -0.6128114 -1.180436 -1.194781 -1.205169 -1.212669 -1.217031 -1.218886 -1.233413 -1.244147 -1.247726 -1.248265 -1.242072 -1.228394 -1.204298 -1.179610 -1.155506 -1.119930 -1.067745 -0.9951514 -0.8862905 -0.6128114 -1.200757 -1.210058 -1.219000 -1.224737 -1.228486 -1.229150 -1.241826 -1.248067 -1.252359 -1.251072 -1.242941 -1.227302 -1.202047 -1.176511 -1.151388 -1.114837 -1.062266 -0.9897351 -0.8815866 -0.6128114 -1.218839 -1.226589 -1.233415 -1.238560 -1.240824 -1.239993 -1.250652 -1.254627 -1.256936 -1.253694 -1.243519 -1.224298 -1.199925 -1.172851 -1.147294 -1.109566 -1.056783 -0.9841954 -0.8767554 -0.6128114 -1.238847 -1.243869 -1.249921 -1.253511 -1.254022 -1.251381 -1.256837 -1.261234 -1.261443 -1.256131 -1.241568 -1.223351 -1.197977 -1.169759 -1.143190 -1.104189 -1.051403 -0.9785334 -0.8717847 -0.6128114 -1.259810 -1.263596 -1.267750 -1.269437 -1.265560 -1.260452 -1.265941 -1.267943 -1.265919 -1.258366 -1.242047 -1.222750 -1.195199 -1.166517 -1.138584 -1.098846 -1.045645 -0.9727507 -0.8666726 -0.6128114 -1.283503 -1.284920 -1.286834 -1.283891 -1.279966 -1.272475 -1.275279 -1.274827 -1.270360 -1.258040 -1.243073 -1.222540 -1.193624 -1.163689 -1.133768 -1.093375 -1.040959 -0.9668569 -0.8613712 -0.6128114 -1.309174 -1.305841 -1.304938 -1.301486 -1.295030 -1.285143 -1.285061 -1.281916 -1.272171 -1.261284 -1.244795 -1.221236 -1.191937 -1.160408 -1.129033 -1.088323 -1.035007 -0.9608567 -0.8558670 -0.6128114 -1.334952 -1.330510 -1.326646 -1.320290 -1.311141 -1.298698 -1.292337 -1.286598 -1.278268 -1.265681 -1.245432 -1.221408 -1.191271 -1.156984 -1.124763 -1.083719 -1.029048 -0.9547644 -0.8501131 -0.6128114 -1.365066 -1.357372 -1.350459 -1.341056 -1.328794 -1.310576 -1.304601 -1.296478 -1.286172 -1.269243 -1.248247 -1.223195 -1.193237 -1.158063 -1.121335 -1.080616 -1.023155 -0.9489552 -0.8440428 -0.6128114 -1.398722 -1.387757 -1.377344 -1.361836 -1.346347 -1.328505 -1.320092 -1.306543 -1.293828 -1.276056 -1.253572 -1.227238 -1.196228 -1.161028 -1.120385 -1.075684 -1.017462 -0.9426960 -0.8375319 -0.6128114 -1.435183 -1.420645 -1.406660 -1.390575 -1.371872 -1.348546 -1.337121 -1.321834 -1.306173 -1.286431 -1.261738 -1.234120 -1.202658 -1.165829 -1.123446 -1.071444 -1.012137 -0.9365441 -0.8304760 -0.6128114 -1.483148 -1.465195 -1.445040 -1.424975 -1.400992 -1.376396 -1.361523 -1.342958 -1.322956 -1.299979 -1.273989 -1.244949 -1.213737 -1.174240 -1.126208 -1.071517 -1.008758 -0.9303924 -0.8214176 -0.6128114 -1.543828 -1.520309 -1.497315 -1.472203 -1.445774 -1.419714 -1.391774 -1.370557 -1.346915 -1.322709 -1.295271 -1.265899 -1.226208 -1.181619 -1.131394 -1.075896 -1.008041 -0.9249319 -0.8099142 -0.6128114 -1.626014 -1.598238 -1.570315 -1.542874 -1.513066 -1.485276 -1.457455 -1.425020 -1.395801 -1.359595 -1.324588 -1.285773 -1.242924 -1.194799 -1.142809 -1.080129 -1.006347 -0.9168808 -0.7965047 -0.6128114 -1.753585 -1.717454 -1.688944 -1.656028 -1.621616 -1.586487 -1.549721 -1.510751 -1.470531 -1.427644 -1.381923 -1.337844 -1.282936 -1.225343 -1.160282 -1.087384 -1.002699 -0.8970234 -0.7801213 -0.6128114 -2.013236 -1.968261 -1.921900 -1.879277 -1.828459 -1.775962 -1.721619 -1.667385 -1.607703 -1.545735 -1.480176 -1.410467 -1.335292 -1.253013 -1.162553 -1.067612 -0.9695160 -0.8672298 -0.7580051 -0.6128114 -2.074072 -2.009172 -1.942870 -1.875177 -1.806105 -1.735666 -1.664116 -1.590736 -1.516274 -1.440498 -1.363413 -1.285034 -1.205372 -1.124439 -1.042249 -0.9588103 -0.8741248 -0.7882220 -0.7011136 -0.6128114 -1.108958 -1.161897 -1.207536 -1.283592 -1.349821 -1.413777 -1.467751 -1.511611 -1.538763 -1.571168 -1.617136 -1.653496 -1.674260 -1.679465 -1.659840 -1.641024 -1.608554 -1.537420 -1.399912 -1.004622 -1.131569 -1.179048 -1.227278 -1.299816 -1.370386 -1.433765 -1.484874 -1.524880 -1.545287 -1.579781 -1.625266 -1.657509 -1.678345 -1.680181 -1.656614 -1.636446 -1.602955 -1.531043 -1.393857 -1.004622 -1.155707 -1.203642 -1.256079 -1.326114 -1.394864 -1.451499 -1.500676 -1.536487 -1.555190 -1.590374 -1.634291 -1.663940 -1.680530 -1.679764 -1.652800 -1.631784 -1.597159 -1.524449 -1.387645 -1.004622 -1.187963 -1.234136 -1.285672 -1.356802 -1.416115 -1.470562 -1.516006 -1.545739 -1.567849 -1.602421 -1.640767 -1.670113 -1.683181 -1.678452 -1.649154 -1.627014 -1.591157 -1.517621 -1.381274 -1.004622 -1.226472 -1.273883 -1.324421 -1.384515 -1.439961 -1.490562 -1.528898 -1.559639 -1.582533 -1.615502 -1.650113 -1.676059 -1.684272 -1.676034 -1.645610 -1.622116 -1.584941 -1.510396 -1.374740 -1.004622 -1.274147 -1.319090 -1.360614 -1.414544 -1.465483 -1.508579 -1.545918 -1.576372 -1.598484 -1.625613 -1.659276 -1.678759 -1.685102 -1.673247 -1.642118 -1.617076 -1.578517 -1.502903 -1.368059 -1.004622 -1.323251 -1.362422 -1.398405 -1.447343 -1.489959 -1.530555 -1.566137 -1.594960 -1.612574 -1.638654 -1.665283 -1.681855 -1.685032 -1.670968 -1.638708 -1.611904 -1.571899 -1.495169 -1.361240 -1.004622 -1.376234 -1.407788 -1.439104 -1.479618 -1.518856 -1.556120 -1.588788 -1.612698 -1.629520 -1.651607 -1.673123 -1.685150 -1.684540 -1.669096 -1.635414 -1.606673 -1.565108 -1.487204 -1.354280 -1.004622 -1.432419 -1.455875 -1.480301 -1.516647 -1.551634 -1.584419 -1.611403 -1.633291 -1.646725 -1.661167 -1.678765 -1.687491 -1.684725 -1.667647 -1.632212 -1.601400 -1.558155 -1.479021 -1.347182 -1.004622 -1.489968 -1.507452 -1.527226 -1.557697 -1.587267 -1.613218 -1.637032 -1.654795 -1.661447 -1.671797 -1.685290 -1.690402 -1.685528 -1.666721 -1.629286 -1.596171 -1.550534 -1.470648 -1.339952 -1.004622 -1.552692 -1.564706 -1.578460 -1.600927 -1.623934 -1.645229 -1.662342 -1.674982 -1.677535 -1.683648 -1.692456 -1.694433 -1.687245 -1.666432 -1.626774 -1.591133 -1.542514 -1.462106 -1.332605 -1.004622 -1.621132 -1.625692 -1.632683 -1.647960 -1.663856 -1.677969 -1.690057 -1.697232 -1.695532 -1.696812 -1.701569 -1.700140 -1.690195 -1.667051 -1.624879 -1.586355 -1.534563 -1.453478 -1.325168 -1.004622 -1.693958 -1.690971 -1.689198 -1.697232 -1.705413 -1.714360 -1.721048 -1.722630 -1.716420 -1.713098 -1.713394 -1.708177 -1.695043 -1.669012 -1.623989 -1.580718 -1.526857 -1.444968 -1.317687 -1.004622 -1.771606 -1.761344 -1.752502 -1.752938 -1.753889 -1.756031 -1.756725 -1.752995 -1.742172 -1.733777 -1.729111 -1.719682 -1.702758 -1.673195 -1.625668 -1.576046 -1.519714 -1.436877 -1.310251 -1.004622 -1.862478 -1.842984 -1.825849 -1.817949 -1.811061 -1.806214 -1.800790 -1.791318 -1.775164 -1.761111 -1.750774 -1.736355 -1.715085 -1.681199 -1.632735 -1.573249 -1.513790 -1.429637 -1.303004 -1.004622 -1.974305 -1.944637 -1.917652 -1.900387 -1.885087 -1.872042 -1.859102 -1.842641 -1.819859 -1.799010 -1.782025 -1.761121 -1.734595 -1.696535 -1.644718 -1.576035 -1.510642 -1.424085 -1.297091 -1.004622 -2.126391 -2.084731 -2.045211 -2.016561 -1.990627 -1.967118 -1.944165 -1.918046 -1.885614 -1.854725 -1.829058 -1.801035 -1.766765 -1.722743 -1.665445 -1.594137 -1.513206 -1.421953 -1.291136 -1.004622 -2.360162 -2.301504 -2.244140 -2.199822 -2.160333 -2.122362 -2.086189 -2.048399 -2.006998 -1.961071 -1.910597 -1.871642 -1.827514 -1.773768 -1.709042 -1.630146 -1.535464 -1.430031 -1.288054 -1.004622 -2.796117 -2.722692 -2.651316 -2.581203 -2.517561 -2.452355 -2.390658 -2.334152 -2.274683 -2.211599 -2.143384 -2.069632 -1.988352 -1.900959 -1.815155 -1.718553 -1.600433 -1.464355 -1.291406 -1.004622 -4.355299 -4.224098 -4.087332 -3.945099 -3.797502 -3.644641 -3.486600 -3.323721 -3.155353 -2.982341 -2.804555 -2.622086 -2.435235 -2.243408 -2.047439 -1.847162 -1.642623 -1.433973 -1.221286 -1.004622 -0.9999700 -1.118460 -1.227973 -1.313351 -1.389785 -1.499319 -1.603528 -1.694411 -1.771391 -1.820731 -1.866653 -1.943813 -2.002826 -2.043720 -2.055742 -2.030879 -2.020912 -1.958734 -1.805056 -1.332105 -1.004714 -1.124308 -1.234278 -1.313936 -1.400830 -1.514342 -1.617256 -1.710657 -1.785452 -1.827759 -1.875738 -1.951211 -2.009792 -2.048870 -2.055978 -2.026459 -2.015125 -1.951394 -1.797330 -1.332105 -1.028015 -1.141749 -1.242784 -1.330138 -1.421592 -1.534096 -1.637064 -1.727704 -1.796945 -1.835405 -1.889467 -1.963093 -2.018159 -2.052936 -2.054283 -2.022352 -2.009128 -1.943699 -1.789341 -1.332105 -1.063455 -1.165269 -1.266205 -1.357558 -1.451055 -1.559973 -1.660049 -1.744871 -1.805503 -1.849881 -1.903834 -1.975843 -2.025267 -2.055640 -2.050507 -2.018345 -2.002834 -1.935629 -1.781081 -1.332105 -1.103995 -1.204112 -1.303479 -1.394357 -1.486339 -1.590474 -1.683545 -1.759902 -1.819299 -1.866575 -1.921851 -1.986081 -2.032403 -2.056700 -2.045912 -2.014202 -1.996165 -1.927160 -1.772542 -1.332105 -1.157741 -1.255898 -1.350234 -1.438184 -1.526801 -1.622397 -1.706629 -1.777207 -1.838345 -1.886672 -1.938148 -1.996939 -2.038515 -2.055969 -2.041949 -2.009882 -1.988961 -1.918274 -1.763766 -1.332105 -1.227243 -1.316404 -1.403926 -1.487678 -1.569426 -1.655330 -1.731293 -1.800654 -1.859628 -1.908160 -1.955212 -2.007764 -2.042950 -2.053436 -2.038327 -2.005272 -1.981428 -1.908116 -1.754783 -1.332105 -1.302943 -1.383993 -1.463959 -1.540497 -1.613581 -1.690606 -1.762473 -1.827360 -1.884683 -1.928049 -1.970313 -2.017131 -2.045383 -2.050936 -2.034819 -2.000315 -1.973439 -1.898268 -1.745590 -1.332105 -1.388813 -1.458265 -1.529186 -1.596319 -1.661579 -1.732440 -1.798088 -1.858216 -1.909620 -1.948831 -1.985737 -2.024501 -2.045779 -2.049033 -2.031344 -1.995029 -1.965012 -1.887920 -1.736579 -1.332105 -1.481372 -1.539147 -1.599615 -1.658345 -1.715886 -1.779222 -1.838512 -1.890576 -1.935924 -1.970618 -2.000373 -2.030344 -2.046356 -2.047364 -2.027774 -1.989222 -1.956199 -1.876917 -1.726961 -1.332105 -1.581291 -1.628163 -1.677760 -1.726389 -1.776352 -1.830436 -1.881004 -1.925622 -1.963996 -1.992277 -2.014067 -2.035985 -2.047618 -2.045906 -2.024153 -1.983112 -1.947026 -1.865474 -1.717686 -1.332105 -1.690153 -1.724512 -1.762828 -1.802240 -1.842132 -1.885659 -1.926930 -1.963480 -1.993120 -2.013437 -2.028353 -2.043474 -2.049798 -2.044742 -2.020546 -1.976833 -1.937453 -1.853701 -1.708376 -1.332105 -1.808751 -1.830272 -1.856644 -1.885218 -1.914002 -1.946231 -1.977017 -2.003456 -2.023402 -2.036483 -2.045189 -2.053338 -2.053453 -2.044483 -2.017322 -1.970736 -1.927622 -1.841764 -1.698109 -1.332105 -1.938352 -1.946787 -1.960638 -1.976746 -1.993221 -2.012219 -2.030977 -2.047666 -2.058453 -2.063763 -2.065648 -2.066447 -2.059758 -2.045954 -2.015222 -1.965284 -1.917192 -1.830030 -1.687730 -1.332105 -2.083473 -2.077538 -2.075493 -2.076787 -2.080021 -2.087187 -2.094274 -2.100694 -2.101261 -2.097770 -2.091751 -2.084965 -2.070597 -2.050926 -2.015558 -1.960213 -1.907491 -1.819419 -1.677447 -1.332105 -2.246376 -2.223518 -2.207322 -2.195154 -2.184962 -2.179158 -2.173174 -2.168125 -2.157145 -2.143625 -2.128313 -2.112799 -2.089732 -2.062353 -2.020514 -1.957440 -1.899852 -1.810261 -1.667655 -1.332105 -2.454472 -2.412413 -2.377587 -2.347980 -2.321893 -2.301432 -2.280792 -2.262504 -2.238031 -2.211952 -2.184872 -2.158450 -2.123038 -2.085415 -2.038636 -1.970656 -1.897066 -1.803306 -1.659277 -1.332105 -2.762317 -2.694107 -2.635031 -2.581594 -2.532400 -2.491525 -2.451282 -2.414593 -2.371282 -2.326576 -2.279723 -2.237689 -2.188817 -2.138681 -2.082481 -2.004824 -1.907548 -1.804449 -1.654390 -1.332105 -3.325031 -3.218173 -3.122629 -3.032768 -2.946690 -2.859819 -2.791778 -2.728039 -2.664656 -2.598336 -2.524234 -2.444559 -2.366923 -2.289841 -2.204403 -2.103577 -1.977182 -1.833339 -1.662326 -1.332105 -6.924547 -6.725896 -6.514347 -6.290972 -6.055847 -5.809285 -5.551589 -5.283147 -5.004237 -4.715214 -4.416409 -4.108054 -3.790533 -3.464062 -3.128941 -2.785440 -2.433744 -2.074167 -1.707116 -1.332105 -0.8515911 -1.026328 -1.192996 -1.342603 -1.451398 -1.553547 -1.696816 -1.828994 -1.947550 -2.041913 -2.080759 -2.178649 -2.271575 -2.344583 -2.388018 -2.365283 -2.374626 -2.323723 -2.157170 -1.613434 -0.8104344 -0.9949663 -1.172523 -1.324247 -1.428788 -1.547131 -1.700429 -1.839454 -1.961475 -2.053236 -2.085017 -2.189101 -2.282669 -2.354948 -2.393623 -2.361822 -2.369849 -2.316297 -2.147729 -1.613434 -0.8118024 -0.9943380 -1.168425 -1.313101 -1.432228 -1.565705 -1.719490 -1.857159 -1.976506 -2.058559 -2.101145 -2.206248 -2.296423 -2.364948 -2.396641 -2.359786 -2.365093 -2.308405 -2.137835 -1.613434 -0.8398155 -1.010969 -1.175749 -1.325338 -1.462507 -1.597588 -1.745625 -1.879437 -1.989721 -2.065831 -2.123626 -2.225705 -2.311396 -2.373574 -2.397042 -2.358511 -2.360045 -2.300001 -2.127445 -1.613434 -0.8868412 -1.042837 -1.205818 -1.363867 -1.501742 -1.635436 -1.776949 -1.901715 -2.001050 -2.083453 -2.150085 -2.246124 -2.325664 -2.380387 -2.394346 -2.358180 -2.354592 -2.290514 -2.116917 -1.613434 -0.9513106 -1.099105 -1.259147 -1.414178 -1.549896 -1.679557 -1.810763 -1.923742 -2.020306 -2.106261 -2.176472 -2.265897 -2.338719 -2.385117 -2.391176 -2.357040 -2.348594 -2.280759 -2.106081 -1.613434 -1.037862 -1.177888 -1.327680 -1.472369 -1.605085 -1.727723 -1.845542 -1.951397 -2.047436 -2.132697 -2.201967 -2.284143 -2.349324 -2.387193 -2.389131 -2.355572 -2.342642 -2.270032 -2.094945 -1.613434 -1.142810 -1.269926 -1.404920 -1.540288 -1.664763 -1.777139 -1.885359 -1.987058 -2.080141 -2.160892 -2.226820 -2.300712 -2.357381 -2.386818 -2.388134 -2.353370 -2.334981 -2.258725 -2.083497 -1.613434 -1.256624 -1.372032 -1.494327 -1.615458 -1.727692 -1.831656 -1.933251 -2.028478 -2.115343 -2.190361 -2.250950 -2.315362 -2.362914 -2.386815 -2.386432 -2.350249 -2.326467 -2.246573 -2.071699 -1.613434 -1.384251 -1.485073 -1.590652 -1.697526 -1.798308 -1.894137 -1.987351 -2.073772 -2.152088 -2.220709 -2.274637 -2.328613 -2.367044 -2.387366 -2.384119 -2.346932 -2.317649 -2.233537 -2.059554 -1.613434 -1.523728 -1.605539 -1.694738 -1.788715 -1.878207 -1.963484 -2.046090 -2.121804 -2.190687 -2.251190 -2.297752 -2.340909 -2.371855 -2.387378 -2.380860 -2.341132 -2.307092 -2.219595 -2.047059 -1.613434 -1.672869 -1.736130 -1.810208 -1.889963 -1.966121 -2.037941 -2.108671 -2.173525 -2.231017 -2.282052 -2.320245 -2.354058 -2.377474 -2.387128 -2.377233 -2.334123 -2.295898 -2.204555 -2.034217 -1.613434 -1.836540 -1.881274 -1.937291 -1.999453 -2.060562 -2.118674 -2.176432 -2.228679 -2.273733 -2.313959 -2.343343 -2.368522 -2.383624 -2.386784 -2.371974 -2.326747 -2.283355 -2.188528 -2.021019 -1.613434 -2.013549 -2.037734 -2.073667 -2.119271 -2.164267 -2.206954 -2.250621 -2.288913 -2.320220 -2.348099 -2.368442 -2.384614 -2.390974 -2.387117 -2.367036 -2.318065 -2.270039 -2.172067 -2.007525 -1.613434 -2.207965 -2.211091 -2.226660 -2.253026 -2.280345 -2.306176 -2.333498 -2.355554 -2.372555 -2.387803 -2.397704 -2.404077 -2.401142 -2.389182 -2.362612 -2.308922 -2.255793 -2.155858 -1.993841 -1.613434 -2.429256 -2.410963 -2.403635 -2.407092 -2.413232 -2.419499 -2.429999 -2.435981 -2.437734 -2.437778 -2.435248 -2.430187 -2.417279 -2.395503 -2.361052 -2.300822 -2.242099 -2.140849 -1.980289 -1.613434 -2.693916 -2.647853 -2.613851 -2.595568 -2.580064 -2.565214 -2.556200 -2.542819 -2.526787 -2.508385 -2.491172 -2.472361 -2.446680 -2.412328 -2.366801 -2.303087 -2.231849 -2.128662 -1.967670 -1.613434 -3.065728 -2.982921 -2.914125 -2.866600 -2.823629 -2.781781 -2.748142 -2.711128 -2.671792 -2.629028 -2.590661 -2.550395 -2.505060 -2.454330 -2.396254 -2.322057 -2.232894 -2.123416 -1.958358 -1.613434 -3.748375 -3.611323 -3.482685 -3.380990 -3.286853 -3.197410 -3.127639 -3.058836 -2.985641 -2.908931 -2.831485 -2.753610 -2.678318 -2.594674 -2.502044 -2.402467 -2.275545 -2.143374 -1.961466 -1.613434 -9.740750 -9.472783 -9.182953 -8.872050 -8.540804 -8.190005 -7.820441 -7.432890 -7.028074 -6.606737 -6.169502 -5.717065 -5.249949 -4.768794 -4.274045 -3.766279 -3.245886 -2.713362 -2.169075 -1.613434 -0.7360798 -0.9244148 -1.138080 -1.338076 -1.508820 -1.605724 -1.776987 -1.940601 -2.094009 -2.228783 -2.309370 -2.382566 -2.504032 -2.602576 -2.674412 -2.673941 -2.683715 -2.646683 -2.469946 -1.860027 -0.6284090 -0.8430021 -1.070864 -1.285228 -1.462669 -1.573019 -1.761524 -1.937812 -2.102483 -2.242823 -2.310447 -2.396601 -2.520381 -2.619015 -2.686982 -2.673038 -2.681312 -2.640054 -2.459405 -1.860027 -0.5957940 -0.8169091 -1.046175 -1.257653 -1.432701 -1.583687 -1.772500 -1.952918 -2.118941 -2.252515 -2.319246 -2.421600 -2.541918 -2.636533 -2.696561 -2.672797 -2.679577 -2.632816 -2.448244 -1.860027 -0.6069189 -0.8266967 -1.049915 -1.254512 -1.443274 -1.607829 -1.798818 -1.978079 -2.138700 -2.258772 -2.345040 -2.453204 -2.566261 -2.653152 -2.703529 -2.674359 -2.678767 -2.624972 -2.436422 -1.860027 -0.6516791 -0.8615848 -1.077948 -1.285746 -1.475431 -1.649918 -1.836260 -2.010562 -2.157543 -2.277329 -2.376179 -2.484654 -2.589955 -2.668359 -2.707051 -2.677182 -2.676607 -2.616338 -2.423884 -1.860027 -0.7219333 -0.9217619 -1.133778 -1.336318 -1.527872 -1.704479 -1.885035 -2.043789 -2.181941 -2.305252 -2.409645 -2.513821 -2.611138 -2.681737 -2.707473 -2.680660 -2.673658 -2.606774 -2.410608 -1.860027 -0.8194482 -1.006827 -1.208604 -1.406983 -1.595415 -1.770291 -1.934147 -2.082807 -2.217273 -2.338422 -2.442194 -2.540728 -2.630001 -2.691783 -2.709460 -2.683896 -2.669607 -2.596184 -2.396846 -1.860027 -0.9390104 -1.113641 -1.305185 -1.495160 -1.675528 -1.835649 -1.989231 -2.130579 -2.257887 -2.373810 -2.474334 -2.565727 -2.646372 -2.697822 -2.712410 -2.686592 -2.664822 -2.584452 -2.383054 -1.860027 -1.082254 -1.241996 -1.420112 -1.595503 -1.757272 -1.908985 -2.051380 -2.182027 -2.301179 -2.411008 -2.506300 -2.589508 -2.660466 -2.703018 -2.714830 -2.686509 -2.658051 -2.571367 -2.369082 -1.860027 -1.245595 -1.388525 -1.544006 -1.701156 -1.850855 -1.988769 -2.117115 -2.237247 -2.347619 -2.449353 -2.537571 -2.612395 -2.672489 -2.708419 -2.715940 -2.684272 -2.648991 -2.556937 -2.354655 -1.860027 -1.422172 -1.541860 -1.678585 -1.818236 -1.949819 -2.073012 -2.188514 -2.297123 -2.397002 -2.488575 -2.568297 -2.633826 -2.684411 -2.713341 -2.715431 -2.679962 -2.637969 -2.541089 -2.339736 -1.860027 -1.613273 -1.711639 -1.824351 -1.941736 -2.055503 -2.164910 -2.266849 -2.361692 -2.448519 -2.528878 -2.598179 -2.654549 -2.696286 -2.717235 -2.712603 -2.672561 -2.624795 -2.523596 -2.324292 -1.860027 -1.820843 -1.892510 -1.979767 -2.076727 -2.172873 -2.265617 -2.350842 -2.429879 -2.503209 -2.570589 -2.628239 -2.674848 -2.707304 -2.719414 -2.708032 -2.662189 -2.609315 -2.504432 -2.308353 -1.860027 -2.042871 -2.090059 -2.152916 -2.226935 -2.300584 -2.373249 -2.441270 -2.503491 -2.561473 -2.614703 -2.659430 -2.694207 -2.717402 -2.720347 -2.701422 -2.649590 -2.591787 -2.483933 -2.291909 -1.860027 -2.289343 -2.307201 -2.341964 -2.390836 -2.442002 -2.492784 -2.540660 -2.584346 -2.625825 -2.661784 -2.692137 -2.714333 -2.727699 -2.720711 -2.693728 -2.635385 -2.572301 -2.463079 -2.275036 -1.860027 -2.562424 -2.550962 -2.557298 -2.578927 -2.604757 -2.631084 -2.654932 -2.675527 -2.698063 -2.716110 -2.731476 -2.738755 -2.740537 -2.722844 -2.686703 -2.620911 -2.550979 -2.441946 -2.257875 -1.860027 -2.888610 -2.845025 -2.816433 -2.805352 -2.801014 -2.798281 -2.795585 -2.791178 -2.792206 -2.788464 -2.785743 -2.774952 -2.762899 -2.732291 -2.684522 -2.609002 -2.530672 -2.422202 -2.240934 -1.860027 -3.326629 -3.235667 -3.166424 -3.118665 -3.078250 -3.040179 -3.003616 -2.966600 -2.938239 -2.907376 -2.880071 -2.845257 -2.812469 -2.761803 -2.698559 -2.614778 -2.518957 -2.407163 -2.225498 -1.860027 -4.124799 -3.957929 -3.813503 -3.701053 -3.602876 -3.505829 -3.412521 -3.325589 -3.253199 -3.181581 -3.109245 -3.033387 -2.958039 -2.881128 -2.783825 -2.673353 -2.541467 -2.411917 -2.219278 -1.860027 -12.77138 -12.43298 -12.06073 -11.65612 -11.22064 -10.75584 -10.26325 -9.744214 -9.200136 -8.632277 -8.041727 -7.429603 -6.796912 -6.144513 -5.473290 -4.784029 -4.077417 -3.354144 -2.614829 -1.860027 -0.6310297 -0.8288211 -1.091846 -1.334270 -1.551839 -1.709657 -1.848010 -2.042588 -2.225632 -2.389949 -2.509426 -2.563141 -2.706956 -2.826009 -2.922832 -2.948638 -2.957401 -2.935436 -2.754238 -2.079525 -0.4586552 -0.6930023 -0.9710528 -1.234612 -1.471504 -1.629573 -1.814806 -2.025843 -2.224026 -2.400478 -2.517004 -2.579953 -2.728296 -2.847841 -2.943108 -2.953864 -2.958630 -2.930565 -2.743042 -2.079525 -0.3832902 -0.6363024 -0.9142137 -1.179623 -1.409337 -1.607523 -1.818283 -2.037941 -2.234941 -2.413997 -2.518885 -2.615556 -2.760252 -2.873162 -2.960408 -2.954960 -2.962392 -2.925188 -2.731048 -2.079525 -0.3704492 -0.6313134 -0.9021980 -1.158857 -1.397696 -1.621746 -1.844254 -2.056717 -2.256655 -2.428369 -2.545510 -2.661684 -2.794927 -2.899034 -2.975303 -2.960428 -2.965799 -2.919088 -2.718198 -2.079525 -0.4045066 -0.6633452 -0.9258769 -1.180112 -1.427590 -1.660881 -1.878730 -2.089352 -2.286808 -2.451206 -2.582041 -2.705907 -2.828465 -2.923586 -2.986717 -2.969103 -2.969144 -2.911990 -2.704423 -2.079525 -0.4768030 -0.7267052 -0.9860286 -1.238190 -1.484093 -1.712226 -1.927445 -2.136298 -2.325431 -2.485986 -2.624927 -2.745621 -2.859528 -2.946043 -2.993596 -2.979252 -2.972450 -2.903626 -2.689649 -2.079525 -0.5836188 -0.8230751 -1.075500 -1.322526 -1.555264 -1.776920 -1.991222 -2.194125 -2.371592 -2.530144 -2.665481 -2.782210 -2.888128 -2.965047 -3.000614 -2.989560 -2.973105 -2.893830 -2.674145 -2.079525 -0.7211097 -0.9459965 -1.189259 -1.419298 -1.642037 -1.859119 -2.067198 -2.256612 -2.424382 -2.576520 -2.705837 -2.817378 -2.914916 -2.980115 -3.009442 -2.997352 -2.972085 -2.882454 -2.658136 -2.079525 -0.8849357 -1.091150 -1.313764 -1.534242 -1.748090 -1.956243 -2.146430 -2.322523 -2.481132 -2.621458 -2.745663 -2.851240 -2.939606 -2.993405 -3.017866 -3.002658 -2.967954 -2.869285 -2.641509 -2.079525 -1.069809 -1.254768 -1.460946 -1.668603 -1.869569 -2.054825 -2.229980 -2.392355 -2.536302 -2.667080 -2.784745 -2.883676 -2.961604 -3.007304 -3.025316 -3.005147 -2.961081 -2.854244 -2.624569 -2.079525 -1.279362 -1.443155 -1.629867 -1.814076 -1.990824 -2.161579 -2.317494 -2.461694 -2.593864 -2.714696 -2.823243 -2.913471 -2.981676 -3.020000 -3.030240 -3.003675 -2.951021 -2.837162 -2.607322 -2.079525 -1.513065 -1.648766 -1.805422 -1.967660 -2.123925 -2.270602 -2.406701 -2.535993 -2.655679 -2.764463 -2.860440 -2.940932 -3.000362 -3.030267 -3.032474 -2.998123 -2.937793 -2.817901 -2.589321 -2.079525 -1.758887 -1.868373 -1.997632 -2.132110 -2.261907 -2.386204 -2.504292 -2.617011 -2.720657 -2.815390 -2.897627 -2.966697 -3.016370 -3.037001 -3.031134 -2.988852 -2.921329 -2.796277 -2.570545 -2.079525 -2.029934 -2.105299 -2.201302 -2.307347 -2.413993 -2.515190 -2.611025 -2.703108 -2.789129 -2.868077 -2.935382 -2.990830 -3.029032 -3.039898 -3.025855 -2.975784 -2.901611 -2.772420 -2.550918 -2.079525 -2.322185 -2.363551 -2.428176 -2.503845 -2.581339 -2.655261 -2.727199 -2.796968 -2.862860 -2.923475 -2.974767 -3.013515 -3.038821 -3.039299 -3.016883 -2.959399 -2.878709 -2.746647 -2.530426 -2.079525 -2.649298 -2.652340 -2.680132 -2.722594 -2.769387 -2.813746 -2.858404 -2.903090 -2.945138 -2.983487 -3.016638 -3.037965 -3.048435 -3.036994 -3.005332 -2.940470 -2.853079 -2.719860 -2.509138 -2.079525 -3.030193 -2.992328 -2.979537 -2.984718 -2.996402 -3.004421 -3.015049 -3.030264 -3.044141 -3.058051 -3.070267 -3.071041 -3.063604 -3.037802 -2.994725 -2.921063 -2.824896 -2.692250 -2.487293 -2.079525 -3.538088 -3.444269 -3.377417 -3.335922 -3.303132 -3.269355 -3.237874 -3.216058 -3.193446 -3.173956 -3.158272 -3.132985 -3.101024 -3.054487 -2.992883 -2.907443 -2.799228 -2.666520 -2.466233 -2.079525 -4.451219 -4.265203 -4.102306 -3.983427 -3.879655 -3.775412 -3.674531 -3.590331 -3.505438 -3.427961 -3.368316 -3.298517 -3.222904 -3.144380 -3.047881 -2.937119 -2.795520 -2.654476 -2.452554 -2.079525 -15.99132 -15.58112 -15.12262 -14.61836 -14.07101 -13.48318 -12.85730 -12.19571 -11.50051 -10.77364 -10.01684 -9.231688 -8.419641 -7.582025 -6.720036 -5.834761 -4.927192 -3.998245 -3.048763 -2.079525 -0.5039308 -0.7523078 -1.038837 -1.326003 -1.592746 -1.805206 -1.925122 -2.143725 -2.344175 -2.534162 -2.688703 -2.723128 -2.888484 -3.024020 -3.142163 -3.193800 -3.201665 -3.196080 -3.015866 -2.277299 -0.2623374 -0.5384303 -0.8633406 -1.182592 -1.477951 -1.691685 -1.868624 -2.107404 -2.331012 -2.542626 -2.699930 -2.742247 -2.913731 -3.051349 -3.170203 -3.206645 -3.208506 -3.193931 -3.004535 -2.277299 -0.1364488 -0.4468440 -0.7816762 -1.105419 -1.390364 -1.631121 -1.861097 -2.108031 -2.340889 -2.556403 -2.698328 -2.792109 -2.955260 -3.084796 -3.196206 -3.212022 -3.217244 -3.191395 -2.992211 -2.277299 -0.1073503 -0.4276962 -0.7581136 -1.067571 -1.353263 -1.623057 -1.874276 -2.128525 -2.367071 -2.571689 -2.724374 -2.854993 -2.999779 -3.120541 -3.220294 -3.222019 -3.227777 -3.188078 -2.978825 -2.277299 -0.1396137 -0.4578428 -0.7728868 -1.075363 -1.367786 -1.645755 -1.910811 -2.166874 -2.396261 -2.595840 -2.769448 -2.910112 -3.045044 -3.154964 -3.241175 -3.237715 -3.239772 -3.183500 -2.964293 -2.277299 -0.2163131 -0.5211179 -0.8296022 -1.127259 -1.415274 -1.698288 -1.966313 -2.215304 -2.438541 -2.643286 -2.821950 -2.962706 -3.087181 -3.187415 -3.257455 -3.255768 -3.249442 -3.177433 -2.948520 -2.277299 -0.3295357 -0.6220621 -0.9216851 -1.211547 -1.495466 -1.773283 -2.033298 -2.274762 -2.497822 -2.704572 -2.873096 -3.013042 -3.127982 -3.217351 -3.272170 -3.273902 -3.256199 -3.169652 -2.931684 -2.277299 -0.4796266 -0.7558942 -1.043389 -1.324179 -1.599286 -1.862014 -2.110363 -2.350294 -2.570989 -2.761321 -2.926515 -3.058947 -3.167138 -3.244057 -3.289599 -3.289732 -3.260197 -3.159956 -2.914282 -2.277299 -0.6631413 -0.9189401 -1.190711 -1.460844 -1.714295 -1.963198 -2.206254 -2.439426 -2.640683 -2.820576 -2.975179 -3.101521 -3.202787 -3.268730 -3.307437 -3.303176 -3.260911 -3.148003 -2.896196 -2.277299 -0.8730550 -1.107452 -1.359082 -1.605621 -1.846169 -2.084512 -2.317433 -2.524121 -2.712477 -2.877208 -3.020784 -3.141217 -3.234365 -3.292997 -3.323455 -3.312317 -3.257987 -3.133666 -2.877284 -2.277299 -1.110225 -1.315129 -1.543792 -1.773878 -1.999515 -2.217032 -2.420879 -2.612838 -2.782586 -2.932261 -3.065767 -3.178060 -3.262328 -3.314634 -3.336501 -3.316556 -3.251404 -3.116717 -2.857346 -2.277299 -1.370948 -1.548868 -1.755144 -1.962988 -2.158649 -2.348427 -2.531834 -2.698941 -2.851615 -2.989829 -3.110831 -3.212081 -3.287634 -3.332106 -3.345003 -3.315856 -3.241052 -3.097002 -2.837194 -2.277299 -1.662434 -1.808174 -1.979051 -2.155031 -2.326725 -2.486971 -2.641564 -2.787987 -2.925264 -3.049676 -3.155952 -3.244771 -3.309818 -3.344597 -3.348005 -3.309800 -3.226536 -3.074069 -2.815919 -2.277299 -1.972765 -2.082998 -2.219411 -2.362462 -2.499622 -2.631029 -2.762005 -2.886346 -3.003272 -3.110231 -3.201098 -3.275303 -3.328099 -3.351078 -3.345153 -3.298302 -3.207474 -3.048034 -2.793382 -2.277299 -2.316827 -2.382169 -2.476871 -2.584734 -2.691609 -2.793042 -2.894391 -2.992842 -3.086432 -3.173056 -3.245935 -3.303689 -3.341748 -3.351907 -3.336116 -3.281036 -3.183457 -3.019249 -2.769540 -2.277299 -2.695523 -2.717365 -2.768614 -2.834916 -2.904514 -2.972421 -3.041523 -3.111535 -3.178347 -3.240263 -3.291473 -3.330111 -3.352062 -3.348325 -3.321344 -3.258379 -3.154569 -2.987388 -2.744316 -2.277299 -3.131229 -3.102033 -3.105579 -3.127092 -3.155656 -3.185008 -3.216369 -3.250721 -3.286018 -3.317425 -3.343747 -3.360370 -3.363717 -3.344072 -3.303392 -3.231880 -3.121358 -2.953703 -2.717786 -2.277299 -3.701589 -3.607439 -3.550956 -3.515192 -3.490498 -3.469894 -3.452562 -3.442141 -3.439485 -3.432319 -3.425541 -3.412149 -3.391368 -3.350053 -3.289882 -3.205684 -3.087094 -2.919948 -2.690840 -2.277299 -4.699436 -4.502563 -4.348966 -4.220026 -4.108422 -4.005823 -3.908845 -3.821774 -3.755221 -3.683585 -3.615043 -3.553096 -3.490291 -3.412143 -3.316659 -3.210254 -3.067769 -2.895442 -2.669153 -2.277299 -19.38085 -18.89751 -18.34903 -17.73945 -17.07299 -16.35368 -15.58524 -14.77105 -13.91415 -13.01723 -12.08276 -11.11289 -10.10957 -9.074553 -8.009408 -6.915556 -5.794293 -4.646791 -3.474128 -2.277299 -0.3722785 -0.7004009 -0.9942582 -1.316750 -1.619640 -1.883120 -2.003356 -2.247503 -2.463498 -2.668643 -2.848406 -2.869776 -3.052826 -3.203754 -3.339700 -3.415336 -3.422332 -3.432949 -3.259180 -2.457263 -5.0742585E-02 -0.3972445 -0.7563028 -1.115855 -1.461823 -1.752572 -1.932491 -2.197441 -2.438199 -2.669731 -2.865480 -2.891344 -3.082490 -3.237053 -3.375886 -3.437065 -3.433042 -3.434334 -3.248327 -2.457263 0.1226703 -0.2556897 -0.6378321 -1.009747 -1.365778 -1.663509 -1.916651 -2.189464 -2.439631 -2.684263 -2.871430 -2.953572 -3.134748 -3.280089 -3.411501 -3.449523 -3.449337 -3.435687 -3.236277 -2.457263 0.1703980 -0.2086804 -0.5955356 -0.9702852 -1.319001 -1.631791 -1.919021 -2.197916 -2.460124 -2.706474 -2.891194 -3.027923 -3.191480 -3.327330 -3.445824 -3.464242 -3.469505 -3.436326 -3.222947 -2.457263 0.1452396 -0.2308513 -0.6133310 -0.9787396 -1.317453 -1.640464 -1.941635 -2.228162 -2.497487 -2.737041 -2.937829 -3.097363 -3.248507 -3.374139 -3.477322 -3.487693 -3.488637 -3.435729 -3.208245 -2.457263 6.2646277E-02 -0.3041967 -0.6759325 -1.022923 -1.356571 -1.680068 -1.986328 -2.281645 -2.552129 -2.784243 -2.997095 -3.166645 -3.305091 -3.419489 -3.504999 -3.515283 -3.506951 -3.433418 -3.192051 -2.457263 -6.4937107E-02 -0.4160297 -0.7669436 -1.104104 -1.430037 -1.747860 -2.058378 -2.352644 -2.608849 -2.848582 -3.064119 -3.228832 -3.361311 -3.461865 -3.530321 -3.542482 -3.521774 -3.429237 -3.174454 -2.457263 -0.2289265 -0.5574740 -0.8930452 -1.217010 -1.532951 -1.846863 -2.151614 -2.427731 -2.683847 -2.923711 -3.128454 -3.287755 -3.412210 -3.501205 -3.558242 -3.568635 -3.533688 -3.422856 -3.156191 -2.457263 -0.4266027 -0.7330037 -1.050164 -1.360596 -1.665097 -1.969612 -2.249740 -2.520028 -2.773966 -3.000554 -3.189164 -3.340157 -3.457241 -3.537319 -3.586274 -3.590943 -3.542157 -3.413758 -3.137162 -2.457263 -0.6594236 -0.9390368 -1.236944 -1.531528 -1.817773 -2.093833 -2.366254 -2.629233 -2.868481 -3.071275 -3.247486 -3.387480 -3.497439 -3.571469 -3.611711 -3.607970 -3.546144 -3.401890 -3.117199 -2.457263 -0.9228854 -1.172577 -1.450480 -1.717749 -1.979557 -2.241308 -2.501215 -2.739937 -2.954804 -3.142275 -3.300183 -3.432307 -3.534028 -3.602013 -3.633244 -3.619286 -3.545331 -3.386930 -3.096115 -2.457263 -1.215545 -1.431414 -1.677364 -1.923293 -2.166578 -2.406866 -2.632528 -2.846442 -3.039741 -3.206739 -3.352250 -3.475250 -3.568040 -3.627704 -3.649248 -3.624255 -3.539651 -3.368688 -3.073579 -2.457263 -1.535525 -1.718417 -1.934329 -2.153845 -2.361663 -2.566529 -2.767343 -2.951061 -3.120611 -3.272584 -3.404979 -3.516262 -3.598973 -3.646810 -3.658428 -3.622279 -3.528346 -3.346266 -3.050196 -2.457263 -1.894489 -2.033702 -2.206874 -2.388896 -2.564865 -2.734605 -2.900156 -3.058958 -3.207833 -3.341573 -3.456585 -3.553873 -3.624654 -3.659406 -3.659728 -3.613303 -3.510649 -3.319738 -3.025190 -2.457263 -2.278979 -2.373819 -2.503836 -2.641893 -2.777042 -2.912724 -3.047745 -3.178565 -3.301519 -3.412603 -3.507047 -3.587358 -3.644051 -3.664549 -3.652351 -3.596420 -3.485979 -3.289260 -2.998317 -2.457263 -2.706915 -2.749351 -2.830398 -2.923305 -3.017366 -3.112572 -3.210712 -3.308274 -3.403385 -3.487229 -3.557710 -3.617065 -3.656625 -3.662166 -3.636272 -3.571757 -3.454261 -3.253968 -2.969345 -2.457263 -3.198693 -3.181061 -3.205749 -3.246093 -3.292483 -3.343974 -3.401412 -3.459225 -3.519795 -3.570118 -3.611284 -3.646003 -3.665546 -3.654197 -3.613303 -3.539914 -3.416284 -3.216040 -2.938097 -2.457263 -3.825245 -3.734787 -3.693577 -3.668557 -3.652776 -3.647155 -3.651728 -3.659753 -3.674518 -3.684640 -3.687369 -3.690937 -3.682713 -3.649611 -3.589897 -3.503309 -3.373639 -3.176319 -2.904578 -2.457263 -4.906732 -4.691534 -4.543516 -4.419067 -4.304516 -4.204184 -4.120739 -4.047063 -3.986923 -3.929074 -3.865676 -3.813643 -3.757516 -3.688428 -3.595278 -3.487809 -3.339914 -3.143080 -2.871951 -2.457263 -22.92415 -22.36635 -21.72444 -21.00384 -20.21147 -19.35290 -18.43334 -17.45744 -16.42928 -15.35247 -14.23018 -13.06520 -11.86002 -10.61683 -9.337589 -8.024076 -6.677896 -5.300500 -3.893214 -2.457263 -0.2389962 -0.6428039 -0.9628357 -1.321799 -1.651813 -1.948691 -2.086845 -2.348899 -2.582720 -2.799769 -2.996314 -3.020389 -3.205682 -3.367523 -3.519372 -3.616423 -3.618681 -3.649487 -3.486626 -2.622362 0.1620359 -0.2628340 -0.6607474 -1.059289 -1.440460 -1.782598 -1.994312 -2.292793 -2.547288 -2.797212 -3.015268 -3.039615 -3.240827 -3.407758 -3.564241 -3.647853 -3.634834 -3.655206 -3.476892 -2.622362 0.3776224 -7.1176656E-02 -0.5026507 -0.9167219 -1.314661 -1.671811 -1.981855 -2.277923 -2.546638 -2.808121 -3.026112 -3.115621 -3.302691 -3.462218 -3.610125 -3.669369 -3.659127 -3.661389 -3.465787 -2.622362 0.4493881 4.7390051E-03 -0.4370993 -0.8571477 -1.260330 -1.642350 -1.975781 -2.277497 -2.563338 -2.829055 -3.047808 -3.197922 -3.371820 -3.521484 -3.655036 -3.689184 -3.688187 -3.667033 -3.453187 -2.622362 0.4316944 -4.9966625E-03 -0.4415583 -0.8610641 -1.267390 -1.646521 -1.981496 -2.301794 -2.592541 -2.865713 -3.101227 -3.275040 -3.444992 -3.581599 -3.698392 -3.721374 -3.717630 -3.671722 -3.438978 -2.622362 0.3450014 -7.5385094E-02 -0.5029539 -0.9151981 -1.309154 -1.670332 -2.018049 -2.340419 -2.644201 -2.922314 -3.160797 -3.353648 -3.516835 -3.641633 -3.738907 -3.759050 -3.744738 -3.674694 -3.423024 -2.622362 0.2094162 -0.1958639 -0.6081368 -1.002472 -1.372675 -1.733442 -2.076735 -2.405678 -2.712716 -2.987255 -3.230044 -3.430819 -3.584831 -3.697360 -3.776297 -3.797187 -3.769859 -3.675613 -3.405312 -2.622362 2.9653443E-02 -0.3558773 -0.7436368 -1.113423 -1.473395 -1.823964 -2.167281 -2.494585 -2.794054 -3.062742 -3.307374 -3.500620 -3.648450 -3.748881 -3.815081 -3.833365 -3.791875 -3.673994 -3.386770 -2.622362 -0.1888817 -0.5441800 -0.9068963 -1.260364 -1.604558 -1.948097 -2.283773 -2.598074 -2.884680 -3.152249 -3.387585 -3.565393 -3.704376 -3.795984 -3.853239 -3.865035 -3.808975 -3.669231 -3.367422 -2.622362 -0.4393733 -0.7641138 -1.104882 -1.439498 -1.769195 -2.098744 -2.412180 -2.709041 -2.992932 -3.249641 -3.458649 -3.627511 -3.753904 -3.839980 -3.888381 -3.890834 -3.820091 -3.661149 -3.347010 -2.622362 -0.7269163 -1.018335 -1.334771 -1.648384 -1.958454 -2.256745 -2.552568 -2.840164 -3.108882 -3.332964 -3.528770 -3.682316 -3.799556 -3.879281 -3.919207 -3.909944 -3.825474 -3.649257 -3.325289 -2.622362 -1.046928 -1.304455 -1.593006 -1.875301 -2.153879 -2.434790 -2.715317 -2.975316 -3.210851 -3.414790 -3.589012 -3.733320 -3.842465 -3.913223 -3.943681 -3.921981 -3.824934 -3.633098 -3.301976 -2.622362 -1.400161 -1.617575 -1.868276 -2.123099 -2.377764 -2.630536 -2.871848 -3.104223 -3.310035 -3.488312 -3.647795 -3.781857 -3.881112 -3.940613 -3.960207 -3.926242 -3.817711 -3.611937 -3.276661 -2.622362 -1.788655 -1.964270 -2.179435 -2.394382 -2.607207 -2.823591 -3.030016 -3.225689 -3.404595 -3.564626 -3.706867 -3.825910 -3.913647 -3.960812 -3.967563 -3.922008 -3.802855 -3.585607 -3.250103 -2.622362 -2.220201 -2.341858 -2.506857 -2.679592 -2.848769 -3.020048 -3.189978 -3.354975 -3.507941 -3.644098 -3.764923 -3.865362 -3.938546 -3.971616 -3.964794 -3.907929 -3.779435 -3.554335 -3.221169 -2.622362 -2.697858 -2.761498 -2.868712 -2.988007 -3.110007 -3.239117 -3.370213 -3.497828 -3.619062 -3.726975 -3.821715 -3.900460 -3.954810 -3.971269 -3.951270 -3.883312 -3.747323 -3.517409 -3.189470 -2.622362 -3.242584 -3.239441 -3.283842 -3.343823 -3.411209 -3.489608 -3.574899 -3.660360 -3.743074 -3.817221 -3.878747 -3.931244 -3.962141 -3.960861 -3.927332 -3.848036 -3.706559 -3.474292 -3.154537 -2.622362 -3.923437 -3.834953 -3.806767 -3.797911 -3.798509 -3.810809 -3.836517 -3.868076 -3.900918 -3.930694 -3.952519 -3.970838 -3.970894 -3.947006 -3.897008 -3.804148 -3.657564 -3.426972 -3.115923 -2.622362 -5.078718 -4.855452 -4.707868 -4.583922 -4.472662 -4.381773 -4.312773 -4.257619 -4.209817 -4.164690 -4.121016 -4.079693 -4.023837 -3.962689 -3.882838 -3.768909 -3.613366 -3.380027 -3.074750 -2.622362 -26.60814 -25.97457 -25.23518 -24.39881 -23.47413 -22.46904 -21.39047 -20.24453 -19.03647 -17.77084 -16.45159 -15.08216 -13.66559 -12.20455 -10.70142 -9.158332 -7.577211 -5.959808 -4.307705 -2.622362 -0.1030829 -0.5807702 -0.9406481 -1.339039 -1.702019 -2.019567 -2.207374 -2.438460 -2.691684 -2.927211 -3.134710 -3.190789 -3.346888 -3.519782 -3.684382 -3.798605 -3.797823 -3.848914 -3.699524 -2.774865 0.3795745 -0.1221889 -0.5771318 -1.026868 -1.435705 -1.811032 -2.060390 -2.372261 -2.656147 -2.920330 -3.157150 -3.195684 -3.389795 -3.566651 -3.738546 -3.840912 -3.820311 -3.859701 -3.691489 -2.774865 0.6335014 0.1109436 -0.3809649 -0.8410046 -1.272361 -1.669414 -2.025709 -2.364702 -2.658552 -2.932050 -3.170662 -3.276354 -3.464621 -3.631812 -3.794615 -3.871424 -3.854963 -3.871805 -3.681891 -2.774865 0.7266325 0.2093605 -0.2887301 -0.7537569 -1.198503 -1.623013 -2.018774 -2.367172 -2.667605 -2.956375 -3.191015 -3.368188 -3.546429 -3.704765 -3.850949 -3.898244 -3.893691 -3.883775 -3.670620 -2.774865 0.7139025 0.2149075 -0.2771294 -0.7454613 -1.194347 -1.629260 -2.028774 -2.375725 -2.696259 -2.988916 -3.248760 -3.453412 -3.630416 -3.780458 -3.907974 -3.941690 -3.933276 -3.895213 -3.657491 -2.774865 0.6267838 0.1469039 -0.3325323 -0.7925559 -1.239938 -1.666389 -2.052029 -2.407772 -2.738600 -3.043614 -3.317811 -3.533672 -3.713577 -3.852761 -3.962075 -3.990633 -3.971578 -3.905021 -3.642354 -2.774865 0.4813570 2.3914112E-02 -0.4389995 -0.8861594 -1.319708 -1.723945 -2.104820 -2.465177 -2.801116 -3.116175 -3.388335 -3.613788 -3.796011 -3.921964 -4.011778 -4.039984 -4.007624 -3.912503 -3.625103 -2.774865 0.2893113 -0.1451182 -0.5868673 -1.013962 -1.419392 -1.811345 -2.188476 -2.546957 -2.888819 -3.200249 -3.467225 -3.696234 -3.868574 -3.986588 -4.061543 -4.086014 -4.039403 -3.917017 -3.606876 -2.774865 5.4180514E-02 -0.3528179 -0.7664475 -1.162702 -1.551450 -1.930553 -2.300141 -2.658926 -2.993645 -3.289541 -3.558530 -3.778073 -3.937172 -4.045314 -4.110718 -4.127056 -4.065543 -3.918040 -3.587790 -2.774865 -0.2197686 -0.5891216 -0.9716403 -1.347474 -1.716165 -2.083773 -2.444325 -2.788444 -3.100679 -3.396245 -3.655818 -3.852483 -3.999407 -4.099160 -4.156646 -4.162908 -4.085236 -3.915174 -3.567540 -2.774865 -0.5267028 -0.8592632 -1.215012 -1.566122 -1.915516 -2.267733 -2.602711 -2.923187 -3.230632 -3.511363 -3.738179 -3.922840 -4.054936 -4.147948 -4.197459 -4.191591 -4.098706 -3.907673 -3.545802 -2.774865 -0.8722929 -1.168438 -1.491874 -1.816796 -2.139771 -2.457779 -2.772460 -3.082178 -3.366683 -3.607977 -3.816351 -3.982813 -4.105792 -4.191565 -4.230848 -4.212608 -4.105130 -3.895083 -3.522241 -2.774865 -1.254126 -1.510306 -1.798146 -2.084992 -2.373954 -2.671477 -2.967485 -3.238042 -3.486895 -3.700613 -3.883642 -4.037899 -4.151944 -4.228669 -4.255949 -4.224647 -4.103884 -3.876834 -3.496508 -2.774865 -1.674139 -1.880897 -2.128615 -2.381924 -2.639494 -2.895121 -3.146760 -3.385296 -3.597506 -3.783948 -3.950244 -4.088953 -4.191705 -4.257196 -4.271563 -4.226532 -4.093485 -3.852346 -3.468249 -2.774865 -2.145504 -2.299057 -2.493489 -2.697890 -2.906713 -3.118886 -3.326015 -3.524342 -3.708084 -3.872487 -4.016702 -4.135434 -4.223357 -4.274637 -4.275727 -4.216632 -4.072639 -3.821844 -3.437786 -2.774865 -2.664742 -2.755262 -2.892943 -3.038408 -3.189970 -3.353243 -3.518935 -3.679301 -3.828405 -3.963890 -4.081969 -4.176617 -4.244512 -4.278849 -4.266333 -4.193995 -4.040543 -3.784436 -3.403981 -2.774865 -3.263127 -3.275874 -3.344170 -3.425688 -3.517438 -3.624213 -3.738888 -3.852934 -3.960337 -4.058802 -4.146482 -4.210067 -4.253360 -4.269411 -4.242033 -4.157642 -3.997047 -3.738528 -3.366139 -2.774865 -4.002899 -3.921314 -3.902155 -3.905725 -3.926749 -3.964668 -4.014053 -4.068779 -4.121907 -4.171455 -4.219248 -4.244691 -4.257549 -4.250593 -4.204789 -4.108426 -3.940989 -3.686284 -3.323617 -2.774865 -5.224350 -4.998847 -4.845882 -4.721213 -4.620209 -4.546162 -4.495810 -4.457739 -4.423864 -4.394399 -4.374560 -4.337065 -4.296932 -4.247947 -4.170993 -4.059512 -3.886631 -3.629611 -3.276600 -2.774865 -30.42189 -29.71124 -28.87115 -27.91376 -26.85065 -25.69224 -24.44742 -23.12380 -21.72793 -20.26534 -18.74079 -17.15842 -15.52183 -13.83416 -12.09826 -10.31662 -8.491511 -6.624970 -4.718852 -2.774865 3.8918711E-02 -0.5067371 -0.9171584 -1.358522 -1.751057 -2.101830 -2.328679 -2.528121 -2.791962 -3.043101 -3.266521 -3.352464 -3.479605 -3.662097 -3.837249 -3.966031 -3.962750 -4.031808 -3.899467 -2.916559 0.6063088 1.6538315E-02 -0.4987342 -0.9955571 -1.450761 -1.859744 -2.131843 -2.445386 -2.749446 -3.039969 -3.290735 -3.349734 -3.529732 -3.716997 -3.900432 -4.018794 -3.992949 -4.047966 -3.893720 -2.916559 0.8895778 0.2961001 -0.2641120 -0.7822633 -1.259125 -1.679554 -2.063601 -2.427444 -2.761605 -3.057918 -3.310308 -3.433079 -3.619593 -3.794369 -3.968677 -4.059592 -4.037914 -4.066467 -3.886281 -2.916559 1.003501 0.4135989 -0.1485255 -0.6712776 -1.149319 -1.606234 -2.037464 -2.436226 -2.781288 -3.080382 -3.337137 -3.529923 -3.718341 -3.880914 -4.038528 -4.094656 -4.088451 -4.085583 -3.877002 -2.916559 0.9959595 0.4290853 -0.1230124 -0.6384047 -1.127677 -1.598997 -2.048384 -2.456524 -2.801344 -3.117913 -3.391712 -3.620029 -3.811796 -3.969197 -4.109161 -4.148495 -4.139963 -4.104364 -3.865629 -2.916559 0.9071190 0.3635400 -0.1681866 -0.6767444 -1.165670 -1.638594 -2.087142 -2.481904 -2.838647 -3.167335 -3.461303 -3.709625 -3.901848 -4.056912 -4.176339 -4.208097 -4.190322 -4.121607 -3.851972 -2.916559 0.7532557 0.2388730 -0.2746851 -0.7674391 -1.247706 -1.712549 -2.140200 -2.529218 -2.898502 -3.235192 -3.540726 -3.789568 -3.991203 -4.138680 -4.238964 -4.268019 -4.237298 -4.136513 -3.835867 -2.916559 0.5470563 6.1470564E-02 -0.4262682 -0.9002087 -1.364975 -1.804739 -2.214198 -2.609748 -2.976257 -3.323831 -3.626355 -3.876059 -4.079642 -4.215750 -4.300935 -4.325640 -4.279117 -4.148262 -3.818601 -2.916559 0.2957260 -0.1565095 -0.6171725 -1.068761 -1.502787 -1.920926 -2.324608 -2.711895 -3.084257 -3.427276 -3.718907 -3.970315 -4.159636 -4.287963 -4.361672 -4.378733 -4.315094 -4.156267 -3.800476 -2.916559 3.1207928E-03 -0.4113433 -0.8412315 -1.258221 -1.669190 -2.072197 -2.464954 -2.850138 -3.211049 -3.532822 -3.825567 -4.064020 -4.236983 -4.352855 -4.418215 -4.425742 -4.344285 -4.159644 -3.781066 -2.916559 -0.3276156 -0.7004422 -1.094608 -1.483983 -1.871003 -2.259596 -2.640777 -3.006295 -3.341794 -3.659663 -3.935920 -4.147168 -4.306059 -4.411848 -4.468744 -4.464208 -4.366418 -4.157498 -3.759939 -2.916559 -0.6936785 -1.028013 -1.387987 -1.746440 -2.110152 -2.480678 -2.828086 -3.170592 -3.497561 -3.791260 -4.028953 -4.222329 -4.366185 -4.465350 -4.511563 -4.493964 -4.381005 -4.149366 -3.736696 -2.916559 -1.103292 -1.392689 -1.716810 -2.044240 -2.369613 -2.701930 -3.033534 -3.360433 -3.649408 -3.904375 -4.114912 -4.286634 -4.421416 -4.511196 -4.545755 -4.514014 -4.386554 -4.134776 -3.710944 -2.916559 -1.553437 -1.793579 -2.072695 -2.356693 -2.649843 -2.956235 -3.250844 -3.530149 -3.785103 -4.003965 -4.189968 -4.346955 -4.470182 -4.547336 -4.569331 -4.523105 -4.381135 -4.112816 -3.682051 -2.916559 -2.054207 -2.237245 -2.468649 -2.706867 -2.950163 -3.205644 -3.456716 -3.690877 -3.904223 -4.098403 -4.264591 -4.402547 -4.510140 -4.572200 -4.579785 -4.519114 -4.363468 -4.083712 -3.650052 -2.916559 -2.619538 -2.733081 -2.900011 -3.077209 -3.263572 -3.460980 -3.661585 -3.854750 -4.033369 -4.195903 -4.337622 -4.451011 -4.538674 -4.583603 -4.574029 -4.499937 -4.332698 -4.046388 -3.614294 -2.916559 -3.267930 -3.297720 -3.386018 -3.491982 -3.614848 -3.751837 -3.896284 -4.040214 -4.173772 -4.296469 -4.407471 -4.489828 -4.552642 -4.578595 -4.550458 -4.463864 -4.288411 -3.998989 -3.573619 -2.916559 -4.063533 -3.992368 -3.984724 -4.003586 -4.046416 -4.109476 -4.186157 -4.266570 -4.340376 -4.410890 -4.479285 -4.523596 -4.555462 -4.558547 -4.509719 -4.410597 -4.228591 -3.942220 -3.526951 -2.916559 -5.353274 -5.120996 -4.965978 -4.845626 -4.758618 -4.704231 -4.674164 -4.654787 -4.637206 -4.623795 -4.619191 -4.603631 -4.582709 -4.544704 -4.463979 -4.349416 -4.163693 -3.878571 -3.473379 -2.916559 -34.35604 -33.56700 -32.62283 -31.53955 -30.33235 -29.01426 -27.59641 -26.08807 -24.49710 -22.83006 -21.09257 -19.28945 -17.42491 -15.50261 -13.52582 -11.49745 -9.420085 -7.296094 -5.127599 -2.916559 0.1760659 -0.4257608 -0.8765520 -1.370118 -1.802674 -2.177115 -2.448761 -2.623840 -2.891749 -3.151879 -3.388427 -3.505037 -3.605199 -3.794755 -3.978338 -4.121859 -4.114615 -4.200485 -4.087064 -3.048875 0.8347316 0.1773020 -0.4078297 -0.9697707 -1.463629 -1.912730 -2.224723 -2.526791 -2.839163 -3.147017 -3.419615 -3.498965 -3.663787 -3.857917 -4.050477 -4.186057 -4.152454 -4.222238 -4.084198 -3.048875 1.155905 0.4850392 -0.1504303 -0.7245861 -1.248523 -1.722135 -2.116479 -2.494297 -2.847939 -3.177357 -3.448555 -3.587653 -3.770285 -3.950628 -4.130718 -4.237668 -4.208193 -4.247655 -4.079558 -3.048875 1.279765 0.6157820 -1.0269985E-02 -0.5894804 -1.126049 -1.608621 -2.060545 -2.488981 -2.877784 -3.214015 -3.479902 -3.687693 -3.882219 -4.051036 -4.214713 -4.281976 -4.271261 -4.274650 -4.072859 -3.048875 1.276880 0.6405197 2.8328542E-02 -0.5451366 -1.074536 -1.575683 -2.056540 -2.510986 -2.913012 -3.247051 -3.540749 -3.780082 -3.988991 -4.150896 -4.299662 -4.345229 -4.335872 -4.301476 -4.063815 -3.048875 1.184961 0.5768527 -1.1868354E-02 -0.5693045 -1.097482 -1.606257 -2.095937 -2.555310 -2.946113 -3.295382 -3.606039 -3.871778 -4.086950 -4.249356 -4.379959 -4.416650 -4.397650 -4.326890 -4.052244 -3.048875 1.023460 0.4488266 -0.1154518 -0.6541567 -1.176337 -1.680629 -2.168503 -2.604488 -2.995723 -3.361386 -3.685608 -3.963482 -4.181801 -4.346134 -4.457353 -4.488681 -4.455140 -4.349847 -4.037866 -3.048875 0.8033829 0.2642134 -0.2709265 -0.7886950 -1.296039 -1.790053 -2.251092 -2.671059 -3.075821 -3.443031 -3.778258 -4.053971 -4.277857 -4.436468 -4.533214 -4.557700 -4.506704 -4.369549 -4.021956 -3.048875 0.5350936 3.4312703E-02 -0.4698584 -0.9629882 -1.450925 -1.916441 -2.352988 -2.776390 -3.172258 -3.549200 -3.880018 -4.152655 -4.375525 -4.520464 -4.604798 -4.621099 -4.552310 -4.384934 -4.005235 -3.048875 0.2253440 -0.2333027 -0.7056454 -1.172940 -1.625680 -2.065701 -2.492690 -2.906392 -3.304646 -3.669685 -3.987499 -4.260420 -4.465105 -4.598512 -4.670238 -4.676775 -4.591770 -4.395247 -3.986996 -3.048875 -0.1234452 -0.5414060 -0.9775460 -1.404941 -1.832201 -2.251706 -2.667884 -3.075818 -3.455084 -3.799201 -4.112186 -4.364281 -4.549112 -4.667507 -4.729897 -4.724241 -4.623123 -4.399508 -3.966761 -3.048875 -0.5129101 -0.8845205 -1.282827 -1.676349 -2.075998 -2.478713 -2.881158 -3.257957 -3.615905 -3.951721 -4.233706 -4.456351 -4.621914 -4.729473 -4.781931 -4.763484 -4.645661 -4.397390 -3.944194 -3.048875 -0.9453977 -1.270738 -1.629618 -1.988606 -2.359358 -2.731016 -3.096244 -3.457339 -3.800297 -4.094213 -4.339701 -4.535933 -4.687630 -4.784055 -4.824982 -4.792499 -4.658187 -4.388013 -3.918828 -3.048875 -1.426178 -1.698768 -2.013335 -2.330099 -2.656748 -2.996808 -3.342944 -3.667053 -3.958712 -4.217810 -4.426869 -4.605125 -4.746593 -4.829749 -4.856959 -4.809628 -4.658663 -4.370263 -3.890108 -3.048875 -1.957686 -2.169767 -2.429223 -2.702503 -2.990440 -3.282389 -3.576970 -3.853495 -4.099591 -4.320714 -4.509682 -4.670697 -4.795919 -4.864473 -4.875187 -4.812444 -4.645714 -4.343987 -3.857233 -3.048875 -2.567543 -2.703713 -2.894295 -3.104288 -3.330168 -3.566987 -3.801754 -4.026536 -4.236089 -4.426399 -4.591319 -4.729257 -4.833477 -4.883950 -4.876286 -4.798680 -4.617830 -4.307704 -3.820192 -3.048875 -3.258411 -3.309586 -3.417350 -3.547691 -3.703501 -3.874685 -4.050531 -4.223032 -4.385581 -4.534699 -4.667146 -4.776938 -4.854768 -4.883291 -4.857341 -4.765918 -4.573893 -4.259645 -3.777381 -3.048875 -4.112033 -4.047194 -4.055032 -4.094090 -4.160655 -4.249405 -4.351806 -4.457562 -4.558605 -4.653603 -4.740236 -4.813050 -4.859161 -4.861617 -4.816578 -4.712027 -4.511322 -4.197979 -3.727406 -3.048875 -5.466692 -5.228280 -5.072184 -4.962481 -4.890575 -4.855827 -4.843617 -4.841342 -4.845523 -4.856151 -4.869308 -4.881117 -4.876158 -4.838186 -4.762860 -4.641483 -4.435752 -4.125668 -3.668684 -3.048875 -38.40252 -37.53382 -36.48221 -35.26851 -33.91172 -32.42805 -30.83084 -29.13124 -27.33840 -25.45997 -23.50245 -21.47139 -19.37159 -17.20727 -14.98213 -12.69948 -10.36229 -7.973217 -5.534679 -3.048875 0.3036154 -0.3520661 -0.8667702 -1.362117 -1.836790 -2.250843 -2.556457 -2.719819 -2.993592 -3.258224 -3.501713 -3.648461 -3.723828 -3.921181 -4.110608 -4.265366 -4.256099 -4.356306 -4.262616 -3.172978 1.056896 0.3374045 -0.2994218 -0.9120200 -1.479073 -1.960465 -2.312158 -2.626619 -2.934128 -3.248965 -3.536695 -3.646536 -3.794714 -3.993552 -4.191899 -4.341645 -4.301023 -4.384026 -4.262995 -3.172978 1.417880 0.6834376 -1.2794456E-02 -0.6694114 -1.240536 -1.753550 -2.197304 -2.576604 -2.936872 -3.281199 -3.580327 -3.738514 -3.920058 -4.101343 -4.283781 -4.404554 -4.369398 -4.416874 -4.261413 -3.172978 1.557819 0.8252145 0.1261646 -0.5121072 -1.097630 -1.634489 -2.105297 -2.546288 -2.959302 -3.332860 -3.624476 -3.845436 -4.043471 -4.218305 -4.379572 -4.459295 -4.445948 -4.452079 -4.257640 -3.172978 1.556945 0.8468465 0.1770381 -0.4497673 -1.037156 -1.572420 -2.072025 -2.554405 -3.000790 -3.381873 -3.683728 -3.942489 -4.158794 -4.330058 -4.477267 -4.533313 -4.522902 -4.487555 -4.251404 -3.172978 1.460521 0.7884400 0.1407904 -0.4687563 -1.041308 -1.580183 -2.101441 -2.599189 -3.052872 -3.425779 -3.754907 -4.033082 -4.267408 -4.439200 -4.574241 -4.618318 -4.596578 -4.521529 -4.242431 -3.172978 1.290258 0.6568521 3.8846586E-02 -0.5462999 -1.109070 -1.649288 -2.172502 -2.671386 -3.102201 -3.487209 -3.831722 -4.129724 -4.370650 -4.545011 -4.665015 -4.703111 -4.664689 -4.553123 -4.230454 -3.172978 1.057386 0.4643040 -0.1193686 -0.6809112 -1.228481 -1.759584 -2.277251 -2.744807 -3.169184 -3.569639 -3.924033 -4.233236 -4.470859 -4.647301 -4.752758 -4.782826 -4.727354 -4.581349 -4.216808 -3.172978 0.7729443 0.2229725 -0.3247335 -0.8607118 -1.387645 -1.903670 -2.390346 -2.838273 -3.270695 -3.668700 -4.033249 -4.334122 -4.575696 -4.742914 -4.835962 -4.855000 -4.783841 -4.604979 -4.202296 -3.172978 0.4457531 -5.6970894E-02 -0.5708485 -1.078725 -1.582385 -2.063599 -2.525414 -2.970994 -3.395759 -3.797656 -4.149226 -4.447567 -4.684683 -4.831653 -4.911788 -4.919734 -4.832706 -4.623202 -4.186287 -3.172978 7.9547554E-02 -0.3812854 -0.8583257 -1.331202 -1.794705 -2.251667 -2.698370 -3.136999 -3.559021 -3.939864 -4.278190 -4.571558 -4.779510 -4.911902 -4.981164 -4.976656 -4.872846 -4.634939 -4.168216 -3.172978 -0.3333700 -0.7443939 -1.178028 -1.609128 -2.043987 -2.478692 -2.915059 -3.342872 -3.732169 -4.096626 -4.423872 -4.682155 -4.869616 -4.983613 -5.043358 -5.025187 -4.903879 -4.639391 -4.147443 -3.172978 -0.7884630 -1.147671 -1.538738 -1.933404 -2.337425 -2.751547 -3.159901 -3.550075 -3.926688 -4.275004 -4.552515 -4.782619 -4.946042 -5.049112 -5.096998 -5.063267 -4.924498 -4.635551 -4.123431 -3.172978 -1.296876 -1.600091 -1.943422 -2.299787 -2.664028 -3.036878 -3.416082 -3.788828 -4.125048 -4.419073 -4.664363 -4.864331 -5.013330 -5.105592 -5.138667 -5.089646 -4.931839 -4.622060 -4.095435 -3.172978 -1.859162 -2.099305 -2.386536 -2.690032 -3.013868 -3.357543 -3.688760 -4.004487 -4.292096 -4.541049 -4.757326 -4.939908 -5.071546 -5.150057 -5.165522 -5.101613 -4.924081 -4.598494 -4.062601 -3.172978 -2.497370 -2.665325 -2.885694 -3.123719 -3.387686 -3.667929 -3.940239 -4.196792 -4.437352 -4.655303 -4.846633 -5.005019 -5.117574 -5.178048 -5.174448 -5.094459 -4.899906 -4.563257 -4.024830 -3.172978 -3.236063 -3.307144 -3.441132 -3.599123 -3.785849 -3.990966 -4.198676 -4.402400 -4.595626 -4.772822 -4.929928 -5.057983 -5.145021 -5.183356 -5.161436 -5.064383 -4.858142 -4.514522 -3.980592 -3.172978 -4.146787 -4.094463 -4.115335 -4.176806 -4.270364 -4.385831 -4.513625 -4.645608 -4.777819 -4.900377 -5.009669 -5.097618 -5.151430 -5.163463 -5.122417 -5.008689 -4.795253 -4.449707 -3.928121 -3.172978 -5.567057 -5.323686 -5.173871 -5.074519 -5.022212 -5.002968 -5.009119 -5.028297 -5.061894 -5.098567 -5.135275 -5.161864 -5.162974 -5.134028 -5.062803 -4.930155 -4.713262 -4.372418 -3.864790 -3.172978 -42.55429 -41.60466 -40.44265 -39.09381 -37.58234 -35.92743 -34.14500 -32.24800 -30.24697 -28.15070 -25.96657 -23.70087 -21.35904 -18.94584 -16.46568 -13.92180 -11.31752 -8.656326 -5.940656 -3.172978 0.4266064 -0.2878513 -0.8714900 -1.362753 -1.857485 -2.303844 -2.656891 -2.809422 -3.094498 -3.363301 -3.610169 -3.781844 -3.837252 -4.041096 -4.235236 -4.398786 -4.388875 -4.500127 -4.426559 -3.289828 1.270746 0.4892311 -0.1970725 -0.8389705 -1.448786 -2.007704 -2.394941 -2.721066 -3.039901 -3.351947 -3.645149 -3.788088 -3.922351 -4.123705 -4.327400 -4.486534 -4.442530 -4.533441 -4.430370 -3.289828 1.675130 0.8763716 0.1325220 -0.5696997 -1.227120 -1.787175 -2.264505 -2.683822 -3.036448 -3.385114 -3.696958 -3.889477 -4.067984 -4.246889 -4.432281 -4.559497 -4.523841 -4.573673 -4.432113 -3.289828 1.831386 1.035692 0.2856749 -0.4296581 -1.072169 -1.650745 -2.172675 -2.623572 -3.044196 -3.435513 -3.760411 -4.001262 -4.202783 -4.377611 -4.541869 -4.624961 -4.613838 -4.617093 -4.431555 -3.289828 1.835480 1.059879 0.3261474 -0.3591803 -0.9968538 -1.583452 -2.111531 -2.603668 -3.075592 -3.498393 -3.833008 -4.102116 -4.324228 -4.505188 -4.652606 -4.709316 -4.702888 -4.661225 -4.428437 -3.289828 1.734315 0.9950389 0.2917838 -0.3688032 -0.9941331 -1.571984 -2.113078 -2.638266 -3.133355 -3.558898 -3.899601 -4.197028 -4.439678 -4.625991 -4.761121 -4.807433 -4.787666 -4.704347 -4.422426 -3.289828 1.554388 0.8622318 0.1907223 -0.4443044 -1.049994 -1.622409 -2.177583 -2.710594 -3.205294 -3.615767 -3.982179 -4.291623 -4.550518 -4.737297 -4.865739 -4.903548 -4.867511 -4.745585 -4.413080 -3.289828 1.308549 0.6609761 2.9297175E-02 -0.5785556 -1.163745 -1.730924 -2.283058 -2.809685 -3.272843 -3.693264 -4.070134 -4.399187 -4.657570 -4.846314 -4.963705 -4.992424 -4.941000 -4.783354 -4.401807 -3.289828 1.008044 0.4091907 -0.1829383 -0.7628604 -1.325956 -1.879496 -2.418655 -2.909846 -3.367377 -3.793014 -4.180864 -4.515521 -4.765616 -4.955829 -5.057761 -5.075784 -5.007508 -4.816012 -4.389787 -3.289828 0.6631747 0.1160423 -0.4395504 -0.9882082 -1.527956 -2.060442 -2.562194 -3.037796 -3.493670 -3.919667 -4.309371 -4.629481 -4.883469 -5.056297 -5.144548 -5.152520 -5.065920 -4.842772 -4.376129 -3.289828 0.2788773 -0.2239604 -0.7372052 -1.250409 -1.763814 -2.254063 -2.736637 -3.201221 -3.655528 -4.076419 -4.443785 -4.761123 -5.000735 -5.150354 -5.224977 -5.220039 -5.115844 -4.862591 -4.360042 -3.289828 -0.1537264 -0.6024879 -1.075849 -1.546006 -2.016987 -2.485488 -2.949009 -3.409787 -3.852196 -4.240273 -4.600989 -4.899003 -5.102890 -5.233448 -5.297397 -5.279341 -5.156100 -4.874226 -4.340884 -3.289828 -0.6332954 -1.024536 -1.449405 -1.879452 -2.316895 -2.763453 -3.212480 -3.643618 -4.049670 -4.431461 -4.763693 -5.013146 -5.192824 -5.308445 -5.359111 -5.327567 -5.185107 -4.876066 -4.318012 -3.289828 -1.163185 -1.498339 -1.872608 -2.259469 -2.665702 -3.078062 -3.486674 -3.892486 -4.281217 -4.612729 -4.895049 -5.110653 -5.269312 -5.374526 -5.408676 -5.362545 -5.199858 -4.866795 -4.290673 -3.289828 -1.754687 -2.024477 -2.342224 -2.677052 -3.034317 -3.411119 -3.794935 -4.148059 -4.477249 -4.761072 -5.000359 -5.194264 -5.337632 -5.428718 -5.444246 -5.380849 -5.198813 -4.845740 -4.258035 -3.289828 -2.423665 -2.616328 -2.865785 -3.142833 -3.440257 -3.758815 -4.074178 -4.368636 -4.641504 -4.887245 -5.100541 -5.272259 -5.395041 -5.466103 -5.460890 -5.378612 -5.179556 -4.811642 -4.219465 -3.289828 -3.204623 -3.295818 -3.455430 -3.646981 -3.866832 -4.104783 -4.346326 -4.583067 -4.810993 -5.016742 -5.196740 -5.339390 -5.435225 -5.479926 -5.452793 -5.352240 -5.139516 -4.762933 -4.174360 -3.289828 -4.170685 -4.130003 -4.171393 -4.253491 -4.374596 -4.519589 -4.675233 -4.836202 -5.001281 -5.153983 -5.285834 -5.388525 -5.450406 -5.465380 -5.414684 -5.297738 -5.075030 -4.696279 -4.120281 -3.289828 -5.660207 -5.409867 -5.264408 -5.177073 -5.145683 -5.148600 -5.171843 -5.219321 -5.284425 -5.351485 -5.408926 -5.448491 -5.460409 -5.434587 -5.350273 -5.215052 -4.987138 -4.615640 -4.053886 -3.289828 -46.80515 -45.77333 -44.49729 -43.00955 -41.33845 -39.50706 -37.53387 -35.43371 -33.21860 -30.89843 -28.48152 -25.97494 -23.38476 -20.71629 -17.97421 -15.16262 -12.28523 -9.345352 -6.345975 -3.289828 0.5474152 -0.2301324 -0.8813278 -1.392405 -1.887967 -2.347165 -2.736917 -2.894456 -3.188426 -3.466581 -3.715784 -3.906797 -3.944720 -4.153981 -4.352646 -4.525625 -4.512721 -4.635072 -4.582084 -3.400226 1.483452 0.6364591 -0.1228976 -0.7812982 -1.411019 -2.005166 -2.475793 -2.812084 -3.143836 -3.458633 -3.752225 -3.922208 -4.047851 -4.247942 -4.455307 -4.624386 -4.575087 -4.674836 -4.589925 -3.400226 1.929191 1.061169 0.2681939 -0.4687050 -1.167658 -1.812621 -2.331043 -2.774903 -3.154284 -3.492703 -3.808059 -4.031255 -4.211959 -4.387403 -4.575181 -4.709445 -4.670001 -4.723296 -4.595716 -3.400226 2.102793 1.243661 0.4425296 -0.3187186 -1.035759 -1.669355 -2.226311 -2.723983 -3.141800 -3.538143 -3.882664 -4.154836 -4.358749 -4.533901 -4.700477 -4.786764 -4.772775 -4.775450 -4.599171 -3.400226 2.110550 1.271490 0.4878458 -0.2650206 -0.9580393 -1.589237 -2.166806 -2.674686 -3.153211 -3.598415 -3.971880 -4.257831 -4.489996 -4.673433 -4.823186 -4.884228 -4.873919 -4.828955 -4.599789 -3.400226 2.006330 1.206277 0.4410920 -0.2733244 -0.9459351 -1.573331 -2.145516 -2.682479 -3.203663 -3.673965 -4.052123 -4.354099 -4.605346 -4.804109 -4.941420 -4.992965 -4.971130 -4.881985 -4.597269 -3.400226 1.815986 1.063364 0.3400414 -0.3468137 -0.9984024 -1.609630 -2.187050 -2.748322 -3.283379 -3.747517 -4.125402 -4.453156 -4.720669 -4.922433 -5.056181 -5.100236 -5.061967 -4.932518 -4.591121 -3.400226 1.556085 0.8551164 0.1748176 -0.4824738 -1.106552 -1.706833 -2.290211 -2.853275 -3.375880 -3.817720 -4.220853 -4.558552 -4.836854 -5.037135 -5.168911 -5.201926 -5.145164 -4.978906 -4.582669 -3.400226 1.240123 0.5914788 -4.4760503E-02 -0.6685594 -1.270128 -1.857341 -2.431937 -2.979006 -3.467744 -3.919707 -4.325023 -4.678767 -4.951221 -5.155943 -5.273673 -5.295959 -5.219922 -5.019635 -4.573340 -3.400226 0.8790931 0.2841176 -0.3109095 -0.9007733 -1.476842 -2.045935 -2.599420 -3.107182 -3.595067 -4.042274 -4.459202 -4.806421 -5.075058 -5.273004 -5.373165 -5.380532 -5.285575 -5.054060 -4.562153 -3.400226 0.4769800 -6.6130325E-02 -0.6201472 -1.171829 -1.721886 -2.264564 -2.774412 -3.275917 -3.750969 -4.205600 -4.610825 -4.938387 -5.206472 -5.374821 -5.461990 -5.456575 -5.342679 -5.080567 -4.548272 -3.400226 2.5725977E-02 -0.4603336 -0.9704155 -1.486015 -1.992929 -2.495886 -2.991068 -3.477900 -3.951716 -4.388477 -4.766657 -5.088079 -5.326526 -5.470888 -5.540289 -5.522874 -5.390855 -5.098298 -4.530941 -3.400226 -0.4764873 -0.9024326 -1.362831 -1.827495 -2.298677 -2.775625 -3.256553 -3.733201 -4.173023 -4.583634 -4.949389 -5.228365 -5.434897 -5.554489 -5.609420 -5.577847 -5.427642 -5.106194 -4.509449 -3.400226 -1.029397 -1.393936 -1.800072 -2.220037 -2.658604 -3.112012 -3.558686 -3.995507 -4.417162 -4.804964 -5.109972 -5.349837 -5.522565 -5.628067 -5.667447 -5.620223 -5.449718 -5.102729 -4.482975 -3.400226 -1.648964 -1.946452 -2.292307 -2.664427 -3.055052 -3.463647 -3.881538 -4.292493 -4.654458 -4.981097 -5.242112 -5.448523 -5.600931 -5.690121 -5.711327 -5.646096 -5.454738 -5.086916 -4.450702 -3.400226 -2.348957 -2.563789 -2.839691 -3.150416 -3.493049 -3.846208 -4.200957 -4.540708 -4.848008 -5.121691 -5.352948 -5.537233 -5.668969 -5.736566 -5.735839 -5.651206 -5.439743 -5.056255 -4.411290 -3.400226 -3.169700 -3.276845 -3.462755 -3.688137 -3.946917 -4.219034 -4.492401 -4.765504 -5.027298 -5.261588 -5.457272 -5.611135 -5.716486 -5.758535 -5.734139 -5.630123 -5.401831 -5.008540 -4.364608 -3.400226 -4.181571 -4.152570 -4.215167 -4.325785 -4.476314 -4.650727 -4.836110 -5.033541 -5.228260 -5.408181 -5.556157 -5.666340 -5.736755 -5.749174 -5.699610 -5.577086 -5.336855 -4.939617 -4.307888 -3.400226 -5.733799 -5.485561 -5.351793 -5.280137 -5.267646 -5.292120 -5.344253 -5.426308 -5.518047 -5.607873 -5.678874 -5.724618 -5.747115 -5.716665 -5.635134 -5.490161 -5.245134 -4.855045 -4.237936 -3.400226 -51.14960 -50.03434 -48.64146 -47.01073 -45.17513 -43.16224 -40.99304 -38.68431 -36.24953 -33.69979 -31.04457 -28.29100 -25.44656 -22.51686 -19.50706 -16.42171 -13.26513 -10.04022 -6.751004 -3.400226 0.6672360 -0.1778672 -0.8905284 -1.424068 -1.946708 -2.397971 -2.805314 -2.970225 -3.278306 -3.562233 -3.819361 -4.024939 -4.046353 -4.261711 -4.462804 -4.644938 -4.629230 -4.761295 -4.727444 -3.504848 1.694714 0.7773613 -4.6725992E-02 -0.7648491 -1.391795 -1.997053 -2.517102 -2.901513 -3.241055 -3.567940 -3.860018 -4.051414 -4.167430 -4.367940 -4.572263 -4.755286 -4.700705 -4.808168 -4.739513 -3.504848 2.180589 1.245625 0.3825906 -0.3835447 -1.104742 -1.789036 -2.393983 -2.864448 -3.263434 -3.608000 -3.920837 -4.161939 -4.353776 -4.526377 -4.704352 -4.853032 -4.808792 -4.864159 -4.749544 -3.504848 2.372294 1.446247 0.5900059 -0.2090503 -0.9650920 -1.677516 -2.279935 -2.805754 -3.261070 -3.645584 -3.999651 -4.296112 -4.513733 -4.687961 -4.844296 -4.941797 -4.923908 -4.925604 -4.757073 -3.504848 2.385114 1.480004 0.6461389 -0.1537078 -0.9112203 -1.596956 -2.210682 -2.767771 -3.243601 -3.697636 -4.092462 -4.411244 -4.649893 -4.834903 -4.983268 -5.050565 -5.038538 -4.989151 -4.761744 -3.504848 2.274799 1.414673 0.5982590 -0.1776157 -0.9007584 -1.571993 -2.192007 -2.746073 -3.275274 -3.771105 -4.191171 -4.506281 -4.769830 -4.970774 -5.114049 -5.172259 -5.147480 -5.051528 -4.763176 -3.504848 2.074985 1.265574 0.4860818 -0.2531649 -0.9500170 -1.607318 -2.212241 -2.791022 -3.350692 -3.863672 -4.274866 -4.607712 -4.885228 -5.099751 -5.241934 -5.289997 -5.248386 -5.110559 -4.761129 -3.504848 1.801242 1.046424 0.3165640 -0.3881143 -1.058292 -1.692166 -2.300103 -2.893602 -3.459418 -3.951367 -4.360910 -4.716392 -5.007125 -5.221880 -5.365037 -5.400995 -5.341213 -5.165707 -4.756738 -3.504848 1.469002 0.7742580 9.0031691E-02 -0.5777678 -1.218654 -1.838598 -2.442717 -3.032546 -3.574129 -4.042830 -4.474385 -4.836321 -5.133788 -5.345702 -5.481313 -5.504286 -5.425899 -5.215596 -4.751413 -3.504848 1.096580 0.4510721 -0.1850253 -0.8175185 -1.431086 -2.030456 -2.622753 -3.185533 -3.693261 -4.177545 -4.598759 -4.971282 -5.258368 -5.470030 -5.586623 -5.598036 -5.502239 -5.258944 -4.744143 -3.504848 0.6685076 8.5623741E-02 -0.5061245 -1.097421 -1.681246 -2.261249 -2.820432 -3.346305 -3.858310 -4.328240 -4.755863 -5.111636 -5.396780 -5.587631 -5.685097 -5.681475 -5.569134 -5.294371 -4.734118 -3.504848 0.1984215 -0.3232014 -0.8688471 -1.419752 -1.972108 -2.508695 -3.036117 -3.553272 -4.054056 -4.523142 -4.926545 -5.269077 -5.539784 -5.694380 -5.772117 -5.755883 -5.625659 -5.320561 -4.720240 -3.504848 -0.3209853 -0.7818884 -1.279827 -1.778797 -2.284952 -2.792713 -3.301018 -3.811630 -4.301577 -4.733227 -5.121781 -5.440212 -5.659613 -5.788024 -5.849781 -5.818806 -5.670659 -5.335381 -4.701601 -3.504848 -0.8968410 -1.290989 -1.727512 -2.181362 -2.652634 -3.135976 -3.629424 -4.100950 -4.552920 -4.973361 -5.318589 -5.579082 -5.762813 -5.868916 -5.916783 -5.869763 -5.700140 -5.337065 -4.677097 -3.504848 -1.542115 -1.866278 -2.239607 -2.645532 -3.076662 -3.517401 -3.967230 -4.415709 -4.833659 -5.186481 -5.472545 -5.690096 -5.850134 -5.940143 -5.970231 -5.904620 -5.711162 -5.324923 -4.645985 -3.504848 -2.272136 -2.509209 -2.812579 -3.154276 -3.531823 -3.934851 -4.325862 -4.709139 -5.056962 -5.353542 -5.595794 -5.786869 -5.925851 -5.996921 -6.004862 -5.917430 -5.701786 -5.297102 -4.606555 -3.504848 -3.131391 -3.255276 -3.464663 -3.724221 -4.022879 -4.335670 -4.646540 -4.959095 -5.248973 -5.504971 -5.712355 -5.871441 -5.984727 -6.029570 -6.012315 -5.902174 -5.668890 -5.251135 -4.558589 -3.504848 -4.185130 -4.166241 -4.252890 -4.393771 -4.576810 -4.782678 -5.004824 -5.238518 -5.462361 -5.663725 -5.822611 -5.935860 -6.014050 -6.027962 -5.984006 -5.852689 -5.606493 -5.181971 -4.499109 -3.504848 -5.799450 -5.551532 -5.432413 -5.382002 -5.390697 -5.440322 -5.521959 -5.634768 -5.753056 -5.867954 -5.949265 -5.998141 -6.022447 -5.998192 -5.921306 -5.764280 -5.511093 -5.093124 -4.424553 -3.504848 -55.58271 -54.38276 -52.87003 -51.09190 -49.08784 -46.88874 -44.51858 -41.99615 -39.33646 -36.55177 -33.65232 -30.64675 -27.54248 -24.34594 -21.06279 -17.69800 -14.25602 -10.74084 -7.156037 -3.504848 0.7837967 -0.1300392 -0.9006376 -1.458215 -2.003327 -2.469975 -2.875032 -3.037412 -3.363869 -3.653231 -3.919557 -4.136831 -4.143776 -4.364648 -4.568360 -4.757188 -4.736682 -4.881435 -4.863071 -3.604268 1.905918 0.9120680 2.4482410E-02 -0.7404502 -1.419535 -2.004059 -2.547255 -2.970501 -3.335905 -3.666805 -3.970100 -4.176715 -4.282769 -4.485263 -4.685889 -4.880192 -4.816984 -4.934167 -4.878891 -3.604268 2.429354 1.424557 0.4975661 -0.3309530 -1.059583 -1.758344 -2.405760 -2.949790 -3.365623 -3.726648 -4.035802 -4.287121 -4.489918 -4.662147 -4.828654 -4.989588 -4.937742 -4.998657 -4.892447 -3.604268 2.640630 1.645271 0.7234277 -0.1107469 -0.8929529 -1.644324 -2.329899 -2.885077 -3.364629 -3.763398 -4.114596 -4.425465 -4.665286 -4.836566 -4.983325 -5.091546 -5.068173 -5.069233 -4.903532 -3.604268 2.658628 1.682604 0.7969828 -4.3316226E-02 -0.8391429 -1.597523 -2.254257 -2.840487 -3.355931 -3.799508 -4.205804 -4.551937 -4.801952 -4.992239 -5.134415 -5.210384 -5.196691 -5.141801 -4.911994 -3.604268 2.541323 1.618877 0.7528768 -6.9817282E-02 -0.8544648 -1.573076 -2.227709 -2.831818 -3.356623 -3.864710 -4.309648 -4.659103 -4.925062 -5.136522 -5.279758 -5.341753 -5.317612 -5.213715 -4.917061 -3.604268 2.329663 1.464283 0.6374283 -0.1627018 -0.9051052 -1.602373 -2.254586 -2.846633 -3.419073 -3.957772 -4.413199 -4.756648 -5.046016 -5.273363 -5.414714 -5.469978 -5.429928 -5.283411 -4.918254 -3.604268 2.043526 1.233985 0.4541776 -0.2980735 -1.011383 -1.689333 -2.319661 -2.935941 -3.528462 -4.071727 -4.501956 -4.869778 -5.167722 -5.404820 -5.545074 -5.591298 -5.533198 -5.348432 -4.916874 -3.604268 1.695175 0.9532665 0.2211213 -0.4911104 -1.172837 -1.823382 -2.456316 -3.076241 -3.668857 -4.172690 -4.608877 -4.987503 -5.297411 -5.528463 -5.670676 -5.705557 -5.627230 -5.407151 -4.915085 -3.604268 1.305421 0.6171114 -6.3153222E-02 -0.7363456 -1.385767 -2.018543 -2.639281 -3.250992 -3.801715 -4.293500 -4.737883 -5.128819 -5.433623 -5.657179 -5.786243 -5.808922 -5.711111 -5.458396 -4.911341 -3.604268 0.8597423 0.2383759 -0.3968109 -1.026236 -1.642358 -2.253873 -2.855973 -3.424322 -3.958988 -4.452786 -4.899154 -5.284468 -5.573543 -5.788581 -5.895387 -5.902168 -5.786612 -5.500622 -4.904398 -3.604268 0.3703300 -0.1872383 -0.7720305 -1.356731 -1.942040 -2.526230 -3.081990 -3.634692 -4.158331 -4.653348 -5.088644 -5.443069 -5.726121 -5.906533 -5.993618 -5.986238 -5.851680 -5.532812 -4.893475 -3.604268 -0.1677579 -0.6629053 -1.193148 -1.732887 -2.273481 -2.812942 -3.352481 -3.891251 -4.411064 -4.880001 -5.283927 -5.627995 -5.866013 -6.015621 -6.080584 -6.058980 -5.904237 -5.553221 -4.877603 -3.604268 -0.7661399 -1.190453 -1.658152 -2.144819 -2.648075 -3.161067 -3.685827 -4.210998 -4.687476 -5.128319 -5.510436 -5.791749 -5.987589 -6.108352 -6.157700 -6.119186 -5.941055 -5.559439 -4.855603 -3.604268 -1.435339 -1.782849 -2.187213 -2.623016 -3.090519 -3.572447 -4.054837 -4.539117 -4.999434 -5.383346 -5.689764 -5.925272 -6.087812 -6.191780 -6.222167 -6.162144 -5.959855 -5.550175 -4.826306 -3.604268 -2.190398 -2.454647 -2.785506 -3.157420 -3.568652 -4.009691 -4.454305 -4.877200 -5.264738 -5.580911 -5.831609 -6.033561 -6.178041 -6.261745 -6.268262 -6.181669 -5.956524 -5.522902 -4.787950 -3.604268 -3.079369 -3.229982 -3.466082 -3.756311 -4.094952 -4.450439 -4.804777 -5.151621 -5.470134 -5.746138 -5.961924 -6.133084 -6.249851 -6.308633 -6.286949 -6.171286 -5.925935 -5.475616 -4.740287 -3.604268 -4.185086 -4.177073 -4.283359 -4.455442 -4.672689 -4.915813 -5.174516 -5.441604 -5.694847 -5.913561 -6.084026 -6.214959 -6.292844 -6.319221 -6.267220 -6.124351 -5.862622 -5.403766 -4.681560 -3.604268 -5.858729 -5.611984 -5.502590 -5.481498 -5.517343 -5.593135 -5.703450 -5.841831 -5.991752 -6.118871 -6.216727 -6.285820 -6.313931 -6.296537 -6.208289 -6.037036 -5.762848 -5.311403 -4.607003 -3.604268 -60.10012 -58.81427 -57.17879 -55.24974 -53.07273 -50.68288 -48.10705 -45.36606 -42.47647 -39.45178 -36.30319 -33.04017 -29.67081 -26.20215 -22.64032 -18.99074 -15.25825 -11.44716 -7.561338 -3.604268 0.8956088 -8.6222738E-02 -0.9114583 -1.494628 -2.060518 -2.543674 -2.954957 -3.104310 -3.439004 -3.740533 -4.013942 -4.243911 -4.237462 -4.462173 -4.670949 -4.863384 -4.839053 -4.994471 -4.994000 -3.698979 2.112866 1.043812 9.3713038E-02 -0.7202755 -1.434229 -2.051640 -2.583615 -3.024995 -3.424930 -3.761154 -4.076458 -4.300378 -4.394423 -4.598615 -4.802815 -4.997272 -4.927513 -5.054276 -5.014698 -3.698979 2.678361 1.597972 0.6085934 -0.2706081 -1.057588 -1.742256 -2.407590 -3.003611 -3.464058 -3.832658 -4.152807 -4.412251 -4.618414 -4.795951 -4.960065 -5.118441 -5.062927 -5.128032 -5.033184 -3.698979 2.909936 1.837199 0.8565496 -3.4350626E-02 -0.8343243 -1.604913 -2.330974 -2.959507 -3.461560 -3.886161 -4.230918 -4.550169 -4.803352 -4.982773 -5.126946 -5.231763 -5.209074 -5.207860 -5.049143 -3.698979 2.932079 1.882791 0.9354220 5.9834220E-02 -0.7668201 -1.563183 -2.294960 -2.911362 -3.454657 -3.910870 -4.315878 -4.677591 -4.950256 -5.149697 -5.288678 -5.361981 -5.350568 -5.290235 -5.062191 -3.698979 2.804659 1.819177 0.9031004 3.8352937E-02 -0.7871003 -1.574324 -2.264956 -2.896655 -3.458697 -3.957119 -4.417829 -4.799578 -5.075915 -5.297435 -5.441537 -5.505774 -5.482342 -5.371088 -5.071743 -3.698979 2.580716 1.659867 0.7845125 -5.9245229E-02 -0.8624490 -1.601436 -2.285771 -2.922919 -3.493703 -4.044425 -4.532415 -4.906908 -5.200459 -5.434361 -5.585541 -5.645355 -5.604690 -5.448911 -5.077036 -3.698979 2.280352 1.420774 0.5932158 -0.2096866 -0.9691153 -1.683509 -2.357267 -2.984455 -3.596944 -4.162811 -4.639371 -5.012157 -5.322843 -5.568005 -5.721334 -5.776578 -5.716608 -5.521770 -5.079383 -3.698979 1.916349 1.123278 0.3511797 -0.4094276 -1.129515 -1.816512 -2.473936 -3.121182 -3.740609 -4.290579 -4.741236 -5.137484 -5.454880 -5.701782 -5.854112 -5.899982 -5.818757 -5.587710 -5.081189 -3.698979 1.507962 0.7805241 5.5056408E-02 -0.6595348 -1.343819 -2.006484 -2.658483 -3.300581 -3.900686 -4.413614 -4.877610 -5.271890 -5.599406 -5.834456 -5.983685 -6.013558 -5.909824 -5.645985 -5.080987 -3.698979 1.051847 0.3880392 -0.2904720 -0.9558047 -1.605804 -2.247290 -2.885233 -3.502871 -4.060301 -4.580553 -5.033182 -5.434769 -5.744001 -5.974196 -6.102206 -6.115406 -5.990153 -5.694946 -5.077359 -3.698979 0.5413048 -5.4187059E-02 -0.6759984 -1.294291 -1.913007 -2.530281 -3.136451 -3.712759 -4.270133 -4.772902 -5.229088 -5.606515 -5.903001 -6.111764 -6.211949 -6.206800 -6.060486 -5.733697 -5.068997 -3.698979 -1.7961148E-02 -0.5452259 -1.107989 -1.681586 -2.265916 -2.835146 -3.409518 -3.976068 -4.520796 -5.017243 -5.440360 -5.798254 -6.068909 -6.237101 -6.307301 -6.285642 -6.120274 -5.760940 -5.054863 -3.698979 -0.6360658 -1.091492 -1.591731 -2.110688 -2.646059 -3.189282 -3.747468 -4.304792 -4.821069 -5.277070 -5.677960 -5.992435 -6.211756 -6.345288 -6.393125 -6.351223 -6.164055 -5.773738 -5.034069 -3.698979 -1.328185 -1.700156 -2.133948 -2.601167 -3.099740 -3.621651 -4.146930 -4.661161 -5.147872 -5.573059 -5.896767 -6.150580 -6.329360 -6.440891 -6.466779 -6.399287 -6.188570 -5.770318 -5.005264 -3.698979 -2.107658 -2.395463 -2.757012 -3.160155 -3.605231 -4.081295 -4.573471 -5.040900 -5.455919 -5.800332 -6.067214 -6.277814 -6.432795 -6.521801 -6.521184 -6.425177 -6.190334 -5.747820 -4.967216 -3.698979 -3.024011 -3.197556 -3.464171 -3.788010 -4.162775 -4.563318 -4.963214 -5.343876 -5.688322 -5.976923 -6.213172 -6.392756 -6.519526 -6.577657 -6.546233 -6.421194 -6.164020 -5.703322 -4.918617 -3.698979 -4.177915 -4.184789 -4.311817 -4.515395 -4.771109 -5.051724 -5.348166 -5.646123 -5.924638 -6.157350 -6.349407 -6.487970 -6.576031 -6.596772 -6.530776 -6.378269 -6.102577 -5.632126 -4.858272 -3.698979 -5.909559 -5.663548 -5.567173 -5.572431 -5.642071 -5.748269 -5.890691 -6.064026 -6.230443 -6.374568 -6.491222 -6.572598 -6.608234 -6.581067 -6.474274 -6.291568 -5.999954 -5.535844 -4.781216 -3.698979 -64.69788 -63.32493 -61.56387 -59.48021 -57.12621 -54.54133 -51.75533 -48.79116 -45.66695 -42.39745 -38.99484 -35.46944 -31.83005 -28.08425 -24.23871 -20.29929 -16.27122 -12.15911 -7.967110 -3.698979 1.003414 -4.6487190E-02 -0.9238328 -1.532799 -2.118619 -2.613087 -3.041224 -3.173908 -3.511719 -3.823306 -4.103586 -4.345500 -4.326335 -4.553648 -4.768206 -4.964876 -4.937620 -5.098897 -5.116177 -3.789407 2.316065 1.171485 0.1621539 -0.7019660 -1.453621 -2.099192 -2.644140 -3.079630 -3.492535 -3.853263 -4.174407 -4.421549 -4.501473 -4.703375 -4.911400 -5.110511 -5.034409 -5.164206 -5.141312 -3.789407 2.924995 1.767365 0.7186314 -0.2140053 -1.043412 -1.769579 -2.415930 -3.035519 -3.554605 -3.936187 -4.267803 -4.533413 -4.741895 -4.920127 -5.085418 -5.242787 -5.186562 -5.245455 -5.164475 -3.789407 3.187821 2.021965 0.9864583 4.6113186E-02 -0.8112756 -1.575659 -2.321898 -3.005235 -3.553389 -3.992013 -4.351555 -4.666770 -4.934230 -5.122285 -5.266040 -5.370838 -5.346412 -5.334229 -5.185378 -3.789407 3.207502 2.077955 1.074569 0.1436889 -0.7042670 -1.523271 -2.298163 -2.977422 -3.543349 -4.033203 -4.426448 -4.794454 -5.093116 -5.293793 -5.439890 -5.511913 -5.498646 -5.425270 -5.203164 -3.789407 3.063117 2.016536 1.047543 0.1406992 -0.7188933 -1.543192 -2.299829 -2.962011 -3.556282 -4.057263 -4.521215 -4.921965 -5.226302 -5.447592 -5.603244 -5.663127 -5.639519 -5.515153 -5.217242 -3.789407 2.826459 1.850941 0.9287998 4.1287392E-02 -0.8059759 -1.598015 -2.320025 -2.987987 -3.582166 -4.128852 -4.635385 -5.043241 -5.345392 -5.586563 -5.757679 -5.811405 -5.768970 -5.602161 -5.227041 -3.789407 2.510729 1.602439 0.7288465 -0.1192078 -0.9285329 -1.681215 -2.389393 -3.047863 -3.663848 -4.246093 -4.762860 -5.152888 -5.474501 -5.725570 -5.901124 -5.951907 -5.886523 -5.684038 -5.233525 -3.789407 2.140749 1.294969 0.4755280 -0.3283946 -1.090306 -1.814106 -2.503245 -3.166463 -3.806957 -4.394832 -4.878060 -5.275306 -5.603797 -5.868220 -6.039174 -6.080053 -5.994828 -5.759077 -5.239400 -3.789407 1.711753 0.9379196 0.1677871 -0.5849649 -1.305837 -1.999552 -2.680016 -3.349152 -3.986322 -4.541215 -5.005136 -5.412858 -5.752874 -6.006959 -6.174387 -6.200741 -6.092826 -5.826045 -5.242896 -3.789407 1.233112 0.5302633 -0.1876664 -0.8877690 -1.570704 -2.244574 -2.911742 -3.571657 -4.168363 -4.694839 -5.168209 -5.578271 -5.911497 -6.152936 -6.301198 -6.308444 -6.182353 -5.881968 -5.242659 -3.789407 0.7059472 7.2685696E-02 -0.5838121 -1.236307 -1.886787 -2.533729 -3.181380 -3.796407 -4.372338 -4.894837 -5.366803 -5.765543 -6.078244 -6.309325 -6.416961 -6.405077 -6.260708 -5.926437 -5.237388 -3.789407 0.1297037 -0.4295998 -1.025944 -1.633994 -2.249037 -2.862847 -3.467309 -4.067912 -4.626589 -5.144945 -5.594546 -5.963223 -6.266496 -6.447116 -6.520077 -6.491067 -6.326658 -5.958753 -5.226066 -3.789407 -0.5082273 -0.9926786 -1.526358 -2.079079 -2.645434 -3.222457 -3.812237 -4.396874 -4.948704 -5.424252 -5.843076 -6.189987 -6.429749 -6.568407 -6.611822 -6.563987 -6.376287 -5.976386 -5.207033 -3.789407 -1.221018 -1.620552 -2.081864 -2.579406 -3.108624 -3.663825 -4.240351 -4.778800 -5.288374 -5.738307 -6.100259 -6.375070 -6.565413 -6.670141 -6.692017 -6.620347 -6.405756 -5.977014 -5.179436 -3.789407 -2.024558 -2.335838 -2.724727 -3.163076 -3.642726 -4.155480 -4.682804 -5.199866 -5.639606 -6.010058 -6.300150 -6.518739 -6.679249 -6.760576 -6.754225 -6.654766 -6.412319 -5.957227 -5.141914 -3.789407 -2.967743 -3.163245 -3.455558 -3.818989 -4.234216 -4.675508 -5.124973 -5.539706 -5.902089 -6.209574 -6.459983 -6.647110 -6.777458 -6.828736 -6.789645 -6.659486 -6.390804 -5.914374 -5.091831 -3.789407 -4.162533 -4.185633 -4.337744 -4.572872 -4.866398 -5.189321 -5.524734 -5.858088 -6.151353 -6.405162 -6.608278 -6.754267 -6.842800 -6.858418 -6.784483 -6.622886 -6.332757 -5.843676 -5.028483 -3.789407 -5.955517 -5.708406 -5.625609 -5.656294 -5.758032 -5.904334 -6.086205 -6.283236 -6.467893 -6.634989 -6.761246 -6.843874 -6.874991 -6.847297 -6.735293 -6.538889 -6.230675 -5.744028 -4.947204 -3.789407 -69.07755 -67.91139 -66.02174 -63.77997 -61.24509 -58.46106 -55.46062 -52.26886 -48.90553 -45.38663 -41.72538 -37.93293 -34.01877 -29.99109 -25.85708 -21.62304 -17.29455 -12.87656 -8.373505 -3.789407 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -2.002279 -2.033765 -2.062994 -2.090135 -2.114520 -2.135610 -2.164037 -2.190267 -2.213880 -2.234412 -2.250691 -2.263301 -2.270656 -2.274724 -2.277740 -2.272600 -2.256098 -2.222871 -2.159738 -1.934567 -2.023978 -2.053670 -2.081897 -2.107459 -2.129764 -2.149550 -2.176947 -2.202006 -2.224325 -2.242773 -2.258045 -2.268938 -2.274457 -2.276914 -2.278557 -2.272039 -2.254181 -2.219953 -2.156380 -1.934567 -2.046476 -2.074950 -2.101422 -2.124725 -2.145447 -2.164243 -2.190435 -2.214121 -2.234968 -2.251748 -2.265304 -2.274381 -2.277989 -2.278997 -2.279166 -2.271287 -2.252054 -2.216931 -2.152870 -1.934567 -2.070423 -2.096926 -2.120909 -2.142476 -2.161983 -2.179675 -2.204393 -2.226543 -2.245010 -2.260716 -2.272419 -2.279579 -2.281079 -2.280948 -2.279631 -2.270321 -2.249703 -2.213617 -2.149204 -1.934567 -2.095119 -2.118816 -2.141043 -2.161146 -2.179455 -2.195724 -2.218754 -2.238429 -2.255778 -2.269610 -2.279345 -2.284479 -2.284377 -2.282747 -2.279877 -2.268987 -2.247107 -2.210082 -2.145354 -1.934567 -2.119672 -2.141519 -2.162133 -2.180967 -2.197685 -2.212302 -2.233471 -2.251148 -2.266534 -2.278361 -2.286016 -2.288760 -2.287568 -2.284223 -2.279911 -2.267359 -2.244271 -2.206307 -2.141309 -1.934567 -2.145415 -2.165323 -2.184528 -2.201690 -2.216585 -2.229320 -2.247567 -2.263912 -2.277202 -2.286901 -2.291809 -2.293438 -2.290627 -2.285621 -2.279691 -2.265433 -2.241195 -2.202270 -2.137049 -1.934567 -2.172402 -2.190607 -2.207914 -2.223151 -2.235266 -2.245809 -2.262563 -2.276654 -2.287711 -2.295142 -2.298100 -2.298043 -2.293261 -2.286726 -2.278957 -2.263211 -2.237744 -2.197946 -2.132549 -1.934567 -2.201003 -2.217012 -2.232146 -2.244436 -2.255017 -2.263248 -2.277576 -2.289298 -2.297958 -2.302522 -2.304381 -2.302532 -2.295935 -2.287631 -2.277792 -2.260615 -2.234201 -2.193306 -2.127774 -1.934567 -2.230870 -2.243720 -2.256346 -2.266894 -2.275021 -2.280827 -2.292554 -2.301727 -2.307275 -2.310715 -2.310633 -2.306470 -2.298264 -2.287913 -2.276254 -2.257728 -2.230013 -2.188313 -2.122684 -1.934567 -2.261184 -2.271967 -2.281866 -2.289754 -2.295263 -2.298480 -2.306494 -2.313272 -2.317636 -2.319005 -2.316316 -2.310450 -2.300465 -2.287628 -2.274376 -2.254499 -2.225405 -2.182923 -2.117227 -1.934567 -2.293181 -2.301020 -2.308037 -2.313092 -2.315715 -2.315330 -2.321764 -2.326157 -2.328277 -2.326769 -2.322211 -2.314405 -2.303440 -2.288866 -2.272176 -2.251092 -2.220332 -2.177158 -2.111325 -1.934567 -2.326342 -2.331101 -2.334939 -2.336116 -2.335926 -2.333921 -2.337828 -2.338849 -2.338524 -2.335024 -2.328270 -2.318769 -2.306087 -2.290058 -2.269943 -2.246695 -2.214744 -2.170780 -2.104864 -1.934567 -2.360125 -2.361702 -2.362453 -2.361572 -2.358485 -2.352932 -2.354051 -2.352681 -2.349628 -2.343622 -2.334646 -2.323213 -2.308869 -2.290951 -2.269009 -2.241768 -2.208574 -2.163798 -2.097714 -1.934567 -2.397699 -2.396095 -2.392775 -2.388578 -2.381853 -2.373962 -2.372005 -2.367336 -2.360881 -2.352203 -2.341231 -2.327789 -2.311873 -2.291790 -2.267155 -2.237760 -2.202105 -2.156067 -2.089103 -1.934567 -2.439372 -2.433709 -2.427262 -2.419189 -2.410069 -2.400500 -2.389613 -2.382230 -2.372944 -2.362153 -2.348996 -2.333686 -2.314092 -2.291289 -2.264705 -2.233770 -2.195766 -2.147607 -2.078656 -1.934567 -2.487543 -2.478292 -2.468365 -2.457968 -2.446099 -2.434114 -2.421272 -2.406401 -2.391526 -2.374261 -2.357340 -2.337969 -2.315912 -2.290631 -2.262035 -2.227998 -2.187270 -2.136489 -2.066314 -1.934567 -2.549841 -2.534322 -2.521468 -2.507231 -2.491887 -2.475647 -2.458230 -2.439474 -2.419536 -2.398027 -2.374837 -2.350841 -2.323024 -2.292944 -2.259073 -2.220501 -2.175008 -2.117749 -2.051008 -1.934567 -2.659107 -2.637640 -2.615431 -2.593623 -2.569379 -2.544207 -2.518013 -2.491158 -2.462301 -2.432039 -2.399921 -2.365549 -2.328298 -2.287382 -2.242226 -2.194323 -2.143963 -2.090100 -2.029980 -1.934567 -2.590475 -2.561377 -2.531642 -2.501274 -2.470281 -2.438669 -2.406688 -2.373612 -2.340175 -2.306140 -2.271521 -2.236322 -2.200550 -2.164211 -2.127311 -2.089854 -2.051837 -2.013280 -1.974188 -1.934567 -1.917384 -1.983342 -2.044164 -2.121094 -2.192588 -2.260453 -2.322070 -2.376835 -2.422040 -2.471498 -2.527937 -2.578368 -2.620418 -2.652940 -2.671665 -2.690574 -2.699630 -2.683288 -2.620373 -2.326377 -1.938284 -2.002059 -2.064244 -2.141149 -2.214402 -2.282120 -2.342492 -2.395034 -2.436473 -2.486183 -2.542010 -2.590403 -2.631033 -2.660787 -2.676115 -2.692906 -2.699801 -2.681212 -2.616654 -2.326377 -1.963948 -2.027747 -2.091939 -2.168065 -2.240441 -2.305539 -2.364131 -2.413634 -2.453274 -2.502693 -2.557214 -2.603580 -2.641390 -2.668300 -2.680309 -2.695153 -2.699763 -2.678883 -2.612727 -2.326377 -1.996984 -2.060173 -2.123854 -2.199626 -2.268097 -2.331148 -2.386678 -2.432259 -2.472414 -2.520761 -2.572434 -2.617092 -2.651969 -2.675443 -2.684592 -2.697276 -2.699486 -2.676270 -2.608577 -2.326377 -2.037017 -2.099815 -2.162214 -2.232986 -2.298513 -2.358246 -2.409092 -2.454127 -2.493542 -2.540152 -2.589084 -2.630857 -2.662150 -2.682058 -2.688905 -2.699233 -2.698940 -2.673290 -2.604186 -2.326377 -2.084455 -2.144973 -2.202552 -2.269050 -2.330737 -2.385379 -2.434662 -2.478478 -2.516298 -2.559393 -2.606163 -2.643910 -2.672146 -2.688457 -2.693190 -2.700980 -2.698091 -2.669966 -2.599543 -2.326377 -2.135941 -2.192276 -2.245339 -2.307406 -2.363391 -2.415728 -2.463068 -2.504856 -2.539398 -2.580244 -2.622653 -2.657084 -2.681653 -2.695069 -2.697405 -2.702475 -2.696902 -2.666273 -2.594630 -2.326377 -2.191615 -2.242220 -2.290496 -2.346528 -2.399729 -2.449275 -2.493923 -2.532056 -2.564342 -2.601572 -2.639827 -2.670155 -2.690856 -2.701797 -2.701498 -2.703687 -2.695333 -2.662178 -2.589419 -2.326377 -2.250327 -2.294305 -2.337141 -2.389897 -2.439579 -2.485554 -2.526002 -2.561308 -2.590024 -2.622050 -2.656294 -2.682623 -2.700358 -2.708573 -2.705390 -2.704559 -2.693326 -2.657641 -2.583881 -2.326377 -2.310809 -2.349953 -2.388781 -2.436984 -2.482346 -2.523292 -2.560356 -2.591677 -2.615186 -2.642933 -2.672751 -2.695277 -2.710049 -2.715339 -2.709058 -2.705043 -2.690575 -2.652618 -2.577977 -2.326377 -2.376241 -2.410624 -2.444329 -2.486594 -2.526764 -2.563548 -2.595309 -2.621917 -2.640921 -2.663969 -2.689314 -2.708373 -2.719923 -2.722017 -2.712446 -2.705088 -2.687118 -2.647051 -2.571663 -2.326377 -2.446465 -2.474720 -2.502653 -2.539307 -2.573775 -2.604735 -2.631510 -2.652928 -2.667064 -2.685387 -2.706702 -2.721967 -2.729932 -2.728567 -2.715491 -2.704572 -2.683038 -2.640886 -2.564888 -2.326377 -2.520097 -2.542225 -2.563135 -2.593696 -2.621687 -2.647516 -2.668849 -2.684791 -2.694354 -2.708150 -2.724998 -2.736088 -2.740123 -2.734962 -2.718153 -2.702705 -2.678265 -2.634080 -2.557585 -2.326377 -2.596725 -2.612317 -2.626770 -2.650837 -2.672322 -2.692088 -2.707839 -2.718741 -2.723586 -2.732399 -2.744345 -2.750886 -2.750590 -2.741263 -2.721061 -2.700125 -2.672741 -2.626607 -2.549677 -2.326377 -2.678829 -2.686614 -2.693871 -2.711095 -2.726076 -2.740002 -2.750162 -2.755534 -2.755142 -2.758558 -2.765111 -2.766608 -2.761600 -2.747834 -2.725414 -2.696891 -2.666449 -2.618412 -2.541058 -2.326377 -2.768675 -2.768510 -2.768116 -2.778144 -2.786296 -2.793555 -2.797308 -2.796412 -2.790006 -2.787429 -2.788066 -2.783725 -2.773510 -2.755834 -2.729907 -2.694494 -2.659572 -2.609479 -2.531781 -2.326377 -2.874518 -2.865374 -2.855978 -2.857756 -2.857945 -2.857205 -2.853224 -2.844671 -2.830777 -2.820167 -2.813405 -2.802984 -2.787358 -2.765243 -2.735194 -2.696833 -2.652584 -2.599931 -2.521263 -2.326377 -3.011749 -2.991262 -2.970675 -2.962162 -2.952428 -2.941213 -2.928559 -2.912859 -2.893634 -2.870973 -2.845864 -2.829075 -2.807328 -2.779394 -2.744846 -2.702230 -2.650642 -2.590953 -2.509613 -2.326377 -3.233091 -3.204992 -3.176373 -3.146704 -3.117414 -3.085986 -3.057528 -3.032157 -3.003915 -2.972804 -2.938137 -2.899992 -2.858055 -2.813412 -2.770067 -2.719732 -2.659438 -2.588292 -2.496503 -2.326377 -3.828560 -3.769727 -3.708367 -3.644529 -3.578260 -3.509606 -3.438635 -3.365640 -3.289922 -3.212273 -3.132508 -3.050670 -2.967028 -2.880917 -2.793114 -2.703414 -2.611837 -2.518451 -2.423288 -2.326377 -1.795549 -1.917229 -2.028945 -2.124753 -2.215287 -2.324512 -2.427348 -2.520665 -2.602920 -2.668137 -2.733258 -2.816352 -2.889007 -2.949953 -2.993574 -3.018042 -3.051875 -3.053651 -2.994689 -2.653861 -1.794583 -1.919970 -2.033988 -2.127939 -2.224825 -2.338587 -2.443373 -2.538619 -2.619924 -2.680970 -2.746821 -2.830150 -2.902416 -2.961517 -3.001359 -3.021802 -3.053488 -3.052347 -2.990657 -2.653861 -1.813721 -1.937341 -2.047202 -2.145092 -2.245991 -2.360911 -2.466257 -2.560069 -2.637877 -2.695748 -2.764234 -2.846848 -2.917118 -2.973148 -3.008466 -3.025825 -3.054976 -3.050748 -2.986349 -2.653861 -1.847040 -1.963898 -2.073762 -2.174609 -2.277040 -2.390403 -2.493796 -2.583760 -2.655761 -2.715655 -2.783942 -2.865219 -2.932251 -2.984579 -3.014677 -3.030003 -3.056278 -3.048817 -2.981742 -2.653861 -1.888194 -2.004100 -2.113564 -2.214324 -2.315417 -2.425324 -2.523957 -2.607850 -2.677982 -2.738715 -2.806687 -2.884026 -2.947895 -2.995501 -3.020594 -3.034217 -3.057330 -3.046514 -2.976813 -2.653861 -1.942449 -2.057061 -2.163556 -2.261856 -2.359460 -2.463348 -2.555317 -2.634491 -2.704953 -2.765152 -2.830455 -2.903902 -2.963545 -3.005653 -3.026999 -3.038398 -3.058100 -3.043793 -2.971560 -2.653861 -2.011072 -2.119764 -2.221295 -2.315241 -2.406909 -2.503212 -2.588674 -2.666578 -2.735112 -2.794049 -2.855617 -2.924328 -2.978684 -3.014832 -3.033722 -3.042448 -3.058465 -3.040407 -2.965971 -2.653861 -2.087786 -2.189964 -2.285122 -2.372468 -2.456275 -2.545442 -2.627963 -2.702523 -2.768990 -2.823794 -2.881051 -2.944574 -2.992921 -3.024215 -3.040612 -3.046265 -3.058384 -3.036673 -2.960013 -2.653861 -2.173393 -2.266002 -2.353419 -2.432137 -2.509173 -2.593892 -2.671891 -2.742586 -2.804398 -2.855055 -2.907151 -2.964053 -3.005986 -3.034124 -3.047534 -3.049821 -3.057783 -3.032324 -2.953733 -2.653861 -2.264654 -2.346995 -2.425310 -2.497120 -2.568519 -2.647404 -2.720440 -2.784963 -2.841611 -2.887541 -2.933153 -2.982588 -3.019446 -3.044300 -3.054328 -3.052829 -3.056588 -3.027194 -2.946907 -2.653861 -2.361149 -2.434621 -2.504346 -2.568582 -2.633833 -2.705281 -2.771415 -2.829838 -2.880423 -2.920212 -2.958527 -3.001015 -3.033532 -3.054605 -3.060862 -3.055285 -3.054689 -3.021300 -2.939685 -2.653861 -2.466042 -2.529324 -2.590090 -2.646984 -2.703772 -2.766558 -2.825126 -2.876748 -2.919844 -2.952274 -2.984092 -3.020779 -3.048136 -3.064873 -3.067018 -3.057072 -3.052002 -3.014576 -2.931907 -2.653861 -2.579235 -2.632047 -2.683150 -2.730814 -2.778049 -2.831593 -2.881363 -2.924595 -2.959197 -2.985127 -3.011363 -3.041828 -3.063249 -3.075099 -3.072617 -3.058092 -3.048161 -3.006940 -2.923281 -2.653861 -2.700702 -2.742780 -2.782918 -2.820003 -2.856684 -2.899643 -2.939175 -2.973970 -3.001019 -3.020357 -3.040384 -3.064112 -3.079022 -3.085215 -3.077651 -3.058281 -3.042646 -2.998381 -2.913864 -2.653861 -2.830910 -2.861122 -2.888493 -2.913507 -2.938984 -2.971698 -3.001394 -3.027871 -3.046704 -3.058400 -3.071332 -3.087976 -3.095655 -3.095475 -3.082228 -3.056706 -3.035852 -2.988886 -2.903535 -2.653861 -2.968164 -2.985381 -3.001053 -3.014827 -3.029460 -3.051727 -3.070726 -3.087976 -3.097663 -3.100527 -3.105377 -3.114110 -3.113937 -3.106342 -3.086667 -3.053321 -3.027825 -2.978178 -2.892143 -2.653861 -3.123076 -3.126676 -3.129047 -3.129997 -3.132668 -3.143809 -3.151425 -3.158062 -3.157395 -3.149811 -3.145078 -3.144739 -3.134897 -3.118842 -3.094550 -3.056370 -3.018704 -2.966164 -2.879542 -2.653861 -3.316542 -3.303397 -3.289696 -3.274497 -3.262037 -3.259871 -3.254274 -3.247960 -3.234632 -3.214323 -3.193390 -3.181746 -3.162969 -3.138325 -3.107471 -3.063337 -3.010237 -2.953594 -2.865652 -2.653861 -3.612850 -3.577789 -3.544631 -3.510786 -3.475501 -3.440000 -3.417673 -3.394189 -3.369174 -3.338907 -3.301681 -3.257949 -3.220737 -3.184455 -3.140704 -3.087252 -3.020141 -2.944932 -2.851864 -2.653861 -5.157303 -5.068347 -4.973272 -4.872968 -4.767378 -4.656682 -4.541017 -4.420588 -4.295527 -4.165998 -4.032156 -3.894111 -3.752031 -3.606017 -3.456202 -3.302703 -3.145607 -2.985046 -2.821340 -2.653861 -1.650181 -1.826880 -1.990169 -2.136876 -2.256212 -2.372759 -2.512359 -2.641375 -2.757121 -2.854283 -2.918079 -3.020535 -3.119419 -3.204910 -3.270765 -3.299259 -3.352355 -3.370750 -3.316139 -2.935190 -1.603047 -1.792712 -1.967006 -2.117786 -2.237279 -2.365876 -2.515542 -2.651287 -2.770690 -2.866705 -2.925683 -3.033252 -3.133816 -3.219048 -3.281572 -3.303470 -3.355121 -3.370267 -3.311718 -2.935190 -1.599003 -1.791999 -1.966316 -2.113415 -2.241709 -2.381167 -2.534064 -2.670606 -2.789239 -2.878954 -2.941707 -3.051211 -3.151111 -3.234062 -3.291711 -3.308619 -3.357987 -3.369479 -3.306916 -2.935190 -1.624636 -1.811926 -1.980706 -2.131247 -2.269728 -2.411868 -2.562180 -2.696831 -2.809487 -2.894011 -2.964118 -3.072968 -3.170473 -3.249355 -3.300861 -3.314489 -3.360817 -3.368334 -3.301690 -2.935190 -1.670162 -1.847477 -2.015894 -2.172633 -2.312427 -2.451569 -2.598044 -2.726184 -2.829765 -2.917327 -2.991561 -3.097418 -3.190918 -3.264433 -3.308539 -3.321218 -3.363526 -3.366643 -3.296196 -2.935190 -1.732479 -1.904552 -2.072391 -2.228399 -2.364869 -2.500106 -2.638515 -2.756222 -2.857032 -2.946586 -3.022074 -3.123516 -3.211878 -3.278862 -3.316117 -3.327894 -3.366009 -3.364553 -3.290323 -2.935190 -1.815815 -1.982119 -2.143592 -2.292251 -2.425988 -2.554116 -2.680133 -2.791348 -2.891938 -2.980719 -3.054625 -3.150501 -3.232451 -3.291962 -3.324772 -3.334713 -3.368501 -3.361829 -3.284055 -2.935190 -1.917568 -2.072783 -2.223219 -2.365431 -2.491619 -2.608823 -2.726053 -2.834528 -2.932854 -3.018313 -3.088794 -3.177799 -3.252134 -3.303643 -3.334509 -3.341434 -3.370116 -3.358495 -3.277346 -2.935190 -2.028037 -2.173136 -2.313391 -2.443868 -2.558565 -2.667984 -2.780144 -2.883965 -2.977677 -3.058496 -3.123978 -3.204738 -3.270374 -3.316197 -3.344326 -3.347874 -3.371131 -3.354398 -3.270143 -2.935190 -2.150829 -2.282317 -2.407933 -2.526121 -2.632179 -2.735228 -2.840749 -2.937805 -3.025016 -3.100405 -3.159722 -3.230956 -3.287737 -3.329952 -3.354218 -3.354308 -3.371706 -3.349426 -3.262385 -2.935190 -2.281292 -2.395864 -2.508399 -2.616807 -2.714637 -2.809046 -2.905908 -2.994640 -3.074403 -3.142794 -3.195113 -3.256128 -3.306539 -3.343912 -3.363869 -3.359410 -3.371018 -3.343436 -3.254001 -2.935190 -2.418319 -2.518386 -2.619231 -2.716551 -2.804000 -2.887428 -2.974526 -3.054379 -3.124939 -3.184957 -3.229346 -3.282600 -3.326673 -3.358118 -3.373435 -3.363557 -3.369379 -3.336172 -3.244899 -2.935190 -2.568011 -2.653142 -2.739362 -2.823419 -2.899076 -2.970606 -3.046680 -3.116159 -3.176185 -3.226669 -3.264400 -3.310743 -3.347369 -3.372301 -3.381692 -3.366930 -3.366201 -3.327482 -3.234963 -2.935190 -2.729251 -2.796746 -2.867419 -2.938051 -3.000060 -3.058490 -3.122075 -3.180023 -3.229017 -3.270385 -3.301029 -3.339702 -3.368493 -3.386436 -3.389314 -3.368551 -3.361388 -3.317530 -3.224053 -2.935190 -2.901396 -2.951424 -3.006173 -3.060410 -3.107247 -3.151800 -3.201581 -3.247713 -3.285817 -3.317075 -3.339117 -3.369672 -3.390169 -3.400055 -3.395540 -3.368188 -3.354151 -3.306227 -3.211983 -2.935190 -3.087882 -3.119627 -3.156723 -3.193214 -3.223560 -3.253079 -3.288442 -3.322211 -3.348386 -3.367972 -3.379566 -3.400548 -3.412431 -3.413070 -3.400387 -3.365565 -3.344382 -3.293382 -3.198528 -2.935190 -3.292115 -3.303964 -3.323397 -3.342859 -3.355774 -3.368512 -3.388089 -3.407264 -3.419774 -3.425586 -3.424730 -3.434885 -3.436364 -3.426467 -3.404484 -3.366205 -3.332664 -3.278782 -3.183410 -2.935190 -3.534874 -3.524629 -3.524459 -3.524519 -3.517641 -3.511053 -3.512907 -3.514697 -3.510541 -3.499413 -3.482147 -3.477257 -3.465776 -3.444047 -3.413450 -3.368584 -3.319959 -3.262495 -3.166418 -2.935190 -3.896297 -3.858099 -3.829492 -3.798939 -3.762818 -3.727204 -3.706827 -3.685794 -3.660846 -3.629421 -3.593352 -3.551579 -3.525474 -3.488911 -3.441216 -3.385999 -3.313644 -3.247651 -3.148284 -2.935190 -6.568760 -6.448566 -6.318460 -6.178835 -6.030122 -5.872708 -5.706984 -5.533314 -5.352037 -5.163488 -4.967951 -4.765730 -4.557065 -4.342227 -4.121421 -3.894888 -3.662807 -3.425386 -3.182789 -2.935190 -1.522145 -1.729038 -1.939530 -2.132578 -2.300549 -2.421752 -2.589119 -2.747512 -2.893764 -3.021765 -3.111753 -3.203487 -3.324590 -3.430411 -3.516016 -3.557454 -3.615427 -3.649346 -3.599253 -3.181782 -1.411396 -1.642655 -1.870831 -2.079087 -2.255728 -2.386675 -2.570263 -2.742189 -2.899148 -3.032061 -3.114035 -3.213354 -3.338919 -3.446469 -3.529837 -3.562318 -3.619217 -3.649751 -3.594673 -3.181782 -1.371673 -1.613633 -1.847562 -2.056716 -2.233195 -2.388048 -2.577344 -2.755543 -2.916144 -3.044693 -3.123457 -3.232376 -3.358503 -3.464696 -3.543188 -3.567787 -3.623535 -3.649864 -3.589625 -3.181782 -1.380348 -1.623728 -1.854585 -2.058592 -2.244739 -2.410411 -2.603179 -2.782235 -2.939345 -3.057203 -3.146089 -3.258855 -3.382123 -3.484051 -3.555642 -3.574631 -3.628525 -3.649630 -3.584065 -3.181782 -1.424870 -1.661284 -1.885866 -2.092705 -2.279768 -2.452691 -2.643608 -2.818558 -2.963740 -3.079809 -3.176458 -3.289478 -3.407871 -3.503893 -3.566448 -3.582755 -3.633207 -3.648941 -3.577936 -3.181782 -1.495173 -1.723093 -1.944704 -2.147887 -2.337373 -2.511004 -2.696497 -2.856945 -2.992939 -3.112755 -3.212974 -3.322495 -3.434510 -3.523494 -3.575467 -3.591866 -3.637786 -3.647693 -3.571194 -3.181782 -1.590858 -1.808808 -2.023133 -2.223998 -2.411476 -2.582415 -2.750895 -2.899725 -3.033856 -3.153281 -3.252855 -3.357135 -3.461448 -3.541668 -3.586140 -3.601581 -3.642070 -3.645781 -3.563937 -3.181782 -1.706338 -1.914490 -2.122172 -2.317684 -2.497995 -2.653507 -2.809459 -2.952592 -3.082250 -3.198528 -3.295326 -3.392560 -3.487867 -3.557498 -3.598275 -3.611828 -3.646157 -3.643083 -3.556374 -3.181782 -1.844127 -2.040340 -2.238185 -2.421554 -2.584136 -2.730397 -2.876595 -3.011308 -3.135116 -3.246989 -3.339494 -3.428429 -3.513206 -3.573512 -3.611351 -3.621276 -3.649340 -3.639417 -3.548378 -3.181782 -2.001611 -2.182394 -2.359637 -2.527002 -2.679911 -2.814456 -2.948965 -3.074655 -3.191702 -3.297328 -3.384159 -3.464097 -3.536851 -3.591158 -3.624829 -3.630169 -3.651353 -3.634662 -3.539750 -3.181782 -2.169714 -2.326404 -2.487968 -2.641768 -2.780424 -2.903070 -3.026838 -3.142791 -3.251257 -3.348778 -3.428444 -3.498153 -3.561780 -3.610019 -3.638412 -3.638380 -3.652154 -3.628644 -3.530394 -3.181782 -2.347161 -2.482869 -2.624897 -2.761259 -2.886261 -2.997598 -3.110313 -3.214968 -3.312658 -3.400826 -3.471089 -3.532175 -3.588166 -3.629689 -3.651186 -3.644996 -3.651398 -3.621078 -3.520197 -3.181782 -2.534897 -2.646845 -2.769081 -2.889231 -3.000440 -3.098492 -3.197655 -3.290014 -3.375810 -3.452772 -3.513833 -3.567103 -3.615194 -3.648869 -3.663284 -3.649651 -3.648685 -3.611691 -3.509033 -3.181782 -2.732731 -2.823129 -2.925808 -3.027555 -3.121339 -3.204308 -3.288694 -3.367483 -3.440326 -3.506768 -3.558187 -3.602222 -3.641752 -3.667395 -3.673738 -3.652220 -3.643724 -3.600487 -3.496718 -3.181782 -2.948038 -3.013015 -3.093632 -3.175299 -3.250557 -3.316426 -3.383834 -3.448394 -3.508689 -3.563156 -3.603698 -3.637102 -3.667490 -3.684297 -3.682152 -3.652306 -3.635926 -3.587696 -3.483026 -3.181782 -3.178199 -3.218749 -3.276605 -3.335990 -3.390812 -3.438054 -3.486768 -3.534541 -3.580524 -3.622306 -3.650812 -3.672134 -3.691946 -3.699347 -3.688176 -3.649462 -3.624443 -3.572749 -3.467633 -3.181782 -3.433872 -3.448553 -3.481037 -3.516067 -3.547660 -3.572697 -3.600916 -3.630057 -3.659540 -3.686337 -3.700945 -3.708199 -3.715995 -3.712888 -3.691614 -3.643788 -3.609163 -3.555226 -3.450104 -3.181782 -3.728239 -3.713917 -3.721664 -3.731124 -3.736797 -3.736080 -3.739896 -3.746147 -3.754896 -3.763287 -3.760643 -3.750626 -3.743103 -3.726300 -3.694691 -3.642391 -3.590916 -3.534520 -3.429759 -3.181782 -4.144513 -4.092297 -4.067130 -4.044387 -4.018247 -3.983533 -3.953102 -3.927939 -3.907342 -3.887274 -3.861597 -3.822648 -3.792547 -3.759073 -3.713682 -3.651423 -3.574130 -3.511858 -3.406563 -3.181782 -8.055264 -7.903459 -7.736310 -7.554644 -7.359212 -7.150799 -6.930118 -6.697793 -6.454455 -6.200665 -5.936908 -5.663671 -5.381393 -5.090451 -4.791226 -4.484056 -4.169244 -3.847087 -3.517852 -3.181782 -1.405169 -1.637618 -1.898028 -2.133838 -2.342643 -2.505072 -2.659711 -2.846216 -3.019462 -3.172780 -3.288427 -3.369090 -3.508850 -3.631593 -3.735373 -3.790987 -3.850079 -3.897987 -3.853280 -3.401281 -1.230091 -1.496149 -1.778278 -2.036658 -2.264931 -2.430845 -2.616565 -2.822931 -3.012438 -3.176616 -3.289454 -3.374034 -3.521582 -3.648366 -3.752094 -3.797791 -3.854877 -3.899417 -3.848660 -3.401281 -1.152452 -1.435338 -1.723611 -1.988394 -2.214353 -2.406382 -2.612797 -2.829190 -3.022532 -3.188926 -3.291296 -3.394188 -3.543457 -3.669264 -3.768808 -3.802739 -3.861192 -3.900647 -3.843484 -3.401281 -1.138862 -1.427782 -1.713127 -1.970930 -2.205345 -2.419969 -2.636390 -2.849765 -3.045241 -3.204268 -3.311841 -3.426225 -3.571225 -3.692657 -3.784888 -3.810424 -3.867861 -3.901558 -3.837692 -3.401281 -1.173314 -1.458665 -1.734223 -1.991747 -2.236448 -2.461108 -2.674830 -2.885657 -3.076545 -3.226657 -3.344846 -3.464141 -3.602165 -3.717200 -3.799279 -3.820657 -3.875019 -3.902008 -3.831214 -3.401281 -1.244312 -1.520519 -1.791664 -2.049476 -2.295821 -2.517762 -2.728696 -2.934695 -3.113715 -3.263319 -3.388497 -3.505032 -3.635244 -3.741822 -3.810827 -3.832784 -3.882711 -3.901825 -3.823970 -3.401281 -1.346840 -1.615996 -1.881864 -2.135874 -2.370732 -2.588929 -2.796755 -2.991744 -3.161829 -3.312318 -3.435929 -3.548276 -3.669240 -3.765437 -3.823044 -3.846423 -3.889790 -3.900873 -3.816070 -3.401281 -1.481074 -1.740742 -1.999005 -2.236033 -2.462507 -2.676806 -2.874498 -3.056099 -3.220593 -3.367478 -3.487051 -3.593428 -3.703782 -3.786792 -3.838104 -3.859986 -3.896525 -3.898996 -3.807597 -3.401281 -1.643039 -1.886509 -2.126213 -2.355021 -2.573692 -2.777590 -2.957886 -3.128609 -3.286335 -3.424533 -3.539809 -3.639254 -3.737834 -3.807055 -3.854889 -3.873452 -3.902115 -3.895986 -3.798449 -3.401281 -1.821486 -2.046510 -2.274445 -2.491909 -2.697985 -2.880630 -3.048840 -3.207833 -3.353363 -3.483443 -3.592948 -3.684629 -3.769697 -3.830253 -3.873022 -3.886559 -3.906535 -3.891657 -3.788759 -3.401281 -2.022170 -2.228177 -2.440689 -2.636357 -2.820686 -2.992147 -3.144081 -3.288057 -3.422765 -3.544399 -3.645626 -3.727682 -3.801274 -3.855227 -3.891097 -3.898282 -3.909338 -3.885789 -3.778461 -3.401281 -2.245546 -2.422425 -2.607468 -2.786031 -2.953060 -3.103705 -3.239698 -3.371351 -3.495222 -3.606758 -3.696871 -3.768753 -3.834215 -3.880647 -3.908964 -3.908191 -3.910181 -3.878098 -3.767195 -3.401281 -2.473489 -2.624762 -2.785576 -2.940528 -3.085485 -3.218430 -3.340060 -3.458377 -3.569363 -3.668898 -3.747591 -3.810596 -3.867333 -3.905306 -3.925355 -3.916123 -3.908675 -3.868196 -3.754802 -3.401281 -2.717036 -2.835174 -2.967935 -3.100123 -3.226295 -3.341731 -3.445798 -3.547808 -3.644587 -3.731864 -3.799991 -3.852743 -3.899479 -3.927758 -3.939278 -3.921412 -3.904372 -3.856009 -3.741058 -3.401281 -2.970730 -3.059020 -3.165454 -3.273047 -3.376248 -3.471253 -3.556517 -3.641187 -3.722831 -3.796819 -3.853501 -3.894348 -3.929593 -3.947227 -3.949864 -3.923526 -3.896599 -3.841493 -3.725669 -3.401281 -3.247551 -3.302244 -3.378683 -3.458874 -3.537413 -3.610323 -3.675097 -3.740721 -3.804845 -3.863258 -3.906695 -3.934784 -3.957548 -3.963356 -3.956283 -3.921572 -3.884728 -3.824752 -3.708244 -3.401281 -3.551703 -3.572971 -3.616964 -3.666272 -3.717051 -3.763503 -3.804122 -3.847881 -3.891902 -3.932736 -3.960663 -3.974301 -3.983290 -3.975941 -3.957861 -3.914460 -3.867668 -3.804492 -3.688192 -3.401281 -3.903866 -3.887494 -3.895952 -3.910465 -3.928277 -3.944200 -3.955824 -3.973200 -3.992935 -4.012015 -4.020432 -4.016471 -4.008940 -3.986054 -3.954264 -3.904007 -3.844531 -3.779324 -3.664681 -3.401281 -4.385197 -4.319642 -4.285341 -4.259250 -4.237704 -4.211739 -4.181342 -4.160202 -4.144104 -4.129859 -4.110078 -4.078042 -4.047948 -4.009048 -3.960474 -3.898587 -3.815531 -3.748913 -3.637033 -3.401281 -9.610223 -9.426191 -9.220298 -8.993936 -8.748446 -8.485076 -8.204950 -7.909122 -7.598527 -7.274015 -6.936351 -6.586218 -6.224251 -5.851023 -5.467052 -5.072810 -4.668729 -4.255207 -3.832610 -3.401281 -1.282743 -1.566430 -1.855411 -2.134875 -2.386706 -2.588984 -2.734697 -2.943460 -3.135145 -3.311219 -3.451714 -3.519210 -3.676116 -3.813807 -3.934221 -4.003574 -4.061485 -4.122445 -4.084278 -3.599054 -1.041749 -1.354643 -1.683548 -1.997545 -2.277277 -2.483773 -2.664361 -2.897361 -3.113314 -3.308525 -3.450024 -3.517484 -3.685790 -3.830618 -3.953695 -4.012836 -4.067584 -4.125030 -4.079773 -3.599054 -0.9173808 -1.260314 -1.606080 -1.929240 -2.205568 -2.430200 -2.647166 -2.891143 -3.118559 -3.318689 -3.445645 -3.539747 -3.708986 -3.853761 -3.974145 -4.018405 -4.075238 -4.127541 -4.074619 -3.599054 -0.8858221 -1.238467 -1.585211 -1.896001 -2.174659 -2.427090 -2.661448 -2.911077 -3.142896 -3.333436 -3.462343 -3.578649 -3.740096 -3.881227 -3.994524 -4.026715 -4.084441 -4.129793 -4.068743 -3.599054 -0.9168807 -1.266745 -1.595614 -1.901409 -2.191496 -2.456039 -2.702250 -2.951534 -3.174007 -3.353371 -3.499230 -3.623349 -3.776959 -3.910554 -4.013429 -4.039265 -4.095093 -4.131564 -4.062054 -3.599054 -0.9910817 -1.324718 -1.644812 -1.949066 -2.239957 -2.513199 -2.762730 -3.003272 -3.213421 -3.396377 -3.549768 -3.673739 -3.816667 -3.940722 -4.029153 -4.054826 -4.105703 -4.132682 -4.054454 -3.599054 -1.097527 -1.420559 -1.730940 -2.030054 -2.320478 -2.592153 -2.834764 -3.063187 -3.269764 -3.456969 -3.605738 -3.728403 -3.858959 -3.970715 -4.043907 -4.072501 -4.115969 -4.132977 -4.045992 -3.599054 -1.241313 -1.551106 -1.850899 -2.142233 -2.425605 -2.684778 -2.916015 -3.138856 -3.344644 -3.520494 -3.667842 -3.784181 -3.902631 -3.998839 -4.062856 -4.090730 -4.125734 -4.132263 -4.036920 -3.599054 -1.418320 -1.712728 -2.000440 -2.280746 -2.542180 -2.789602 -3.015959 -3.233410 -3.422863 -3.589990 -3.729712 -3.839741 -3.945281 -4.025207 -4.085014 -4.109502 -4.134477 -4.130260 -4.027137 -3.599054 -1.624517 -1.901706 -2.170500 -2.425970 -2.675994 -2.915776 -3.134234 -3.328572 -3.506254 -3.661018 -3.791277 -3.893888 -3.984915 -4.054313 -4.108572 -4.127486 -4.141850 -4.126749 -4.016511 -3.599054 -1.855344 -2.104322 -2.353078 -2.595198 -2.833206 -3.054578 -3.246468 -3.428707 -3.589829 -3.732124 -3.852680 -3.945579 -4.022538 -4.085045 -4.132665 -4.143973 -4.147585 -4.121465 -4.004856 -3.599054 -2.103240 -2.329484 -2.560390 -2.784050 -2.992859 -3.189733 -3.364730 -3.525948 -3.672305 -3.803931 -3.913306 -3.994911 -4.062059 -4.115809 -4.155667 -4.158692 -4.151312 -4.114057 -3.992628 -3.599054 -2.380378 -2.575943 -2.773333 -2.967553 -3.155872 -3.326965 -3.479008 -3.623230 -3.756603 -3.875404 -3.972820 -4.045683 -4.102544 -4.145857 -4.176431 -4.170906 -4.152458 -4.103973 -3.979096 -3.599054 -2.665316 -2.825869 -2.993058 -3.157070 -3.315046 -3.463687 -3.597644 -3.724753 -3.842094 -3.946676 -4.033425 -4.096339 -4.142375 -4.173403 -4.194119 -4.179794 -4.150321 -4.091108 -3.963997 -3.599054 -2.966748 -3.085371 -3.217457 -3.351878 -3.484679 -3.609709 -3.722028 -3.829866 -3.930233 -4.019755 -4.093697 -4.145172 -4.179473 -4.197685 -4.207728 -4.184328 -4.143945 -4.075580 -3.947001 -3.599054 -3.287427 -3.366690 -3.462673 -3.563577 -3.666615 -3.764999 -3.854074 -3.940681 -4.021438 -4.094064 -4.152765 -4.190650 -4.212373 -4.217727 -4.216168 -4.183189 -4.132381 -4.056712 -3.927624 -3.599054 -3.640312 -3.677425 -3.733643 -3.797934 -3.868006 -3.936015 -3.997390 -4.058572 -4.116586 -4.169264 -4.210571 -4.232689 -4.240016 -4.232471 -4.218082 -4.174979 -4.114976 -4.034197 -3.905154 -3.599054 -4.049709 -4.039664 -4.050673 -4.071826 -4.102282 -4.133470 -4.160748 -4.191644 -4.222667 -4.250880 -4.270821 -4.273213 -4.262874 -4.240778 -4.212397 -4.159278 -4.090085 -4.005897 -3.878536 -3.599054 -4.593846 -4.527565 -4.485418 -4.455323 -4.435429 -4.416409 -4.394949 -4.381339 -4.373030 -4.365438 -4.352423 -4.327028 -4.293139 -4.250589 -4.200893 -4.140662 -4.055415 -3.970452 -3.846415 -3.599054 -11.22807 -11.01120 -10.76490 -10.49135 -10.19262 -9.870596 -9.526965 -9.163231 -8.780727 -8.380641 -7.964028 -7.531832 -7.084896 -6.623978 -6.149762 -5.662865 -5.163854 -4.653240 -4.131495 -3.599054 -1.157456 -1.511037 -1.820550 -2.136101 -2.422022 -2.664440 -2.810917 -3.041060 -3.248821 -3.440945 -3.601856 -3.657968 -3.829664 -3.981307 -4.116075 -4.198655 -4.254244 -4.327333 -4.296549 -3.779018 -0.8438636 -1.227402 -1.590091 -1.946689 -2.274755 -2.539164 -2.717454 -2.974674 -3.210805 -3.427921 -3.598789 -3.648535 -3.835537 -3.997868 -4.138386 -4.210823 -4.260733 -4.331248 -4.292357 -3.779018 -0.6803048 -1.095219 -1.480516 -1.854343 -2.195766 -2.463592 -2.690998 -2.958865 -3.206763 -3.435754 -3.595136 -3.671556 -3.860291 -4.023584 -4.162834 -4.218132 -4.270463 -4.335304 -4.287416 -3.779018 -0.6295333 -1.048943 -1.443761 -1.822347 -2.156135 -2.443932 -2.700344 -2.971373 -3.226443 -3.454248 -3.604616 -3.715285 -3.895925 -4.055550 -4.188038 -4.226723 -4.282971 -4.339221 -4.281641 -3.779018 -0.6495282 -1.064863 -1.459957 -1.826081 -2.158600 -2.463224 -2.734626 -3.008001 -3.263679 -3.476896 -3.641848 -3.768923 -3.938309 -4.090901 -4.212020 -4.241735 -4.296409 -4.342749 -4.274921 -3.779018 -0.7261590 -1.131710 -1.513233 -1.863534 -2.199312 -2.510234 -2.789265 -3.065146 -3.313444 -3.518781 -3.697273 -3.831397 -3.986228 -4.128251 -4.232904 -4.261447 -4.310820 -4.345624 -4.267140 -3.779018 -0.8470861 -1.234460 -1.593920 -1.939358 -2.271208 -2.581896 -2.866991 -3.137089 -3.368397 -3.581418 -3.765090 -3.896388 -4.038105 -4.165721 -4.251518 -4.283496 -4.325071 -4.347692 -4.258278 -3.779018 -1.001631 -1.366589 -1.713427 -2.046103 -2.371772 -2.681957 -2.963099 -3.214477 -3.446065 -3.658726 -3.836464 -3.963330 -4.090046 -4.201876 -4.275265 -4.307742 -4.339029 -4.348705 -4.248748 -3.779018 -1.190381 -1.535335 -1.864143 -2.185882 -2.502193 -2.804201 -3.064817 -3.313090 -3.541376 -3.743560 -3.909492 -4.028534 -4.140134 -4.234962 -4.303226 -4.332238 -4.352219 -4.348296 -4.238471 -3.779018 -1.413934 -1.736328 -2.048445 -2.355479 -2.653985 -2.930813 -3.188615 -3.430537 -3.644687 -3.827922 -3.983697 -4.091773 -4.187774 -4.270296 -4.333101 -4.355930 -4.364028 -4.346266 -4.227300 -3.779018 -1.669519 -1.968216 -2.261767 -2.540370 -2.816863 -3.084887 -3.332708 -3.552050 -3.744287 -3.913930 -4.054730 -4.153565 -4.234137 -4.308210 -4.363507 -4.378230 -4.374012 -4.342255 -4.215059 -3.779018 -1.953233 -2.219774 -2.483763 -2.745717 -3.007034 -3.257095 -3.472883 -3.670677 -3.843655 -3.994838 -4.123851 -4.213341 -4.282923 -4.346968 -4.392820 -4.398156 -4.381631 -4.335850 -4.201458 -3.779018 -2.254222 -2.494180 -2.735612 -2.974180 -3.200321 -3.417068 -3.612732 -3.784892 -3.937919 -4.075009 -4.192042 -4.272964 -4.332567 -4.384628 -4.419807 -4.414832 -4.386080 -4.326272 -4.186899 -3.779018 -2.590820 -2.790317 -2.992343 -3.194770 -3.392145 -3.576835 -3.743978 -3.896201 -4.033403 -4.156090 -4.260634 -4.331038 -4.380232 -4.419456 -4.443313 -4.427526 -4.386371 -4.313361 -4.170621 -3.779018 -2.935157 -3.092553 -3.256119 -3.418736 -3.580447 -3.736460 -3.880889 -4.012486 -4.131244 -4.238122 -4.328727 -4.386813 -4.423577 -4.449913 -4.461918 -4.434944 -4.381366 -4.297306 -4.152170 -3.779018 -3.301552 -3.409148 -3.530349 -3.656541 -3.784062 -3.908316 -4.025637 -4.133746 -4.231734 -4.320308 -4.394902 -4.439066 -4.461267 -4.474345 -4.473995 -4.435680 -4.369836 -4.276939 -4.130971 -3.779018 -3.704067 -3.760092 -3.833770 -3.916996 -4.006040 -4.096009 -4.181909 -4.261699 -4.335267 -4.402006 -4.457375 -4.485773 -4.491971 -4.490707 -4.477355 -4.427795 -4.351299 -4.252675 -4.106162 -3.779018 -4.165832 -4.167856 -4.186429 -4.218012 -4.261232 -4.310009 -4.357970 -4.402783 -4.445929 -4.486478 -4.518209 -4.526879 -4.514532 -4.496794 -4.469875 -4.409141 -4.324183 -4.221927 -4.076249 -3.779018 -4.773833 -4.710357 -4.661377 -4.630164 -4.613686 -4.605699 -4.600348 -4.595867 -4.594703 -4.597211 -4.594787 -4.571488 -4.535187 -4.494094 -4.449794 -4.382704 -4.285229 -4.182791 -4.038708 -3.779018 -12.90406 -12.65376 -12.36566 -12.04228 -11.68733 -11.30325 -10.89236 -10.45672 -9.998104 -9.518086 -9.018037 -8.499171 -7.962564 -7.409168 -6.839845 -6.255364 -5.656433 -5.043684 -4.417699 -3.779018 -1.039754 -1.458980 -1.799430 -2.147866 -2.461102 -2.733267 -2.889797 -3.135535 -3.360137 -3.565651 -3.742573 -3.796098 -3.973293 -4.135839 -4.283378 -4.378769 -4.429679 -4.515409 -4.493047 -3.944117 -0.6499451 -1.104413 -1.509054 -1.904192 -2.268124 -2.576824 -2.769433 -3.052668 -3.306325 -3.543539 -3.736128 -3.776631 -3.975313 -4.152013 -4.308496 -4.394262 -4.436826 -4.520767 -4.489373 -3.944117 -0.4437348 -0.9306065 -1.363903 -1.780640 -2.164997 -2.482196 -2.743136 -3.030137 -3.296989 -3.547143 -3.732515 -3.801647 -4.000813 -4.180820 -4.337234 -4.404310 -4.448561 -4.526532 -4.484861 -3.944117 -0.3710050 -0.8632750 -1.307752 -1.731111 -2.118825 -2.464870 -2.752295 -3.039217 -3.314768 -3.564811 -3.738856 -3.849104 -4.041148 -4.217438 -4.367435 -4.413150 -4.463946 -4.532320 -4.479397 -3.944117 -0.3831473 -0.8694878 -1.312945 -1.733323 -2.130601 -2.482566 -2.779583 -3.074920 -3.349279 -3.591590 -3.779962 -3.908756 -4.091832 -4.259137 -4.397103 -4.430844 -4.481238 -4.537912 -4.472853 -3.944117 -0.4604850 -0.9300357 -1.365506 -1.784174 -2.173023 -2.517254 -2.831328 -3.125583 -3.399884 -3.639720 -3.837601 -3.978851 -4.148963 -4.304557 -4.424294 -4.454747 -4.499478 -4.542949 -4.465085 -3.944117 -0.5863252 -1.037554 -1.461919 -1.861798 -2.233571 -2.585293 -2.900592 -3.196662 -3.465087 -3.705086 -3.908243 -4.054481 -4.208600 -4.350469 -4.447970 -4.482392 -4.518417 -4.547189 -4.456018 -3.944117 -0.7571808 -1.187004 -1.585008 -1.963402 -2.331424 -2.675762 -2.994524 -3.286137 -3.549350 -3.784665 -3.989379 -4.130151 -4.270000 -4.395059 -4.476935 -4.512390 -4.537343 -4.550310 -4.446193 -3.944117 -0.9649053 -1.362042 -1.736722 -2.102148 -2.455867 -2.797401 -3.110779 -3.393007 -3.645916 -3.879520 -4.077165 -4.206319 -4.330190 -4.436027 -4.510684 -4.542833 -4.555204 -4.551912 -4.435598 -3.944117 -1.201887 -1.572321 -1.924326 -2.271946 -2.616309 -2.946047 -3.242690 -3.511762 -3.760791 -3.984361 -4.161878 -4.283120 -4.388441 -4.479186 -4.547081 -4.572551 -4.571362 -4.551692 -4.424065 -3.944117 -1.476299 -1.816808 -2.148084 -2.477691 -2.802969 -3.105747 -3.391080 -3.652241 -3.886126 -4.081918 -4.247488 -4.355205 -4.444375 -4.525408 -4.584276 -4.600661 -4.585500 -4.549194 -4.411384 -3.944117 -1.784102 -2.096160 -2.405040 -2.702125 -2.998488 -3.290096 -3.562706 -3.797243 -4.001904 -4.180287 -4.326753 -4.423136 -4.502053 -4.572182 -4.620537 -4.626271 -4.596979 -4.543831 -4.397287 -3.944117 -2.121738 -2.398298 -2.672508 -2.948426 -3.225910 -3.490433 -3.725769 -3.934994 -4.114506 -4.271151 -4.403800 -4.491263 -4.559392 -4.617517 -4.654050 -4.648612 -4.604812 -4.534873 -4.381394 -3.944117 -2.485969 -2.728772 -2.974848 -3.213463 -3.449188 -3.678446 -3.883298 -4.061522 -4.219569 -4.360855 -4.481224 -4.558797 -4.614293 -4.659633 -4.683362 -4.666412 -4.607989 -4.521987 -4.364173 -3.944117 -2.882350 -3.074308 -3.274432 -3.473077 -3.668738 -3.857575 -4.032220 -4.187740 -4.327605 -4.451765 -4.556834 -4.623539 -4.664772 -4.696669 -4.707107 -4.678045 -4.604965 -4.505586 -4.344504 -3.944117 -3.297106 -3.434161 -3.581699 -3.734125 -3.889804 -4.044970 -4.190568 -4.319988 -4.437344 -4.542392 -4.629835 -4.683130 -4.709030 -4.726178 -4.723299 -4.681495 -4.594510 -4.484548 -4.321711 -3.944117 -3.747693 -3.824327 -3.918282 -4.021359 -4.132304 -4.248031 -4.359426 -4.458385 -4.548883 -4.631667 -4.698433 -4.734758 -4.744663 -4.745250 -4.729168 -4.674347 -4.576065 -4.457193 -4.294790 -3.944117 -4.260639 -4.273248 -4.305388 -4.351277 -4.410568 -4.477978 -4.546758 -4.607953 -4.665009 -4.719239 -4.761803 -4.777158 -4.768618 -4.750527 -4.721304 -4.654265 -4.547206 -4.422222 -4.262021 -3.944117 -4.930159 -4.868193 -4.821714 -4.792512 -4.782748 -4.786647 -4.795709 -4.803215 -4.812575 -4.825127 -4.832729 -4.816806 -4.780996 -4.740171 -4.696163 -4.619232 -4.506931 -4.376704 -4.220077 -3.944117 -14.63411 -14.34977 -14.01782 -13.64280 -13.22884 -12.77951 -12.29790 -11.78668 -11.24814 -10.68424 -10.09669 -9.487007 -8.856495 -8.206324 -7.537535 -6.851061 -6.147749 -5.428365 -4.693607 -3.944117 -0.9222234 -1.412854 -1.782164 -2.169200 -2.511349 -2.804953 -2.991796 -3.222431 -3.463798 -3.685263 -3.874635 -3.944625 -4.107359 -4.280161 -4.438262 -4.545274 -4.591188 -4.689663 -4.676020 -4.096621 -0.4615497 -0.9914160 -1.440937 -1.880595 -2.273076 -2.614048 -2.829788 -3.119823 -3.398356 -3.653296 -3.865412 -3.910143 -4.106266 -4.295419 -4.466269 -4.564620 -4.599035 -4.696671 -4.673078 -4.096621 -0.2188420 -0.7749774 -1.267907 -1.724244 -2.141333 -2.494899 -2.788436 -3.097992 -3.387690 -3.654855 -3.861439 -3.933057 -4.134294 -4.326609 -4.499044 -4.577459 -4.613452 -4.704482 -4.669200 -4.096621 -0.1210182 -0.6826009 -1.183980 -1.650221 -2.078003 -2.463766 -2.799215 -3.112784 -3.402958 -3.674705 -3.862663 -3.985738 -4.180125 -4.368701 -4.534491 -4.586866 -4.631805 -4.712573 -4.664265 -4.096621 -0.1222062 -0.6755399 -1.173197 -1.640259 -2.079300 -2.484816 -2.834125 -3.143477 -3.439748 -3.701900 -3.905909 -4.052326 -4.237070 -4.418188 -4.570734 -4.607730 -4.652855 -4.720737 -4.658110 -4.096621 -0.1975234 -0.7315703 -1.220978 -1.685448 -2.129401 -2.532935 -2.878821 -3.193614 -3.489341 -3.748983 -3.970615 -4.126176 -4.301916 -4.470665 -4.604795 -4.636206 -4.675670 -4.728539 -4.650571 -4.096621 -0.3292136 -0.8405856 -1.315631 -1.774020 -2.206102 -2.594043 -2.943993 -3.262720 -3.553950 -3.821808 -4.044538 -4.205657 -4.372517 -4.525190 -4.633865 -4.669641 -4.699401 -4.735574 -4.641503 -4.096621 -0.5087032 -0.9943619 -1.452757 -1.891576 -2.297256 -2.681176 -3.032579 -3.348277 -3.643918 -3.910238 -4.129000 -4.291157 -4.442934 -4.578839 -4.667975 -4.705220 -4.722930 -4.741454 -4.631580 -4.096621 -0.7317231 -1.188994 -1.617340 -2.024323 -2.422373 -2.796664 -3.143474 -3.461367 -3.751945 -4.005422 -4.224262 -4.380103 -4.514565 -4.628706 -4.708375 -4.741514 -4.745653 -4.745785 -4.620891 -4.096621 -0.9929825 -1.409650 -1.807073 -2.198193 -2.576788 -2.943897 -3.285984 -3.593101 -3.866036 -4.116455 -4.326333 -4.466258 -4.583486 -4.679787 -4.752347 -4.777680 -4.766564 -4.748137 -4.609238 -4.096621 -1.282913 -1.664460 -2.037015 -2.404795 -2.769994 -3.124713 -3.445289 -3.734128 -4.001527 -4.238503 -4.422091 -4.550161 -4.648638 -4.734177 -4.797178 -4.812476 -4.785599 -4.747920 -4.596378 -4.096621 -1.611856 -1.959414 -2.306858 -2.651475 -2.991931 -3.315818 -3.622023 -3.900382 -4.145521 -4.349928 -4.517920 -4.627804 -4.714754 -4.789200 -4.840119 -4.844821 -4.801625 -4.744515 -4.582014 -4.096621 -1.977662 -2.293326 -2.607757 -2.915850 -3.228125 -3.535898 -3.824566 -4.064665 -4.278288 -4.458579 -4.605363 -4.704947 -4.779956 -4.842602 -4.879922 -4.873001 -4.813688 -4.737186 -4.565787 -4.096621 -2.375438 -2.648286 -2.928018 -3.210291 -3.496317 -3.761113 -4.005816 -4.218131 -4.400548 -4.558418 -4.691217 -4.781325 -4.842270 -4.892304 -4.915674 -4.895816 -4.820422 -4.725400 -4.547380 -4.096621 -2.811949 -3.042177 -3.274049 -3.508024 -3.746501 -3.971974 -4.177437 -4.356171 -4.517208 -4.658623 -4.776491 -4.854259 -4.900802 -4.936115 -4.945525 -4.911630 -4.820150 -4.709701 -4.526796 -4.096621 -3.272724 -3.441566 -3.622089 -3.803175 -3.989109 -4.173542 -4.346859 -4.499380 -4.636050 -4.757614 -4.858238 -4.921317 -4.953023 -4.971176 -4.966581 -4.918846 -4.811212 -4.688790 -4.502719 -4.096621 -3.770946 -3.870367 -3.990055 -4.116643 -4.252555 -4.393088 -4.527612 -4.647742 -4.756289 -4.853846 -4.933132 -4.979068 -4.994767 -4.994393 -4.975450 -4.913975 -4.792747 -4.660235 -4.473988 -4.096621 -4.338266 -4.361984 -4.410137 -4.472905 -4.551091 -4.639601 -4.726409 -4.805558 -4.878756 -4.946205 -4.998867 -5.023962 -5.021093 -5.001485 -4.967764 -4.893692 -4.760812 -4.621924 -4.438628 -4.096621 -5.065813 -5.004747 -4.963345 -4.941821 -4.941919 -4.958759 -4.980634 -5.001703 -5.024536 -5.049164 -5.064728 -5.058302 -5.028947 -4.986747 -4.936234 -4.854152 -4.715809 -4.569018 -4.392646 -4.096621 -16.41466 -16.09571 -15.71861 -15.28952 -14.81385 -14.29631 -13.74079 -13.15063 -12.52864 -11.87725 -11.19851 -10.49423 -9.765972 -9.015121 -8.242917 -7.450458 -6.638739 -5.808659 -4.961035 -4.096621 -0.8004333 -1.357581 -1.772251 -2.190963 -2.558985 -2.880252 -3.094790 -3.308377 -3.561475 -3.796027 -3.999742 -4.086925 -4.233689 -4.415595 -4.582495 -4.699859 -4.741592 -4.851455 -4.847126 -4.238315 -0.2717302 -0.8814505 -1.374103 -1.856722 -2.289304 -2.661718 -2.892904 -3.182912 -3.480135 -3.757219 -3.986776 -4.040557 -4.228467 -4.430210 -4.612884 -4.722823 -4.750553 -4.860244 -4.845118 -4.238315 3.8657475E-03 -0.6277936 -1.177233 -1.683696 -2.140291 -2.516969 -2.831110 -3.152925 -3.469768 -3.759272 -3.984033 -4.060852 -4.260321 -4.464340 -4.650321 -4.739075 -4.767715 -4.870302 -4.842093 -4.238315 0.1279576 -0.5120910 -1.075700 -1.594398 -2.050622 -2.465258 -2.830676 -3.172267 -3.492777 -3.779218 -3.984968 -4.117043 -4.314098 -4.511721 -4.691848 -4.749009 -4.790120 -4.881052 -4.837907 -4.238315 0.1338956 -0.4889961 -1.048996 -1.558895 -2.034171 -2.475017 -2.867007 -3.215029 -3.529849 -3.811849 -4.025948 -4.189279 -4.377484 -4.567344 -4.734567 -4.772245 -4.816086 -4.892121 -4.832366 -4.238315 6.1117157E-02 -0.5385394 -1.081912 -1.591942 -2.075950 -2.526664 -2.926632 -3.267306 -3.581538 -3.857987 -4.091990 -4.271663 -4.448301 -4.628644 -4.775096 -4.804913 -4.844419 -4.903010 -4.825272 -4.238315 -7.5456701E-02 -0.6462101 -1.174407 -1.676978 -2.158821 -2.605491 -2.992872 -3.332057 -3.647913 -3.930986 -4.174454 -4.354635 -4.525974 -4.691683 -4.810472 -4.843534 -4.873630 -4.913280 -4.816420 -4.238315 -0.2638132 -0.8052537 -1.311807 -1.801417 -2.269757 -2.693730 -3.073059 -3.419241 -3.733575 -4.024242 -4.265476 -4.444324 -4.608562 -4.754624 -4.851195 -4.886271 -4.902581 -4.922478 -4.806597 -4.238315 -0.4993388 -1.007351 -1.488921 -1.955140 -2.393521 -2.804138 -3.183606 -3.525163 -3.845248 -4.131124 -4.361604 -4.541493 -4.689927 -4.814507 -4.899195 -4.929957 -4.930845 -4.930146 -4.796042 -4.238315 -0.7774808 -1.248078 -1.696742 -2.127810 -2.548571 -2.947442 -3.319311 -3.662309 -3.973771 -4.241961 -4.470479 -4.640635 -4.770486 -4.874093 -4.950434 -4.973035 -4.957259 -4.935712 -4.784513 -4.238315 -1.091626 -1.515074 -1.931657 -2.340041 -2.738220 -3.127007 -3.490871 -3.817382 -4.108319 -4.371454 -4.587182 -4.734399 -4.846607 -4.937022 -5.002120 -5.013929 -4.981417 -4.938499 -4.771725 -4.238315 -1.436483 -1.823293 -2.208961 -2.590428 -2.971669 -3.344326 -3.677879 -3.985934 -4.267909 -4.508654 -4.695682 -4.825413 -4.920766 -5.000628 -5.052425 -5.052016 -5.002436 -4.937880 -4.757334 -4.238315 -1.826656 -2.175863 -2.529676 -2.885087 -3.230333 -3.568677 -3.889996 -4.181764 -4.426741 -4.635472 -4.799741 -4.912238 -4.994253 -5.061897 -5.100061 -5.086241 -5.019069 -4.933030 -4.740947 -4.238315 -2.257843 -2.565451 -2.877553 -3.191462 -3.513508 -3.831219 -4.113375 -4.358975 -4.572537 -4.750960 -4.895577 -4.996679 -5.066018 -5.118968 -5.142918 -5.115772 -5.029953 -4.923250 -4.721979 -4.238315 -2.723623 -2.983876 -3.259643 -3.534225 -3.807069 -4.073989 -4.314610 -4.520537 -4.701420 -4.859458 -4.988845 -5.076519 -5.133653 -5.170310 -5.178907 -5.137820 -5.033334 -4.909132 -4.700438 -4.238315 -3.232794 -3.431310 -3.648336 -3.864292 -4.084751 -4.299120 -4.496801 -4.673506 -4.830456 -4.967329 -5.077679 -5.150098 -5.192830 -5.213682 -5.205336 -5.149085 -5.027297 -4.889226 -4.675285 -4.238315 -3.780426 -3.901326 -4.046309 -4.202605 -4.366730 -4.533593 -4.690159 -4.831995 -4.959511 -5.071540 -5.159449 -5.214233 -5.239034 -5.244838 -5.219021 -5.145731 -5.010550 -4.860922 -4.644942 -4.238315 -4.400882 -4.436996 -4.502287 -4.584766 -4.684939 -4.794565 -4.901397 -4.998550 -5.089065 -5.169958 -5.229969 -5.262912 -5.266820 -5.257197 -5.214162 -5.124682 -4.978429 -4.820624 -4.607185 -4.238315 -5.184760 -5.126131 -5.091213 -5.080181 -5.095580 -5.125809 -5.162129 -5.196681 -5.234501 -5.270463 -5.292502 -5.293907 -5.270737 -5.241016 -5.180472 -5.081172 -4.928534 -4.762077 -4.557329 -4.238315 -18.24260 -17.88844 -17.46471 -16.97941 -16.43957 -15.85101 -15.21859 -14.54636 -13.83771 -13.09550 -12.32216 -11.51982 -10.69029 -9.835195 -8.955964 -8.053876 -7.130076 -6.185604 -5.221395 -4.238315 -0.7343011 -1.251711 -1.748134 -2.205403 -2.609215 -2.950757 -3.195038 -3.395282 -3.656918 -3.900738 -4.116639 -4.222489 -4.353535 -4.542456 -4.716777 -4.845254 -4.882091 -5.002075 -5.007802 -4.370631 -7.1569383E-02 -0.7520883 -1.301801 -1.834465 -2.301202 -2.707662 -2.966426 -3.249158 -3.558208 -3.851793 -4.101686 -4.166225 -4.344400 -4.556077 -4.749243 -4.872652 -4.892085 -5.012691 -5.006958 -4.370631 0.2313657 -0.4761267 -1.090137 -1.641530 -2.137984 -2.558030 -2.882737 -3.210750 -3.542305 -3.855169 -4.102033 -4.184908 -4.380988 -4.594380 -4.790665 -4.892838 -4.912215 -5.025165 -5.005036 -4.370631 0.3719922 -0.3449451 -0.9702002 -1.537949 -2.046871 -2.481478 -2.865478 -3.224255 -3.569889 -3.883372 -4.102704 -4.243959 -4.441156 -4.646755 -4.838068 -4.904300 -4.939356 -5.038810 -5.001841 -4.370631 0.3914682 -0.3088731 -0.9291040 -1.499353 -2.006296 -2.471272 -2.890898 -3.270597 -3.619344 -3.918184 -4.145527 -4.320543 -4.513321 -4.708070 -4.887659 -4.929898 -4.971076 -5.053020 -4.997151 -4.370631 0.3167610 -0.3503013 -0.9570742 -1.511189 -2.029402 -2.513773 -2.950723 -3.339313 -3.676738 -3.967112 -4.212543 -4.406911 -4.591967 -4.776208 -4.935127 -4.967426 -5.005017 -5.067270 -4.990743 -4.370631 0.1752341 -0.4574100 -1.038519 -1.586276 -2.106718 -2.593953 -3.036327 -3.410637 -3.741265 -4.041685 -4.297169 -4.498999 -4.675737 -4.849233 -4.978370 -5.012569 -5.040092 -5.081084 -4.982343 -4.370631 -2.2305841E-02 -0.6173107 -1.176444 -1.708978 -2.223500 -2.703204 -3.123408 -3.489594 -3.831019 -4.133041 -4.393642 -4.593042 -4.764792 -4.921567 -5.026879 -5.062136 -5.075070 -5.093941 -4.972794 -4.370631 -0.2695560 -0.8279324 -1.356385 -1.872425 -2.367580 -2.818410 -3.224214 -3.599531 -3.936234 -4.244239 -4.498044 -4.693690 -4.858479 -4.990782 -5.082482 -5.112502 -5.109147 -5.105222 -4.962575 -4.370631 -0.5621757 -1.079279 -1.577992 -2.068128 -2.523614 -2.957819 -3.360345 -3.729069 -4.068936 -4.368463 -4.609541 -4.801433 -4.949123 -5.061384 -5.141083 -5.161844 -5.141895 -5.114399 -4.951362 -4.370631 -0.8934062 -1.368658 -1.829795 -2.279083 -2.717283 -3.133248 -3.527700 -3.892707 -4.217793 -4.499956 -4.736014 -4.909992 -5.037452 -5.133432 -5.200612 -5.209585 -5.171864 -5.120641 -4.938819 -4.370631 -1.262047 -1.691102 -2.114377 -2.534167 -2.947995 -3.352973 -3.734753 -4.071400 -4.378869 -4.651704 -4.863811 -5.013883 -5.122493 -5.204508 -5.258705 -5.254727 -5.197986 -5.123271 -4.924586 -4.370631 -1.673169 -2.058980 -2.445850 -2.836289 -3.228565 -3.602366 -3.951121 -4.274556 -4.564837 -4.799761 -4.983371 -5.111436 -5.205530 -5.273944 -5.313539 -5.295755 -5.219409 -5.121296 -4.908221 -4.370631 -2.130999 -2.472410 -2.825957 -3.172804 -3.526252 -3.875856 -4.205081 -4.489437 -4.732213 -4.935186 -5.091221 -5.202387 -5.286012 -5.340002 -5.363712 -5.330468 -5.234906 -5.113816 -4.889169 -4.370631 -2.631793 -2.919530 -3.224970 -3.540446 -3.863835 -4.163557 -4.439251 -4.678523 -4.883121 -5.054255 -5.193080 -5.290213 -5.359574 -5.400311 -5.406967 -5.356670 -5.243052 -5.101387 -4.866733 -4.370631 -3.186181 -3.411048 -3.656919 -3.913506 -4.173523 -4.421384 -4.645174 -4.844223 -5.021594 -5.171803 -5.290688 -5.372275 -5.424138 -5.451136 -5.440196 -5.372235 -5.241149 -5.082400 -4.840662 -4.370631 -3.778974 -3.923525 -4.094437 -4.280241 -4.475585 -4.669826 -4.851400 -5.013680 -5.160203 -5.284706 -5.380593 -5.443914 -5.477051 -5.487107 -5.458786 -5.373662 -5.227251 -5.054053 -4.808891 -4.370631 -4.450601 -4.498917 -4.584002 -4.689580 -4.813450 -4.946389 -5.073359 -5.190028 -5.298019 -5.389656 -5.457227 -5.497876 -5.509919 -5.501339 -5.455640 -5.355616 -5.195705 -5.011915 -4.768925 -4.370631 -5.288317 -5.231695 -5.208552 -5.211197 -5.240766 -5.288870 -5.338475 -5.389659 -5.442441 -5.489515 -5.518116 -5.527277 -5.513391 -5.482654 -5.418399 -5.308845 -5.139119 -4.949192 -4.715486 -4.370631 -20.11515 -19.72523 -19.25337 -18.70988 -18.10345 -17.44128 -16.72918 -15.97198 -15.17366 -14.33754 -13.46646 -12.56284 -11.62879 -10.66617 -9.676591 -8.661524 -7.622272 -6.560010 -5.475806 -4.370631 -0.6794432 -1.282956 -1.736422 -2.204048 -2.645819 -3.016282 -3.289474 -3.480814 -3.751594 -4.001950 -4.226438 -4.351506 -4.467099 -4.662756 -4.843090 -4.981570 -5.013491 -5.143135 -5.158969 -4.494734 0.1011047 -0.6174057 -1.221738 -1.793222 -2.311341 -2.747435 -3.036271 -3.321671 -3.636788 -3.940996 -4.207396 -4.289121 -4.455510 -4.675366 -4.877700 -5.014192 -5.024210 -5.155712 -5.159470 -4.494734 0.4617051 -0.3110327 -0.9834030 -1.602421 -2.135050 -2.589809 -2.947799 -3.276233 -3.615187 -3.940794 -4.212567 -4.305850 -4.497943 -4.717225 -4.922788 -5.038803 -5.048017 -5.170775 -5.158804 -4.494734 0.6193628 -0.1677213 -0.8671407 -1.482952 -2.034647 -2.513318 -2.913967 -3.280797 -3.639661 -3.974655 -4.218817 -4.369649 -4.564398 -4.776458 -4.974765 -5.052560 -5.080131 -5.187536 -5.156773 -4.494734 0.6437794 -0.1301392 -0.8124002 -1.434824 -1.994137 -2.485568 -2.920123 -3.320997 -3.694048 -4.022051 -4.261466 -4.450945 -4.644470 -4.844459 -5.030342 -5.081059 -5.117199 -5.205248 -5.153130 -4.494734 0.5707672 -0.1654625 -0.8316870 -1.445905 -2.000448 -2.506023 -2.970000 -3.389968 -3.766608 -4.074636 -4.333046 -4.539578 -4.732614 -4.919762 -5.086784 -5.124715 -5.156962 -5.223256 -5.147604 -4.494734 0.4232715 -0.2708189 -0.9125012 -1.506940 -2.060274 -2.579153 -3.054289 -3.481246 -3.839216 -4.149581 -4.418621 -4.636519 -4.824137 -4.999639 -5.137968 -5.176861 -5.197896 -5.240993 -5.139894 -4.494734 0.2164652 -0.4342243 -1.044730 -1.622564 -2.174439 -2.690441 -3.165546 -3.569730 -3.923745 -4.243806 -4.516582 -4.740181 -4.919365 -5.081673 -5.194149 -5.232925 -5.239128 -5.257893 -5.130890 -4.494734 -4.3240294E-02 -0.6490031 -1.227729 -1.789217 -2.325237 -2.829248 -3.273713 -3.670556 -4.033531 -4.354191 -4.628344 -4.843231 -5.020079 -5.162332 -5.258989 -5.289188 -5.279545 -5.273228 -5.121245 -4.494734 -0.3505391 -0.9111507 -1.455651 -1.994495 -2.503990 -2.971986 -3.403567 -3.802617 -4.162262 -4.485378 -4.747435 -4.954927 -5.124726 -5.242606 -5.325697 -5.345132 -5.318141 -5.286275 -5.110654 -4.494734 -0.6986695 -1.216590 -1.726408 -2.226559 -2.695787 -3.149190 -3.568431 -3.962216 -4.319538 -4.626520 -4.875846 -5.076472 -5.223002 -5.324366 -5.391810 -5.399611 -5.353767 -5.296173 -5.098744 -4.494734 -1.089953 -1.562441 -2.023896 -2.483742 -2.930919 -3.363477 -3.776267 -4.158134 -4.488795 -4.780691 -5.018954 -5.191912 -5.322031 -5.404501 -5.456879 -5.450712 -5.385843 -5.302198 -5.085011 -4.494734 -1.521389 -1.941180 -2.365177 -2.789494 -3.215662 -3.630052 -4.014185 -4.364124 -4.681938 -4.954584 -5.153934 -5.303117 -5.414461 -5.482536 -5.519239 -5.497147 -5.413482 -5.303107 -5.068973 -4.494734 -2.003970 -2.373638 -2.758211 -3.151575 -3.540002 -3.916628 -4.276013 -4.606225 -4.882819 -5.106861 -5.279895 -5.404343 -5.500835 -5.555919 -5.576796 -5.537927 -5.435217 -5.297827 -5.049993 -4.494734 -2.538805 -2.854203 -3.187669 -3.535271 -3.894371 -4.245918 -4.552450 -4.826485 -5.058166 -5.244519 -5.392249 -5.500885 -5.581732 -5.622753 -5.626948 -5.571483 -5.448644 -5.286999 -5.027172 -4.494734 -3.122688 -3.379724 -3.660689 -3.951440 -4.251038 -4.537716 -4.790929 -5.014278 -5.208513 -5.371644 -5.499043 -5.591597 -5.655441 -5.680369 -5.666387 -5.593683 -5.450856 -5.268958 -5.000437 -4.494734 -3.766352 -3.935625 -4.136833 -4.353028 -4.579603 -4.803001 -5.006873 -5.192700 -5.356355 -5.493414 -5.597207 -5.670602 -5.716270 -5.722829 -5.689962 -5.599498 -5.439520 -5.240882 -4.967694 -4.494734 -4.489881 -4.552379 -4.657487 -4.786695 -4.937367 -5.092062 -5.236770 -5.375611 -5.501000 -5.606958 -5.681164 -5.729150 -5.755360 -5.741658 -5.689533 -5.582397 -5.408852 -5.197526 -4.926005 -4.494734 -5.386569 -5.327092 -5.314802 -5.333095 -5.382748 -5.442658 -5.506616 -5.577624 -5.645882 -5.708830 -5.743363 -5.759050 -5.760148 -5.722762 -5.650746 -5.531466 -5.348500 -5.131159 -4.869181 -4.494734 -22.02986 -21.60359 -21.08246 -20.47857 -19.80333 -19.06504 -18.27066 -17.42577 -16.53497 -15.60207 -14.63032 -13.62245 -12.58087 -11.50766 -10.40491 -9.273770 -8.115702 -6.932519 -5.725166 -4.494734 -0.5967808 -1.346138 -1.867463 -2.190998 -2.686720 -3.067459 -3.374339 -3.559752 -3.843639 -4.100427 -4.331127 -4.473749 -4.575180 -4.777310 -4.962605 -5.109347 -5.137311 -5.275107 -5.300931 -4.611584 0.2624950 -0.5419683 -1.143986 -1.746332 -2.301301 -2.785653 -3.101180 -3.389553 -3.717403 -4.028154 -4.306103 -4.407436 -4.561777 -4.789526 -4.999877 -5.146859 -5.149350 -5.289545 -5.302801 -4.611584 0.6754240 -0.1506988 -0.8728560 -1.527856 -2.128866 -2.619443 -3.003700 -3.351861 -3.691444 -4.024392 -4.312430 -4.425096 -4.610874 -4.835694 -5.049276 -5.175125 -5.177063 -5.307255 -5.303449 -4.611584 0.8648981 1.4717345E-02 -0.7372832 -1.424482 -2.020694 -2.535020 -2.973473 -3.347439 -3.710998 -4.057237 -4.326580 -4.493552 -4.684967 -4.901041 -5.106112 -5.190899 -5.214290 -5.327114 -5.302633 -4.611584 0.8997917 5.8261544E-02 -0.6963795 -1.370559 -1.974705 -2.509502 -2.966324 -3.375413 -3.762326 -4.113289 -4.376857 -4.579607 -4.772866 -4.977628 -5.168029 -5.222213 -5.257050 -5.348387 -5.300096 -4.611584 0.8243305 1.6753921E-02 -0.7075612 -1.377298 -1.981137 -2.516513 -2.995030 -3.437492 -3.838728 -4.178885 -4.448935 -4.672921 -4.867918 -5.061074 -5.231440 -5.271693 -5.302950 -5.370293 -5.295491 -4.611584 0.6693011 -8.7383553E-02 -0.7858329 -1.437566 -2.029029 -2.568584 -3.071684 -3.528454 -3.928973 -4.257671 -4.539082 -4.771255 -4.968532 -5.147641 -5.291821 -5.329539 -5.350584 -5.392050 -5.288452 -4.611584 0.4526961 -0.2540312 -0.9208902 -1.544142 -2.128433 -2.675990 -3.183607 -3.640085 -4.020854 -4.353007 -4.637331 -4.878241 -5.072140 -5.237942 -5.354439 -5.390888 -5.398108 -5.413127 -5.279918 -4.611584 0.1794951 -0.4762496 -1.102052 -1.709653 -2.279697 -2.821221 -3.318071 -3.747430 -4.127800 -4.465782 -4.752044 -4.992871 -5.178271 -5.329690 -5.425932 -5.454603 -5.444350 -5.432667 -5.270883 -4.611584 -0.1422085 -0.7469531 -1.337828 -1.918200 -2.469721 -2.988989 -3.450531 -3.874875 -4.257922 -4.595990 -4.880205 -5.108182 -5.290403 -5.418237 -5.499927 -5.518970 -5.488605 -5.449794 -5.260908 -4.611584 -0.5067071 -1.067362 -1.618565 -2.166055 -2.685073 -3.162992 -3.617489 -4.033088 -4.414037 -4.747944 -5.012869 -5.234339 -5.402695 -5.509568 -5.574876 -5.579967 -5.530651 -5.463834 -5.249536 -4.611584 -0.9152389 -1.430180 -1.939926 -2.434681 -2.918125 -3.382181 -3.818181 -4.231067 -4.601097 -4.906221 -5.161159 -5.366004 -5.509136 -5.598505 -5.648803 -5.637639 -5.569414 -5.473742 -5.236328 -4.611584 -1.369930 -1.827005 -2.288192 -2.747052 -3.203092 -3.648469 -4.070750 -4.455213 -4.794321 -5.088166 -5.319003 -5.488632 -5.611666 -5.683896 -5.719014 -5.691290 -5.603181 -5.478350 -5.220749 -4.611584 -1.874099 -2.276160 -2.690678 -3.116557 -3.547883 -3.958425 -4.344723 -4.705024 -5.021960 -5.268675 -5.462140 -5.604386 -5.707237 -5.765007 -5.783479 -5.739180 -5.630055 -5.476462 -5.202106 -4.611584 -2.437231 -2.785042 -3.149832 -3.528669 -3.918077 -4.301445 -4.661139 -4.963740 -5.222653 -5.427966 -5.587167 -5.710603 -5.797657 -5.839391 -5.840276 -5.778549 -5.647915 -5.468949 -5.179466 -4.611584 -3.055400 -3.336083 -3.649639 -3.985558 -4.318955 -4.640234 -4.929942 -5.179122 -5.391988 -5.566942 -5.703342 -5.808851 -5.879417 -5.903608 -5.885820 -5.805892 -5.653757 -5.453888 -5.152164 -4.611584 -3.743360 -3.938682 -4.170356 -4.421602 -4.682377 -4.930311 -5.159255 -5.367294 -5.550177 -5.698965 -5.811215 -5.895848 -5.947032 -5.951922 -5.914989 -5.816661 -5.645077 -5.427858 -5.118903 -4.611584 -4.521226 -4.596285 -4.723435 -4.878481 -5.057403 -5.233786 -5.403400 -5.561456 -5.703941 -5.820330 -5.902628 -5.963326 -5.991331 -5.975104 -5.918923 -5.803543 -5.615699 -5.384984 -5.076139 -4.611584 -5.477971 -5.414123 -5.412431 -5.449092 -5.518139 -5.595276 -5.681944 -5.769236 -5.852696 -5.922708 -5.965991 -5.994598 -5.996743 -5.957414 -5.881279 -5.751045 -5.553927 -5.316422 -5.017389 -4.611584 -23.98451 -23.52134 -22.94906 -22.28341 -21.53717 -20.72047 -19.84134 -18.90620 -17.92029 -16.88794 -15.81276 -14.69787 -13.54595 -12.35932 -11.14004 -9.889944 -8.610653 -7.303632 -5.970207 -4.611584 -0.5103441 -1.325874 -1.965943 -2.450029 -2.682873 -3.120209 -3.466482 -3.634670 -3.931508 -4.195740 -4.431939 -4.590119 -4.677808 -4.886168 -5.076074 -5.230809 -5.254235 -5.399435 -5.435934 -4.721982 0.4256762 -0.4569167 -1.180436 -1.718446 -2.271891 -2.796937 -3.161837 -3.452043 -3.795708 -4.114447 -4.401277 -4.521227 -4.664002 -4.898541 -5.115911 -5.273057 -5.267429 -5.415902 -5.439482 -4.721982 0.8844975 -3.0491745E-02 -0.7780891 -1.460899 -2.086344 -2.645388 -3.055044 -3.417301 -3.772882 -4.107711 -4.406634 -4.538570 -4.719849 -4.949601 -5.170293 -5.306096 -5.299129 -5.436472 -5.441789 -4.721982 1.094463 0.1878497 -0.6115587 -1.338687 -2.001422 -2.552244 -3.020835 -3.422452 -3.787088 -4.138562 -4.425041 -4.616392 -4.803110 -5.021345 -5.233628 -5.324983 -5.341814 -5.459579 -5.442581 -4.721982 1.147743 0.2473127 -0.5617188 -1.303493 -1.952279 -2.522978 -3.018731 -3.440019 -3.831399 -4.195685 -4.482737 -4.707280 -4.899624 -5.104765 -5.302349 -5.359777 -5.390784 -5.484468 -5.441487 -4.721982 1.077370 0.2064380 -0.5844526 -1.307515 -1.955518 -2.533662 -3.036594 -3.487326 -3.904406 -4.271033 -4.566421 -4.804508 -4.999831 -5.196934 -5.372316 -5.413561 -5.443250 -5.510363 -5.438166 -4.721982 0.9136853 9.2215076E-02 -0.6618360 -1.363473 -2.005167 -2.574556 -3.092858 -3.572342 -4.001211 -4.364574 -4.654608 -4.906992 -5.107017 -5.291441 -5.439305 -5.477751 -5.497411 -5.536358 -5.432206 -4.721982 0.6858792 -7.7711798E-02 -0.7970110 -1.475306 -2.092894 -2.664312 -3.200002 -3.688269 -4.112568 -4.461236 -4.759159 -5.015400 -5.218690 -5.387935 -5.510536 -5.546865 -5.551122 -5.561826 -5.424531 -4.721982 0.3975235 -0.3073023 -0.9846690 -1.633536 -2.236808 -2.808851 -3.342294 -3.819381 -4.222241 -4.574832 -4.872907 -5.135605 -5.331134 -5.486583 -5.589828 -5.617787 -5.603904 -5.586029 -5.416492 -4.721982 6.7041628E-02 -0.5887792 -1.222861 -1.845219 -2.429924 -2.990471 -3.500407 -3.947252 -4.353053 -4.703556 -5.005660 -5.261133 -5.446941 -5.587008 -5.673987 -5.687468 -5.655375 -5.608098 -5.407585 -4.721982 -0.3164936 -0.9219213 -1.513340 -2.098340 -2.662829 -3.188265 -3.662243 -4.110568 -4.505759 -4.859201 -5.151505 -5.388379 -5.567391 -5.686905 -5.756741 -5.755320 -5.704131 -5.627069 -5.397316 -4.721982 -0.7457222 -1.297493 -1.847788 -2.390549 -2.907195 -3.401593 -3.868893 -4.301939 -4.695298 -5.031427 -5.302497 -5.529848 -5.686372 -5.787115 -5.835954 -5.820521 -5.749163 -5.641681 -5.385162 -4.721982 -1.221002 -1.717614 -2.212755 -2.707491 -3.196885 -3.666770 -4.122161 -4.542088 -4.904548 -5.215560 -5.474994 -5.669623 -5.802315 -5.880219 -5.911333 -5.882112 -5.788998 -5.650630 -5.370440 -4.721982 -1.747072 -2.180759 -2.625321 -3.083402 -3.545452 -3.996143 -4.414697 -4.798446 -5.140665 -5.424587 -5.634540 -5.799906 -5.906155 -5.967839 -5.982598 -5.938292 -5.822013 -5.652554 -5.352372 -4.721982 -2.335222 -2.709221 -3.105870 -3.523298 -3.941021 -4.351267 -4.741517 -5.093281 -5.376577 -5.605361 -5.778080 -5.914869 -6.003034 -6.049367 -6.046505 -5.985031 -5.846094 -5.647995 -5.329955 -4.721982 -2.986590 -3.290050 -3.629500 -3.999832 -4.384514 -4.734488 -5.058134 -5.338408 -5.572604 -5.757866 -5.904009 -6.023276 -6.091963 -6.121965 -6.099430 -6.018900 -5.857863 -5.634552 -5.301883 -4.721982 -3.717413 -3.931502 -4.195329 -4.484659 -4.781621 -5.059053 -5.314861 -5.541715 -5.740395 -5.899859 -6.020527 -6.119223 -6.168183 -6.179368 -6.135840 -6.034424 -5.853791 -5.608815 -5.267463 -4.721982 -4.541032 -4.631994 -4.782549 -4.967892 -5.172513 -5.375635 -5.570780 -5.747570 -5.902910 -6.028952 -6.120329 -6.193486 -6.220407 -6.210058 -6.145933 -6.023490 -5.826046 -5.564774 -5.222644 -4.721982 -5.557662 -5.498101 -5.503790 -5.562090 -5.646395 -5.745893 -5.855198 -5.961207 -6.057767 -6.134212 -6.190159 -6.231543 -6.230258 -6.194813 -6.110727 -5.969067 -5.759822 -5.494780 -5.160417 -4.721982 -25.97711 -25.47649 -24.85197 -24.12276 -23.30324 -22.40590 -21.43970 -20.41191 -19.32842 -18.19407 -17.01315 -15.78839 -14.52349 -13.22078 -11.88255 -10.51080 -9.107579 -7.673762 -6.211536 -4.721982 -0.4311296 -1.307261 -1.992954 -2.540914 -3.008611 -3.134854 -3.534612 -3.702478 -4.009084 -4.286148 -4.530210 -4.701184 -4.775625 -4.989887 -5.183385 -5.346270 -5.364810 -5.517169 -5.563812 -4.826604 0.5816032 -0.3708162 -1.146218 -1.804566 -2.304513 -2.802258 -3.206047 -3.513284 -3.868994 -4.199508 -4.494311 -4.631751 -4.761207 -5.002138 -5.223546 -5.394117 -5.378896 -5.536074 -5.569208 -4.826604 1.086584 9.9555001E-02 -0.7380921 -1.423750 -2.048349 -2.632423 -3.109657 -3.482387 -3.851116 -4.192704 -4.499199 -4.646852 -4.826356 -5.058179 -5.281213 -5.433006 -5.415141 -5.559351 -5.573366 -4.826604 1.326251 0.3361381 -0.5041549 -1.257420 -1.950556 -2.564141 -3.065330 -3.487813 -3.871618 -4.221406 -4.520385 -4.732661 -4.919365 -5.136020 -5.349849 -5.456385 -5.463474 -5.586036 -5.575904 -4.826604 1.389084 0.4238937 -0.4283182 -1.212136 -1.924750 -2.531457 -3.058729 -3.513557 -3.905951 -4.276327 -4.581436 -4.832619 -5.023522 -5.226796 -5.425268 -5.494900 -5.519221 -5.615310 -5.576468 -4.826604 1.323801 0.3921486 -0.4487992 -1.235995 -1.927230 -2.540555 -3.083619 -3.547618 -3.969931 -4.353875 -4.674476 -4.933233 -5.131283 -5.325326 -5.501695 -5.555128 -5.578718 -5.645790 -5.574684 -4.826604 1.159815 0.2741269 -0.5427734 -1.290885 -1.974496 -2.588755 -3.127165 -3.617568 -4.065550 -4.459004 -4.772592 -5.038245 -5.241943 -5.428380 -5.577676 -5.626536 -5.639202 -5.676513 -5.570209 -4.826604 0.9154139 9.4994791E-02 -0.6770831 -1.404227 -2.069777 -2.665669 -3.217687 -3.729929 -4.187235 -4.569236 -4.875913 -5.150050 -5.359309 -5.530701 -5.657248 -5.703292 -5.700373 -5.706893 -5.563851 -4.826604 0.6171352 -0.1421112 -0.8692470 -1.567153 -2.201218 -2.799044 -3.359250 -3.873722 -4.315449 -4.679439 -4.996165 -5.269745 -5.480225 -5.636019 -5.747029 -5.780666 -5.760871 -5.735872 -5.557163 -4.826604 0.2722605 -0.4359961 -1.114036 -1.772909 -2.393012 -2.982786 -3.535384 -4.025028 -4.441715 -4.816192 -5.126710 -5.400016 -5.598713 -5.746058 -5.838079 -5.856776 -5.819611 -5.762583 -5.549617 -4.826604 -0.1287302 -0.7787710 -1.411344 -2.033132 -2.630646 -3.201493 -3.716360 -4.179687 -4.602527 -4.967006 -5.279169 -5.536482 -5.725554 -5.856896 -5.929631 -5.931901 -5.875320 -5.786031 -5.540729 -4.826604 -0.5763460 -1.165296 -1.754587 -2.337565 -2.902490 -3.423315 -3.920221 -4.376702 -4.788169 -5.147611 -5.441221 -5.683248 -5.858459 -5.963419 -6.018554 -6.004146 -5.927061 -5.805133 -5.529801 -4.826604 -1.073170 -1.603552 -2.141207 -2.670731 -3.191339 -3.693553 -4.169925 -4.618067 -5.015115 -5.341645 -5.617929 -5.840354 -5.980137 -6.065522 -6.103926 -6.070521 -5.974151 -5.818232 -5.516103 -4.826604 -1.622993 -2.085046 -2.563945 -3.053855 -3.542851 -4.023364 -4.482545 -4.890697 -5.254771 -5.564526 -5.801546 -5.982210 -6.095849 -6.161818 -6.182519 -6.130322 -6.014124 -5.823866 -5.498755 -4.826604 -2.233202 -2.632534 -3.058137 -3.508795 -3.965145 -4.401954 -4.820664 -5.200828 -5.524778 -5.771811 -5.963272 -6.110505 -6.202796 -6.253041 -6.252753 -6.182713 -6.043706 -5.822697 -5.476804 -4.826604 -2.917844 -3.242700 -3.608486 -4.009306 -4.426683 -4.828803 -5.182038 -5.490675 -5.744215 -5.946551 -6.102137 -6.228653 -6.302177 -6.334711 -6.312561 -6.223444 -6.058764 -5.812553 -5.448537 -4.826604 -3.686770 -3.921945 -4.212900 -4.541337 -4.875517 -5.187647 -5.470000 -5.716415 -5.925761 -6.098969 -6.232448 -6.336301 -6.388844 -6.398130 -6.355299 -6.246261 -6.056517 -5.789472 -5.413774 -4.826604 -4.555050 -4.662980 -4.837519 -5.053936 -5.285260 -5.517642 -5.737729 -5.933305 -6.100545 -6.238830 -6.346093 -6.421769 -6.448903 -6.433244 -6.369142 -6.240855 -6.030077 -5.746735 -5.367977 -4.826604 -5.634853 -5.576143 -5.594281 -5.670367 -5.775288 -5.902232 -6.031210 -6.153577 -6.261909 -6.353047 -6.422297 -6.463343 -6.462355 -6.420990 -6.334535 -6.187007 -5.963754 -5.674366 -5.303517 -4.826604 -28.00587 -27.46723 -26.78915 -25.99417 -25.09992 -24.11985 -23.06438 -21.94166 -20.75825 -19.51951 -18.22995 -16.89335 -15.51299 -14.09171 -12.63202 -11.13609 -9.605913 -8.043240 -6.449658 -4.826604 -0.3522677 -1.291265 -2.021480 -2.588294 -3.105095 -3.512106 -3.540478 -3.766412 -4.096603 -4.370135 -4.624679 -4.807399 -4.869326 -5.088958 -5.285456 -5.455897 -5.468180 -5.629171 -5.684002 -4.926024 0.7315730 -0.2888434 -1.114260 -1.812798 -2.416811 -2.852473 -3.231905 -3.568654 -3.937349 -4.280215 -4.586072 -4.739625 -4.854513 -5.102163 -5.325725 -5.509946 -5.483510 -5.649942 -5.690988 -4.926024 1.280256 0.2234150 -0.6691311 -1.436218 -2.044788 -2.623606 -3.123499 -3.541198 -3.920290 -4.276525 -4.592073 -4.752061 -4.928663 -5.163320 -5.385496 -5.555530 -5.523829 -5.676475 -5.696586 -4.926024 1.548437 0.4864223 -0.4277894 -1.198037 -1.895792 -2.544539 -3.106914 -3.546791 -3.946788 -4.306306 -4.615755 -4.841968 -5.032967 -5.248837 -5.457749 -5.584003 -5.578650 -5.707247 -5.700507 -4.926024 1.625169 0.5863687 -0.3091474 -1.119834 -1.866971 -2.539297 -3.094629 -3.573868 -3.989449 -4.358292 -4.677561 -4.949271 -5.143532 -5.347464 -5.537193 -5.626693 -5.641637 -5.740389 -5.702443 -4.926024 1.558581 0.5691904 -0.3176048 -1.145230 -1.898789 -2.545730 -3.116417 -3.618483 -4.040235 -4.433873 -4.773426 -5.057766 -5.257432 -5.451542 -5.623049 -5.694325 -5.708637 -5.775311 -5.701800 -4.926024 1.400576 0.4527120 -0.4139836 -1.223103 -1.945060 -2.591594 -3.171915 -3.670600 -4.128136 -4.540129 -4.883016 -5.163526 -5.374631 -5.560613 -5.706645 -5.774238 -5.777694 -5.810749 -5.698009 -4.926024 1.145536 0.2644789 -0.5595530 -1.335112 -2.039155 -2.680426 -3.244096 -3.770671 -4.248857 -4.665007 -4.991733 -5.278094 -5.494019 -5.674411 -5.794118 -5.857748 -5.846686 -5.845501 -5.692060 -4.926024 0.8359416 2.0429546E-02 -0.7571416 -1.498599 -2.178775 -2.795091 -3.376617 -3.915098 -4.394371 -4.787502 -5.110291 -5.397236 -5.618773 -5.787058 -5.892699 -5.942850 -5.914460 -5.879062 -5.686097 -4.926024 0.4734353 -0.2842798 -1.009935 -1.708420 -2.358390 -2.976986 -3.555897 -4.088161 -4.534668 -4.919838 -5.244528 -5.533151 -5.747806 -5.901909 -5.994370 -6.026969 -5.979814 -5.910605 -5.679455 -4.926024 5.6250270E-02 -0.6348711 -1.312688 -1.970561 -2.599959 -3.202488 -3.762135 -4.253201 -4.690326 -5.075610 -5.401140 -5.679810 -5.878277 -6.022315 -6.095595 -6.107478 -6.042675 -5.938859 -5.671467 -4.926024 -0.4086770 -1.037813 -1.665366 -2.282166 -2.887002 -3.453509 -3.968019 -4.453611 -4.879397 -5.261039 -5.576284 -5.827157 -6.018294 -6.137687 -6.192126 -6.184438 -6.101266 -5.962573 -5.661527 -4.926024 -0.9261275 -1.491984 -2.065283 -2.640278 -3.188230 -3.719830 -4.223567 -4.691128 -5.110047 -5.469489 -5.755896 -5.994322 -6.156769 -6.251172 -6.282640 -6.258147 -6.153685 -5.980336 -5.648863 -4.926024 -1.499192 -1.994669 -2.505270 -3.027735 -3.544650 -4.051068 -4.538707 -4.985688 -5.366305 -5.695671 -5.961527 -6.154926 -6.286048 -6.356807 -6.368296 -6.326249 -6.197591 -5.990050 -5.632463 -4.926024 -2.132274 -2.557732 -3.011074 -3.490896 -3.980131 -4.455371 -4.899039 -5.303266 -5.658075 -5.933009 -6.146739 -6.300117 -6.402140 -6.453382 -6.447410 -6.384911 -6.231948 -5.992478 -5.611143 -4.926024 -2.842392 -3.196290 -3.588591 -4.017884 -4.462948 -4.902642 -5.301373 -5.633215 -5.912734 -6.129822 -6.302513 -6.427533 -6.510180 -6.538607 -6.516533 -6.429791 -6.253284 -5.984905 -5.583167 -4.926024 -3.644168 -3.908650 -4.229279 -4.590535 -4.963250 -5.312807 -5.623340 -5.888011 -6.111423 -6.295658 -6.442729 -6.542639 -6.603806 -6.610025 -6.568115 -6.455023 -6.256390 -5.962991 -5.548073 -4.926024 -4.565021 -4.689514 -4.889674 -5.135872 -5.398485 -5.661605 -5.902200 -6.117810 -6.299268 -6.447460 -6.563650 -6.636020 -6.672115 -6.653771 -6.590143 -6.449965 -6.232607 -5.919771 -5.502319 -4.926024 -5.707240 -5.648705 -5.680799 -5.773376 -5.903770 -6.055259 -6.203571 -6.344807 -6.471045 -6.567719 -6.645749 -6.684165 -6.690224 -6.644257 -6.560479 -6.394946 -6.164870 -5.845824 -5.437526 -4.926024 -30.06916 -29.49197 -28.75905 -27.89690 -26.92579 -25.86098 -24.71414 -23.49433 -22.20879 -20.86342 -19.46316 -18.01217 -16.51402 -14.97182 -13.38829 -11.76581 -10.10653 -8.412355 -6.685004 -4.926024 -0.2812811 -1.276889 -2.050192 -2.636030 -3.168069 -3.620323 -3.925324 -3.742507 -4.168684 -4.463076 -4.711754 -4.908476 -4.959232 -5.183676 -5.384553 -5.559975 -5.567032 -5.735749 -5.800199 -5.020735 0.8835914 -0.2065831 -1.087456 -1.816363 -2.450398 -2.979900 -3.294817 -3.604994 -4.006006 -4.350747 -4.675035 -4.844810 -4.944065 -5.198766 -5.429366 -5.620160 -5.583076 -5.759095 -5.809357 -5.020735 1.468356 0.3501785 -0.6050063 -1.411857 -2.104801 -2.647001 -3.156113 -3.586320 -3.989932 -4.354731 -4.685085 -4.855068 -5.026788 -5.266967 -5.494413 -5.671888 -5.628492 -5.789081 -5.817165 -5.020735 1.766119 0.6346765 -0.3375705 -1.180320 -1.874811 -2.513761 -3.116805 -3.604961 -4.017461 -4.391471 -4.710544 -4.947968 -5.140317 -5.360386 -5.572758 -5.705230 -5.690403 -5.823687 -5.823262 -5.020735 1.846418 0.7496949 -0.2172042 -1.047704 -1.811528 -2.514681 -3.128923 -3.626929 -4.064358 -4.442786 -4.772318 -5.057580 -5.260727 -5.466123 -5.659842 -5.751196 -5.760891 -5.861516 -5.827189 -5.020735 1.780213 0.7369441 -0.1954296 -1.054063 -1.844972 -2.550561 -3.147454 -3.672529 -4.120800 -4.513783 -4.868278 -5.172715 -5.379727 -5.577385 -5.752677 -5.825232 -5.835412 -5.900752 -5.828426 -5.020735 1.628549 0.6244472 -0.2878120 -1.140762 -1.916274 -2.594218 -3.199768 -3.734084 -4.194158 -4.617473 -4.984346 -5.286492 -5.501394 -5.695106 -5.844928 -5.911032 -5.911347 -5.940916 -5.826335 -5.020735 1.375041 0.4325394 -0.4419116 -1.265762 -2.009526 -2.680907 -3.284545 -3.814312 -4.308754 -4.744964 -5.104487 -5.398551 -5.624039 -5.816217 -5.938749 -6.001263 -5.986972 -5.980941 -5.821860 -5.020735 1.054057 0.1757158 -0.6464116 -1.431902 -2.150484 -2.804085 -3.396892 -3.953653 -4.456744 -4.885618 -5.224888 -5.523602 -5.752066 -5.936628 -6.043532 -6.092622 -6.061384 -6.019609 -5.817512 -5.020735 0.6717680 -0.1345824 -0.9068203 -1.650042 -2.332543 -2.971402 -3.574801 -4.131694 -4.618840 -5.021318 -5.365318 -5.656185 -5.887877 -6.055868 -6.153075 -6.182290 -6.133407 -6.056182 -5.812613 -5.020735 0.2355902 -0.4966185 -1.219165 -1.911347 -2.572331 -3.200972 -3.794124 -4.325459 -4.777927 -5.181469 -5.518085 -5.806721 -6.024816 -6.181806 -6.260880 -6.268783 -6.201833 -6.089115 -5.806393 -5.020735 -0.2483210 -0.9138904 -1.578576 -2.230016 -2.864038 -3.470618 -4.022820 -4.522405 -4.974957 -5.364460 -5.698270 -5.966107 -6.172709 -6.309330 -6.367083 -6.352561 -6.266022 -6.117490 -5.798046 -5.020735 -0.7864559 -1.382958 -1.991125 -2.601182 -3.192713 -3.746136 -4.279612 -4.765666 -5.205963 -5.586936 -5.892472 -6.140921 -6.322908 -6.430405 -6.465749 -6.431491 -6.325019 -6.139822 -5.786685 -5.020735 -1.375317 -1.906870 -2.450873 -3.001733 -3.550938 -4.082974 -4.595639 -5.066088 -5.477599 -5.822509 -6.109147 -6.319780 -6.462119 -6.542036 -6.558445 -6.504764 -6.375835 -6.154371 -5.771526 -5.020735 -2.031409 -2.484926 -2.966274 -3.472459 -3.990174 -4.503562 -4.977301 -5.403289 -5.778872 -6.088295 -6.316953 -6.479939 -6.587984 -6.647751 -6.643163 -6.569897 -6.415635 -6.161342 -5.750894 -5.020735 -2.767852 -3.143582 -3.570314 -4.026289 -4.498489 -4.969188 -5.404856 -5.772741 -6.070206 -6.308467 -6.490555 -6.617533 -6.701856 -6.744796 -6.718404 -6.622181 -6.441045 -6.157858 -5.723329 -5.020735 -3.598858 -3.883840 -4.242163 -4.638019 -5.044764 -5.434279 -5.771460 -6.059166 -6.294698 -6.488794 -6.640233 -6.742927 -6.803282 -6.823256 -6.777653 -6.655471 -6.447761 -6.139382 -5.687218 -5.020735 -4.569105 -4.713195 -4.939818 -5.215321 -5.511527 -5.803346 -6.068117 -6.296599 -6.495423 -6.651216 -6.771874 -6.847070 -6.879899 -6.873051 -6.804548 -6.657679 -6.426755 -6.098351 -5.639215 -5.020735 -5.774130 -5.717661 -5.762549 -5.875150 -6.034373 -6.208931 -6.378158 -6.532088 -6.669010 -6.779054 -6.862527 -6.902029 -6.902073 -6.871300 -6.773987 -6.604709 -6.358664 -6.021266 -5.570192 -5.020735 -32.16550 -31.54922 -30.76023 -29.82930 -28.77953 -27.62809 -26.38789 -25.06893 -23.67915 -22.22500 -20.71188 -19.14430 -17.52616 -15.86081 -14.15120 -12.39993 -10.60929 -8.781347 -6.917940 -5.020735 -0.2204264 -1.267088 -2.078931 -2.683104 -3.229879 -3.697230 -4.054316 -3.815483 -4.238451 -4.542961 -4.800385 -5.005617 -5.045324 -5.274194 -5.479683 -5.659228 -5.662416 -5.835715 -5.911074 -5.111163 1.026376 -0.1226804 -1.058835 -1.824902 -2.477906 -3.045801 -3.415919 -3.628982 -4.066616 -4.424501 -4.759104 -4.948792 -5.030191 -5.289917 -5.528288 -5.725446 -5.679649 -5.860728 -5.922491 -5.111163 1.656153 0.4869573 -0.5443048 -1.392796 -2.116508 -2.707483 -3.155702 -3.629409 -4.060041 -4.425844 -4.776448 -4.955550 -5.122185 -5.366040 -5.600289 -5.783124 -5.731408 -5.893413 -5.932648 -5.111163 1.978123 0.7940143 -0.2559859 -1.138302 -1.898872 -2.495821 -3.130744 -3.648792 -4.084938 -4.469003 -4.806418 -5.050543 -5.244072 -5.467571 -5.686034 -5.822394 -5.800187 -5.931269 -5.941175 -5.111163 2.045733 0.9109001 -0.1164358 -1.009772 -1.764971 -2.490154 -3.135375 -3.679805 -4.131903 -4.530609 -4.865287 -5.160507 -5.374444 -5.580146 -5.780708 -5.872472 -5.877181 -5.972899 -5.947453 -5.111163 1.979149 0.9020650 -9.5227800E-02 -0.9713541 -1.788414 -2.526503 -3.171508 -3.720142 -4.196870 -4.596070 -4.959740 -5.278167 -5.503524 -5.700613 -5.879927 -5.951090 -5.958272 -6.016609 -5.950915 -5.111163 1.837423 0.7884005 -0.1649983 -1.055215 -1.868634 -2.592973 -3.224932 -3.785148 -4.267166 -4.692113 -5.075655 -5.398664 -5.628726 -5.822397 -5.979531 -6.042741 -6.040861 -6.061327 -5.950954 -5.111163 1.601327 0.5962577 -0.3219217 -1.193172 -1.977689 -2.682330 -3.313013 -3.868188 -4.368866 -4.818901 -5.207760 -5.515718 -5.756274 -5.947159 -6.078517 -6.140638 -6.122695 -6.106051 -5.948358 -5.111163 1.266312 0.3315758 -0.5406014 -1.367018 -2.120894 -2.811913 -3.426747 -3.991729 -4.515353 -4.969930 -5.339318 -5.640612 -5.885212 -6.074782 -6.189250 -6.238702 -6.203282 -6.149711 -5.946040 -5.111163 0.8633602 8.9180972E-03 -0.8075933 -1.588934 -2.315535 -2.973746 -3.592822 -4.171587 -4.691398 -5.123284 -5.474262 -5.777966 -6.026301 -6.202146 -6.305907 -6.335937 -6.281803 -6.191649 -5.943227 -5.111163 0.4110778 -0.3655687 -1.129515 -1.860079 -2.546325 -3.200944 -3.816551 -4.386390 -4.870179 -5.278358 -5.633539 -5.933270 -6.172339 -6.335144 -6.420333 -6.429338 -6.356480 -6.230493 -5.939082 -5.111163 -9.0457864E-02 -0.7951188 -1.495760 -2.181485 -2.843059 -3.478910 -4.070680 -4.593787 -5.062547 -5.468553 -5.818467 -6.105694 -6.319323 -6.473288 -6.531102 -6.519026 -6.425770 -6.264723 -5.932746 -5.111163 -0.6478476 -1.279540 -1.920585 -2.560773 -3.187685 -3.779276 -4.330781 -4.846200 -5.296250 -5.696297 -6.024598 -6.282953 -6.481221 -6.603492 -6.637330 -6.604595 -6.489689 -6.292473 -5.923564 -5.111163 -1.254382 -1.817240 -2.395956 -2.980574 -3.554447 -4.120718 -4.652546 -5.148029 -5.583553 -5.945342 -6.244851 -6.480705 -6.631345 -6.727938 -6.738833 -6.684597 -6.546966 -6.311553 -5.909698 -5.111163 -1.931781 -2.413338 -2.924407 -3.457011 -3.999765 -4.542177 -5.055255 -5.503672 -5.893946 -6.226497 -6.476969 -6.654182 -6.767660 -6.838974 -6.832859 -6.755192 -6.594117 -6.321898 -5.890163 -5.111163 -2.693268 -3.091944 -3.543561 -4.035396 -4.535202 -5.033481 -5.498035 -5.908740 -6.221408 -6.478888 -6.670381 -6.804006 -6.894561 -6.939613 -6.912172 -6.811620 -6.626515 -6.320657 -5.863561 -5.111163 -3.552292 -3.858103 -4.241959 -4.681678 -5.124689 -5.545820 -5.920062 -6.222902 -6.470837 -6.675651 -6.831815 -6.939786 -7.004945 -7.027010 -6.972410 -6.847678 -6.638185 -6.303724 -5.826912 -5.111163 -4.567821 -4.731696 -4.988159 -5.295241 -5.624775 -5.945797 -6.229960 -6.475877 -6.678142 -6.850439 -6.973872 -7.051381 -7.088044 -7.087264 -7.003326 -6.852910 -6.618895 -6.263153 -5.777298 -5.111163 -5.835221 -5.782485 -5.840103 -5.975523 -6.160917 -6.362608 -6.552081 -6.726192 -6.861940 -6.988187 -7.073317 -7.112071 -7.119779 -7.088027 -6.976894 -6.802722 -6.548072 -6.185431 -5.705125 -5.111163 -34.29354 -33.63787 -32.79136 -31.79009 -30.65997 -29.42006 -28.08459 -26.66452 -25.16850 -23.60355 -21.97549 -20.28925 -18.54902 -16.75841 -14.92061 -13.03841 -11.11427 -9.150400 -7.148768 -5.111163 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.938811 -1.964830 -1.988125 -2.008795 -2.026135 -2.039584 -2.059643 -2.076727 -2.090352 -2.099977 -2.104335 -2.103968 -2.097217 -2.085994 -2.072381 -2.049193 -2.013173 -1.958944 -1.873358 -1.624412 -1.955378 -1.979423 -2.001532 -2.020471 -2.035622 -2.047657 -2.066579 -2.082424 -2.094736 -2.102307 -2.105776 -2.103887 -2.095593 -2.083138 -2.068631 -2.044678 -2.008058 -1.953740 -1.868782 -1.624412 -1.972232 -1.994876 -2.015080 -2.031651 -2.045111 -2.056045 -2.073683 -2.088120 -2.098978 -2.104961 -2.106867 -2.103400 -2.093532 -2.080034 -2.064574 -2.039904 -2.002695 -1.948415 -1.864051 -1.624412 -1.989961 -2.010485 -2.028095 -2.042824 -2.054961 -2.064703 -2.080825 -2.093729 -2.102256 -2.107299 -2.107551 -2.102453 -2.090855 -2.076653 -2.060266 -2.034847 -1.997069 -1.942781 -1.859159 -1.624412 -2.007828 -2.025451 -2.041196 -2.054361 -2.065211 -2.073482 -2.087913 -2.098377 -2.105902 -2.109243 -2.107776 -2.100990 -2.088187 -2.072974 -2.055634 -2.029353 -1.991158 -1.936909 -1.854079 -1.624412 -2.024923 -2.040588 -2.054627 -2.066436 -2.075651 -2.082263 -2.094877 -2.103437 -2.109155 -2.110717 -2.107473 -2.098686 -2.085216 -2.068831 -2.050685 -2.023496 -1.984969 -1.930779 -1.848800 -1.624412 -2.042468 -2.056116 -2.068663 -2.078762 -2.086155 -2.090928 -2.100703 -2.108094 -2.111928 -2.111645 -2.106031 -2.096516 -2.081914 -2.064453 -2.045375 -2.017273 -1.978501 -1.924371 -1.843301 -1.624412 -2.060441 -2.072323 -2.082948 -2.091132 -2.095788 -2.098467 -2.106915 -2.112263 -2.114139 -2.111933 -2.104762 -2.094016 -2.078000 -2.059634 -2.039443 -2.010683 -1.971619 -1.917659 -1.837559 -1.624412 -2.079115 -2.088802 -2.097284 -2.102579 -2.105822 -2.106354 -2.112600 -2.115856 -2.115676 -2.111016 -2.103164 -2.091141 -2.073908 -2.054458 -2.032972 -2.003652 -1.964610 -1.910614 -1.831538 -1.624412 -2.098079 -2.104661 -2.110729 -2.114429 -2.115402 -2.113744 -2.117686 -2.118743 -2.115870 -2.110498 -2.101209 -2.087472 -2.069272 -2.048504 -2.026020 -1.996257 -1.956913 -1.903199 -1.825199 -1.624412 -2.116429 -2.121089 -2.124609 -2.125863 -2.124480 -2.120545 -2.121179 -2.120247 -2.116607 -2.109673 -2.098381 -2.083566 -2.064292 -2.041829 -2.018616 -1.988451 -1.948759 -1.895371 -1.818488 -1.624412 -2.135352 -2.137293 -2.138191 -2.136914 -2.132999 -2.125882 -2.125339 -2.122496 -2.117137 -2.107946 -2.095414 -2.079353 -2.059873 -2.036514 -2.010779 -1.980404 -1.940102 -1.887150 -1.811329 -1.624412 -2.154252 -2.153433 -2.151517 -2.146781 -2.140479 -2.132174 -2.129616 -2.124010 -2.116812 -2.106273 -2.092251 -2.075273 -2.054914 -2.030993 -2.002803 -1.971294 -1.930891 -1.878301 -1.803607 -1.624412 -2.172552 -2.168971 -2.164413 -2.158067 -2.149390 -2.138138 -2.133406 -2.126046 -2.116820 -2.104498 -2.089053 -2.070983 -2.049856 -2.025020 -1.996026 -1.961587 -1.921060 -1.868831 -1.795193 -1.624412 -2.193254 -2.187011 -2.178982 -2.169916 -2.158259 -2.145296 -2.138202 -2.128270 -2.116436 -2.102270 -2.085696 -2.066545 -2.044823 -2.018848 -1.988214 -1.952727 -1.910890 -1.858596 -1.785317 -1.624412 -2.216653 -2.207031 -2.196523 -2.184306 -2.170984 -2.157130 -2.141901 -2.130091 -2.116319 -2.100949 -2.083158 -2.063163 -2.038805 -2.011174 -1.979699 -1.943813 -1.900814 -1.847618 -1.773602 -1.624412 -2.245083 -2.232640 -2.219472 -2.205769 -2.190571 -2.175185 -2.158916 -2.140583 -2.122209 -2.101393 -2.080887 -2.057890 -2.032167 -2.003187 -1.970853 -1.933058 -1.888548 -1.833969 -1.759989 -1.624412 -2.286132 -2.268335 -2.253201 -2.236652 -2.218970 -2.200367 -2.180566 -2.159403 -2.137033 -2.113073 -2.087415 -2.060920 -2.030608 -1.998015 -1.961623 -1.920518 -1.872488 -1.812694 -1.743410 -1.624412 -2.372866 -2.350174 -2.326735 -2.303677 -2.278196 -2.251781 -2.224340 -2.196226 -2.166113 -2.134591 -2.101208 -2.065568 -2.027047 -1.984862 -1.938439 -1.889268 -1.837638 -1.782501 -1.721105 -1.624412 -2.280320 -2.251222 -2.221487 -2.191119 -2.160126 -2.128514 -2.096533 -2.063457 -2.030020 -1.995986 -1.961366 -1.926167 -1.890395 -1.854056 -1.817156 -1.779699 -1.741682 -1.703125 -1.664033 -1.624412 -1.903170 -1.966774 -2.024868 -2.098552 -2.166233 -2.229600 -2.285918 -2.334437 -2.372311 -2.413095 -2.459142 -2.497184 -2.524469 -2.539369 -2.537175 -2.531313 -2.510910 -2.459796 -2.356396 -2.016222 -1.922140 -1.983334 -2.042513 -2.115860 -2.184944 -2.247793 -2.302493 -2.348419 -2.382187 -2.422817 -2.467839 -2.503495 -2.529073 -2.541088 -2.535612 -2.527928 -2.506003 -2.453754 -2.350395 -2.016222 -1.945501 -2.006442 -2.067303 -2.139531 -2.207371 -2.267238 -2.319779 -2.362311 -2.393910 -2.433824 -2.477151 -2.510455 -2.533012 -2.542129 -2.533515 -2.524237 -2.500748 -2.447393 -2.344170 -2.016222 -1.975755 -2.035771 -2.095775 -2.167279 -2.230858 -2.288295 -2.337407 -2.375667 -2.407360 -2.445795 -2.485935 -2.517237 -2.536716 -2.542438 -2.531192 -2.520195 -2.495115 -2.440684 -2.337705 -2.016222 -2.012419 -2.071692 -2.130042 -2.196193 -2.256445 -2.310189 -2.354270 -2.391582 -2.422120 -2.458437 -2.495526 -2.523724 -2.539569 -2.541850 -2.528573 -2.515755 -2.489069 -2.433543 -2.330983 -2.016222 -2.055773 -2.112394 -2.165563 -2.227059 -2.283089 -2.331394 -2.373522 -2.409204 -2.437757 -2.470241 -2.504891 -2.528954 -2.541741 -2.540640 -2.525588 -2.510866 -2.482576 -2.425991 -2.323992 -2.016222 -2.102340 -2.154397 -2.202665 -2.259343 -2.309318 -2.354933 -2.394715 -2.427982 -2.452927 -2.482864 -2.513002 -2.533686 -2.542920 -2.539186 -2.522181 -2.505481 -2.475598 -2.418004 -2.316714 -2.016222 -2.152076 -2.198027 -2.241119 -2.291397 -2.338201 -2.380628 -2.417340 -2.446625 -2.469009 -2.495123 -2.521019 -2.537659 -2.543249 -2.537369 -2.518291 -2.499565 -2.468093 -2.409549 -2.309121 -2.016222 -2.203635 -2.242590 -2.279871 -2.326479 -2.369371 -2.407864 -2.440059 -2.466224 -2.484825 -2.505669 -2.527565 -2.540362 -2.543261 -2.535101 -2.513826 -2.493055 -2.460002 -2.400586 -2.301184 -2.016222 -2.255524 -2.289263 -2.322143 -2.363828 -2.402048 -2.435217 -2.463751 -2.485736 -2.499067 -2.515635 -2.533239 -2.542495 -2.542810 -2.532303 -2.508752 -2.485897 -2.451020 -2.391069 -2.292863 -2.016222 -2.310573 -2.339174 -2.366581 -2.402023 -2.434772 -2.463539 -2.486639 -2.503835 -2.512685 -2.524692 -2.538090 -2.544238 -2.541857 -2.528882 -2.503004 -2.478040 -2.441181 -2.380942 -2.284117 -2.016222 -2.368242 -2.390409 -2.411762 -2.441361 -2.468231 -2.491095 -2.509180 -2.521259 -2.525413 -2.532976 -2.542722 -2.545595 -2.540325 -2.524777 -2.496510 -2.469359 -2.430568 -2.370151 -2.274892 -2.016222 -2.426752 -2.442572 -2.456767 -2.480172 -2.500562 -2.518322 -2.531101 -2.537950 -2.537841 -2.541304 -2.547143 -2.546552 -2.538228 -2.519946 -2.489224 -2.459060 -2.419112 -2.358650 -2.265123 -2.016222 -2.485251 -2.494470 -2.502213 -2.519212 -2.533263 -2.545215 -2.552734 -2.554932 -2.550602 -2.549719 -2.551433 -2.547212 -2.535634 -2.514439 -2.481776 -2.447778 -2.406753 -2.346413 -2.254732 -2.016222 -2.545692 -2.547285 -2.548063 -2.558536 -2.566465 -2.573021 -2.575482 -2.572784 -2.563961 -2.558560 -2.555898 -2.547782 -2.532787 -2.508613 -2.475354 -2.435576 -2.393474 -2.333386 -2.243615 -2.016222 -2.609823 -2.603892 -2.597513 -2.601373 -2.603132 -2.603763 -2.600647 -2.592605 -2.578795 -2.568555 -2.561259 -2.548716 -2.530035 -2.503610 -2.468654 -2.423939 -2.379456 -2.319553 -2.231822 -2.016222 -2.685238 -2.671108 -2.656583 -2.653143 -2.647961 -2.641689 -2.632012 -2.617575 -2.597633 -2.580821 -2.567685 -2.550730 -2.528397 -2.499415 -2.462325 -2.416765 -2.365171 -2.305037 -2.218774 -2.016222 -2.786965 -2.762702 -2.738259 -2.725905 -2.712228 -2.696958 -2.680160 -2.660212 -2.636636 -2.609531 -2.579884 -2.558498 -2.532057 -2.499340 -2.459931 -2.412374 -2.355778 -2.291024 -2.204578 -2.016222 -2.967880 -2.937702 -2.906971 -2.875151 -2.843667 -2.809999 -2.779290 -2.751658 -2.721112 -2.687655 -2.650602 -2.610035 -2.565647 -2.518524 -2.472681 -2.419816 -2.356976 -2.283265 -2.188908 -2.016222 -3.518405 -3.459572 -3.398212 -3.334374 -3.268105 -3.199451 -3.128481 -3.055485 -2.979768 -2.902119 -2.822353 -2.740515 -2.656873 -2.570762 -2.482960 -2.393259 -2.301682 -2.208296 -2.113133 -2.016222 -1.792118 -1.912941 -2.023587 -2.118064 -2.206958 -2.314091 -2.414274 -2.504225 -2.582200 -2.642029 -2.700344 -2.774520 -2.835603 -2.881503 -2.905589 -2.904953 -2.905921 -2.864977 -2.751583 -2.343706 -1.790574 -1.914965 -2.027752 -2.120204 -2.215219 -2.326606 -2.428410 -2.519907 -2.596514 -2.651758 -2.710282 -2.784077 -2.844124 -2.887570 -2.907439 -2.902624 -2.901572 -2.858556 -2.744354 -2.343706 -1.808943 -1.931408 -2.039866 -2.136033 -2.234784 -2.347014 -2.449010 -2.538662 -2.611345 -2.662970 -2.723530 -2.795975 -2.853391 -2.893204 -2.908199 -2.900182 -2.896836 -2.851703 -2.736814 -2.343706 -1.841259 -1.956789 -2.065027 -2.163874 -2.263847 -2.374164 -2.473802 -2.559175 -2.625625 -2.678720 -2.738467 -2.808926 -2.862500 -2.898102 -2.907639 -2.897499 -2.891645 -2.844383 -2.728940 -2.343706 -1.881127 -1.995476 -2.103037 -2.201484 -2.299764 -2.406224 -2.500672 -2.579537 -2.643613 -2.696949 -2.755740 -2.821643 -2.871463 -2.901923 -2.906299 -2.894440 -2.885929 -2.836551 -2.720708 -2.343706 -1.933702 -2.046474 -2.150748 -2.246377 -2.340765 -2.440773 -2.528106 -2.601773 -2.665591 -2.717768 -2.773264 -2.834662 -2.879724 -2.904371 -2.904883 -2.890915 -2.879645 -2.828162 -2.712114 -2.343706 -2.000114 -2.106644 -2.205585 -2.296451 -2.384459 -2.476421 -2.556768 -2.628591 -2.689868 -2.740144 -2.791287 -2.847378 -2.886710 -2.905211 -2.903187 -2.886806 -2.872664 -2.818971 -2.703147 -2.343706 -2.073935 -2.173566 -2.265717 -2.349529 -2.429205 -2.513531 -2.590365 -2.658240 -2.716809 -2.762347 -2.808598 -2.858985 -2.891979 -2.905505 -2.901021 -2.881993 -2.864939 -2.809286 -2.693773 -2.343706 -2.155733 -2.245366 -2.329304 -2.404008 -2.476387 -2.555686 -2.627386 -2.690772 -2.744067 -2.784869 -2.825434 -2.868810 -2.895202 -2.905489 -2.898215 -2.876429 -2.856390 -2.798846 -2.684038 -2.343706 -2.241983 -2.320864 -2.395196 -2.462441 -2.528598 -2.601447 -2.667542 -2.724160 -2.771701 -2.807231 -2.840908 -2.876584 -2.897786 -2.904844 -2.894568 -2.869805 -2.846933 -2.787485 -2.673719 -2.343706 -2.331874 -2.401354 -2.466522 -2.525598 -2.584985 -2.649775 -2.708354 -2.758304 -2.799256 -2.828220 -2.854351 -2.882985 -2.899843 -2.903367 -2.889914 -2.862103 -2.836458 -2.775219 -2.662968 -2.343706 -2.428017 -2.486716 -2.542311 -2.593430 -2.643762 -2.699309 -2.749758 -2.792420 -2.825499 -2.846854 -2.866383 -2.889239 -2.901156 -2.900826 -2.884096 -2.853191 -2.824874 -2.761979 -2.651626 -2.343706 -2.529548 -2.577179 -2.622526 -2.663850 -2.704088 -2.749903 -2.791119 -2.825091 -2.849492 -2.864252 -2.878238 -2.895135 -2.901608 -2.897149 -2.876899 -2.842954 -2.811820 -2.747681 -2.639393 -2.343706 -2.635523 -2.671879 -2.705754 -2.736030 -2.765329 -2.800279 -2.831066 -2.856502 -2.873352 -2.881644 -2.889738 -2.900460 -2.901237 -2.892197 -2.868288 -2.831319 -2.796767 -2.732308 -2.626331 -2.343706 -2.745216 -2.769325 -2.790143 -2.808137 -2.826114 -2.850788 -2.871795 -2.889080 -2.898039 -2.899162 -2.900838 -2.905398 -2.900131 -2.886166 -2.858339 -2.817357 -2.780109 -2.715843 -2.612321 -2.343706 -2.855607 -2.866674 -2.875812 -2.882663 -2.890002 -2.904560 -2.915336 -2.923986 -2.924559 -2.917769 -2.912484 -2.910494 -2.898985 -2.879470 -2.847368 -2.800998 -2.761879 -2.698011 -2.597212 -2.343706 -2.975617 -2.973492 -2.969858 -2.964509 -2.960614 -2.964911 -2.965325 -2.964499 -2.956024 -2.940262 -2.927047 -2.917852 -2.898782 -2.873114 -2.838921 -2.790481 -2.742207 -2.678717 -2.580856 -2.343706 -3.124498 -3.106753 -3.088277 -3.068117 -3.050538 -3.043105 -3.032014 -3.020065 -3.000908 -2.974546 -2.947374 -2.929300 -2.903882 -2.872410 -2.834565 -2.783263 -2.722836 -2.658718 -2.563176 -2.343706 -3.365944 -3.328195 -3.292306 -3.255655 -3.217499 -3.179033 -3.153675 -3.127087 -3.098907 -3.065371 -3.024773 -2.977580 -2.936843 -2.896966 -2.849559 -2.792391 -2.721506 -2.642480 -2.545563 -2.343706 -4.847148 -4.758192 -4.663117 -4.562813 -4.457223 -4.346527 -4.230862 -4.110434 -3.985371 -3.855843 -3.722001 -3.583956 -3.441876 -3.295862 -3.146047 -2.992548 -2.835452 -2.674891 -2.511185 -2.343706 -1.649316 -1.825723 -1.988624 -2.134805 -2.253444 -2.369077 -2.507442 -2.634784 -2.748251 -2.842314 -2.901991 -2.998710 -3.089524 -3.163628 -3.213347 -3.219280 -3.240053 -3.212090 -3.092538 -2.625035 -1.602020 -1.791338 -1.965171 -2.115332 -2.234020 -2.361548 -2.509773 -2.643587 -2.760385 -2.852924 -2.907397 -3.008631 -3.100407 -3.173435 -3.219010 -3.217799 -3.236659 -3.205771 -3.084135 -2.625035 -1.597743 -1.790319 -1.964080 -2.110454 -2.237796 -2.375989 -2.527203 -2.661514 -2.777179 -2.863032 -2.920783 -3.023299 -3.113656 -3.183573 -3.223503 -3.216766 -3.232986 -3.198928 -3.075291 -2.625035 -1.623042 -1.809819 -1.977932 -2.127605 -2.264944 -2.405586 -2.553933 -2.686001 -2.795300 -2.875537 -2.940039 -3.041197 -3.128365 -3.193387 -3.226478 -3.215927 -3.228880 -3.191506 -3.065965 -2.625035 -1.668103 -1.844789 -2.012393 -2.168076 -2.306498 -2.443867 -2.588037 -2.713206 -2.813019 -2.895749 -2.963714 -3.061128 -3.143473 -3.202320 -3.227422 -3.215390 -3.224237 -3.183318 -3.056313 -2.625035 -1.729773 -1.901063 -2.067898 -2.222617 -2.357442 -2.490568 -2.626282 -2.740605 -2.837141 -2.921236 -2.989739 -3.081942 -3.158317 -3.209878 -3.227599 -3.214183 -3.218933 -3.174493 -3.046220 -2.625035 -1.812200 -1.977520 -2.137749 -2.284842 -2.416588 -2.542211 -2.665110 -2.772447 -2.868156 -2.950787 -3.016945 -3.102760 -3.171905 -3.215319 -3.228066 -3.212471 -3.213175 -3.164805 -3.035665 -2.625035 -1.912668 -2.066651 -2.215546 -2.355833 -2.479625 -2.593885 -2.707497 -2.811492 -2.904250 -2.982816 -3.044748 -3.122863 -3.183630 -3.218475 -3.228759 -3.209970 -3.206082 -3.154266 -3.024602 -2.625035 -2.021331 -2.164866 -2.303196 -2.431334 -2.543178 -2.649126 -2.757054 -2.855711 -2.943105 -3.016232 -3.072347 -3.141427 -3.192827 -3.221438 -3.228585 -3.206452 -3.197900 -3.142726 -3.012977 -2.625035 -2.141531 -2.271044 -2.394287 -2.509645 -2.612299 -2.711238 -2.811824 -2.902970 -2.983059 -3.049913 -3.099059 -3.157909 -3.199904 -3.224403 -3.227467 -3.202135 -3.188754 -3.130068 -3.000731 -2.625035 -2.268270 -2.380379 -2.490007 -2.594979 -2.688735 -2.778316 -2.869473 -2.951492 -3.023298 -3.082324 -3.123720 -3.171786 -3.206898 -3.226229 -3.225008 -3.195681 -3.177846 -3.116153 -2.987790 -2.625035 -2.399927 -2.496935 -2.594213 -2.687386 -2.770019 -2.847838 -2.928405 -3.000721 -3.062521 -3.112412 -3.145252 -3.185057 -3.213495 -3.226818 -3.221265 -3.187411 -3.165444 -3.100727 -2.974067 -2.625035 -2.541776 -2.623139 -2.705057 -2.784206 -2.854238 -2.919337 -2.988062 -3.049235 -3.099800 -3.139547 -3.165203 -3.197767 -3.218691 -3.225745 -3.214954 -3.177440 -3.150976 -3.083628 -2.959442 -2.625035 -2.691556 -2.754495 -2.820084 -2.885011 -2.940597 -2.991841 -3.047357 -3.096379 -3.135391 -3.165590 -3.183865 -3.208731 -3.222120 -3.222829 -3.206630 -3.164798 -3.134330 -3.065002 -2.943777 -2.625035 -2.846887 -2.891595 -2.940547 -2.988393 -3.028149 -3.064931 -3.106159 -3.142987 -3.170866 -3.190863 -3.200647 -3.217795 -3.223653 -3.217453 -3.195486 -3.149228 -3.114720 -3.044758 -2.926887 -2.625035 -3.008909 -3.034743 -3.065542 -3.095257 -3.118207 -3.139721 -3.166435 -3.190951 -3.207145 -3.215922 -3.215948 -3.224515 -3.223091 -3.209413 -3.181479 -3.130435 -3.091994 -3.022702 -2.908547 -2.625035 -3.177940 -3.183783 -3.196946 -3.209774 -3.215549 -3.220675 -3.232193 -3.242887 -3.246382 -3.242592 -3.231615 -3.231081 -3.221331 -3.199589 -3.165191 -3.113882 -3.066719 -2.998622 -2.888480 -2.625035 -3.371144 -3.355696 -3.350212 -3.344757 -3.331949 -3.319100 -3.314456 -3.309523 -3.298296 -3.279753 -3.254775 -3.241874 -3.222078 -3.191695 -3.152121 -3.098001 -3.039852 -2.972589 -2.866475 -2.625035 -3.666103 -3.624691 -3.592987 -3.559327 -3.519756 -3.480523 -3.456442 -3.431590 -3.402651 -3.367064 -3.326703 -3.280532 -3.249900 -3.208678 -3.156199 -3.096102 -3.018780 -2.947741 -2.843265 -2.625035 -6.258605 -6.138412 -6.008305 -5.868680 -5.719967 -5.562553 -5.396829 -5.223159 -5.041882 -4.853333 -4.657796 -4.455575 -4.246910 -4.032073 -3.811266 -3.584733 -3.352653 -3.115231 -2.872634 -2.625035 -1.521930 -1.728712 -1.939078 -2.131914 -2.299603 -2.420409 -2.587210 -2.744788 -2.889866 -3.016156 -3.103685 -3.191894 -3.307656 -3.405381 -3.478515 -3.500877 -3.529314 -3.516408 -3.393876 -2.871628 -1.411127 -1.642269 -1.870284 -2.078295 -2.254593 -2.385067 -2.567982 -2.738941 -2.894515 -3.025443 -3.104662 -3.200011 -3.319608 -3.418257 -3.488192 -3.500755 -3.527194 -3.510612 -3.384649 -2.871628 -1.371340 -1.613152 -1.846871 -2.055731 -2.231797 -2.386073 -2.574558 -2.751604 -2.910568 -3.036831 -3.112492 -3.216897 -3.336366 -3.432794 -3.496879 -3.500742 -3.525124 -3.504221 -3.374866 -2.871628 -1.379903 -1.623097 -1.853692 -2.057336 -2.242973 -2.407936 -2.599718 -2.777390 -2.932574 -3.047820 -3.133139 -3.240777 -3.356627 -3.447877 -3.504098 -3.501493 -3.523210 -3.497168 -3.364482 -2.871628 -1.424267 -1.660437 -1.884684 -2.091064 -2.277494 -2.449538 -2.639247 -2.812529 -2.955462 -3.068514 -3.161051 -3.268252 -3.378394 -3.462784 -3.509052 -3.502861 -3.520457 -3.489339 -3.353442 -2.871628 -1.494332 -1.721931 -1.943111 -2.145706 -2.334390 -2.506926 -2.690932 -2.849395 -2.982752 -3.099049 -3.194523 -3.297464 -3.400324 -3.476694 -3.511542 -3.504483 -3.517030 -3.480620 -3.341702 -2.871628 -1.589660 -1.807186 -2.020947 -2.221051 -2.407504 -2.577068 -2.743744 -2.890199 -3.021210 -3.136523 -3.230643 -3.327497 -3.421698 -3.488330 -3.514818 -3.505908 -3.512698 -3.470896 -3.329347 -2.871628 -1.704603 -1.912184 -2.119118 -2.313639 -2.492638 -2.646450 -2.800196 -2.940468 -3.066429 -3.177911 -3.268449 -3.357342 -3.441549 -3.496685 -3.518548 -3.506984 -3.507508 -3.460039 -3.316585 -2.871628 -1.841572 -2.037008 -2.233854 -2.415935 -2.576862 -2.720999 -2.864494 -2.995766 -3.115197 -3.221478 -3.306825 -3.386449 -3.459147 -3.504082 -3.522099 -3.506326 -3.500743 -3.447862 -3.303286 -2.871628 -1.997784 -2.177508 -2.353436 -2.519132 -2.669929 -2.801833 -2.933040 -3.054596 -3.166462 -3.265606 -3.344301 -3.413922 -3.473691 -3.511710 -3.524795 -3.504087 -3.492111 -3.434237 -3.289250 -2.871628 -2.163918 -2.319183 -2.478993 -2.630627 -2.766614 -2.885983 -3.005720 -3.116715 -3.219093 -3.309158 -3.379665 -3.438078 -3.487818 -3.518940 -3.526188 -3.500041 -3.481527 -3.418988 -3.274384 -2.871628 -2.338271 -2.472049 -2.611772 -2.745355 -2.866995 -2.974272 -3.082079 -3.180850 -3.271466 -3.351156 -3.411266 -3.460097 -3.501346 -3.525119 -3.525217 -3.493224 -3.468621 -3.401832 -3.258575 -2.871628 -2.521086 -2.630477 -2.749715 -2.866310 -2.973296 -3.066379 -3.159660 -3.245120 -3.322822 -3.390328 -3.440291 -3.480418 -3.513107 -3.528700 -3.521827 -3.483196 -3.452970 -3.382495 -3.241695 -2.871628 -2.711048 -2.798085 -2.896905 -2.994190 -3.082801 -3.159801 -3.237266 -3.308141 -3.371941 -3.428016 -3.467543 -3.497808 -3.521596 -3.529229 -3.514906 -3.469737 -3.434264 -3.360956 -3.223563 -2.871628 -2.913616 -2.974323 -3.050148 -3.126378 -3.195459 -3.254395 -3.313944 -3.369683 -3.420125 -3.463587 -3.491798 -3.511229 -3.526027 -3.525472 -3.503899 -3.452382 -3.411907 -3.337410 -3.203952 -2.871628 -3.123194 -3.158578 -3.210770 -3.263864 -3.311697 -3.351256 -3.391463 -3.429890 -3.465657 -3.496280 -3.512595 -3.520411 -3.525506 -3.516925 -3.488308 -3.430627 -3.385033 -3.311299 -3.182538 -2.871628 -3.345943 -3.354872 -3.381205 -3.409579 -3.433923 -3.451164 -3.470907 -3.490914 -3.510619 -3.526959 -3.530399 -3.525565 -3.520463 -3.503676 -3.467830 -3.404536 -3.353428 -3.282200 -3.158891 -2.871628 -3.588979 -3.569312 -3.571402 -3.574862 -3.574122 -3.566657 -3.563236 -3.561803 -3.562489 -3.562389 -3.550846 -3.531394 -3.514007 -3.486949 -3.444577 -3.381072 -3.317935 -3.249509 -3.132328 -2.871628 -3.929936 -3.874293 -3.845645 -3.819285 -3.789263 -3.750525 -3.715818 -3.686096 -3.660768 -3.635782 -3.604997 -3.560724 -3.525084 -3.485929 -3.434691 -3.366425 -3.282991 -3.214467 -3.102818 -2.871628 -7.745110 -7.593304 -7.426156 -7.244489 -7.049057 -6.840644 -6.619963 -6.387639 -6.144300 -5.890510 -5.626753 -5.353517 -5.071238 -4.780296 -4.481071 -4.173902 -3.859090 -3.536932 -3.207697 -2.871628 -1.405076 -1.637519 -1.897884 -2.133621 -2.342311 -2.504577 -2.658961 -2.845069 -3.017708 -3.170093 -3.284295 -3.362795 -3.499085 -3.616217 -3.710733 -3.750967 -3.784243 -3.786944 -3.664948 -3.091126 -1.230016 -1.496038 -1.778111 -2.036392 -2.264531 -2.430235 -2.615644 -2.821531 -3.010314 -3.173381 -3.284546 -3.366663 -3.510251 -3.630734 -3.724258 -3.753575 -3.783646 -3.782091 -3.655130 -3.091126 -1.152361 -1.435197 -1.723397 -1.988070 -2.213847 -2.405618 -2.611638 -2.827446 -3.019913 -3.184984 -3.285433 -3.385458 -3.530206 -3.648946 -3.737286 -3.753877 -3.784020 -3.776653 -3.644634 -3.091126 -1.138738 -1.427588 -1.712841 -1.970494 -2.204683 -2.418978 -2.634907 -2.847561 -3.041966 -3.199422 -3.304750 -3.415787 -3.555632 -3.669143 -3.749125 -3.756297 -3.784169 -3.770495 -3.633399 -3.091126 -1.173135 -1.458395 -1.733821 -1.991148 -2.235561 -2.459798 -2.672899 -2.882827 -3.072402 -3.220653 -3.336185 -3.451571 -3.583717 -3.689891 -3.758658 -3.760558 -3.784171 -3.763458 -3.621356 -3.091126 -1.244051 -1.520128 -1.791092 -2.048641 -2.294606 -2.515997 -2.726141 -2.931008 -3.108429 -3.255805 -3.377818 -3.489808 -3.613315 -3.710010 -3.764675 -3.765916 -3.784004 -3.755353 -3.608429 -3.091126 -1.346444 -1.615418 -1.881033 -2.134685 -2.369037 -2.586517 -2.793322 -2.986890 -3.155025 -3.302813 -3.422676 -3.529736 -3.643068 -3.728302 -3.770512 -3.771887 -3.782499 -3.746029 -3.594713 -3.091126 -1.480456 -1.739866 -1.997775 -2.234314 -2.460109 -2.673457 -2.869832 -3.049657 -3.211747 -3.355361 -3.470494 -3.570730 -3.672427 -3.743387 -3.778135 -3.776795 -3.779842 -3.735318 -3.580280 -3.091126 -1.642062 -1.885159 -2.124366 -2.352494 -2.570240 -2.772878 -2.951493 -3.119981 -3.274734 -3.408990 -3.519001 -3.611326 -3.700153 -3.756236 -3.786261 -3.780499 -3.775201 -3.722995 -3.565026 -3.091126 -1.819915 -2.044397 -2.271621 -2.488133 -2.692951 -2.873952 -3.039994 -3.196170 -3.338051 -3.463381 -3.566652 -3.650125 -3.724319 -3.770541 -3.794312 -3.782605 -3.768478 -3.708863 -3.549085 -3.091126 -2.019595 -2.224808 -2.436297 -2.630656 -2.813298 -2.982574 -3.131731 -3.272186 -3.402415 -3.518330 -3.612238 -3.684927 -3.746470 -3.784856 -3.800678 -3.781973 -3.759178 -3.692693 -3.532386 -3.091126 -2.241246 -2.416977 -2.600581 -2.777327 -2.942076 -3.089875 -3.222328 -3.349579 -3.467965 -3.572680 -3.654316 -3.715629 -3.767806 -3.797522 -3.804950 -3.778040 -3.746901 -3.674197 -3.514575 -3.091126 -2.466239 -2.615832 -2.774615 -2.927087 -3.069018 -3.198272 -3.315397 -3.428247 -3.532610 -3.624133 -3.693146 -3.744348 -3.786646 -3.806953 -3.805613 -3.770482 -3.731205 -3.652987 -3.495490 -3.091126 -2.704587 -2.820348 -2.950312 -3.079151 -3.201319 -3.312011 -3.410458 -3.505824 -3.594748 -3.672773 -3.730030 -3.769876 -3.801263 -3.811304 -3.801419 -3.758495 -3.711597 -3.628961 -3.474907 -3.091126 -2.949104 -3.034096 -3.136725 -3.239896 -3.337968 -3.427052 -3.505489 -3.582296 -3.654883 -3.718480 -3.763291 -3.790481 -3.809942 -3.809347 -3.791230 -3.741406 -3.687377 -3.602042 -3.452535 -3.091126 -3.209518 -3.259856 -3.331388 -3.405998 -3.478256 -3.544105 -3.600963 -3.657690 -3.711846 -3.759133 -3.790207 -3.804498 -3.811795 -3.800232 -3.773958 -3.718217 -3.657885 -3.572312 -3.427985 -3.091126 -3.484508 -3.500463 -3.538641 -3.581512 -3.625234 -3.663944 -3.696114 -3.730597 -3.764513 -3.794325 -3.810326 -3.811044 -3.805991 -3.783278 -3.748702 -3.687771 -3.621931 -3.538476 -3.400664 -3.091126 -3.786136 -3.764234 -3.766915 -3.775179 -3.786308 -3.795018 -3.798969 -3.808040 -3.818962 -3.828614 -3.827075 -3.812565 -3.793941 -3.759170 -3.714953 -3.651730 -3.578577 -3.499149 -3.369747 -3.091126 -4.186026 -4.116284 -4.078193 -4.048026 -4.022184 -3.991697 -3.956594 -3.930351 -3.908899 -3.888989 -3.863256 -3.825017 -3.788492 -3.742896 -3.687397 -3.618425 -3.528083 -3.454018 -3.334556 -3.091126 -9.300068 -9.116036 -8.910143 -8.683781 -8.438292 -8.174921 -7.894796 -7.598967 -7.288372 -6.963861 -6.626196 -6.276063 -5.914096 -5.540868 -5.156897 -4.762655 -4.358574 -3.945052 -3.522455 -3.091126 -1.282748 -1.566432 -1.855355 -2.134828 -2.386600 -2.588806 -2.734387 -2.942963 -3.134343 -3.309910 -3.449565 -3.515723 -3.670372 -3.804219 -3.917894 -3.975155 -4.011187 -4.029942 -3.911874 -3.288899 -1.041741 -1.354605 -1.683503 -1.997462 -2.277132 -2.483540 -2.663979 -2.896748 -3.112327 -3.306918 -3.447417 -3.513335 -3.679018 -3.819452 -3.934966 -3.980990 -4.012528 -4.026380 -3.901729 -3.288899 -0.9173490 -1.260281 -1.606015 -1.929134 -2.205389 -2.429898 -2.646680 -2.890363 -3.117309 -3.316683 -3.442461 -3.534733 -3.700922 -3.840671 -3.952582 -3.982727 -4.014863 -4.022291 -3.890772 -3.288899 -0.8857921 -1.238409 -1.585120 -1.895849 -2.174407 -2.426688 -2.660804 -2.910060 -3.141285 -3.330901 -3.458404 -3.572517 -3.730416 -3.865797 -3.969627 -3.986630 -4.018120 -4.017464 -3.878932 -3.288899 -0.9168305 -1.266660 -1.595479 -1.901187 -2.191146 -2.455487 -2.701383 -2.950180 -3.171908 -3.350141 -3.494288 -3.615793 -3.765260 -3.892275 -3.984622 -3.994072 -4.022121 -4.011650 -3.866120 -3.288899 -0.9910000 -1.324586 -1.644603 -1.948745 -2.239458 -2.512426 -2.761536 -3.001446 -3.210652 -3.392204 -3.543504 -3.664354 -3.802443 -3.918977 -3.995792 -4.003720 -4.025324 -4.004650 -3.852239 -3.288899 -1.097394 -1.420352 -1.730622 -2.029570 -2.319747 -2.591046 -2.833095 -3.060696 -3.266066 -3.451507 -3.597733 -3.716657 -3.841565 -3.944759 -4.005208 -4.014557 -4.027358 -3.996268 -3.837331 -3.288899 -1.241091 -1.550771 -1.850400 -2.141494 -2.424513 -2.683170 -2.913653 -3.135409 -3.339642 -3.513297 -3.657521 -3.769388 -3.881247 -3.967774 -4.017782 -4.024896 -4.027972 -3.986293 -3.821619 -3.288899 -1.417944 -1.712177 -1.999642 -2.279594 -2.540529 -2.787234 -3.012564 -3.228575 -3.416044 -3.580420 -3.716320 -3.821006 -3.918876 -3.987946 -4.032317 -4.034558 -4.026564 -3.974420 -3.805002 -3.288899 -1.623864 -1.900781 -2.169200 -2.424151 -2.673455 -2.912228 -3.129284 -3.321743 -3.496872 -3.648197 -3.773794 -3.870032 -3.952211 -4.009426 -4.046767 -4.042055 -4.022698 -3.960409 -3.787347 -3.288899 -1.854190 -2.102746 -2.350927 -2.592273 -2.829235 -3.049196 -3.239210 -3.418959 -3.576822 -3.714831 -3.829709 -3.915064 -3.981905 -4.030754 -4.059984 -4.046495 -4.016002 -3.943976 -3.768469 -3.288899 -2.101161 -2.326739 -2.556761 -2.779267 -2.986588 -3.181501 -3.353959 -3.511933 -3.654140 -3.780427 -3.882937 -3.955716 -4.011322 -4.049927 -4.070038 -4.047386 -4.006010 -3.924754 -3.748814 -3.288899 -2.376554 -2.571072 -2.767133 -2.959663 -3.145836 -3.314229 -3.462900 -3.602909 -3.731003 -3.843224 -3.932451 -3.995046 -4.038909 -4.065691 -4.075426 -4.043773 -3.992058 -3.902192 -3.727659 -3.288899 -2.658185 -2.817103 -2.982295 -3.143855 -3.298829 -3.443799 -3.573282 -3.694964 -3.805718 -3.902324 -3.979421 -4.030605 -4.062275 -4.075696 -4.074906 -4.034611 -3.973366 -3.876151 -3.704741 -3.288899 -2.953178 -3.069346 -3.198528 -3.329460 -3.458108 -3.578223 -3.684766 -3.785789 -3.878121 -3.958208 -4.021081 -4.059533 -4.078436 -4.078485 -4.067050 -4.018660 -3.948923 -3.846687 -3.679733 -3.288899 -3.261212 -3.336917 -3.428823 -3.524981 -3.622536 -3.714616 -3.796512 -3.874907 -3.946290 -4.008223 -4.054807 -4.078897 -4.084857 -4.072333 -4.050327 -3.994418 -3.917731 -3.813113 -3.652151 -3.288899 -3.589115 -3.621490 -3.672468 -3.730820 -3.794212 -3.854771 -3.907906 -3.959949 -4.007854 -4.049328 -4.078346 -4.086924 -4.079300 -4.055398 -4.022978 -3.960342 -3.879030 -3.775091 -3.621285 -3.288899 -3.950158 -3.934864 -3.940247 -3.955193 -3.978798 -4.002547 -4.021802 -4.043997 -4.065631 -4.083731 -4.092906 -4.083778 -4.061091 -4.025912 -3.983613 -3.915820 -3.831070 -3.730516 -3.586085 -3.288899 -4.408027 -4.337816 -4.291758 -4.257367 -4.232873 -4.208962 -4.182271 -4.163083 -4.148779 -4.134848 -4.115217 -4.082782 -4.041500 -3.991307 -3.933664 -3.865273 -3.771631 -3.678044 -3.545201 -3.288899 -10.91791 -10.70105 -10.45475 -10.18120 -9.882466 -9.560441 -9.216810 -8.853076 -8.470572 -8.070486 -7.653873 -7.221676 -6.774741 -6.313823 -5.839607 -5.352710 -4.853699 -4.343085 -3.821340 -3.288899 -1.157321 -1.510976 -1.820595 -2.136073 -2.421998 -2.664353 -2.810795 -3.040858 -3.248447 -3.440302 -3.600729 -3.656006 -3.826232 -3.975242 -4.105136 -4.178341 -4.215747 -4.250459 -4.139017 -3.468863 -0.8438525 -1.227399 -1.590084 -1.946634 -2.274714 -2.539082 -2.717298 -2.974405 -3.210345 -3.427114 -3.597390 -3.646163 -3.831427 -3.990706 -4.125666 -4.187757 -4.218154 -4.248525 -4.128840 -3.468863 -0.6802991 -1.095216 -1.480462 -1.854298 -2.195696 -2.463476 -2.690796 -2.958509 -3.206157 -3.434722 -3.593385 -3.668632 -3.855312 -4.015056 -4.147969 -4.191948 -4.223237 -4.246223 -4.117712 -3.468863 -0.6295395 -1.048918 -1.443723 -1.822286 -2.156042 -2.443761 -2.700064 -2.970896 -3.225642 -3.452908 -3.602399 -3.711633 -3.889831 -4.045323 -4.170597 -4.196929 -4.230454 -4.243241 -4.105546 -3.468863 -0.6495162 -1.064839 -1.459904 -1.826002 -2.158461 -2.462987 -2.734233 -3.007349 -3.262602 -3.475134 -3.638997 -3.764316 -3.930793 -4.078561 -4.191495 -4.207671 -4.237901 -4.239285 -4.092236 -3.468863 -0.7261357 -1.131666 -1.513159 -1.863405 -2.199102 -2.509891 -2.788704 -3.064231 -3.311970 -3.516437 -3.693560 -3.825527 -3.976891 -4.113279 -4.208704 -4.222340 -4.245514 -4.234057 -4.077663 -3.468863 -0.8470410 -1.234385 -1.593799 -1.939162 -2.270890 -2.581386 -2.866172 -3.135790 -3.366364 -3.578258 -3.760201 -3.888855 -4.026418 -4.147475 -4.222940 -4.238443 -4.252081 -4.227359 -4.061806 -3.468863 -1.001551 -1.366460 -1.713223 -2.045784 -2.371274 -2.681178 -2.961885 -3.212613 -3.443222 -3.654413 -3.829969 -3.953584 -4.075332 -4.179553 -4.241345 -4.255665 -4.257342 -4.218904 -4.045036 -3.468863 -1.190234 -1.535108 -1.863795 -2.185354 -2.501395 -2.802993 -3.063000 -3.310374 -3.537340 -3.737613 -3.900799 -4.015848 -4.121521 -4.207575 -4.262766 -4.271886 -4.260704 -4.208286 -4.027269 -3.468863 -1.413659 -1.735920 -2.047842 -2.354592 -2.652687 -2.928917 -3.185847 -3.426515 -3.638896 -3.819665 -3.971969 -4.075162 -4.164121 -4.236530 -4.284633 -4.285841 -4.261426 -4.195271 -4.008357 -3.468863 -1.668996 -1.967469 -2.260701 -2.538858 -2.814723 -3.081857 -3.328420 -3.546036 -3.735921 -3.902360 -4.038807 -4.131672 -4.203933 -4.266350 -4.305233 -4.296690 -4.258927 -4.179459 -3.988121 -3.468863 -1.952215 -2.218380 -2.481847 -2.743090 -3.003436 -3.252169 -3.466185 -3.661604 -3.831452 -3.978520 -4.102078 -4.184305 -4.244101 -4.294810 -4.322552 -4.303178 -4.252524 -4.160413 -3.966275 -3.468863 -2.252207 -2.491519 -2.732092 -2.969528 -3.194199 -3.409007 -3.602149 -3.771081 -3.919989 -4.051795 -4.162030 -4.234185 -4.282346 -4.319380 -4.334886 -4.304127 -4.241278 -4.137348 -3.943209 -3.468863 -2.586717 -2.785131 -2.985778 -3.186439 -3.381576 -3.563466 -3.727116 -3.874980 -4.006768 -4.122741 -4.218923 -4.278911 -4.314949 -4.337578 -4.340534 -4.298478 -4.224078 -4.110068 -3.918170 -3.468863 -2.926660 -3.082250 -3.243623 -3.403552 -3.561982 -3.714018 -3.853631 -3.979435 -4.091239 -4.189760 -4.270308 -4.316351 -4.338425 -4.346971 -4.337469 -4.284603 -4.199689 -4.078674 -3.890707 -3.468863 -3.283521 -3.388293 -3.506150 -3.628369 -3.751216 -3.870035 -3.980978 -4.081652 -4.171038 -4.249624 -4.312617 -4.343435 -4.350000 -4.344864 -4.323416 -4.260783 -4.166801 -4.041992 -3.860248 -3.468863 -3.665169 -3.717110 -3.786104 -3.863936 -3.946822 -4.029891 -4.107954 -4.178913 -4.242577 -4.298239 -4.341217 -4.355875 -4.346645 -4.328092 -4.295569 -4.224821 -4.124774 -4.000379 -3.825932 -3.468863 -4.081932 -4.079020 -4.092190 -4.117702 -4.154090 -4.195448 -4.235200 -4.271044 -4.304398 -4.334353 -4.354650 -4.351032 -4.325443 -4.293418 -4.251276 -4.174324 -4.071955 -3.951293 -3.786273 -3.468863 -4.600729 -4.533441 -4.480600 -4.444954 -4.423594 -4.410504 -4.399471 -4.388838 -4.381104 -4.376618 -4.366779 -4.335722 -4.291226 -4.241537 -4.188342 -4.112053 -4.005067 -3.892860 -3.738755 -3.468863 -12.59390 -12.34360 -12.05551 -11.73213 -11.37718 -10.99309 -10.58221 -10.14656 -9.687949 -9.207932 -8.707882 -8.189016 -7.652409 -7.099013 -6.529690 -5.945210 -5.346278 -4.733529 -4.107544 -3.468863 -1.039498 -1.458685 -1.798997 -2.148173 -2.461187 -2.733268 -2.889719 -3.135419 -3.359973 -3.565337 -3.741976 -3.794982 -3.971220 -4.131956 -4.275961 -4.364125 -4.400085 -4.451561 -4.349365 -3.633962 -0.6499165 -1.104207 -1.509056 -1.904108 -2.268158 -2.576793 -2.769370 -3.052551 -3.306093 -3.543130 -3.735372 -3.775260 -3.972793 -4.147364 -4.299762 -4.377429 -4.403779 -4.451466 -4.339458 -3.633962 -0.4436902 -0.9306179 -1.363879 -1.780566 -2.164974 -2.482124 -2.743054 -3.029974 -3.296694 -3.546606 -3.731543 -3.799920 -3.997705 -4.175199 -4.326886 -4.384960 -4.411518 -4.451233 -4.328468 -3.633962 -0.3710078 -0.8632587 -1.307701 -1.731061 -2.118782 -2.464800 -2.752167 -3.038990 -3.314365 -3.564094 -3.737597 -3.846902 -4.037272 -4.210586 -4.355111 -4.390874 -4.422289 -4.450433 -4.316278 -3.633962 -0.3831376 -0.8694901 -1.312934 -1.733286 -2.130540 -2.482471 -2.779402 -3.074599 -3.348721 -3.590621 -3.778296 -3.905913 -4.086951 -4.250722 -4.382363 -4.405046 -4.434270 -4.448792 -4.302762 -3.633962 -0.4604848 -0.9300186 -1.365466 -1.784124 -2.172941 -2.517099 -2.831062 -3.125122 -3.399097 -3.638388 -3.835376 -3.975143 -4.142767 -4.294155 -4.406618 -4.424709 -4.446399 -4.445899 -4.287776 -3.633962 -0.5863125 -1.037528 -1.461873 -1.861717 -2.233430 -2.585056 -2.900190 -3.195982 -3.463958 -3.703236 -3.905234 -4.049597 -4.200677 -4.337540 -4.426737 -4.447257 -4.458298 -4.441454 -4.271244 -3.633962 -0.7571545 -1.186953 -1.584924 -1.963262 -2.331193 -2.675382 -2.993899 -3.285121 -3.547715 -3.782065 -3.985263 -4.123673 -4.259799 -4.378913 -4.451283 -4.471125 -4.469120 -4.435082 -4.253656 -3.633962 -0.9648476 -1.361949 -1.736571 -2.101904 -2.455479 -2.796784 -3.109797 -3.391464 -3.643515 -3.875811 -4.071474 -4.197662 -4.316977 -4.415795 -4.479510 -4.494201 -4.477665 -4.426325 -4.234989 -3.633962 -1.201772 -1.572140 -1.924046 -2.271513 -2.615642 -2.945023 -3.241126 -3.509388 -3.757208 -3.979003 -4.153959 -4.271454 -4.371224 -4.453681 -4.508988 -4.515066 -4.483139 -4.414824 -4.215067 -3.633962 -1.476061 -1.816451 -2.147553 -2.476902 -2.801802 -3.104028 -3.388547 -3.648521 -3.880710 -4.074142 -4.236366 -4.339386 -4.421813 -4.493035 -4.537502 -4.532539 -4.485034 -4.400073 -4.193682 -3.633962 -1.783600 -2.095444 -2.404018 -2.700669 -2.996419 -3.287155 -3.558524 -3.791348 -3.993672 -4.168880 -4.311034 -4.401540 -4.472252 -4.530830 -4.562859 -4.545374 -4.482511 -4.381444 -4.170564 -3.633962 -2.120665 -2.396834 -2.670506 -2.945685 -3.222159 -3.485311 -3.718807 -3.925569 -4.101864 -4.254302 -4.381383 -4.461509 -4.519724 -4.564399 -4.582686 -4.552401 -4.474391 -4.358181 -4.145335 -3.633962 -2.483607 -2.725693 -2.970821 -3.208196 -3.442298 -3.669436 -3.871564 -4.046323 -4.199985 -4.335691 -4.448910 -4.517427 -4.561131 -4.591081 -4.594855 -4.551902 -4.459473 -4.329908 -4.118446 -3.633962 -2.877012 -3.067687 -3.266187 -3.462777 -3.655861 -3.841520 -4.012232 -4.162898 -4.296820 -4.413709 -4.509798 -4.565547 -4.593131 -4.607899 -4.597188 -4.541790 -4.436061 -4.296915 -4.088793 -3.633962 -3.284708 -3.419540 -3.564420 -3.713589 -3.865340 -4.015840 -4.155875 -4.278718 -4.388300 -4.484190 -4.560787 -4.601342 -4.612123 -4.611061 -4.586799 -4.519601 -4.402771 -4.258052 -4.055706 -3.633962 -3.718197 -3.791337 -3.881236 -3.979525 -4.084919 -4.194264 -4.298305 -4.388937 -4.469942 -4.541951 -4.596534 -4.619123 -4.613459 -4.596117 -4.560003 -4.482518 -4.358823 -4.211616 -4.018184 -3.633962 -4.190102 -4.198153 -4.225184 -4.265202 -4.317879 -4.377902 -4.438372 -4.490510 -4.537590 -4.580897 -4.611578 -4.614080 -4.591603 -4.558191 -4.512584 -4.427824 -4.301720 -4.156303 -3.974515 -3.633962 -4.768821 -4.703322 -4.653051 -4.619382 -4.604626 -4.603065 -4.606047 -4.606984 -4.609257 -4.614195 -4.613657 -4.589239 -4.544524 -4.494220 -4.440410 -4.353262 -4.230393 -4.089235 -3.921384 -3.633962 -14.32395 -14.03962 -13.70767 -13.33265 -12.91868 -12.46935 -11.98774 -11.47653 -10.93798 -10.37408 -9.786539 -9.176852 -8.546340 -7.896168 -7.227380 -6.540906 -5.837594 -5.118210 -4.383452 -3.633962 -0.9242685 -1.411047 -1.783395 -2.168602 -2.511476 -2.804953 -2.991935 -3.222428 -3.463654 -3.685099 -3.874309 -3.943983 -4.106096 -4.277648 -4.433180 -4.534624 -4.568306 -4.636679 -4.545204 -3.786466 -0.4610777 -0.9913361 -1.440794 -1.880643 -2.273012 -2.614122 -2.829772 -3.119752 -3.398259 -3.653094 -3.865007 -3.909342 -4.104706 -4.292370 -4.460213 -4.552236 -4.573258 -4.638693 -4.535872 -3.786466 -0.2189128 -0.7749235 -1.267790 -1.724270 -2.141308 -2.494929 -2.788381 -3.097945 -3.387559 -3.654571 -3.860894 -3.932031 -4.132337 -4.322866 -4.491772 -4.563054 -4.584277 -4.640945 -4.525314 -3.786466 -0.1209459 -0.6826488 -1.183989 -1.650244 -2.078024 -2.463752 -2.799154 -3.112694 -3.402739 -3.674318 -3.861940 -3.984396 -4.177634 -4.364061 -4.525702 -4.570096 -4.598656 -4.642858 -4.513404 -3.786466 -0.1222258 -0.6755248 -1.173184 -1.640272 -2.079297 -2.484769 -2.834040 -3.143322 -3.439450 -3.701365 -3.904928 -4.050554 -4.233872 -4.412389 -4.560059 -4.588068 -4.615065 -4.644156 -4.499979 -3.786466 -0.1975210 -0.7315825 -1.220981 -1.685439 -2.129361 -2.532867 -2.878699 -3.193380 -3.488921 -3.748221 -3.969269 -4.123811 -4.297772 -4.463369 -4.591785 -4.613007 -4.632454 -4.644337 -4.484878 -3.786466 -0.3291993 -0.8405763 -1.315610 -1.773988 -2.206038 -2.593936 -2.943793 -3.262361 -3.553323 -3.820717 -4.042668 -4.202470 -4.367097 -4.515948 -4.617980 -4.642124 -4.649838 -4.642924 -4.467955 -3.786466 -0.5086913 -0.9943427 -1.452725 -1.891521 -2.297148 -2.680990 -3.032255 -3.347719 -3.642972 -3.908652 -4.126371 -4.286819 -4.435801 -4.567067 -4.648467 -4.672426 -4.665950 -4.639453 -4.449825 -3.786466 -0.7317004 -1.188955 -1.617277 -2.024209 -2.422181 -2.796348 -3.142944 -3.460486 -3.750502 -4.003091 -4.220521 -4.374144 -4.505106 -4.613650 -4.684247 -4.702263 -4.680005 -4.633453 -4.430550 -3.786466 -0.9929332 -1.409569 -1.806942 -2.197980 -2.576443 -2.943342 -3.285095 -3.591684 -3.863807 -4.112978 -4.320946 -4.458013 -4.570859 -4.660409 -4.722301 -4.730503 -4.690798 -4.624413 -4.409927 -3.786466 -1.282803 -1.664289 -2.036749 -2.404382 -2.769356 -3.123730 -3.443780 -3.731820 -3.998026 -4.233241 -4.414295 -4.538656 -4.631680 -4.709035 -4.759539 -4.755566 -4.698023 -4.611675 -4.387711 -3.786466 -1.611607 -1.959045 -2.306310 -2.650662 -2.990731 -3.314048 -3.619414 -3.896547 -4.139944 -4.341926 -4.506512 -4.611644 -4.691778 -4.756331 -4.792724 -4.775958 -4.700294 -4.594554 -4.363599 -3.786466 -1.977084 -2.292514 -2.606607 -2.914223 -3.225825 -3.532643 -3.819961 -4.058223 -4.269344 -4.446280 -4.588551 -4.682020 -4.748539 -4.799319 -4.819969 -4.789481 -4.696392 -4.572263 -4.337237 -3.786466 -2.374067 -2.646453 -2.925548 -3.206952 -3.491801 -3.755030 -3.997639 -4.207196 -4.386067 -4.539345 -4.666144 -4.748421 -4.798944 -4.834938 -4.839534 -4.794384 -4.684690 -4.544207 -4.308304 -3.786466 -2.808581 -3.037901 -3.268596 -3.501034 -3.737514 -3.960446 -4.162700 -4.337430 -4.493450 -4.628597 -4.738605 -4.806537 -4.840561 -4.859696 -4.848563 -4.788407 -4.663271 -4.510777 -4.276792 -3.786466 -3.264214 -3.431335 -3.609728 -3.788170 -3.970870 -4.151356 -4.319853 -4.466620 -4.596392 -4.709663 -4.800313 -4.851480 -4.868721 -4.869070 -4.843001 -4.769279 -4.630256 -4.470628 -4.241405 -3.786466 -3.748667 -3.845108 -3.961260 -4.083648 -4.214624 -4.349361 -4.477124 -4.589500 -4.689106 -4.776375 -4.843842 -4.876321 -4.876459 -4.857945 -4.818201 -4.732933 -4.584498 -4.421324 -4.200990 -3.786466 -4.279078 -4.298617 -4.341965 -4.399144 -4.470944 -4.552183 -4.630842 -4.700977 -4.764166 -4.820550 -4.861089 -4.872943 -4.855509 -4.819870 -4.768603 -4.675493 -4.521932 -4.360701 -4.153586 -3.786466 -4.915707 -4.851201 -4.806068 -4.780087 -4.775102 -4.786199 -4.801721 -4.815866 -4.831070 -4.847444 -4.854340 -4.838781 -4.799736 -4.747354 -4.686096 -4.592840 -4.442855 -4.284010 -4.095212 -3.786466 -16.10451 -15.78555 -15.40846 -14.97936 -14.50370 -13.98615 -13.43064 -12.84047 -12.21849 -11.56710 -10.88836 -10.18408 -9.455817 -8.704967 -7.932762 -7.140304 -6.328584 -5.498504 -4.650880 -3.786466 -0.8078259 -1.355792 -1.768803 -2.189284 -2.559122 -2.880756 -3.094535 -3.308406 -3.561405 -3.795890 -3.999569 -4.086554 -4.232919 -4.413958 -4.578984 -4.692048 -4.723808 -4.807454 -4.728213 -3.928160 -0.2714067 -0.8812725 -1.375796 -1.856557 -2.289080 -2.661509 -2.893216 -3.182886 -3.480055 -3.757124 -3.986561 -4.040091 -4.227496 -4.428193 -4.608648 -4.713632 -4.730356 -4.811732 -4.719740 -3.928160 4.1271993E-03 -0.6283157 -1.176999 -1.683598 -2.140430 -2.516946 -2.831073 -3.152852 -3.469696 -3.759117 -3.983734 -4.060232 -4.259080 -4.461824 -4.645164 -4.728259 -4.744652 -4.816711 -4.709916 -3.928160 0.1280483 -0.5120215 -1.075642 -1.594418 -2.050643 -2.465237 -2.830698 -3.172214 -3.492679 -3.779013 -3.984557 -4.116220 -4.312485 -4.508554 -4.685529 -4.736281 -4.763660 -4.821751 -4.698589 -3.928160 0.1339078 -0.4889709 -1.049035 -1.558907 -2.034188 -2.474979 -2.866989 -3.214945 -3.529695 -3.811558 -4.025370 -4.188169 -4.375371 -4.563318 -4.726778 -4.757154 -4.785603 -4.826401 -4.685563 -3.928160 6.1115026E-02 -0.5385227 -1.081907 -1.591928 -2.075923 -2.526642 -2.926572 -3.267184 -3.581308 -3.857549 -4.091171 -4.270143 -4.445506 -4.623484 -4.765455 -4.786897 -4.809169 -4.830081 -4.670640 -3.928160 -7.5450465E-02 -0.6462207 -1.174402 -1.676975 -2.158801 -2.605440 -2.992768 -3.331860 -3.647561 -3.930339 -4.173286 -4.352539 -4.522243 -4.685027 -4.798513 -4.821894 -4.832728 -4.832262 -4.653619 -3.928160 -0.2638110 -0.8052445 -1.311791 -1.801389 -2.269703 -2.693637 -3.072886 -3.418937 -3.733025 -4.023273 -4.263783 -4.441403 -4.603536 -4.745984 -4.836271 -4.860116 -4.854975 -4.832389 -4.635217 -3.928160 -0.4993278 -1.007332 -1.488891 -1.955088 -2.393427 -2.803974 -3.183318 -3.524657 -3.844378 -4.129647 -4.359130 -4.537373 -4.683110 -4.803232 -4.880424 -4.898172 -4.875277 -4.829908 -4.615634 -3.928160 -0.7774596 -1.248041 -1.696679 -2.127705 -2.548395 -2.947139 -3.318805 -3.661462 -3.972373 -4.239690 -4.466816 -4.634772 -4.761171 -4.859291 -4.926649 -4.934225 -4.892242 -4.824140 -4.594618 -3.928160 -1.091576 -1.514992 -1.931524 -2.339825 -2.737872 -3.126444 -3.489968 -3.815939 -4.106045 -4.367900 -4.581686 -4.725995 -4.833788 -4.917420 -4.971774 -4.966337 -4.905185 -4.814312 -4.571878 -3.928160 -1.436359 -1.823102 -2.208665 -2.589974 -2.970971 -3.343254 -3.676241 -3.983438 -4.264132 -4.503019 -4.687383 -4.813258 -4.902976 -4.974433 -5.013451 -4.993418 -4.912901 -4.799698 -4.547067 -3.928160 -1.826344 -2.175410 -2.529011 -2.884115 -3.228913 -3.566603 -3.886963 -4.177344 -4.420403 -4.626472 -4.787077 -4.894486 -4.969303 -5.026592 -5.049686 -5.013826 -4.913811 -4.779390 -4.519790 -3.928160 -2.257043 -2.564350 -2.876025 -3.189340 -3.510555 -3.827100 -4.107661 -4.351103 -4.561796 -4.736443 -4.876057 -4.970423 -5.030628 -5.070999 -5.077456 -5.026028 -4.906200 -4.752605 -4.489467 -3.928160 -2.721499 -2.981118 -3.256020 -3.529458 -3.800791 -4.065707 -4.303717 -4.506337 -4.683022 -4.835719 -4.958290 -5.037191 -5.082902 -5.104655 -5.093500 -5.026446 -4.887960 -4.719745 -4.456092 -3.928160 -3.226944 -3.424149 -3.639491 -3.853317 -4.071100 -4.282158 -4.475754 -4.647455 -4.798321 -4.927801 -5.029124 -5.090472 -5.119419 -5.123315 -5.093676 -5.010963 -4.856850 -4.679288 -4.418637 -3.928160 -3.763609 -3.882038 -4.023994 -4.176578 -4.336333 -4.497993 -4.648460 -4.783135 -4.902335 -5.004694 -5.081351 -5.123015 -5.132348 -5.120179 -5.073111 -4.974959 -4.811199 -4.628613 -4.375544 -3.928160 -4.351332 -4.383663 -4.444475 -4.521661 -4.615724 -4.718299 -4.817217 -4.905486 -4.986089 -5.055934 -5.103779 -5.123178 -5.112008 -5.085787 -5.024339 -4.914542 -4.746140 -4.564080 -4.324605 -3.928160 -5.045126 -4.983346 -4.944740 -4.929261 -4.939460 -4.963767 -4.993470 -5.020712 -5.050488 -5.077742 -5.090591 -5.082220 -5.048656 -5.007990 -4.935909 -4.824494 -4.659186 -4.479528 -4.261154 -3.928160 -17.93244 -17.57829 -17.15455 -16.66925 -16.12941 -15.54085 -14.90844 -14.23621 -13.52756 -12.78534 -12.01201 -11.20966 -10.38013 -9.525040 -8.645809 -7.743721 -6.819921 -5.875449 -4.911240 -3.928160 -0.6927372 -1.295888 -1.743176 -2.205996 -2.606744 -2.950367 -3.195304 -3.395586 -3.657011 -3.900712 -4.116512 -4.222288 -4.353055 -4.541379 -4.714334 -4.839482 -4.868186 -4.965447 -4.899858 -4.060476 -8.0109604E-02 -0.7526900 -1.303969 -1.835070 -2.300551 -2.707947 -2.966624 -3.249083 -3.558253 -3.851671 -4.101601 -4.165954 -4.343794 -4.554737 -4.746257 -4.865787 -4.876173 -4.972024 -4.892547 -4.060476 0.2315285 -0.4766205 -1.089549 -1.641074 -2.138376 -2.558265 -2.882608 -3.210858 -3.542321 -3.855052 -4.101869 -4.184549 -4.380195 -4.592676 -4.786986 -4.884665 -4.893890 -4.979905 -4.883780 -4.060476 0.3720609 -0.3450913 -0.9699888 -1.538037 -2.046879 -2.481439 -2.865464 -3.224288 -3.569853 -3.883255 -4.102468 -4.243457 -4.440111 -4.644578 -4.833494 -4.894578 -4.918140 -4.988328 -4.873353 -4.060476 0.3915075 -0.3088684 -0.9291921 -1.499356 -2.006238 -2.471261 -2.890879 -3.270492 -3.619249 -3.918007 -4.145188 -4.319840 -4.511917 -4.705253 -4.881938 -4.918244 -4.946395 -4.996601 -4.861037 -4.060476 0.3167647 -0.3503075 -0.9570940 -1.511165 -2.029394 -2.513790 -2.950693 -3.339253 -3.676620 -3.966862 -4.212046 -4.405933 -4.590066 -4.772535 -4.927937 -4.953349 -4.976180 -5.004107 -4.846608 -4.060476 0.1752333 -0.4574265 -1.038503 -1.586269 -2.106707 -2.593929 -3.036281 -3.410529 -3.741065 -4.041302 -4.296433 -4.497613 -4.673149 -4.844406 -4.969308 -4.995443 -5.006265 -5.010260 -4.829795 -4.060476 -2.2306450E-02 -0.6173038 -1.176448 -1.708974 -2.223461 -2.703158 -3.123315 -3.489427 -3.830700 -4.132444 -4.392551 -4.591062 -4.761234 -4.915182 -5.015389 -5.041160 -5.035241 -5.014423 -4.811367 -4.060476 -0.2695509 -0.8279277 -1.356374 -1.872403 -2.367532 -2.818328 -3.224054 -3.599241 -3.935708 -4.243303 -4.496398 -4.690829 -4.853540 -4.982290 -5.067796 -5.086661 -5.062083 -5.015851 -4.791747 -4.060476 -0.5621676 -1.079260 -1.577963 -2.068077 -2.523519 -2.957654 -3.360055 -3.728561 -4.068059 -4.366970 -4.607034 -4.797249 -4.942217 -5.050005 -5.122166 -5.129838 -5.086095 -5.013880 -4.770597 -4.060476 -0.8933820 -1.368618 -1.829728 -2.278969 -2.717089 -3.132925 -3.527158 -3.891804 -4.216307 -4.497546 -4.732137 -4.903820 -5.027713 -5.118054 -5.176047 -5.169716 -5.105523 -5.007551 -4.747572 -4.060476 -1.261984 -1.691002 -2.114218 -2.533911 -2.947587 -3.352324 -3.733717 -4.069766 -4.376311 -4.647738 -4.857745 -5.004696 -5.108641 -5.183533 -5.226557 -5.204794 -5.118940 -4.996051 -4.722303 -4.060476 -1.673001 -2.058725 -2.445464 -2.835707 -3.227684 -3.601036 -3.949113 -4.271536 -4.560336 -4.793167 -4.973797 -5.097624 -5.185611 -5.245042 -5.271148 -5.232918 -5.125085 -4.978270 -4.694344 -4.060476 -2.130529 -2.471744 -2.825006 -3.171447 -3.524311 -3.873070 -4.201084 -4.483760 -4.724242 -4.924113 -5.075958 -5.181375 -5.256984 -5.299767 -5.307413 -5.251104 -5.122256 -4.953194 -4.663142 -4.060476 -2.630446 -2.917739 -3.222560 -3.537191 -3.859421 -4.157588 -4.431198 -4.667744 -4.868823 -5.035464 -5.168374 -5.257743 -5.316760 -5.343747 -5.331752 -5.256226 -5.108527 -4.921152 -4.628003 -4.060476 -3.182139 -3.406016 -3.650587 -3.905474 -4.163294 -4.408375 -4.628718 -4.823467 -4.995513 -5.139215 -5.249944 -5.321320 -5.360285 -5.370994 -5.339313 -5.245050 -5.080755 -4.880431 -4.588661 -4.060476 -3.766285 -3.908778 -4.077128 -4.259737 -4.451220 -4.640824 -4.816902 -4.972665 -5.111509 -5.227053 -5.312286 -5.362944 -5.381012 -5.373124 -5.323397 -5.212917 -5.036505 -4.828193 -4.543086 -4.060476 -4.409186 -4.454138 -4.535061 -4.635664 -4.753700 -4.879883 -4.999192 -5.107212 -5.205439 -5.286302 -5.341699 -5.368629 -5.365355 -5.339606 -5.274734 -5.153427 -4.969860 -4.759984 -4.488805 -4.060476 -5.158622 -5.099067 -5.072350 -5.070583 -5.094845 -5.136760 -5.179514 -5.223060 -5.267403 -5.305515 -5.324433 -5.323171 -5.298279 -5.255881 -5.179301 -5.056757 -4.873328 -4.669095 -4.420570 -4.060476 -19.80499 -19.41507 -18.94322 -18.39972 -17.79330 -17.13112 -16.41902 -15.66183 -14.86350 -14.02738 -13.15630 -12.25269 -11.31864 -10.35601 -9.366436 -8.351369 -7.312117 -6.249855 -5.165651 -4.060476 -0.5856939 -1.247488 -1.741730 -2.212070 -2.645253 -3.017429 -3.288449 -3.480907 -3.751432 -4.001889 -4.226407 -4.351371 -4.466810 -4.662048 -4.841378 -4.977284 -5.002545 -5.112558 -5.061095 -4.184579 0.1095835 -0.6258488 -1.222145 -1.794293 -2.312896 -2.748019 -3.035691 -3.321455 -3.636758 -3.940928 -4.207345 -4.288970 -4.455131 -4.674469 -4.875586 -5.009038 -5.011595 -5.121542 -5.055193 -4.184579 0.4603085 -0.3111052 -0.9837998 -1.602237 -2.134908 -2.589849 -2.947777 -3.276403 -3.615187 -3.940733 -4.212471 -4.305622 -4.497436 -4.716071 -4.920145 -5.032594 -5.033371 -5.132476 -5.047706 -4.184579 0.6190747 -0.1677970 -0.8669563 -1.482960 -2.034508 -2.513410 -2.913847 -3.280802 -3.639666 -3.974584 -4.218692 -4.369337 -4.563711 -4.774952 -4.971434 -5.045091 -5.063027 -5.144495 -5.038422 -4.184579 0.6437021 -0.1302983 -0.8123180 -1.434741 -1.994057 -2.485626 -2.920108 -3.320972 -3.693988 -4.021955 -4.261269 -4.450506 -4.643532 -4.842480 -5.026114 -5.072005 -5.097119 -5.156760 -5.027086 -4.184579 0.5706907 -0.1655523 -0.8317165 -1.445936 -2.000484 -2.506043 -2.969987 -3.389925 -3.766538 -4.074491 -4.332745 -4.538943 -4.731320 -4.917133 -5.081388 -5.113647 -5.133275 -5.168510 -5.013420 -4.184579 0.4233002 -0.2708009 -0.9125027 -1.506908 -2.060267 -2.579143 -3.054255 -3.481181 -3.839100 -4.149347 -4.418157 -4.635599 -4.822337 -4.996121 -5.131060 -5.163227 -5.169825 -5.179057 -4.997123 -4.184579 0.2164519 -0.4342185 -1.044743 -1.622563 -2.174428 -2.690412 -3.165491 -3.569642 -3.923560 -4.243440 -4.515872 -4.738831 -4.916837 -5.076931 -5.185252 -5.216020 -5.205716 -5.187694 -4.979012 -4.184579 -4.3237742E-02 -0.6489983 -1.227728 -1.789211 -2.325213 -2.829204 -3.273625 -3.670390 -4.033215 -4.353597 -4.627244 -4.841232 -5.016491 -5.155897 -5.247431 -5.268095 -5.239606 -5.193547 -4.959660 -4.184579 -0.3505378 -0.9111438 -1.455635 -1.994467 -2.503938 -2.971898 -3.403400 -3.802312 -4.161711 -4.484395 -4.745709 -4.951934 -5.119582 -5.233815 -5.310563 -5.318638 -5.270212 -5.195732 -4.938742 -4.184579 -0.6986581 -1.216571 -1.726374 -2.226499 -2.695682 -3.149005 -3.568105 -3.961650 -4.318564 -4.624876 -4.873098 -5.071924 -5.215581 -5.312246 -5.371835 -5.366119 -5.296045 -5.193223 -4.915869 -4.184579 -1.089921 -1.562388 -2.023809 -2.483598 -2.930681 -3.363080 -3.775613 -4.157059 -4.487052 -4.777895 -5.014506 -5.184947 -5.311202 -5.387631 -5.430276 -5.408105 -5.316106 -5.185120 -4.890529 -4.184579 -1.521298 -1.941036 -2.364952 -2.789143 -3.215115 -3.629195 -4.012848 -4.362053 -4.678752 -4.949732 -5.146675 -5.292328 -5.398491 -5.458787 -5.483484 -5.442628 -5.329004 -5.170026 -4.862235 -4.184579 -2.003691 -2.373232 -2.757617 -3.150703 -3.538718 -3.914736 -4.273221 -4.602128 -4.876891 -5.098402 -5.267907 -5.387446 -5.476987 -5.522095 -5.528305 -5.467811 -5.332697 -5.146718 -4.830348 -4.184579 -2.537944 -2.853031 -3.186057 -3.533045 -3.891274 -4.241603 -4.546484 -4.818290 -5.047031 -5.229568 -5.372184 -5.473978 -5.545598 -5.574007 -5.560664 -5.480915 -5.324185 -5.115568 -4.793979 -4.184579 -3.119896 -3.376178 -3.656133 -3.945549 -4.243364 -4.527729 -4.777998 -4.997668 -5.187304 -5.344692 -5.464753 -5.547962 -5.599881 -5.609375 -5.575253 -5.476488 -5.299964 -5.074757 -4.753036 -4.184579 -3.756781 -3.924355 -4.123384 -4.336843 -4.560046 -4.779331 -4.978247 -5.158191 -5.314853 -5.443664 -5.537405 -5.598678 -5.629858 -5.618762 -5.564407 -5.448074 -5.257074 -5.021383 -4.705455 -4.184579 -4.455326 -4.514770 -4.616079 -4.740651 -4.885787 -5.034039 -5.171438 -5.301950 -5.417875 -5.513310 -5.575409 -5.609688 -5.620468 -5.589202 -5.517200 -5.387790 -5.189312 -4.950198 -4.648334 -4.184579 -5.266231 -5.203929 -5.188248 -5.202116 -5.246331 -5.299996 -5.356936 -5.420003 -5.479604 -5.533236 -5.557536 -5.562380 -5.551891 -5.502119 -5.416995 -5.283857 -5.086242 -4.853509 -4.575521 -4.184579 -21.71970 -21.29344 -20.77230 -20.16842 -19.49317 -18.75489 -17.96050 -17.11561 -16.22481 -15.29192 -14.32016 -13.31230 -12.27072 -11.19751 -10.09476 -8.963615 -7.805547 -6.622364 -5.415011 -4.184579 -0.4968795 -1.216706 -1.760038 -2.227777 -2.677693 -3.073423 -3.376870 -3.561300 -3.843384 -4.100329 -4.331174 -4.473729 -4.575021 -4.776843 -4.961401 -5.106145 -5.128645 -5.249497 -5.212214 -4.301429 0.2861437 -0.5174520 -1.153114 -1.746024 -2.298175 -2.786500 -3.100583 -3.389160 -3.717561 -4.028112 -4.306096 -4.407363 -4.561538 -4.788929 -4.998372 -5.142968 -5.139293 -5.260752 -5.207798 -4.301429 0.6815945 -0.1528301 -0.8702232 -1.529234 -2.128292 -2.619178 -3.003083 -3.351633 -3.691304 -4.024407 -4.312422 -4.424931 -4.610549 -4.834907 -5.047370 -5.170381 -5.165295 -5.274773 -5.201706 -4.301429 0.8641102 1.4884136E-02 -0.7380236 -1.425745 -2.021856 -2.534532 -2.973102 -3.347306 -3.710933 -4.057189 -4.326519 -4.493357 -4.684525 -4.899998 -5.103673 -5.185123 -5.200428 -5.290359 -5.193679 -4.301429 0.8996152 5.8695443E-02 -0.6962670 -1.371213 -1.974411 -2.509593 -2.966197 -3.375373 -3.762267 -4.113210 -4.376739 -4.579323 -4.772239 -4.976229 -5.164889 -5.215137 -5.240633 -5.306676 -5.183445 -4.301429 0.8243053 1.6683348E-02 -0.7075733 -1.377148 -1.981190 -2.516450 -2.995016 -3.437502 -3.838716 -4.178794 -4.448754 -4.672517 -4.867033 -5.059183 -5.227369 -5.262943 -5.283404 -5.322829 -5.170649 -4.301429 0.6693187 -8.7342896E-02 -0.7857789 -1.437490 -2.028977 -2.568573 -3.071639 -3.528419 -3.928895 -4.257525 -4.538794 -4.770647 -4.967270 -5.145064 -5.286523 -5.318635 -5.327195 -5.337901 -5.154923 -4.301429 0.4526947 -0.2540176 -0.9208747 -1.544119 -2.128422 -2.675991 -3.183578 -3.640042 -4.020739 -4.352779 -4.636871 -4.877321 -5.070332 -5.234402 -5.347512 -5.377211 -5.369981 -5.351209 -5.137128 -4.301429 0.1795060 -0.4762522 -1.102042 -1.709640 -2.279679 -2.821206 -3.318016 -3.747330 -4.127607 -4.465404 -4.751309 -4.991469 -5.175651 -5.324789 -5.416796 -5.437322 -5.410364 -5.361727 -5.118155 -4.301429 -0.1422063 -0.7469509 -1.337822 -1.918184 -2.469691 -2.988941 -3.450432 -3.874691 -4.257576 -4.595342 -4.879012 -5.106031 -5.286561 -5.411412 -5.487778 -5.496973 -5.447354 -5.368397 -5.097540 -4.301429 -0.5067035 -1.067352 -1.618550 -2.166025 -2.685015 -3.162886 -3.617293 -4.032732 -4.413402 -4.746818 -5.010913 -5.230985 -5.397006 -5.499968 -5.558576 -5.551770 -5.480345 -5.370331 -5.074805 -4.301429 -0.9152236 -1.430153 -1.939878 -2.434599 -2.917985 -3.381941 -3.817768 -4.230360 -4.599904 -4.904240 -5.157897 -5.360706 -5.500643 -5.584867 -5.626714 -5.601236 -5.507798 -5.366274 -5.049492 -4.301429 -1.369880 -1.826925 -2.288060 -2.746841 -3.202751 -3.647919 -4.069860 -4.453785 -4.792056 -5.084603 -5.313477 -5.480192 -5.598833 -5.664303 -5.688770 -5.643941 -5.527444 -5.354852 -5.021054 -4.301429 -1.873935 -2.275912 -2.690305 -3.115995 -3.547031 -3.957134 -4.342765 -4.702067 -5.017542 -5.262187 -5.452691 -5.590762 -5.687596 -5.736475 -5.741644 -5.677171 -5.536736 -5.334664 -4.988791 -4.301429 -2.436678 -2.784270 -3.148748 -3.527139 -3.915898 -4.298334 -4.656697 -4.957491 -5.213971 -5.416025 -5.570807 -5.688259 -5.767081 -5.797273 -5.781841 -5.696905 -5.532813 -5.306234 -4.951778 -4.301429 -3.053464 -3.333579 -3.646358 -3.981216 -4.313188 -4.632554 -4.919761 -5.165782 -5.374687 -5.544571 -5.674409 -5.771453 -5.831002 -5.840624 -5.803555 -5.698068 -5.511907 -5.267428 -4.909355 -4.301429 -3.736137 -3.930059 -4.159910 -4.408800 -4.666632 -4.910941 -5.135489 -5.338221 -5.514772 -5.655905 -5.758766 -5.831998 -5.869231 -5.856860 -5.798695 -5.674291 -5.470694 -5.214722 -4.860235 -4.301429 -4.492417 -4.564755 -4.688394 -4.839131 -5.012852 -5.183141 -5.345823 -5.495912 -5.629323 -5.735370 -5.805787 -5.852893 -5.865450 -5.831404 -5.754918 -5.616445 -5.402400 -5.142254 -4.800924 -4.301429 -5.366108 -5.299843 -5.294869 -5.327121 -5.390743 -5.461493 -5.540957 -5.620159 -5.694729 -5.755080 -5.787782 -5.805020 -5.795079 -5.742745 -5.652823 -5.507910 -5.295203 -5.041222 -4.724989 -4.301429 -23.67435 -23.21119 -22.63891 -21.97325 -21.22701 -20.41031 -19.53118 -18.59605 -17.61014 -16.57778 -15.50261 -14.38772 -13.23579 -12.04916 -10.82989 -9.579789 -8.300498 -6.993477 -5.660052 -4.301429 -0.4171886 -1.196660 -1.786313 -2.266726 -2.718861 -3.125314 -3.455103 -3.638595 -3.930419 -4.195970 -4.432009 -4.590122 -4.677713 -4.885863 -5.075232 -5.228414 -5.247344 -5.377904 -5.355608 -4.411827 0.4462812 -0.4234780 -1.120601 -1.716255 -2.282228 -2.797090 -3.164855 -3.453550 -3.795344 -4.114521 -4.401105 -4.521165 -4.663844 -4.898144 -5.114835 -5.270108 -5.259373 -5.391559 -5.353034 -4.411827 0.8922879 -1.5396559E-02 -0.7740425 -1.457036 -2.088715 -2.642977 -3.055537 -3.417910 -3.773180 -4.107833 -4.406567 -4.538452 -4.719655 -4.949069 -5.168910 -5.302455 -5.289627 -5.408846 -5.348733 -4.411827 1.098149 0.1880774 -0.6100532 -1.339855 -2.001661 -2.552342 -3.020509 -3.422808 -3.787141 -4.138577 -4.425011 -4.616283 -4.802823 -5.020615 -5.231836 -5.320501 -5.330530 -5.428118 -5.342410 -4.411827 1.146801 0.2464661 -0.5622770 -1.303590 -1.952831 -2.522946 -3.019043 -3.440019 -3.831290 -4.195639 -4.482659 -4.707099 -4.899206 -5.103772 -5.300005 -5.354222 -5.377306 -5.448519 -5.333673 -4.411827 1.077256 0.2063901 -0.5840574 -1.307558 -1.955495 -2.533849 -3.036545 -3.487306 -3.904401 -4.270988 -4.566318 -4.804251 -4.999228 -5.195567 -5.369235 -5.406612 -5.427059 -5.469150 -5.322167 -4.411827 0.9137063 9.2122778E-02 -0.6618729 -1.363423 -2.005277 -2.574525 -3.092831 -3.572307 -4.001161 -4.364504 -4.654428 -4.906592 -5.106138 -5.289548 -5.435231 -5.468991 -5.477859 -5.488968 -5.307475 -4.411827 0.6858315 -7.7727392E-02 -0.7970445 -1.475350 -2.092893 -2.664301 -3.199976 -3.688252 -4.112509 -4.461092 -4.758862 -5.014771 -5.217392 -5.385284 -5.505123 -5.535744 -5.527389 -5.507180 -5.290442 -4.411827 0.3975324 -0.3072925 -0.9846812 -1.633537 -2.236787 -2.808846 -3.342262 -3.819329 -4.222126 -4.574596 -4.872417 -5.134626 -5.329214 -5.482845 -5.582578 -5.603562 -5.574939 -5.522858 -5.272290 -4.411827 6.7040510E-02 -0.5887781 -1.222864 -1.845216 -2.429906 -2.990445 -3.500358 -3.947138 -4.352839 -4.703129 -5.004836 -5.259582 -5.444061 -5.581691 -5.664184 -5.669144 -5.619827 -5.534910 -5.252481 -4.411827 -0.3164900 -0.9219131 -1.513329 -2.098325 -2.662797 -3.188205 -3.662127 -4.110345 -4.505343 -4.858431 -5.150108 -5.385899 -5.563024 -5.679283 -5.743374 -5.731528 -5.660264 -5.542130 -5.230491 -4.411827 -0.7457153 -1.297479 -1.847761 -2.390505 -2.907111 -3.401447 -3.868633 -4.301475 -4.694483 -5.030016 -5.300098 -5.525821 -5.679688 -5.776062 -5.817552 -5.789361 -5.694748 -5.543001 -5.205770 -4.411827 -1.220975 -1.717568 -2.212679 -2.707363 -3.196672 -3.666415 -4.121568 -4.541100 -4.902931 -5.212938 -5.470787 -5.663007 -5.791955 -5.864017 -5.885716 -5.840943 -5.721200 -5.535961 -5.177619 -4.411827 -1.746974 -2.180607 -2.625087 -3.083038 -3.544887 -3.995259 -4.413318 -4.796307 -5.137382 -5.419593 -5.627092 -5.788904 -5.889906 -5.943756 -5.946504 -5.883426 -5.737233 -5.519386 -5.145255 -4.411827 -2.334865 -2.708711 -3.105139 -3.522240 -3.939482 -4.349016 -4.738227 -5.088508 -5.369797 -5.595796 -5.764710 -5.896308 -5.977103 -6.013002 -5.995022 -5.911398 -5.739841 -5.493425 -5.107679 -4.411827 -2.985241 -3.288274 -3.627131 -3.996632 -4.380157 -4.728570 -5.050126 -5.327688 -5.558433 -5.739239 -5.879553 -5.991216 -6.049768 -6.066170 -6.025237 -5.919623 -5.724678 -5.455423 -5.063605 -4.411827 -3.711943 -3.924901 -4.187202 -4.474525 -4.768908 -5.043149 -5.295057 -5.517183 -5.710109 -5.862513 -5.974533 -6.062542 -6.098182 -6.092644 -6.028225 -5.900459 -5.687191 -5.401812 -5.012327 -4.411827 -4.517087 -4.605618 -4.752907 -4.934244 -5.133981 -5.331382 -5.519941 -5.689228 -5.835899 -5.951818 -6.031770 -6.091593 -6.103005 -6.074677 -5.989935 -5.843544 -5.618828 -5.326560 -4.949866 -4.411827 -5.453768 -5.392323 -5.394804 -5.448709 -5.527386 -5.620447 -5.722383 -5.820340 -5.907746 -5.974133 -6.019285 -6.049016 -6.034982 -5.985980 -5.887457 -5.730299 -5.504571 -5.222024 -4.869272 -4.411827 -25.66696 -25.16634 -24.54181 -23.81260 -22.99309 -22.09575 -21.12955 -20.10176 -19.01827 -17.88391 -16.70300 -15.47824 -14.21333 -12.91063 -11.57240 -10.20065 -8.797424 -7.363607 -5.901381 -4.411827 -0.3439079 -1.182601 -1.816082 -2.306925 -2.778253 -3.182933 -3.527896 -3.710764 -4.014038 -4.286370 -4.529627 -4.701198 -4.775519 -4.989682 -5.182783 -5.344470 -5.359305 -5.499007 -5.491121 -4.516449 0.5990795 -0.3412201 -1.084885 -1.723659 -2.283502 -2.807587 -3.210714 -3.516870 -3.868277 -4.199856 -4.494059 -4.631639 -4.761150 -5.001864 -5.222783 -5.391876 -5.372414 -5.515431 -5.490597 -4.516449 1.092819 0.1136636 -0.7125678 -1.406941 -2.050239 -2.635315 -3.106730 -3.482173 -3.849540 -4.192532 -4.499258 -4.646819 -4.826222 -5.057798 -5.280213 -5.430206 -5.407434 -5.535789 -5.488326 -4.516449 1.329727 0.3430319 -0.4983551 -1.255298 -1.951513 -2.563922 -3.065124 -3.487034 -3.871549 -4.221201 -4.520314 -4.732606 -4.919185 -5.135518 -5.348527 -5.452897 -5.454248 -5.559036 -5.483895 -4.516449 1.391103 0.4250659 -0.4287534 -1.212587 -1.925041 -2.532713 -3.059132 -3.513623 -3.905930 -4.276276 -4.581378 -4.832531 -5.023242 -5.226099 -5.423512 -5.490525 -5.508108 -5.584251 -5.476923 -4.516449 1.323460 0.3920642 -0.4490367 -1.235924 -1.927908 -2.541096 -3.083986 -3.547352 -3.969896 -4.353834 -4.674428 -4.933073 -5.130862 -5.324341 -5.499354 -5.549591 -5.565256 -5.609934 -5.467015 -4.516449 1.159675 0.2740129 -0.5425556 -1.290871 -1.974635 -2.588976 -3.127164 -3.617603 -4.065526 -4.458966 -4.772477 -5.037973 -5.241326 -5.426982 -5.574534 -5.619471 -5.622805 -5.634974 -5.453813 -4.516449 0.9153163 9.4961293E-02 -0.6770626 -1.404155 -2.069788 -2.665565 -3.217709 -3.729902 -4.187225 -4.569165 -4.875719 -5.149623 -5.358381 -5.528710 -5.653007 -5.694211 -5.680284 -5.658605 -5.438048 -4.516449 0.6171332 -0.1420909 -0.8691900 -1.567147 -2.201213 -2.799031 -3.359234 -3.873710 -4.315372 -4.679285 -4.995837 -5.269056 -5.478814 -5.633160 -5.741253 -5.768911 -5.736108 -5.679568 -5.421125 -4.516449 0.2722601 -0.4359966 -1.114030 -1.772893 -2.393001 -2.982768 -3.535357 -4.024971 -4.441576 -4.815901 -5.126145 -5.398900 -5.596549 -5.741910 -5.830153 -5.841447 -5.788898 -5.696756 -5.402475 -4.516449 -0.1287270 -0.7787665 -1.411342 -2.033123 -2.630626 -3.201461 -3.716290 -4.179547 -4.602253 -4.966481 -5.278170 -5.534646 -5.722198 -5.850824 -5.918652 -5.911736 -5.836993 -5.708899 -5.381565 -4.516449 -0.5763419 -1.165289 -1.754575 -2.337539 -2.902445 -3.423226 -3.920054 -4.376396 -4.787611 -5.146610 -5.439452 -5.680182 -5.853182 -5.954445 -6.003189 -5.977369 -5.878935 -5.714605 -5.357668 -4.516449 -1.073156 -1.603525 -2.141162 -2.670654 -3.191206 -3.693322 -4.169529 -4.617388 -5.013958 -5.339709 -5.614729 -5.835152 -5.971769 -6.052100 -6.082153 -6.034629 -5.913360 -5.711908 -5.330030 -4.516449 -1.622934 -2.084954 -2.563797 -3.053620 -3.542476 -4.022759 -4.481574 -4.889147 -5.252324 -5.560693 -5.795661 -5.973305 -6.082395 -6.141454 -6.151267 -6.081768 -5.936954 -5.699028 -5.297752 -4.516449 -2.232970 -2.632196 -3.057642 -3.508063 -3.964054 -4.400320 -4.818223 -5.197204 -5.519461 -5.764152 -5.952340 -6.095025 -6.180787 -6.221584 -6.207285 -6.116412 -5.945455 -5.676154 -5.259895 -4.516449 -2.916899 -3.241436 -3.606768 -4.006945 -4.423398 -4.824224 -5.175726 -5.482065 -5.732593 -5.931011 -6.081480 -6.201116 -6.265353 -6.285183 -6.245553 -6.132273 -5.933627 -5.640750 -5.214765 -4.516449 -3.682616 -3.916879 -4.206568 -4.533306 -4.865245 -5.174565 -5.453451 -5.695677 -5.899816 -6.066570 -6.192143 -6.285931 -6.325799 -6.318966 -6.255619 -6.120512 -5.897433 -5.588626 -5.162167 -4.516449 -4.535155 -4.640938 -4.812483 -5.025147 -5.251929 -5.478970 -5.692800 -5.881330 -6.040303 -6.168876 -6.265036 -6.327529 -6.339403 -6.305861 -6.220728 -6.068048 -5.828915 -5.513031 -5.097638 -4.516449 -5.538372 -5.478220 -5.493428 -5.564927 -5.664274 -5.784667 -5.906038 -6.020275 -6.119409 -6.200249 -6.258417 -6.287391 -6.273416 -6.218013 -6.116375 -5.952633 -5.712005 -5.404038 -5.013629 -4.516449 -27.69572 -27.15708 -26.47899 -25.68402 -24.78976 -23.80970 -22.75422 -21.63150 -20.44809 -19.20936 -17.91979 -16.58319 -15.20284 -13.78156 -12.32186 -10.82594 -9.295758 -7.733084 -6.139503 -4.516449 -0.2705570 -1.170999 -1.849480 -2.351082 -2.836329 -3.252157 -3.601640 -3.778318 -4.094605 -4.372825 -4.623823 -4.807369 -4.869285 -5.088797 -5.285036 -5.454541 -5.463764 -5.613789 -5.618102 -4.615869 0.7464703 -0.2628731 -1.058174 -1.724035 -2.318609 -2.830248 -3.253551 -3.571221 -3.938513 -4.278594 -4.586088 -4.739506 -4.854455 -5.101975 -5.325178 -5.508244 -5.478276 -5.632369 -5.619384 -4.615869 1.285221 0.2352625 -0.6440812 -1.395197 -2.032631 -2.626687 -3.130707 -3.545120 -3.921477 -4.276477 -4.592113 -4.752095 -4.928588 -5.163074 -5.384763 -5.553374 -5.517557 -5.656305 -5.618751 -4.615869 1.551104 0.4928509 -0.4151241 -1.190371 -1.901025 -2.545621 -3.107759 -3.548286 -3.947180 -4.306116 -4.615654 -4.841983 -5.032820 -5.248479 -5.456776 -5.581283 -5.571081 -5.683997 -5.615877 -4.615869 1.626827 0.5900460 -0.3073950 -1.122276 -1.871233 -2.538699 -3.095518 -3.573149 -3.989428 -4.358220 -4.677602 -4.949207 -5.143364 -5.346972 -5.535877 -5.623240 -5.632442 -5.713477 -5.610421 -4.615869 1.559699 0.5698374 -0.3179587 -1.145482 -1.898489 -2.545527 -3.116791 -3.618570 -4.040162 -4.433888 -4.773415 -5.057639 -5.257151 -5.450833 -5.621269 -5.689898 -5.697401 -5.744033 -5.601765 -4.615869 1.400131 0.4522212 -0.4143841 -1.223204 -1.945329 -2.591812 -3.171762 -3.670582 -4.128131 -4.540124 -4.882958 -5.163352 -5.374207 -5.559583 -5.704215 -5.768521 -5.763884 -5.774256 -5.589325 -4.615869 1.145490 0.2644346 -0.5597022 -1.335251 -2.039019 -2.680455 -3.244084 -3.770632 -4.248814 -4.664958 -4.991609 -5.277799 -5.493356 -5.672917 -5.790784 -5.850311 -5.829610 -5.802764 -5.574004 -4.615869 0.8359564 2.0399177E-02 -0.7571803 -1.498627 -2.178770 -2.795068 -3.376613 -3.915065 -4.394327 -4.787407 -5.110076 -5.396757 -5.617736 -5.784865 -5.888087 -5.933103 -5.893213 -5.828823 -5.557770 -4.615869 0.4734280 -0.2842633 -1.009934 -1.708405 -2.358379 -2.976985 -3.555887 -4.088123 -4.534585 -4.919650 -5.244141 -5.532347 -5.746181 -5.898665 -5.987939 -6.014095 -5.953198 -5.851350 -5.539897 -4.615869 5.6250270E-02 -0.6348671 -1.312689 -1.970552 -2.599956 -3.202474 -3.762093 -4.253114 -4.690148 -5.075252 -5.400432 -5.678446 -5.875695 -6.017465 -6.086541 -6.090335 -6.009094 -5.868772 -5.519678 -4.615869 -0.4086743 -1.037808 -1.665358 -2.282154 -2.886974 -3.453452 -3.967914 -4.453408 -4.879016 -5.260326 -5.574980 -5.824819 -6.014138 -6.130377 -6.179254 -6.161390 -6.058595 -5.879487 -5.496449 -4.615869 -0.9261189 -1.491970 -2.065257 -2.640230 -3.188147 -3.719680 -4.223306 -4.690660 -5.109220 -5.468053 -5.753462 -5.990236 -6.150001 -6.240012 -6.264124 -6.226803 -6.099112 -5.881708 -5.469399 -4.615869 -1.499156 -1.994612 -2.505177 -3.027582 -3.544400 -4.050656 -4.538022 -4.984562 -5.364474 -5.692730 -5.956883 -6.147703 -6.274880 -6.339511 -6.341275 -6.283130 -6.127413 -5.872948 -5.437500 -4.615869 -2.132124 -2.557508 -3.010737 -3.490388 -3.979356 -4.454184 -4.897223 -5.300508 -5.653905 -5.926867 -6.137790 -6.287160 -6.383407 -6.426081 -6.407340 -6.324963 -6.141285 -5.853428 -5.399566 -4.615869 -2.841729 -3.195386 -3.587342 -4.016134 -4.460466 -4.899111 -5.296391 -5.626292 -5.903174 -6.116849 -6.284981 -6.403795 -6.477982 -6.494644 -6.456149 -6.345743 -6.135892 -5.819994 -5.353884 -4.615869 -3.641021 -3.904753 -4.224333 -4.584155 -4.954947 -5.302046 -5.609499 -5.870426 -6.089125 -6.267525 -6.407257 -6.497788 -6.547011 -6.537814 -6.476014 -6.336686 -6.104538 -5.768016 -5.300004 -4.615869 -4.548491 -4.671092 -4.868526 -5.111220 -5.369629 -5.627720 -5.862503 -6.071389 -6.245003 -6.383944 -6.489379 -6.548947 -6.569995 -6.533816 -6.449210 -6.283856 -6.037297 -5.690443 -5.234433 -4.615869 -5.617581 -5.558052 -5.587303 -5.675398 -5.800127 -5.944821 -6.085725 -6.218546 -6.335613 -6.421861 -6.488556 -6.514668 -6.507278 -6.446810 -6.347474 -6.164888 -5.916564 -5.577914 -5.148898 -4.615869 -29.75901 -29.18181 -28.44890 -27.58675 -26.61563 -25.55083 -24.40399 -23.18418 -21.89863 -20.55326 -19.15300 -17.70201 -16.20387 -14.66167 -13.07813 -11.45565 -9.796374 -8.102201 -6.374849 -4.615869 -0.2041426 -1.160606 -1.882744 -2.397954 -2.895674 -3.322024 -3.679942 -3.845636 -4.169199 -4.455994 -4.713657 -4.909030 -4.959225 -5.183602 -5.384263 -5.558952 -5.563483 -5.722682 -5.740552 -4.710580 0.8962898 -0.1837406 -1.036345 -1.731969 -2.343791 -2.877612 -3.302057 -3.620061 -4.006135 -4.353291 -4.675242 -4.845252 -4.944036 -5.198622 -5.428968 -5.618865 -5.578835 -5.744090 -5.744256 -4.710580 1.472339 0.3600311 -0.5832555 -1.371397 -2.054868 -2.632956 -3.151556 -3.594513 -3.991155 -4.353201 -4.685441 -4.855248 -5.026729 -5.266806 -5.493876 -5.670222 -5.623369 -5.771765 -5.746066 -4.710580 1.768154 0.6398578 -0.3260144 -1.160335 -1.868734 -2.525091 -3.119870 -3.606946 -4.017369 -4.391530 -4.710972 -4.948046 -5.140187 -5.360137 -5.572030 -5.703097 -5.684166 -5.803615 -5.745578 -4.710580 1.847677 0.7529126 -0.2115909 -1.046398 -1.814985 -2.515435 -3.129341 -3.628432 -4.063827 -4.442920 -4.772140 -5.057468 -5.260633 -5.465763 -5.658859 -5.748460 -5.753250 -5.838144 -5.742295 -4.710580 1.781067 0.7380562 -0.1968323 -1.055879 -1.845735 -2.550447 -3.146642 -3.672205 -4.120697 -4.513865 -4.868261 -5.172607 -5.379519 -5.576864 -5.751320 -5.821683 -5.825994 -5.873421 -5.735664 -4.710580 1.628742 0.6243696 -0.2876715 -1.140808 -1.916373 -2.593853 -3.199716 -3.734150 -4.194096 -4.617414 -4.984310 -5.286363 -5.501088 -5.694349 -5.843039 -5.906388 -5.899671 -5.908814 -5.725028 -4.710580 1.375054 0.4326083 -0.4419555 -1.265673 -2.009639 -2.680826 -3.284577 -3.814422 -4.308793 -4.744893 -5.104397 -5.398353 -5.623557 -5.815094 -5.936121 -5.995148 -5.972405 -5.943071 -5.711239 -4.710580 1.054067 0.1757178 -0.6464664 -1.431909 -2.150472 -2.804082 -3.396872 -3.953672 -4.456736 -4.885544 -5.224740 -5.523264 -5.751301 -5.934940 -6.039842 -6.084513 -6.043096 -5.974752 -5.696611 -4.710580 0.6717631 -0.1345796 -0.9068133 -1.650029 -2.332541 -2.971398 -3.574785 -4.131650 -4.618778 -5.021198 -5.365044 -5.655602 -5.886654 -6.053326 -6.147843 -6.171452 -6.110279 -6.002843 -5.680394 -4.710580 0.2355926 -0.4966138 -1.219162 -1.911344 -2.572316 -3.200963 -3.794102 -4.325401 -4.777808 -5.181220 -5.517582 -5.805710 -6.022826 -6.177935 -6.253400 -6.254174 -6.172365 -6.025470 -5.661754 -4.710580 -0.2483194 -0.9138860 -1.578571 -2.230009 -2.864016 -3.470585 -4.022751 -4.522274 -4.974696 -5.363953 -5.697312 -5.964320 -6.169425 -6.303364 -6.356269 -6.332665 -6.228176 -6.041326 -5.639825 -4.710580 -0.7864504 -1.382950 -1.991109 -2.601154 -3.192662 -3.746039 -4.279436 -4.765341 -5.205370 -5.585877 -5.890620 -6.137709 -6.317415 -6.421109 -6.449932 -6.404080 -6.276021 -6.048492 -5.613674 -4.710580 -1.375296 -1.906834 -2.450814 -3.001635 -3.550770 -4.082692 -4.595158 -5.065269 -5.476227 -5.820254 -6.105487 -6.313913 -6.452828 -6.527344 -6.534957 -6.466523 -6.311944 -6.044756 -5.582492 -4.710580 -2.031311 -2.484776 -2.966044 -3.472105 -3.989622 -4.502697 -4.975948 -5.401182 -5.775611 -6.083364 -6.309616 -6.469091 -6.572001 -6.624075 -6.607684 -6.515864 -6.331869 -6.029691 -5.544580 -4.710580 -2.767385 -3.142933 -3.569401 -4.024986 -4.496610 -4.966468 -5.400929 -5.767139 -6.062346 -6.297618 -6.475640 -6.597055 -6.673676 -6.705732 -6.663830 -6.545000 -6.330887 -5.999881 -5.498497 -4.710580 -3.596471 -3.880845 -4.238286 -4.632930 -5.038040 -5.425404 -5.759881 -6.044165 -6.275495 -6.464313 -6.608998 -6.702984 -6.752117 -6.757366 -6.692353 -6.544472 -6.302901 -5.950382 -5.442657 -4.710580 -4.555386 -4.697774 -4.921909 -5.194200 -5.486466 -5.773594 -6.032988 -6.255076 -6.446395 -6.593515 -6.703835 -6.766601 -6.784696 -6.760295 -6.670436 -6.498211 -6.237257 -5.873466 -5.373761 -4.710580 -5.690796 -5.633716 -5.675895 -5.784126 -5.937551 -6.105416 -6.267212 -6.412747 -6.540076 -6.639862 -6.711788 -6.738750 -6.725155 -6.679511 -6.565809 -6.378894 -6.113817 -5.755787 -5.282821 -4.710580 -31.85535 -31.23906 -30.45008 -29.51914 -28.46938 -27.31794 -26.07774 -24.75878 -23.36899 -21.91485 -20.40172 -18.83414 -17.21601 -15.55066 -13.84105 -12.08977 -10.29914 -8.471192 -6.607785 -4.710580 -0.1468794 -1.154111 -1.915423 -2.444345 -2.956198 -3.390155 -3.760526 -3.914077 -4.242075 -4.535917 -4.799850 -5.006114 -5.045171 -5.274086 -5.479475 -5.658453 -5.659554 -5.824568 -5.857088 -4.801008 1.037318 -0.1025379 -1.012386 -1.744115 -2.373918 -2.923953 -3.363775 -3.670660 -4.063783 -4.425883 -4.759324 -4.948889 -5.030119 -5.289858 -5.527997 -5.724450 -5.676204 -5.847865 -5.863317 -4.801008 1.659363 0.4950861 -0.5252630 -1.355565 -2.061872 -2.669534 -3.179382 -3.634665 -4.059300 -4.427789 -4.775941 -4.955615 -5.122148 -5.365958 -5.599897 -5.781835 -5.727211 -5.878493 -5.867729 -4.801008 1.979689 0.7981805 -0.2459907 -1.117751 -1.875016 -2.517671 -3.125504 -3.651637 -4.085678 -4.469940 -4.806536 -5.050466 -5.244028 -5.467411 -5.685500 -5.820722 -5.795033 -5.913882 -5.869906 -4.801008 2.046702 0.9135314 -0.1102066 -1.000385 -1.771188 -2.486962 -3.137293 -3.679544 -4.132610 -4.530829 -4.865197 -5.160450 -5.374353 -5.579885 -5.779969 -5.870301 -5.870808 -5.952543 -5.869187 -4.801008 1.979858 0.9039347 -9.2838190E-02 -0.9756604 -1.786886 -2.527577 -3.172208 -3.720077 -4.196913 -4.596066 -4.959690 -5.278131 -5.503397 -5.700233 -5.878884 -5.948235 -5.950350 -5.992663 -5.864963 -4.801008 1.837919 0.7889898 -0.1659594 -1.054632 -1.869147 -2.593364 -3.225234 -3.785080 -4.267053 -4.692184 -5.075608 -5.398580 -5.628508 -5.821832 -5.978065 -6.038966 -6.030957 -6.033025 -5.856597 -4.801008 1.601113 0.5959077 -0.3220722 -1.193367 -1.977636 -2.682310 -3.312969 -3.868229 -4.368805 -4.818866 -5.207708 -5.515589 -5.755926 -5.946309 -6.076444 -6.135604 -6.110234 -6.072442 -5.844786 -4.801008 1.266283 0.3315963 -0.5405739 -1.367054 -2.120977 -2.811922 -3.426698 -3.991687 -4.515310 -4.969897 -5.339226 -5.640375 -5.884653 -6.073485 -6.186289 -6.231945 -6.187497 -6.109615 -5.832223 -4.801008 0.8633636 8.9237690E-03 -0.8076395 -1.588975 -2.315553 -2.973744 -3.592840 -4.171565 -4.691369 -5.123212 -5.474072 -5.777546 -6.025378 -6.200155 -6.301641 -6.326791 -6.261657 -6.143591 -5.818051 -4.801008 0.4110759 -0.3655632 -1.129502 -1.860085 -2.546316 -3.200931 -3.816530 -4.386349 -4.870106 -5.278188 -5.633176 -5.932520 -6.170800 -6.332047 -6.414132 -6.416854 -6.330559 -6.172638 -5.801352 -4.801008 -9.0458840E-02 -0.7951202 -1.495759 -2.181476 -2.843047 -3.478893 -4.070637 -4.593701 -5.062368 -5.468193 -5.817760 -6.104325 -6.316724 -6.468409 -6.521996 -6.501808 -6.392140 -6.194809 -5.781189 -4.801008 -0.6478437 -1.279534 -1.920576 -2.560757 -3.187652 -3.779213 -4.330664 -4.845973 -5.295827 -5.695516 -6.023181 -6.280425 -6.476757 -6.595734 -6.623797 -6.580551 -6.445673 -6.207760 -5.756860 -4.801008 -1.254369 -1.817218 -2.395918 -2.980510 -3.554336 -4.120523 -4.652206 -5.147433 -5.582525 -5.943611 -6.241959 -6.475929 -6.623603 -6.715407 -6.718399 -6.650547 -6.488839 -6.208767 -5.726459 -4.801008 -1.931718 -2.413238 -2.924251 -3.456763 -3.999372 -4.541549 -5.054245 -5.502054 -5.891394 -6.222550 -6.470942 -6.645077 -6.754004 -6.818360 -6.801375 -6.706287 -6.516778 -6.197069 -5.688999 -4.801008 -2.692937 -3.091477 -3.542892 -4.034423 -4.533776 -5.031378 -5.494931 -5.904192 -6.214937 -6.469801 -6.657674 -6.786298 -6.869841 -6.904873 -6.862729 -6.740507 -6.523133 -6.169166 -5.643084 -4.801008 -3.550477 -3.855794 -4.238923 -4.677614 -5.119223 -5.538499 -5.910321 -6.210116 -6.454267 -6.654319 -6.804261 -6.904150 -6.958780 -6.966871 -6.893429 -6.743389 -6.499889 -6.120408 -5.585782 -4.801008 -4.556433 -4.718804 -4.972969 -5.277113 -5.603020 -5.919695 -6.198792 -6.438732 -6.633960 -6.798004 -6.911533 -6.977008 -6.999362 -6.981046 -6.875938 -6.699852 -6.434897 -6.042584 -5.514237 -4.801008 -5.757839 -5.704814 -5.759883 -5.890843 -6.070433 -6.265436 -6.447497 -6.613097 -6.739590 -6.855378 -6.928830 -6.954995 -6.948648 -6.901472 -6.773638 -6.581147 -6.306542 -5.922347 -5.419000 -4.801008 -33.98338 -33.32772 -32.48120 -31.47994 -30.34981 -29.10990 -27.77444 -26.35437 -24.85834 -23.29339 -21.66534 -19.97910 -18.23886 -16.44826 -14.61046 -12.72825 -10.80412 -8.840245 -6.838613 -4.801008 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 0.7995963 -6.8672270E-02 -8.5710108E-02 -0.1018820 -0.1183794 -0.1343072 -0.1485759 -0.1719934 -0.1953856 -0.2186749 -0.2422042 -0.2639853 -0.2867778 -0.3091964 -0.3328019 -0.3606723 -0.3872747 -0.4108731 -0.4306639 -0.4441504 -1.149407 -9.7923249E-02 -0.1145777 -0.1328609 -0.1499734 -0.1656613 -0.1811613 -0.2051546 -0.2290786 -0.2530564 -0.2756839 -0.2979650 -0.3207706 -0.3424498 -0.3651454 -0.3919823 -0.4168475 -0.4379593 -0.4530873 -0.4661290 -1.149407 -0.1280688 -0.1462647 -0.1647332 -0.1815671 -0.1980491 -0.2144796 -0.2389439 -0.2632821 -0.2877349 -0.3097251 -0.3322015 -0.3540652 -0.3748398 -0.3967092 -0.4223924 -0.4452289 -0.4638052 -0.4746515 -0.4866172 -1.149407 -0.1635804 -0.1814393 -0.1990825 -0.2164269 -0.2333790 -0.2508550 -0.2756762 -0.3001673 -0.3232644 -0.3457844 -0.3684262 -0.3898351 -0.4088605 -0.4307488 -0.4546126 -0.4753593 -0.4913876 -0.4978861 -0.5085537 -1.149407 -0.2022025 -0.2181587 -0.2360555 -0.2533190 -0.2712618 -0.2891313 -0.3138007 -0.3373822 -0.3606492 -0.3835279 -0.4052932 -0.4257770 -0.4441838 -0.4649770 -0.4868977 -0.5051729 -0.5185569 -0.5209883 -0.5298443 -1.149407 -0.2405792 -0.2568459 -0.2743559 -0.2921919 -0.3099361 -0.3277654 -0.3524291 -0.3750004 -0.3983042 -0.4205882 -0.4415159 -0.4598340 -0.4784964 -0.4971467 -0.5169355 -0.5323153 -0.5429612 -0.5413893 -0.5478572 -1.149407 -0.2844321 -0.2999680 -0.3177333 -0.3354773 -0.3529086 -0.3706317 -0.3929332 -0.4160854 -0.4389464 -0.4607403 -0.4792617 -0.4977336 -0.5151331 -0.5316373 -0.5486616 -0.5610223 -0.5688778 -0.5633970 -0.5669947 -1.149407 -0.3332447 -0.3481902 -0.3656957 -0.3828966 -0.3992221 -0.4156537 -0.4379864 -0.4605864 -0.4826091 -0.5029551 -0.5205738 -0.5383742 -0.5530123 -0.5673642 -0.5814398 -0.5908640 -0.5928184 -0.5859571 -0.5861591 -1.149407 -0.3890563 -0.4032941 -0.4203389 -0.4357513 -0.4515342 -0.4675368 -0.4889144 -0.5104731 -0.5309486 -0.5483906 -0.5663481 -0.5826852 -0.5949079 -0.6058193 -0.6166874 -0.6230629 -0.6193040 -0.6109046 -0.6072183 -1.149407 -0.4526986 -0.4646154 -0.4801579 -0.4949017 -0.5106858 -0.5258996 -0.5462560 -0.5655973 -0.5827380 -0.6004416 -0.6167334 -0.6293457 -0.6390800 -0.6469211 -0.6543385 -0.6573315 -0.6476512 -0.6373597 -0.6292426 -1.149407 -0.5229486 -0.5340768 -0.5485328 -0.5625537 -0.5764741 -0.5904967 -0.6066498 -0.6243312 -0.6415886 -0.6573440 -0.6691188 -0.6792364 -0.6853782 -0.6889033 -0.6931111 -0.6896597 -0.6767435 -0.6635647 -0.6503780 -1.149407 -0.6066732 -0.6167439 -0.6292578 -0.6419799 -0.6532061 -0.6624167 -0.6777806 -0.6937565 -0.7087519 -0.7197575 -0.7289844 -0.7349812 -0.7380576 -0.7386488 -0.7367082 -0.7259120 -0.7102305 -0.6935623 -0.6745455 -1.149407 -0.7071384 -0.7150207 -0.7238546 -0.7308421 -0.7390571 -0.7480689 -0.7608085 -0.7712950 -0.7826267 -0.7905322 -0.7954413 -0.7976984 -0.7979134 -0.7937135 -0.7822514 -0.7664855 -0.7476031 -0.7263782 -0.7009854 -1.149407 -0.8225458 -0.8266360 -0.8321823 -0.8382408 -0.8428598 -0.8455631 -0.8536056 -0.8604382 -0.8660876 -0.8698812 -0.8700718 -0.8691672 -0.8637515 -0.8518056 -0.8333696 -0.8114896 -0.7881836 -0.7616848 -0.7289136 -1.149407 -0.9659564 -0.9660458 -0.9661420 -0.9667386 -0.9659184 -0.9651241 -0.9679489 -0.9694834 -0.9694923 -0.9683834 -0.9637416 -0.9562877 -0.9426204 -0.9226341 -0.8984495 -0.8711441 -0.8415688 -0.8084527 -1.294014 -1.149407 -1.143811 -1.138499 -1.133069 -1.127627 -1.121431 -1.115274 -1.108265 -1.104900 -1.097947 -1.090402 -1.076895 -1.060013 -1.036834 -1.010063 -0.9798856 -0.9473432 -0.9101700 -0.8689143 -1.283637 -1.149407 -1.375260 -1.363472 -1.352383 -1.341995 -1.328290 -1.315923 -1.302977 -1.283686 -1.265343 -1.241519 -1.217683 -1.190321 -1.159741 -1.125464 -1.089152 -1.047781 -1.002380 -0.9508299 -1.272817 -1.149407 -1.710218 -1.684778 -1.665187 -1.641170 -1.615983 -1.589947 -1.561541 -1.531097 -1.498912 -1.464240 -1.427167 -1.390884 -1.347609 -1.303179 -1.255020 -1.203211 -1.145066 -1.370744 -1.261556 -1.149407 -2.269617 -2.231589 -2.192279 -2.155974 -2.112944 -2.068607 -2.022916 -1.977626 -1.928185 -1.877323 -1.823971 -1.767647 -1.707185 -1.641060 -1.635149 -1.541333 -1.445829 -1.348664 -1.249853 -1.149407 -2.610668 -2.545768 -2.479466 -2.411773 -2.342700 -2.272261 -2.200711 -2.127332 -2.052870 -1.977093 -1.900009 -1.821630 -1.741968 -1.661035 -1.578845 -1.495406 -1.410721 -1.324818 -1.237709 -1.149407 0.1793261 0.1568273 0.1324217 9.2936859E-02 5.5409934E-02 1.6648762E-02 -2.0712985E-02 -5.8328316E-02 -9.4334103E-02 -0.1329299 -0.1732084 -0.2125451 -0.2521687 -0.2909710 -0.3290351 -0.3680328 -0.4080648 -0.4466438 -0.4746315 -3.430635 0.1590987 0.1329800 0.1005876 5.6302894E-02 1.2075417E-02 -3.1224130E-02 -7.2267517E-02 -0.1127601 -0.1513023 -0.1919526 -0.2335923 -0.2735358 -0.3130419 -0.3503305 -0.3862805 -0.4220686 -0.4582781 -0.4905573 -0.5107361 -3.430635 0.1300907 9.7220063E-02 5.7408266E-02 1.0409703E-02 -3.7185181E-02 -8.2191177E-02 -0.1273749 -0.1699156 -0.2108951 -0.2532494 -0.2951947 -0.3359835 -0.3745772 -0.4103240 -0.4442350 -0.4772449 -0.5093353 -0.5348149 -0.5470176 -3.430635 8.5090473E-02 4.7880650E-02 3.9876956E-03 -4.6666909E-02 -9.4326243E-02 -0.1428260 -0.1895408 -0.2343441 -0.2772157 -0.3204440 -0.3631884 -0.4046648 -0.4423628 -0.4771524 -0.5090428 -0.5395963 -0.5682869 -0.5867108 -0.5909302 -3.430635 2.7743759E-02 -1.3909548E-02 -6.1010942E-02 -0.1101446 -0.1609017 -0.2104645 -0.2587775 -0.3051084 -0.3492163 -0.3929089 -0.4366503 -0.4781079 -0.5151911 -0.5493367 -0.5792661 -0.6081852 -0.6336653 -0.6449829 -0.6412657 -3.430635 -4.3866172E-02 -8.7255158E-02 -0.1332439 -0.1843155 -0.2346480 -0.2857420 -0.3354859 -0.3826910 -0.4273026 -0.4721615 -0.5168069 -0.5574466 -0.5950335 -0.6287651 -0.6576539 -0.6853684 -0.7072116 -0.7119750 -0.7004654 -3.430635 -0.1242683 -0.1673648 -0.2137608 -0.2637793 -0.3141434 -0.3653013 -0.4149893 -0.4626164 -0.5080940 -0.5539398 -0.5978287 -0.6383775 -0.6762239 -0.7091011 -0.7380858 -0.7638236 -0.7815756 -0.7796947 -0.7599903 -3.430635 -0.2153405 -0.2567087 -0.3022750 -0.3511965 -0.4002835 -0.4500088 -0.4989924 -0.5464666 -0.5936165 -0.6397020 -0.6826072 -0.7234088 -0.7610525 -0.7930700 -0.8218925 -0.8465902 -0.8584199 -0.8506804 -0.8222461 -3.430635 -0.3162002 -0.3560638 -0.3996883 -0.4456267 -0.4927148 -0.5401210 -0.5886250 -0.6366792 -0.6838160 -0.7285141 -0.7716367 -0.8123553 -0.8492215 -0.8828061 -0.9102737 -0.9323075 -0.9375962 -0.9242424 -0.8862787 -3.430635 -0.4288969 -0.4648968 -0.5048653 -0.5474185 -0.5909014 -0.6374222 -0.6860142 -0.7334121 -0.7778596 -0.8221558 -0.8657554 -0.9058097 -0.9420727 -0.9752271 -1.002100 -1.019082 -1.017552 -0.9977729 -0.9496223 -3.430635 -0.5529679 -0.5847569 -0.6198790 -0.6592233 -0.7016836 -0.7469373 -0.7927101 -0.8376278 -0.8809888 -0.9250489 -0.9679671 -1.006561 -1.044438 -1.076325 -1.100254 -1.109981 -1.101947 -1.074753 -1.015908 -3.430635 -0.6892515 -0.7169529 -0.7503424 -0.7884116 -0.8281122 -0.8687255 -0.9106444 -0.9544271 -0.9965380 -1.038983 -1.080025 -1.121556 -1.157635 -1.186925 -1.204778 -1.206370 -1.191951 -1.155586 -1.085058 -3.430635 -0.8486048 -0.8729196 -0.9020653 -0.9345914 -0.9694345 -1.007443 -1.047689 -1.088177 -1.127305 -1.167545 -1.209824 -1.249396 -1.282887 -1.306931 -1.314757 -1.308357 -1.287303 -1.239121 -1.155006 -3.430635 -1.039669 -1.055866 -1.076572 -1.104910 -1.137154 -1.172782 -1.208867 -1.244365 -1.283346 -1.320550 -1.358640 -1.393205 -1.421456 -1.436031 -1.434376 -1.418920 -1.386025 -1.324396 -1.225322 -3.430635 -1.269738 -1.280441 -1.298106 -1.319226 -1.342158 -1.373092 -1.409411 -1.443265 -1.475706 -1.505198 -1.535663 -1.561877 -1.578118 -1.583363 -1.573464 -1.547040 -1.497370 -1.419594 -1.303908 -3.430635 -1.567322 -1.569696 -1.581339 -1.596940 -1.616425 -1.638683 -1.662924 -1.687672 -1.713024 -1.734593 -1.752263 -1.765353 -1.769995 -1.763987 -1.743158 -1.697805 -1.630391 -1.531353 -1.398277 -3.430635 -1.980742 -1.972403 -1.967287 -1.968016 -1.976984 -1.987352 -2.002502 -2.014887 -2.024200 -2.032849 -2.038295 -2.039412 -2.030109 -2.005220 -1.961680 -1.895275 -1.801725 -1.678661 -1.527567 -3.430635 -2.577132 -2.553475 -2.534344 -2.523586 -2.517168 -2.511283 -2.507042 -2.504451 -2.498415 -2.488779 -2.470712 -2.446220 -2.409491 -2.354631 -2.278758 -2.177462 -2.051290 -1.903173 -1.733740 -3.430635 -3.681192 -3.642012 -3.604582 -3.567686 -3.532209 -3.494257 -3.453666 -3.410310 -3.359694 -3.300036 -3.229201 -3.144602 -3.045473 -2.931997 -2.804981 -2.662000 -2.501885 -2.327646 -2.139135 -3.430635 -6.781313 -6.650111 -6.513345 -6.371113 -6.223516 -6.070654 -5.912613 -5.749734 -5.581366 -5.408355 -5.230568 -5.048099 -4.861248 -4.669422 -4.473452 -4.273175 -4.068636 -3.859986 -3.647300 -3.430635 0.4973170 0.4553632 0.4098025 0.3636900 0.3145979 0.2583868 0.2020186 0.1466925 9.2664592E-02 3.9013527E-02 -1.5394985E-02 -7.0244201E-02 -0.1243231 -0.1762117 -0.2249749 -0.2708197 -0.3143110 -0.3538050 -0.3858346 -5.999882 0.5204871 0.4675416 0.4109166 0.3538776 0.2910634 0.2238363 0.1579875 9.3860865E-02 3.1514440E-02 -2.9537329E-02 -8.9179888E-02 -0.1480642 -0.2025504 -0.2524304 -0.2968566 -0.3355382 -0.3698342 -0.3972269 -0.4137379 -5.999882 0.5118739 0.4510964 0.3858297 0.3170592 0.2442093 0.1682860 9.4567254E-02 2.3145860E-02 -4.7297813E-02 -0.1145510 -0.1797291 -0.2412822 -0.2966915 -0.3448426 -0.3853647 -0.4178050 -0.4434123 -0.4597340 -0.4607711 -5.999882 0.4783660 0.4121401 0.3377129 0.2602008 0.1797697 9.8016918E-02 1.7852806E-02 -6.0515635E-02 -0.1369329 -0.2099704 -0.2795533 -0.3428699 -0.3992544 -0.4462822 -0.4834358 -0.5105602 -0.5280095 -0.5339934 -0.5195715 -5.999882 0.4226286 0.3509312 0.2717031 0.1893456 0.1034609 1.6590608E-02 -6.9081515E-02 -0.1527886 -0.2333875 -0.3104708 -0.3827455 -0.4479253 -0.5039676 -0.5501543 -0.5840682 -0.6065943 -0.6162830 -0.6116616 -0.5818750 -5.999882 0.3436815 0.2690505 0.1875599 0.1021563 1.3210510E-02 -7.7690028E-02 -0.1683402 -0.2562475 -0.3405239 -0.4201078 -0.4940782 -0.5604000 -0.6173685 -0.6626921 -0.6948504 -0.7139723 -0.7168601 -0.7021903 -0.6573715 -5.999882 0.2435445 0.1683410 8.6593121E-02 -8.7293331E-04 -9.2402503E-02 -0.1860241 -0.2785802 -0.3691451 -0.4563875 -0.5383191 -0.6136462 -0.6817001 -0.7393889 -0.7848465 -0.8168463 -0.8337964 -0.8314970 -0.8079196 -0.7485164 -5.999882 0.1248845 5.1445637E-02 -3.0955311E-02 -0.1193918 -0.2116192 -0.3050624 -0.3972933 -0.4881508 -0.5763508 -0.6600209 -0.7371899 -0.8055935 -0.8638175 -0.9097221 -0.9423862 -0.9575271 -0.9512494 -0.9184397 -0.8444483 -5.999882 -1.3422887E-02 -8.5459217E-02 -0.1670024 -0.2540937 -0.3442876 -0.4353370 -0.5259561 -0.6150464 -0.7028420 -0.7874761 -0.8659034 -0.9350769 -0.9932042 -1.041321 -1.075780 -1.089775 -1.081141 -1.037798 -0.9496506 -5.999882 -0.1753369 -0.2441767 -0.3205522 -0.4029255 -0.4895585 -0.5772136 -0.6644375 -0.7506949 -0.8370950 -0.9215479 -0.9992033 -1.068229 -1.127885 -1.178218 -1.213867 -1.227262 -1.216571 -1.162510 -1.059979 -5.999882 -0.3616944 -0.4229455 -0.4917689 -0.5677885 -0.6489347 -0.7320822 -0.8149254 -0.8988169 -0.9819654 -1.063177 -1.138554 -1.207180 -1.270082 -1.323464 -1.359063 -1.372623 -1.357540 -1.292361 -1.175580 -5.999882 -0.5700106 -0.6226300 -0.6835300 -0.7514619 -0.8256162 -0.9035805 -0.9834522 -1.061149 -1.139079 -1.215500 -1.288545 -1.358560 -1.424487 -1.477848 -1.514664 -1.530197 -1.506137 -1.429918 -1.297595 -5.999882 -0.8046705 -0.8481115 -0.8991455 -0.9604510 -1.028715 -1.098592 -1.170400 -1.241229 -1.311858 -1.385153 -1.457531 -1.528677 -1.593041 -1.648581 -1.686565 -1.698089 -1.662997 -1.576373 -1.426264 -5.999882 -1.074882 -1.109567 -1.152073 -1.203118 -1.260488 -1.319581 -1.381746 -1.446015 -1.512980 -1.582685 -1.655262 -1.721815 -1.784864 -1.840643 -1.878994 -1.878590 -1.830402 -1.730827 -1.561209 -5.999882 -1.398561 -1.419102 -1.446829 -1.484785 -1.529389 -1.580800 -1.636125 -1.695361 -1.759570 -1.824521 -1.889755 -1.952400 -2.012722 -2.066415 -2.092977 -2.077177 -2.016494 -1.897054 -1.704759 -5.999882 -1.785980 -1.791917 -1.809498 -1.834700 -1.872052 -1.916812 -1.965581 -2.016432 -2.070026 -2.125209 -2.184655 -2.242921 -2.292171 -2.328031 -2.336371 -2.304514 -2.223171 -2.077778 -1.856673 -5.999882 -2.311205 -2.303711 -2.308055 -2.321108 -2.343417 -2.370100 -2.403329 -2.444247 -2.489708 -2.535166 -2.578290 -2.617137 -2.643228 -2.657604 -2.649714 -2.593400 -2.478148 -2.296510 -2.042386 -5.999882 -3.086485 -3.055183 -3.039203 -3.033728 -3.038121 -3.046596 -3.061353 -3.080505 -3.098916 -3.125187 -3.144866 -3.161598 -3.164959 -3.149570 -3.101171 -3.003290 -2.837988 -2.605026 -2.315902 -5.999882 -4.509515 -4.449746 -4.403366 -4.369199 -4.340873 -4.315681 -4.295833 -4.281199 -4.265152 -4.247450 -4.225922 -4.187397 -4.126240 -4.029382 -3.886450 -3.691996 -3.445316 -3.154927 -2.830548 -5.999882 -11.59232 -11.39367 -11.18212 -10.95875 -10.72362 -10.47706 -10.21937 -9.950925 -9.672014 -9.382991 -9.084186 -8.775831 -8.458310 -8.131839 -7.796718 -7.453217 -7.101521 -6.741944 -6.374893 -5.999882 0.8327925 0.7763346 0.7098908 0.6407640 0.5707724 0.4968943 0.4196922 0.3455177 0.2751368 0.2060762 0.1401833 7.6496936E-02 1.4912910E-02 -4.3466557E-02 -9.9264786E-02 -0.1490566 -0.1925541 -0.2298414 -0.2585971 -8.816086 0.9125856 0.8363724 0.7523589 0.6631645 0.5739832 0.4821724 0.3893672 0.3013408 0.2174415 0.1383800 6.6087581E-02 -1.7202382E-03 -6.4283669E-02 -0.1197829 -0.1673570 -0.2038071 -0.2299277 -0.2457548 -0.2490997 -8.816086 0.9321427 0.8430225 0.7423164 0.6375378 0.5324277 0.4244767 0.3200572 0.2206438 0.1252397 3.7033662E-02 -4.3265313E-02 -0.1169666 -0.1809229 -0.2350131 -0.2753816 -0.3002029 -0.3101916 -0.3057822 -0.2845839 -8.816086 0.9085444 0.8088374 0.6976167 0.5804512 0.4608113 0.3435105 0.2293842 0.1185052 1.4630298E-02 -8.1138954E-02 -0.1696852 -0.2496700 -0.3172983 -0.3710265 -0.4058233 -0.4206023 -0.4157329 -0.3920165 -0.3467251 -8.816086 0.8481779 0.7425032 0.6241420 0.4973665 0.3709155 0.2464977 0.1224174 4.3380209E-03 -0.1067094 -0.2102937 -0.3072553 -0.3927138 -0.4652311 -0.5196958 -0.5504758 -0.5567913 -0.5387601 -0.4966077 -0.4276646 -8.816086 0.7589426 0.6480786 0.5240183 0.3942757 0.2638860 0.1331701 5.1574996E-03 -0.1193528 -0.2369120 -0.3482140 -0.4510875 -0.5433127 -0.6210577 -0.6764858 -0.7051467 -0.7051532 -0.6759689 -0.6162782 -0.5240839 -8.816086 0.6397494 0.5267046 0.4015160 0.2707239 0.1377017 5.9375572E-03 -0.1253062 -0.2532127 -0.3768367 -0.4949638 -0.6036966 -0.7026922 -0.7857454 -0.8440578 -0.8737929 -0.8701582 -0.8323152 -0.7573995 -0.6423376 -8.816086 0.4913287 0.3808449 0.2579516 0.1267591 -4.7688168E-03 -0.1361857 -0.2672910 -0.3978358 -0.5255490 -0.6471933 -0.7629170 -0.8679423 -0.9549250 -1.018221 -1.051146 -1.047763 -1.003680 -0.9161536 -0.7785060 -8.816086 0.3155863 0.2097770 9.2042215E-02 -3.4853879E-02 -0.1638964 -0.2933860 -0.4227088 -0.5528503 -0.6808988 -0.8057341 -0.9259139 -1.034931 -1.125743 -1.193856 -1.231176 -1.230137 -1.181764 -1.082729 -0.9231337 -8.816086 0.1115244 1.3958333E-02 -9.6430629E-02 -0.2169418 -0.3416175 -0.4677660 -0.5932111 -0.7191791 -0.8468806 -0.9736626 -1.094476 -1.205443 -1.300341 -1.373388 -1.417836 -1.421477 -1.371036 -1.261228 -1.080421 -8.816086 -0.1204285 -0.2089286 -0.3098920 -0.4224629 -0.5394549 -0.6592065 -0.7799554 -0.9009585 -1.026663 -1.151031 -1.269833 -1.381438 -1.480369 -1.558492 -1.610457 -1.619492 -1.569280 -1.449262 -1.247483 -8.816086 -0.3836800 -0.4609454 -0.5503260 -0.6522590 -0.7596777 -0.8714178 -0.9870437 -1.103459 -1.221387 -1.340343 -1.455974 -1.566335 -1.667943 -1.753510 -1.811551 -1.825740 -1.778290 -1.644733 -1.421981 -8.816086 -0.6809903 -0.7445675 -0.8217043 -0.9117728 -1.009686 -1.113494 -1.221211 -1.327626 -1.436553 -1.547563 -1.658365 -1.767436 -1.873706 -1.963927 -2.026597 -2.046220 -1.999768 -1.852079 -1.608414 -8.816086 -1.021425 -1.070482 -1.135795 -1.214668 -1.300234 -1.390311 -1.486442 -1.581035 -1.678404 -1.780996 -1.889592 -1.998863 -2.103378 -2.196599 -2.263511 -2.288990 -2.233634 -2.070163 -1.803953 -8.816086 -1.426784 -1.459408 -1.507083 -1.569049 -1.638767 -1.712867 -1.794465 -1.876612 -1.966527 -2.065504 -2.167234 -2.270712 -2.372199 -2.465449 -2.536907 -2.554793 -2.484012 -2.305202 -2.010691 -8.816086 -1.917722 -1.927693 -1.952880 -1.995646 -2.045980 -2.108489 -2.182968 -2.258125 -2.333981 -2.420038 -2.514555 -2.610165 -2.705295 -2.797620 -2.857734 -2.856644 -2.764071 -2.561039 -2.234391 -8.816086 -2.545264 -2.536835 -2.544391 -2.571396 -2.605053 -2.648336 -2.704125 -2.765563 -2.827878 -2.898848 -2.979553 -3.067178 -3.147982 -3.215394 -3.248322 -3.221861 -3.100897 -2.856533 -2.486187 -8.816086 -3.489842 -3.450156 -3.422420 -3.419721 -3.426932 -3.445843 -3.482535 -3.522163 -3.563803 -3.609349 -3.663803 -3.717503 -3.767718 -3.804785 -3.808666 -3.737199 -3.558543 -3.249434 -2.825338 -8.816086 -5.196366 -5.109946 -5.031345 -4.979995 -4.939489 -4.913580 -4.900167 -4.901894 -4.906328 -4.913668 -4.928018 -4.942605 -4.945654 -4.918545 -4.834326 -4.650404 -4.344542 -3.933878 -3.453727 -8.816086 -16.94340 -16.67543 -16.38560 -16.07470 -15.74345 -15.39266 -15.02309 -14.63554 -14.23073 -13.80939 -13.37215 -12.91972 -12.45260 -11.97145 -11.47670 -10.96893 -10.44854 -9.916014 -9.371727 -8.816086 1.131704 1.079355 1.001730 0.9167939 0.8261387 0.7315658 0.6335668 0.5358879 0.4405125 0.3491400 0.2648463 0.1859469 0.1144114 4.9831580E-02 -8.4219174E-03 -6.0857128E-02 -0.1051438 -0.1409189 -0.1667014 -11.84672 1.286834 1.203446 1.099060 0.9859303 0.8684537 0.7491971 0.6282489 0.5090590 0.3957724 0.2918868 0.1982678 0.1150568 4.5009498E-02 -1.2345267E-02 -5.6314439E-02 -8.8261947E-02 -0.1054117 -0.1087249 -9.7710744E-02 -11.84672 1.353240 1.244403 1.114886 0.9764431 0.8367102 0.6965911 0.5554731 0.4190179 0.2911824 0.1742461 6.8901934E-02 -2.0248791E-02 -9.1814823E-02 -0.1447675 -0.1774271 -0.1908233 -0.1830945 -0.1558435 -0.1094314 -11.84672 1.354523 1.225796 1.077471 0.9210309 0.7637971 0.6051282 0.4481692 0.2993219 0.1603366 3.0612931E-02 -8.5752971E-02 -0.1834862 -0.2597595 -0.3111581 -0.3367879 -0.3338926 -0.3031569 -0.2467940 -0.1656777 -11.84672 1.301845 1.159636 0.9981793 0.8300914 0.6604497 0.4895122 0.3223156 0.1641013 1.4244778E-02 -0.1271473 -0.2541560 -0.3620199 -0.4461744 -0.4995628 -0.5214011 -0.5059879 -0.4546160 -0.3705775 -0.2555883 -11.84672 1.202007 1.053304 0.8851097 0.7085319 0.5315161 0.3560109 0.1849168 1.9384587E-02 -0.1412373 -0.2916906 -0.4278676 -0.5471826 -0.6404511 -0.7004232 -0.7214009 -0.6969253 -0.6279916 -0.5180231 -0.3697989 -11.84672 1.060677 0.9102872 0.7398651 0.5610210 0.3828895 0.2082140 3.4771048E-02 -0.1364933 -0.3021860 -0.4609293 -0.6081071 -0.7375497 -0.8408910 -0.9107417 -0.9347830 -0.9066998 -0.8240105 -0.6905112 -0.5099564 -11.84672 0.8826262 0.7338834 0.5666152 0.3921053 0.2181072 4.4496533E-02 -0.1291371 -0.3012468 -0.4703294 -0.6350583 -0.7908416 -0.9297633 -1.044527 -1.125481 -1.156971 -1.129892 -1.038205 -0.8839924 -0.6719600 -11.84672 0.6705334 0.5288591 0.3704833 0.2033180 3.3423170E-02 -0.1378759 -0.3064497 -0.4770392 -0.6480666 -0.8154445 -0.9771383 -1.125251 -1.251206 -1.342439 -1.385856 -1.365426 -1.270577 -1.099014 -0.8568783 -11.84672 0.4286639 0.2981599 0.1495075 -1.0481680E-02 -0.1730209 -0.3380544 -0.5011205 -0.6676570 -0.8365504 -1.004900 -1.168755 -1.324131 -1.459278 -1.561122 -1.618759 -1.609557 -1.516976 -1.332312 -1.060612 -11.84672 0.1544402 3.5679858E-02 -0.1016280 -0.2496398 -0.4026999 -0.5602299 -0.7167086 -0.8751744 -1.039768 -1.205659 -1.369805 -1.527464 -1.668283 -1.781191 -1.852009 -1.858502 -1.771605 -1.576984 -1.276439 -11.84672 -0.1584815 -0.2609474 -0.3840151 -0.5193176 -0.6613873 -0.8083072 -0.9554106 -1.105920 -1.262481 -1.422984 -1.583603 -1.739410 -1.884843 -2.008138 -2.090762 -2.114575 -2.036597 -1.833643 -1.505311 -11.84672 -0.5138456 -0.5985204 -0.7053757 -0.8256984 -0.9524454 -1.087927 -1.225141 -1.364641 -1.510643 -1.661480 -1.814860 -1.969224 -2.116666 -2.246795 -2.343340 -2.381636 -2.314988 -2.103878 -1.747848 -11.84672 -0.9212860 -0.9849702 -1.072425 -1.177807 -1.289911 -1.409183 -1.531911 -1.658492 -1.790511 -1.930947 -2.076293 -2.227016 -2.373735 -2.510415 -2.617304 -2.665907 -2.611170 -2.385237 -2.001244 -11.84672 -1.397451 -1.441105 -1.506779 -1.591740 -1.684588 -1.784182 -1.888415 -2.000679 -2.120311 -2.249727 -2.385823 -2.529905 -2.676251 -2.814930 -2.926893 -2.985846 -2.929783 -2.686347 -2.273859 -11.84672 -1.973261 -1.990134 -2.030097 -2.090725 -2.162453 -2.243183 -2.330164 -2.425740 -2.532282 -2.648102 -2.774182 -2.908874 -3.049757 -3.183363 -3.300474 -3.352678 -3.277687 -3.014903 -2.563637 -11.84672 -2.708711 -2.697079 -2.710342 -2.747159 -2.796346 -2.853927 -2.920390 -2.996794 -3.086717 -3.185540 -3.294370 -3.411040 -3.543169 -3.670304 -3.767519 -3.793282 -3.688489 -3.388554 -2.890105 -11.84672 -3.791189 -3.742508 -3.717257 -3.720155 -3.738513 -3.766540 -3.799592 -3.843424 -3.906816 -3.979610 -4.062391 -4.149681 -4.252369 -4.344338 -4.403799 -4.401441 -4.238289 -3.871418 -3.303056 -11.84672 -5.751137 -5.636965 -5.542649 -5.472627 -5.424417 -5.396081 -5.379275 -5.370123 -5.377609 -5.402231 -5.447708 -5.496130 -5.548056 -5.600507 -5.612705 -5.510674 -5.210908 -4.696119 -4.046009 -11.84672 -22.75808 -22.41967 -22.04742 -21.64282 -21.20733 -20.74253 -20.24994 -19.73091 -19.18683 -18.61897 -18.02842 -17.41630 -16.78361 -16.13120 -15.45998 -14.77072 -14.06411 -13.34084 -12.60152 -11.84672 1.422020 1.372337 1.286430 1.192135 1.086385 0.9726192 0.8539842 0.7330721 0.6124365 0.4971355 0.3887002 0.2916943 0.2073144 0.1335141 7.0476085E-02 1.7009566E-02 -2.7947756E-02 -6.2669605E-02 -8.5991532E-02 -15.06665 1.648732 1.559283 1.440295 1.309796 1.169938 1.024088 0.8746945 0.7247040 0.5800958 0.4444467 0.3235508 0.2227691 0.1409485 7.9398699E-02 3.6783662E-02 1.2465305E-02 4.6921386E-03 1.3799855E-02 3.9081514E-02 -15.06665 1.765849 1.640271 1.487302 1.323042 1.153435 0.9797670 0.8049867 0.6324483 0.4657784 0.3108363 0.1769960 6.9120005E-02 -1.3384527E-02 -6.6458263E-02 -9.1724344E-02 -8.9614563E-02 -6.2325142E-02 -1.1383107E-02 6.0995139E-02 -15.06665 1.797181 1.642690 1.462829 1.273510 1.080003 0.8839694 0.6893827 0.4982618 0.3134427 0.1424240 -4.5716795E-03 -0.1248819 -0.2123387 -0.2633107 -0.2761593 -0.2518025 -0.1919300 -0.1008503 1.7713916E-02 -15.06665 1.757031 1.582083 1.382096 1.176248 0.9680452 0.7579941 0.5482630 0.3411462 0.1422497 -3.9528191E-02 -0.2014772 -0.3361917 -0.4340912 -0.4900002 -0.4968413 -0.4556791 -0.3667462 -0.2372952 -7.3404662E-02 -15.06665 1.652285 1.467578 1.257754 1.041728 0.8257571 0.6076813 0.3886583 0.1727284 -3.4685954E-02 -0.2283947 -0.4041003 -0.5531548 -0.6661083 -0.7324635 -0.7411012 -0.6885986 -0.5754750 -0.4098372 -0.2014801 -15.06665 1.495246 1.307824 1.095759 0.8778265 0.6566299 0.4363708 0.2147204 -3.3910484E-03 -0.2150765 -0.4195833 -0.6079558 -0.7705410 -0.9009144 -0.9819198 -1.001150 -0.9447671 -0.8127146 -0.6144576 -0.3626632 -15.06665 1.293863 1.109744 0.9012406 0.6842719 0.4640670 0.2463716 2.9392909E-02 -0.1875487 -0.4027232 -0.6129014 -0.8106076 -0.9892453 -1.134856 -1.234523 -1.270376 -1.218798 -1.074738 -0.8482415 -0.5544301 -15.06665 1.053062 0.8757876 0.6739389 0.4638484 0.2502643 4.0288292E-02 -0.1703286 -0.3846520 -0.5988143 -0.8103578 -1.015610 -1.205579 -1.366111 -1.485876 -1.541392 -1.503744 -1.355913 -1.105818 -0.7715093 -15.06665 0.7718583 0.6070881 0.4167226 0.2180415 1.5858598E-02 -0.1864908 -0.3895211 -0.5970166 -0.8061831 -1.017573 -1.225915 -1.421819 -1.596503 -1.733697 -1.810953 -1.793686 -1.650809 -1.381816 -1.008586 -15.06665 0.4528140 0.3041648 0.1294041 -5.5710342E-02 -0.2464020 -0.4371398 -0.6303436 -0.8284192 -1.032377 -1.239156 -1.445540 -1.644124 -1.828956 -1.981429 -2.080900 -2.088634 -1.960841 -1.679158 -1.268983 -15.06665 9.2370734E-02 -3.7180725E-02 -0.1950127 -0.3644526 -0.5394437 -0.7161139 -0.8976256 -1.087242 -1.281956 -1.479328 -1.679875 -1.879245 -2.067250 -2.234472 -2.354211 -2.390722 -2.284428 -1.997860 -1.551570 -15.06665 -0.3180999 -0.4250722 -0.5618655 -0.7131114 -0.8713768 -1.033376 -1.201710 -1.377959 -1.559357 -1.745771 -1.937714 -2.131822 -2.321045 -2.497474 -2.633046 -2.698341 -2.615484 -2.326759 -1.845250 -15.06665 -0.7862668 -0.8692788 -0.9827496 -1.115208 -1.255838 -1.399570 -1.548664 -1.708255 -1.874030 -2.049085 -2.227827 -2.415772 -2.602627 -2.782164 -2.937471 -3.024191 -2.966179 -2.676569 -2.160457 -15.06665 -1.333963 -1.391697 -1.479700 -1.587654 -1.705212 -1.826189 -1.954426 -2.094947 -2.242637 -2.403519 -2.570066 -2.746980 -2.928240 -3.112817 -3.277948 -3.380115 -3.345254 -3.044098 -2.492043 -15.06665 -1.995984 -2.021364 -2.077526 -2.157524 -2.248768 -2.344192 -2.448913 -2.568287 -2.696627 -2.841561 -2.994063 -3.157926 -3.333806 -3.513982 -3.682350 -3.799003 -3.763066 -3.440381 -2.850412 -15.06665 -2.839161 -2.825443 -2.843577 -2.893630 -2.954568 -3.021382 -3.102211 -3.194609 -3.299415 -3.425043 -3.560529 -3.706853 -3.866431 -4.040331 -4.208711 -4.311331 -4.242006 -3.891037 -3.245874 -15.06665 -4.058538 -3.992399 -3.958400 -3.966391 -3.991672 -4.018816 -4.061531 -4.121130 -4.191652 -4.280348 -4.394520 -4.516458 -4.650605 -4.801078 -4.934081 -4.993225 -4.882962 -4.461485 -3.739106 -15.06665 -6.226552 -6.089877 -5.973019 -5.901381 -5.849247 -5.806671 -5.779997 -5.781719 -5.799606 -5.832169 -5.885207 -5.956929 -6.051525 -6.149862 -6.247922 -6.256979 -6.019108 -5.427055 -4.597485 -15.06665 -28.97844 -28.56824 -28.10974 -27.60548 -27.05813 -26.47030 -25.84443 -25.18284 -24.48764 -23.76077 -23.00397 -22.21881 -21.40677 -20.56915 -19.70716 -18.82189 -17.91432 -16.98537 -16.03589 -15.06665 1.728617 1.677299 1.583990 1.475616 1.354725 1.226987 1.090663 0.9472468 0.8036037 0.6647933 0.5371822 0.4218841 0.3216923 0.2388295 0.1700777 0.1151216 7.2028793E-02 3.9121866E-02 1.8356677E-02 -18.45619 2.023427 1.924332 1.786814 1.636835 1.477858 1.309852 1.134814 0.9549354 0.7800370 0.6171680 0.4738148 0.3519801 0.2575969 0.1905226 0.1506774 0.1343831 0.1394470 0.1623984 0.2026269 -18.45619 2.186548 2.038539 1.859567 1.671387 1.475433 1.273393 1.065947 0.8574985 0.6553396 0.4708840 0.3091451 0.1785804 8.6321205E-02 3.2158438E-02 1.7876694E-02 3.8647506E-02 8.9688011E-02 0.1667476 0.2664734 -18.45619 2.241457 2.056755 1.846147 1.628083 1.402734 1.172249 0.9387509 0.7062412 0.4833471 0.2760391 9.3334362E-02 -5.2374743E-02 -0.1540275 -0.2056450 -0.2036929 -0.1519783 -5.8902197E-02 6.9746241E-02 0.2276259 -18.45619 2.208529 2.001214 1.767026 1.527766 1.284395 1.035269 0.7828826 0.5327607 0.2914538 6.5304048E-02 -0.1364848 -0.3011108 -0.4209962 -0.4795436 -0.4720096 -0.3974845 -0.2668553 -8.8746056E-02 0.1262919 -18.45619 2.101972 1.882290 1.635952 1.383734 1.129535 0.8703527 0.6079376 0.3480767 9.2498004E-02 -0.1495112 -0.3654023 -0.5509707 -0.6925482 -0.7683206 -0.7645973 -0.6770954 -0.5147263 -0.2898779 -1.8530048E-02 -18.45619 1.933581 1.711430 1.460307 1.202980 0.9427825 0.6821821 0.4174613 0.1516686 -0.1104495 -0.3603029 -0.5918549 -0.7961240 -0.9581507 -1.059639 -1.069575 -0.9806043 -0.7938121 -0.5259885 -0.1993066 -18.45619 1.713901 1.493780 1.244712 0.9880214 0.7299592 0.4719241 0.2087412 -5.5700384E-02 -0.3173663 -0.5721077 -0.8148502 -1.034889 -1.218345 -1.346164 -1.381899 -1.303275 -1.102124 -0.7964157 -0.4158499 -18.45619 1.445295 1.233706 0.9915733 0.7429988 0.4909400 0.2387260 -1.7729843E-02 -0.2749901 -0.5328400 -0.7895678 -1.035945 -1.266392 -1.471413 -1.622971 -1.693960 -1.637745 -1.433475 -1.096935 -0.6644629 -18.45619 1.130261 0.9328846 0.7031605 0.4646904 0.2244538 -1.6980536E-02 -0.2625057 -0.5125007 -0.7635710 -1.015144 -1.260579 -1.498751 -1.715717 -1.892049 -1.999138 -1.975504 -1.780246 -1.420795 -0.9386996 -18.45619 0.7701578 0.5901512 0.3770222 0.1538036 -7.1637183E-02 -0.2986017 -0.5337185 -0.7712865 -1.012936 -1.254798 -1.499162 -1.734742 -1.958849 -2.158784 -2.297507 -2.315289 -2.141973 -1.768174 -1.238986 -18.45619 0.3623240 0.2036832 1.0972285E-02 -0.1946098 -0.4043939 -0.6143035 -0.8329644 -1.055783 -1.285524 -1.519348 -1.752566 -1.983718 -2.212189 -2.426703 -2.593315 -2.652216 -2.514639 -2.134947 -1.561306 -18.45619 -0.1006682 -0.2358877 -0.4053368 -0.5893882 -0.7772883 -0.9680906 -1.167571 -1.374707 -1.590832 -1.809871 -2.031332 -2.257803 -2.484117 -2.706703 -2.896625 -2.995773 -2.902323 -2.527783 -1.911734 -18.45619 -0.6337510 -0.7380263 -0.8781390 -1.037448 -1.201448 -1.370576 -1.551843 -1.737756 -1.934053 -2.139033 -2.349776 -2.566043 -2.786893 -3.011439 -3.215153 -3.353939 -3.302968 -2.937379 -2.279577 -18.45619 -1.248248 -1.319372 -1.426747 -1.558981 -1.697382 -1.840244 -1.996667 -2.161284 -2.336891 -2.526777 -2.721612 -2.926702 -3.139862 -3.357928 -3.579995 -3.742931 -3.732569 -3.375827 -2.676554 -18.45619 -1.982027 -2.016412 -2.087598 -2.186028 -2.293906 -2.408047 -2.537602 -2.678796 -2.829730 -2.999497 -3.178492 -3.369445 -3.572107 -3.787930 -4.010898 -4.191952 -4.212240 -3.844341 -3.101210 -18.45619 -2.913431 -2.904290 -2.933229 -2.990880 -3.063087 -3.144861 -3.238969 -3.353061 -3.480501 -3.621709 -3.782025 -3.956916 -4.145839 -4.348720 -4.568439 -4.757332 -4.764991 -4.367215 -3.567014 -18.45619 -4.242103 -4.175065 -4.149671 -4.155791 -4.178466 -4.217100 -4.269967 -4.342260 -4.433223 -4.540646 -4.667738 -4.817502 -4.987226 -5.170049 -5.365087 -5.515636 -5.480755 -5.019522 -4.136174 -18.45619 -6.597899 -6.438999 -6.320014 -6.234665 -6.180455 -6.143909 -6.120791 -6.118327 -6.140099 -6.196156 -6.264203 -6.354795 -6.467888 -6.610864 -6.756460 -6.871372 -6.740280 -6.102319 -5.083828 -18.45619 -35.55974 -35.07640 -34.52791 -33.91834 -33.25188 -32.53257 -31.76413 -30.94994 -30.09303 -29.19612 -28.26164 -27.29177 -26.28846 -25.25344 -24.18830 -23.09444 -21.97318 -20.82568 -19.65302 -18.45619 2.039001 1.985703 1.888600 1.768835 1.633116 1.485925 1.329112 1.166622 1.002043 0.8420427 0.6936861 0.5607274 0.4459730 0.3513187 0.2768232 0.2198655 0.1775624 0.1469573 0.1284760 -21.99948 2.404599 2.294811 2.140711 1.971856 1.788920 1.597014 1.396775 1.191450 0.9904162 0.8031146 0.6354598 0.4965371 0.3883943 0.3172285 0.2798357 0.2729187 0.2913959 0.3293752 0.3847352 -21.99948 2.611633 2.441188 2.235346 2.018470 1.793666 1.563499 1.325924 1.085261 0.8528895 0.6374885 0.4497204 0.2983451 0.1922287 0.1399318 0.1362114 0.1765768 0.2534795 0.3579889 0.4855529 -21.99948 2.687896 2.473395 2.227940 1.977751 1.721725 1.458502 1.188636 0.9197567 0.6606455 0.4175100 0.2035659 2.7558457E-02 -9.0089738E-02 -0.1404913 -0.1230556 -4.4160351E-02 8.6142622E-02 0.2542956 0.4526188 -21.99948 2.661330 2.418928 2.149095 1.876455 1.599648 1.312959 1.022101 0.7314844 0.4484650 0.1855389 -5.4986823E-02 -0.2587014 -0.3987716 -0.4621036 -0.4375146 -0.3295280 -0.1519070 7.7702224E-02 0.3458539 -21.99948 2.551412 2.295707 2.013148 1.725313 1.435349 1.137290 0.8340092 0.5297933 0.2336107 -4.9774293E-02 -0.3119109 -0.5383383 -0.7106019 -0.7997922 -0.7844453 -0.6598219 -0.4430000 -0.1552093 0.1817822 -21.99948 2.373644 2.114167 1.825400 1.531444 1.235555 0.9333896 0.6258029 0.3181912 1.3409545E-02 -0.2812926 -0.5590003 -0.8059352 -1.009680 -1.133336 -1.143993 -1.018767 -0.7725229 -0.4310206 -2.6360154E-02 -21.99948 2.135735 1.879096 1.592417 1.298619 1.003332 0.7027797 0.3983878 9.1990791E-02 -0.2144755 -0.5120080 -0.7950676 -1.061766 -1.291258 -1.453387 -1.500006 -1.392980 -1.129804 -0.7406133 -0.2696257 -21.99948 1.842448 1.596073 1.315245 1.028105 0.7402377 0.4470125 0.1484933 -0.1528691 -0.4524480 -0.7455281 -1.031475 -1.307838 -1.557232 -1.755701 -1.845484 -1.774717 -1.510409 -1.081211 -0.5457632 -21.99948 1.496571 1.264520 0.9967870 0.7209926 0.4447434 0.1622660 -0.1250178 -0.4156748 -0.7040831 -0.9912724 -1.275388 -1.552045 -1.817336 -2.039644 -2.178885 -2.158074 -1.910909 -1.452514 -0.8553039 -21.99948 1.098904 0.8861082 0.6354532 0.3749193 0.1141374 -0.1519471 -0.4227248 -0.6987716 -0.9773213 -1.254452 -1.531082 -1.806746 -2.074548 -2.315874 -2.499222 -2.536887 -2.323985 -1.849849 -1.194510 -21.99948 0.6450283 0.4553950 0.2279995 -1.1571763E-02 -0.2518514 -0.4981824 -0.7523093 -1.010801 -1.275478 -1.539364 -1.808228 -2.077042 -2.339280 -2.596512 -2.812398 -2.909779 -2.747913 -2.271494 -1.561424 -21.99948 0.1306511 -2.9396139E-02 -0.2284115 -0.4441735 -0.6618497 -0.8853177 -1.119044 -1.358359 -1.605372 -1.856856 -2.110896 -2.369268 -2.628903 -2.890690 -3.130552 -3.277232 -3.182180 -2.714898 -1.953834 -21.99948 -0.4537798 -0.5812519 -0.7486412 -0.9348181 -1.125987 -1.323817 -1.533364 -1.753751 -1.980744 -2.212078 -2.450395 -2.701021 -2.954845 -3.213999 -3.469586 -3.659128 -3.633307 -3.191465 -2.382158 -21.99948 -1.128143 -1.217342 -1.349037 -1.501348 -1.662947 -1.833242 -2.015145 -2.211462 -2.414956 -2.627847 -2.851397 -3.088186 -3.334081 -3.586303 -3.846997 -4.074772 -4.107774 -3.691649 -2.833901 -21.99948 -1.927984 -1.975183 -2.066725 -2.180354 -2.308041 -2.446012 -2.596453 -2.765478 -2.947898 -3.136883 -3.340117 -3.560969 -3.796102 -4.040102 -4.306785 -4.551552 -4.633803 -4.230968 -3.321734 -21.99948 -2.937535 -2.933802 -2.979540 -3.049321 -3.136291 -3.236253 -3.350580 -3.484669 -3.638766 -3.802768 -3.981194 -4.181793 -4.407064 -4.638640 -4.896389 -5.155250 -5.253276 -4.826377 -3.859842 -21.99948 -4.372252 -4.300844 -4.285780 -4.297235 -4.329000 -4.380318 -4.446461 -4.534797 -4.651655 -4.777293 -4.922959 -5.094547 -5.292237 -5.514337 -5.753150 -5.991889 -6.036214 -5.557688 -4.500162 -21.99948 -6.920189 -6.733097 -6.609886 -6.523985 -6.463735 -6.425375 -6.419935 -6.430339 -6.464887 -6.533426 -6.621571 -6.735569 -6.870485 -7.036150 -7.232421 -7.412130 -7.403852 -6.751314 -5.538916 -21.99948 -42.46637 -41.90857 -41.26666 -40.54605 -39.75369 -38.89511 -37.97556 -36.99966 -35.97150 -34.89469 -33.77240 -32.60742 -31.40224 -30.15904 -28.87981 -27.56629 -26.22012 -24.84272 -23.43543 -21.99948 2.345856 2.291885 2.192335 2.064841 1.915511 1.750324 1.572268 1.388132 1.203821 1.024303 0.8545373 0.7036198 0.5747448 0.4685203 0.3871764 0.3274241 0.2855555 0.2573162 0.2409334 -25.68348 2.783362 2.661418 2.494536 2.307212 2.102373 1.884511 1.656274 1.426367 1.203037 0.9902728 0.7997491 0.6413915 0.5231695 0.4454728 0.4116751 0.4139297 0.4456897 0.4991581 0.5697352 -25.68348 3.035442 2.841325 2.609513 2.364589 2.110473 1.847037 1.578122 1.310398 1.049020 0.8026944 0.5864877 0.4145879 0.2972879 0.2416185 0.2496067 0.3102070 0.4125116 0.5451176 0.7007804 -25.68348 3.134191 2.888060 2.608797 2.326472 2.034857 1.736276 1.434053 1.131697 0.8387010 0.5617233 0.3112708 0.1107032 -2.5894251E-02 -7.8474067E-02 -4.5994088E-02 6.2897503E-02 0.2305433 0.4395367 0.6789759 -25.68348 3.113806 2.835848 2.530320 2.220635 1.907189 1.585824 1.257810 0.9299330 0.6111718 0.3086165 3.0271346E-02 -0.2086914 -0.3781751 -0.4478536 -0.4091357 -0.2648973 -3.8599312E-02 0.2443789 0.5667821 -25.68348 3.000842 2.708000 2.386455 2.061876 1.736607 1.400285 1.058220 0.7152067 0.3813352 5.8774352E-02 -0.2441810 -0.5170810 -0.7254184 -0.8334221 -0.8090154 -0.6476703 -0.3728072 -1.9639218E-02 0.3848103 -25.68348 2.812547 2.514183 2.187007 1.857607 1.524559 1.182582 0.8353180 0.4884989 0.1467994 -0.1845323 -0.5074121 -0.8044986 -1.048867 -1.205874 -1.217491 -1.058522 -0.7485552 -0.3299978 0.1553409 -25.68348 2.556417 2.262571 1.937361 1.607484 1.275578 0.9337792 0.5891460 0.2444157 -9.6285909E-02 -0.4328580 -0.7625976 -1.072292 -1.349083 -1.552638 -1.619121 -1.486237 -1.158539 -0.6819911 -0.1173757 -25.68348 2.239397 1.956452 1.638427 1.314136 0.9893713 0.6562444 0.3193415 -1.9371245E-02 -0.3559559 -0.6899572 -1.015294 -1.332582 -1.630115 -1.872103 -1.998637 -1.917986 -1.593790 -1.069129 -0.4274154 -25.68348 1.864260 1.597585 1.291556 0.9802588 0.6686882 0.3484682 2.3273399E-02 -0.3065507 -0.6333342 -0.9563329 -1.278615 -1.595130 -1.899035 -2.171492 -2.350471 -2.341171 -2.044555 -1.484673 -0.7684998 -25.68348 1.430317 1.185053 0.8997959 0.6063181 0.3118603 6.4779059E-03 -0.3030999 -0.6174574 -0.9286651 -1.241405 -1.557180 -1.866629 -2.171309 -2.457818 -2.685469 -2.752437 -2.509314 -1.931760 -1.145047 -25.68348 0.9383856 0.7196856 0.4593081 0.1867557 -8.7163717E-02 -0.3706348 -0.6613558 -0.9558229 -1.252624 -1.550824 -1.854261 -2.157234 -2.454755 -2.747105 -3.010888 -3.149699 -2.978713 -2.404575 -1.552463 -25.68348 0.3802797 0.1928568 -3.7304830E-02 -0.2819766 -0.5307480 -0.7890906 -1.058381 -1.333368 -1.611063 -1.890590 -2.180666 -2.472527 -2.760231 -3.056321 -3.340434 -3.541539 -3.455134 -2.904109 -1.991413 -25.68348 -0.2520727 -0.4031407 -0.5990467 -0.8124030 -1.032798 -1.262777 -1.504990 -1.758164 -2.013379 -2.275567 -2.545232 -2.824552 -3.106757 -3.398048 -3.693777 -3.936419 -3.944307 -3.431373 -2.463354 -25.68348 -0.9823319 -1.091322 -1.248007 -1.423456 -1.609761 -1.809099 -2.021980 -2.249037 -2.479966 -2.717620 -2.972177 -3.237673 -3.508814 -3.794365 -4.090312 -4.370173 -4.456260 -3.996675 -2.974767 -25.68348 -1.846120 -1.905515 -2.018756 -2.152638 -2.299054 -2.462995 -2.643512 -2.838814 -3.044960 -3.259778 -3.492388 -3.738447 -3.999715 -4.272356 -4.571313 -4.870494 -5.022077 -4.604893 -3.527258 -25.68348 -2.929678 -2.930827 -2.993392 -3.079372 -3.179192 -3.300758 -3.444605 -3.602700 -3.776383 -3.963035 -4.167834 -4.393610 -4.639169 -4.904382 -5.194917 -5.506561 -5.699073 -5.276584 -4.134244 -25.68348 -4.464826 -4.386198 -4.381325 -4.403975 -4.440923 -4.503412 -4.596040 -4.709470 -4.838882 -4.990520 -5.155444 -5.351866 -5.575481 -5.822574 -6.106637 -6.407744 -6.564755 -6.085001 -4.845361 -25.68348 -7.184724 -6.975873 -6.850550 -6.758852 -6.695029 -6.664611 -6.670705 -6.703573 -6.764999 -6.847330 -6.951305 -7.080704 -7.254672 -7.446414 -7.667504 -7.922436 -8.026573 -7.379858 -5.967295 -25.68348 -49.66926 -49.03569 -48.29630 -47.45993 -46.53525 -45.53015 -44.45158 -43.30564 -42.09758 -40.83195 -39.51270 -38.14328 -36.72671 -35.26567 -33.76254 -32.21945 -30.63833 -29.02092 -27.36882 -25.68348 2.649627 2.595083 2.491921 2.357317 2.198079 2.016459 1.817720 1.614466 1.409551 1.209449 1.021280 0.8512686 0.7069837 0.5911256 0.5022077 0.4403192 0.3987772 0.3724985 0.3580161 -29.49723 3.157859 3.022153 2.841342 2.637507 2.413222 2.169205 1.916172 1.662799 1.413872 1.178460 0.9657757 0.7900594 0.6588548 0.5787796 0.5476204 0.5598995 0.6054801 0.6744884 0.7604122 -29.49723 3.454464 3.233519 2.977371 2.707095 2.422248 2.127142 1.828683 1.531456 1.242254 0.9663191 0.7227628 0.5289246 0.3990954 0.3425405 0.3617122 0.4424850 0.5711996 0.7325062 0.9166883 -29.49723 3.576202 3.296465 2.986168 2.670355 2.343525 2.009817 1.672617 1.339697 1.015831 0.7029414 0.4204569 0.1891184 3.5366006E-02 -2.2385931E-02 2.6802287E-02 0.1651245 0.3711482 0.6220316 0.9033562 -29.49723 3.563415 3.249425 2.906535 2.561177 2.210109 1.850664 1.487093 1.127928 0.7744969 0.4341988 0.1156646 -0.1585893 -0.3575410 -0.4409671 -0.3884647 -0.2088042 6.6702001E-02 0.4044691 0.7821913 -29.49723 3.448026 3.115336 2.756217 2.395351 2.029611 1.655618 1.279142 0.9023483 0.5334239 0.1722795 -0.1730402 -0.4849640 -0.7368078 -0.8669600 -0.8400211 -0.6413803 -0.3078341 0.1131194 0.5864439 -29.49723 3.247479 2.910809 2.544612 2.177975 1.805693 1.427007 1.042867 0.6611553 0.2851525 -8.6378425E-02 -0.4463973 -0.7874874 -1.080011 -1.273059 -1.296890 -1.108287 -0.7330267 -0.2345914 0.3333117 -29.49723 2.974779 2.641733 2.277295 1.911701 1.541826 1.163394 0.7803254 0.4004808 2.3067581E-02 -0.3496154 -0.7165382 -1.072071 -1.390808 -1.643191 -1.735369 -1.587439 -1.193907 -0.6262867 3.4651529E-02 -29.49723 2.634471 2.313266 1.957656 1.599295 1.237525 0.8667206 0.4916999 0.1168714 -0.2538112 -0.6263480 -0.9917352 -1.344267 -1.684549 -1.977686 -2.143677 -2.064753 -1.682016 -1.057509 -0.3059550 -29.49723 2.230591 1.928802 1.588199 1.243696 0.8948289 0.5361940 0.1732832 -0.1903809 -0.5527232 -0.9171772 -1.273860 -1.623629 -1.970127 -2.285414 -2.516334 -2.527547 -2.187535 -1.523045 -0.6841811 -29.49723 1.766388 1.489125 1.169202 0.8428248 0.5125914 0.1713452 -0.1781133 -0.5274666 -0.8752203 -1.223287 -1.572810 -1.916460 -2.256109 -2.585656 -2.859745 -2.964992 -2.699448 -2.016694 -1.094467 -29.49723 1.239613 0.9902167 0.6979124 0.3953276 8.6044945E-02 -0.2347441 -0.5645678 -0.8946110 -1.222771 -1.557457 -1.894284 -2.225147 -2.559053 -2.887811 -3.194793 -3.379068 -3.214817 -2.541096 -1.541205 -29.49723 0.6433282 0.4281672 0.1657915 -0.1083234 -0.3901769 -0.6858410 -0.9896446 -1.298793 -1.607808 -1.925275 -2.242296 -2.562691 -2.884721 -3.212348 -3.535616 -3.782193 -3.727065 -3.092575 -2.022527 -29.49723 -3.6443163E-02 -0.2108415 -0.4357810 -0.6753756 -0.9255150 -1.192398 -1.469309 -1.753543 -2.040801 -2.333619 -2.635150 -2.937769 -3.249321 -3.574270 -3.900440 -4.193645 -4.247313 -3.674026 -2.539941 -29.49723 -0.8168796 -0.9451635 -1.129616 -1.330093 -1.541947 -1.774424 -2.020149 -2.274802 -2.537602 -2.806176 -3.087074 -3.373596 -3.673708 -3.988080 -4.318906 -4.636709 -4.789720 -4.296328 -3.104632 -29.49723 -1.742740 -1.816238 -1.951322 -2.105304 -2.275025 -2.467060 -2.676894 -2.899916 -3.133591 -3.377726 -3.636472 -3.901747 -4.186407 -4.492161 -4.818364 -5.164479 -5.387040 -4.965900 -3.713748 -29.49723 -2.899236 -2.907160 -2.983666 -3.084013 -3.203982 -3.348455 -3.516574 -3.702977 -3.900304 -4.113134 -4.345213 -4.588510 -4.853211 -5.151471 -5.476331 -5.832271 -6.103778 -5.711637 -4.389295 -29.49723 -4.521384 -4.445711 -4.446383 -4.472632 -4.524563 -4.608112 -4.719731 -4.854459 -5.009933 -5.179260 -5.380668 -5.591947 -5.832870 -6.114302 -6.432008 -6.787440 -7.046612 -6.599323 -5.177186 -29.49723 -7.395437 -7.177958 -7.049200 -6.948033 -6.885670 -6.865935 -6.890049 -6.942034 -7.018893 -7.125263 -7.256058 -7.416815 -7.599612 -7.825938 -8.075851 -8.388072 -8.583035 -7.987075 -6.376667 -29.49723 -57.14426 -56.43360 -55.59351 -54.63612 -53.57301 -52.41460 -51.16978 -49.84616 -48.45029 -46.98770 -45.46315 -43.88079 -42.24419 -40.55653 -38.82063 -37.03899 -35.21387 -33.34734 -31.44122 -29.49723 2.952539 2.895425 2.788558 2.647797 2.477714 2.281869 2.068011 1.845185 1.620797 1.401027 1.194126 1.007007 0.8487034 0.7224934 0.6285796 0.5644228 0.5233837 0.4991218 0.4863949 -33.43137 3.529242 3.377813 3.182554 2.960824 2.716743 2.451708 2.175755 1.899178 1.625865 1.366795 1.135364 0.9408193 0.8005584 0.7179769 0.6913781 0.7151454 0.7750331 0.8597249 0.9610695 -33.43137 3.869458 3.620237 3.337059 3.040309 2.727972 2.403040 2.075026 1.750199 1.430207 1.128332 0.8581530 0.6402095 0.4973933 0.4414909 0.4710308 0.5743961 0.7300360 0.9202350 1.133346 -33.43137 4.013997 3.697435 3.355414 3.008229 2.647367 2.276952 1.907619 1.543839 1.187827 0.8438920 0.5267222 0.2672093 9.2959233E-02 3.1705592E-02 9.4669953E-02 0.2640954 0.5098477 0.8033067 1.127333 -33.43137 4.008830 3.656349 3.277422 2.896927 2.506147 2.110354 1.712962 1.321939 0.9370806 0.5596963 0.2046823 -0.1076401 -0.3354409 -0.4368510 -0.3730015 -0.1580959 0.1687945 0.5627012 0.9969469 -33.43137 3.891565 3.518821 3.121122 2.722047 2.316734 1.905417 1.493982 1.087869 0.6834967 0.2855073 -9.5658757E-02 -0.4480003 -0.7394188 -0.9038782 -0.8764929 -0.6430471 -0.2485632 0.2417824 0.7856056 -33.43137 3.679626 3.302174 2.896475 2.492412 2.080809 1.664254 1.247601 0.8320778 0.4186892 1.4430918E-02 -0.3820024 -0.7604988 -1.101678 -1.335610 -1.380392 -1.165245 -0.7230043 -0.1424840 0.5099139 -33.43137 3.388125 3.015874 2.612832 2.210899 1.801951 1.388681 0.9695873 0.5550339 0.1415844 -0.2669814 -0.6645321 -1.058421 -1.426506 -1.722718 -1.854956 -1.698909 -1.237602 -0.5764089 0.1831167 -33.43137 3.025498 2.667316 2.274627 1.882037 1.482341 1.073632 0.6622447 0.2542948 -0.1545403 -0.5600174 -0.9574479 -1.351970 -1.728290 -2.069891 -2.282551 -2.220879 -1.779435 -1.052259 -0.1879778 -33.43137 2.596426 2.259973 1.884350 1.505693 1.120195 0.7229111 0.3233452 -7.4829690E-02 -0.4724167 -0.8713018 -1.262431 -1.647104 -2.029411 -2.390520 -2.668147 -2.715149 -2.336805 -1.564751 -0.5993425 -33.43137 2.103775 1.793049 1.440989 1.082180 0.7142115 0.3355244 -5.0147984E-02 -0.4334554 -0.8190370 -1.203807 -1.580590 -1.958134 -2.337330 -2.701121 -3.022123 -3.174658 -2.897782 -2.109056 -1.047490 -33.43137 1.545631 1.265583 0.9404877 0.6076383 0.2624016 -9.5674105E-02 -0.4620909 -0.8284066 -1.193931 -1.559621 -1.923823 -2.290207 -2.656401 -3.022245 -3.362904 -3.600706 -3.452730 -2.681128 -1.529428 -33.43137 0.9124334 0.6700788 0.3774071 7.4271284E-02 -0.2433609 -0.5766236 -0.9174926 -1.259723 -1.603760 -1.952595 -2.299181 -2.647440 -3.004606 -3.361046 -3.715772 -4.011434 -4.001100 -3.285390 -2.052634 -33.43137 0.1917451 -8.5429838E-03 -0.2628779 -0.5295098 -0.8126982 -1.113426 -1.425703 -1.742798 -2.063333 -2.390481 -2.714593 -3.047632 -3.389583 -3.739642 -4.097021 -4.433256 -4.543781 -3.918628 -2.614367 -33.43137 -0.6400485 -0.7886222 -0.9966733 -1.222356 -1.466336 -1.730464 -2.009215 -2.295377 -2.586308 -2.890585 -3.192152 -3.506082 -3.837163 -4.175002 -4.532883 -4.892136 -5.110921 -4.590798 -3.223326 -33.43137 -1.625168 -1.714389 -1.866382 -2.041928 -2.239628 -2.461082 -2.701586 -2.952324 -3.211404 -3.487484 -3.768135 -4.061961 -4.377756 -4.705156 -5.058509 -5.438172 -5.729656 -5.321658 -3.892087 -33.43137 -2.848233 -2.866954 -2.953568 -3.069005 -3.212157 -3.384358 -3.580467 -3.789976 -4.012710 -4.253720 -4.510980 -4.778451 -5.078218 -5.394778 -5.748473 -6.135344 -6.478180 -6.135515 -4.633599 -33.43137 -4.553363 -4.481598 -4.483390 -4.520969 -4.592491 -4.698901 -4.836749 -4.991764 -5.163893 -5.362482 -5.587298 -5.824580 -6.096519 -6.405351 -6.742435 -7.139025 -7.484653 -7.098636 -5.494854 -33.43137 -7.588885 -7.353148 -7.208883 -7.109195 -7.057423 -7.051587 -7.097214 -7.168168 -7.261170 -7.380515 -7.540798 -7.727900 -7.939745 -8.198229 -8.484227 -8.815960 -9.108140 -8.582332 -6.775867 -33.43137 -64.87086 -64.08182 -63.13764 -62.05436 -60.84717 -59.52908 -58.11123 -56.60289 -55.01191 -53.34487 -51.60738 -49.80427 -47.93972 -46.01743 -44.04064 -42.01226 -39.93490 -37.81091 -35.64241 -33.43137 3.245929 3.189658 3.076279 2.925997 2.745154 2.533354 2.302830 2.059304 1.809794 1.565461 1.331148 1.119067 0.9364935 0.7925483 0.6870604 0.6156989 0.5722704 0.5478525 0.5357506 -37.47786 3.899118 3.729411 3.516881 3.278367 3.013341 2.728012 2.432940 2.132933 1.836739 1.557815 1.304384 1.095375 0.9434992 0.8594605 0.8405893 0.8763005 0.9510379 1.051511 1.168365 -37.47786 4.280757 4.000527 3.690701 3.365834 3.024365 2.672718 2.318865 1.964158 1.618043 1.289912 0.9941460 0.7545632 0.5988929 0.5431532 0.5874752 0.7145888 0.8980671 1.117678 1.360216 -37.47786 4.447003 4.093157 3.717462 3.336462 2.943044 2.540598 2.138544 1.745269 1.358496 0.9834102 0.6354714 0.3438519 0.1473553 8.0450907E-02 0.1573218 0.3603062 0.6464898 0.9830363 1.350508 -37.47786 4.450035 4.056010 3.640359 3.224509 2.797799 2.364363 1.936205 1.514427 1.095455 0.6877766 0.2962286 -5.2687708E-02 -0.3157507 -0.4356606 -0.3650687 -0.1117743 0.2671849 0.7181026 1.210022 -37.47786 4.328942 3.915151 3.479285 3.043207 2.597425 2.150552 1.706894 1.266636 0.8314242 0.4018281 -1.6349262E-02 -0.4085400 -0.7385936 -0.9402667 -0.9200858 -0.6522767 -0.1958108 0.3654296 0.9812252 -37.47786 4.107290 3.688074 3.243430 2.800005 2.351506 1.898423 1.447704 0.9997003 0.5516479 0.1144369 -0.3146234 -0.7319288 -1.112904 -1.396570 -1.466451 -1.228550 -0.7195630 -5.4986950E-02 0.6838088 -37.47786 3.797997 3.385371 2.943992 2.506352 2.059269 1.608084 1.157190 0.7068648 0.2569267 -0.1811249 -0.6149005 -1.040969 -1.450675 -1.792397 -1.971089 -1.814208 -1.288664 -0.5318969 0.3283899 -37.47786 3.412596 3.018235 2.589627 2.161501 1.723463 1.278178 0.8315780 0.3871663 -5.6166958E-02 -0.4933832 -0.9223047 -1.351946 -1.768666 -2.147801 -2.415622 -2.380002 -1.885401 -1.053553 -7.4135281E-02 -37.47786 2.960819 2.589551 2.179618 1.766970 1.342946 0.9085709 0.4721960 3.9155222E-02 -0.3960187 -0.8221008 -1.245940 -1.670026 -2.081522 -2.480039 -2.806784 -2.901891 -2.493578 -1.612586 -0.5177011 -37.47786 2.442172 2.098240 1.712770 1.321273 0.9158863 0.4982030 7.7476420E-02 -0.3426558 -0.7625897 -1.177087 -1.589043 -1.998000 -2.407236 -2.805232 -3.169912 -3.373623 -3.098224 -2.203094 -0.9982528 -37.47786 1.852737 1.543117 1.186625 0.8209693 0.4392740 4.3463308E-02 -0.3574587 -0.7601219 -1.162857 -1.559667 -1.951703 -2.353119 -2.748744 -3.141098 -3.520404 -3.807461 -3.690260 -2.825615 -1.518305 -37.47786 1.185838 0.9149653 0.5923922 0.2588851 -9.3045995E-02 -0.4634754 -0.8407912 -1.218698 -1.597419 -1.974158 -2.351323 -2.737234 -3.117428 -3.501819 -3.884210 -4.224736 -4.266360 -3.479434 -2.079141 -37.47786 0.4241253 0.2003547 -8.0892116E-02 -0.3777201 -0.6950763 -1.031919 -1.378241 -1.727041 -2.080731 -2.438746 -2.793191 -3.160595 -3.530743 -3.899014 -4.282650 -4.654002 -4.829360 -4.166152 -2.686326 -37.47786 -0.4553039 -0.6244513 -0.8539395 -1.106108 -1.382164 -1.681337 -1.993325 -2.309847 -2.632395 -2.966096 -3.299626 -3.645746 -4.002481 -4.360153 -4.737666 -5.129722 -5.410231 -4.890011 -3.340953 -37.47786 -1.492588 -1.599595 -1.770758 -1.968672 -2.195948 -2.450077 -2.721314 -3.001570 -3.289330 -3.591505 -3.903936 -4.228826 -4.570616 -4.916205 -5.289633 -5.692020 -6.050911 -5.677223 -4.068155 -37.47786 -2.784779 -2.813148 -2.913353 -3.047181 -3.215398 -3.415649 -3.639264 -3.876889 -4.123715 -4.390905 -4.676666 -4.979627 -5.303351 -5.639445 -6.009006 -6.424430 -6.826491 -6.550136 -4.868380 -37.47786 -4.576807 -4.502367 -4.510561 -4.559410 -4.649519 -4.782597 -4.942763 -5.121856 -5.316893 -5.539120 -5.791587 -6.066531 -6.371596 -6.692724 -7.056670 -7.472902 -7.885452 -7.585854 -5.805036 -37.47786 -7.760757 -7.512976 -7.360648 -7.257892 -7.210334 -7.225338 -7.288454 -7.377905 -7.490237 -7.637512 -7.817361 -8.039104 -8.290832 -8.569065 -8.882702 -9.225753 -9.591271 -9.163814 -7.165271 -37.47786 -69.07755 -69.07755 -69.07755 -69.07755 -68.34070 -66.85703 -65.25983 -63.56022 -61.76738 -59.88895 -57.93143 -55.90037 -53.80057 -51.63625 -49.41111 -47.12846 -44.79127 -42.40219 -39.96366 -37.47786 3.534964 3.481187 3.365147 3.206069 3.011920 2.787413 2.540332 2.276938 2.005969 1.734805 1.474061 1.234254 1.028319 0.8650085 0.7472785 0.6692321 0.6231410 0.5983239 0.5868011 -41.62963 4.263529 4.078564 3.847463 3.587904 3.302571 2.997684 2.681967 2.359335 2.041788 1.738757 1.462166 1.233300 1.067950 0.9804668 0.9673395 1.013723 1.102985 1.218780 1.351054 -41.62963 4.689089 4.376960 4.037933 3.683836 3.313588 2.933933 2.555672 2.175118 1.801529 1.447134 1.125029 0.8649505 0.6933188 0.6391271 0.7001613 0.8512060 1.063317 1.312693 1.585045 -41.62963 4.875290 4.482912 4.073011 3.657478 3.229375 2.796554 2.367812 1.941625 1.525972 1.120101 0.7423791 0.4205936 0.1981805 0.1238636 0.2189895 0.4551604 0.7828209 1.163161 1.574865 -41.62963 4.886419 4.449594 3.996721 3.542818 3.080378 2.615420 2.154218 1.700354 1.251451 0.8115382 0.3879458 1.0763572E-03 -0.2966506 -0.4385744 -0.3611445 -6.9748834E-02 0.3625670 0.8713777 1.422063 -41.62963 4.761809 4.304760 3.829219 3.355548 2.874615 2.390862 1.914632 1.439456 0.9730528 0.5147228 6.2049519E-02 -0.3663084 -0.7372092 -0.9756011 -0.9692668 -0.6677237 -0.1488211 0.4843298 1.173544 -41.62963 4.528229 4.067074 3.584388 3.104500 2.616237 2.128066 1.642813 1.158508 0.6819433 0.2124402 -0.2513812 -0.7016721 -1.117976 -1.448578 -1.553433 -1.300518 -0.7245752 2.5696583E-02 0.8526567 -41.62963 4.202780 3.750960 3.272498 2.796260 2.312033 1.823045 1.337045 0.8524352 0.3705453 -9.9870160E-02 -0.5662721 -1.024685 -1.464679 -1.856302 -2.080467 -1.934671 -1.347902 -0.4933906 0.4698732 -41.62963 3.797890 3.365671 2.901442 2.437046 1.960633 1.477199 0.9969131 0.5142047 3.8757831E-02 -0.4271693 -0.8923702 -1.348472 -1.797855 -2.215300 -2.534668 -2.537312 -1.999446 -1.061218 3.5854921E-02 -41.62963 3.323193 2.916776 2.472347 2.024547 1.561608 1.090922 0.6172219 0.1462916 -0.3188404 -0.7766452 -1.233470 -1.684952 -2.128569 -2.557506 -2.931405 -3.082904 -2.658258 -1.667320 -0.4402040 -41.62963 2.779353 2.403233 1.983605 1.558385 1.114191 0.6598626 0.2018450 -0.2539546 -0.7070946 -1.150402 -1.597986 -2.040013 -2.469492 -2.898598 -3.299509 -3.562033 -3.304265 -2.304119 -0.9526886 -41.62963 2.161315 1.820510 1.431684 1.033690 0.6148596 0.1819531 -0.2554659 -0.6907157 -1.128311 -1.556008 -1.987161 -2.414871 -2.833890 -3.251476 -3.665914 -3.999046 -3.929446 -2.977705 -1.511387 -41.62963 1.459116 1.161725 0.8100978 0.4445610 5.6719847E-02 -0.3494465 -0.7626202 -1.174445 -1.589049 -1.996710 -2.407997 -2.823033 -3.226019 -3.634268 -4.043948 -4.422115 -4.524236 -3.679987 -2.110205 -41.62963 0.6594468 0.4118247 0.1059097 -0.2206187 -0.5746709 -0.9480609 -1.329921 -1.710980 -2.095672 -2.485138 -2.876734 -3.271911 -3.662699 -4.055002 -4.460556 -4.862854 -5.104013 -4.417762 -2.760107 -41.62963 -0.2615812 -0.4534850 -0.7068046 -0.9852787 -1.296243 -1.629002 -1.973861 -2.322217 -2.675951 -3.038377 -3.409011 -3.785653 -4.157054 -4.539227 -4.936948 -5.354621 -5.690205 -5.190023 -3.460369 -41.62963 -1.351793 -1.473950 -1.666124 -1.889408 -2.147069 -2.432113 -2.733312 -3.043093 -3.363592 -3.694499 -4.039157 -4.393134 -4.751167 -5.122939 -5.512967 -5.939287 -6.348308 -6.022508 -4.231887 -41.62963 -2.707327 -2.746145 -2.861122 -3.016407 -3.209704 -3.438142 -3.686379 -3.950008 -4.230670 -4.524285 -4.842408 -5.171736 -5.513972 -5.875949 -6.260787 -6.702851 -7.152520 -6.955491 -5.095615 -41.62963 -4.580048 -4.508229 -4.523039 -4.587646 -4.696593 -4.850671 -5.034585 -5.237843 -5.465587 -5.713824 -5.994384 -6.295979 -6.617376 -6.968031 -7.353779 -7.793170 -8.259923 -8.065512 -6.105537 -41.62963 -7.904446 -7.640815 -7.494031 -7.397200 -7.354190 -7.376106 -7.453590 -7.565064 -7.710040 -7.887776 -8.097648 -8.341887 -8.615775 -8.920012 -9.261036 -9.633685 -10.03942 -9.728048 -7.547807 -41.62963 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.70363 -66.60735 -64.42322 -62.15752 -59.81569 -57.40248 -54.92233 -52.37846 -49.77418 -47.11298 -44.39731 -41.62963 3.820469 3.768661 3.653672 3.488456 3.282421 3.046253 2.786166 2.505700 2.214542 1.922701 1.640568 1.378633 1.154221 0.9780012 0.8523384 0.7715604 0.7249047 0.7008364 0.6903325 -45.88049 4.620935 4.422089 4.172930 3.893453 3.585770 3.262628 2.925899 2.581754 2.241482 1.915196 1.616032 1.365025 1.187380 1.095951 1.087971 1.146482 1.250022 1.381236 1.529036 -45.88049 5.093202 4.748606 4.381026 3.994892 3.595701 3.189870 2.784435 2.377809 1.979128 1.598764 1.251375 0.9651021 0.7782964 0.7239944 0.7997569 0.9751209 1.216146 1.495432 1.797974 -45.88049 5.299802 4.868268 4.422434 3.971218 3.509254 3.045807 2.588087 2.133490 1.688294 1.253703 0.8449358 0.4935044 0.2430699 0.1618663 0.2735525 0.5434660 0.9135514 1.338455 1.795112 -45.88049 5.317413 4.837100 4.346711 3.853963 3.355187 2.858083 2.365694 1.878884 1.401918 0.9319258 0.4763132 5.8204636E-02 -0.2786441 -0.4460069 -0.3621613 -3.3604361E-02 0.4532435 1.021067 1.631571 -45.88049 5.189322 4.688070 4.172703 3.660270 3.143004 2.626506 2.114237 1.606066 1.110664 0.6195886 0.1391643 -0.3226384 -0.7311256 -1.009262 -1.022096 -0.6899375 -0.1070782 0.5993490 1.363353 -45.88049 4.943865 4.440426 3.918657 3.401209 2.876037 2.350567 1.830253 1.311816 0.8050655 0.3048218 -0.1896100 -0.6685838 -1.122001 -1.492634 -1.642653 -1.379663 -0.7363718 0.1008339 1.017620 -45.88049 4.601849 4.110834 3.595945 3.082419 2.557454 2.032319 1.510131 0.9897379 0.4813962 -2.3660192E-02 -0.5201060 -1.005997 -1.474740 -1.906335 -2.183698 -2.062038 -1.415284 -0.4613858 0.6067872 -45.88049 4.179932 3.709635 3.209432 2.706046 2.191175 1.671261 1.152617 0.6378351 0.1312835 -0.3696506 -0.8639973 -1.345683 -1.820588 -2.277560 -2.643471 -2.694881 -2.121399 -1.075234 0.1418293 -45.88049 3.683169 3.240075 2.761302 2.276574 1.775733 1.267061 0.7590249 0.2512127 -0.2452066 -0.7371277 -1.227301 -1.700058 -2.171996 -2.629191 -3.045541 -3.255719 -2.829907 -1.729423 -0.3676432 -45.88049 3.113702 2.703802 2.251777 1.790310 1.309858 0.8171281 0.3242078 -0.1677532 -0.6532806 -1.132088 -1.610797 -2.076938 -2.532508 -2.989206 -3.421770 -3.743583 -3.515064 -2.414340 -0.9139936 -45.88049 2.466993 2.095458 1.676733 1.243780 0.7884344 0.3174926 -0.1549249 -0.6261559 -1.095275 -1.559282 -2.024500 -2.473346 -2.918162 -3.361917 -3.801146 -4.183074 -4.166002 -3.135531 -1.507008 -45.88049 1.732863 1.407120 1.029394 0.6299595 0.2046535 -0.2382509 -0.6855633 -1.132377 -1.579369 -2.026217 -2.467960 -2.903322 -3.333941 -3.763143 -4.198521 -4.613362 -4.776320 -3.887874 -2.146134 -45.88049 0.8990353 0.6249273 0.2934893 -6.4330071E-02 -0.4532847 -0.8636493 -1.279282 -1.696096 -2.113900 -2.535296 -2.959200 -3.377194 -3.791357 -4.210958 -4.632112 -5.062725 -5.363093 -4.670607 -2.833171 -45.88049 -6.4250112E-02 -0.2761815 -0.5546473 -0.8638551 -1.207053 -1.575063 -1.950519 -2.332907 -2.721559 -3.116937 -3.516686 -3.916177 -4.313265 -4.718452 -5.130263 -5.566813 -5.957891 -5.489154 -3.578042 -45.88049 -1.203894 -1.342525 -1.554574 -1.806052 -2.094269 -2.411709 -2.741972 -3.085803 -3.441602 -3.806935 -4.181409 -4.556666 -4.934248 -5.325835 -5.728319 -6.174220 -6.632007 -6.366749 -4.395954 -45.88049 -2.621224 -2.670242 -2.802682 -2.982361 -3.202954 -3.457874 -3.734529 -4.029374 -4.345443 -4.675178 -5.018630 -5.370985 -5.727983 -6.107817 -6.506455 -6.964994 -7.464872 -7.351802 -5.317446 -45.88049 -4.576140 -4.505044 -4.532904 -4.613499 -4.744570 -4.916724 -5.120526 -5.355806 -5.620268 -5.904424 -6.210866 -6.536576 -6.873964 -7.243520 -7.640312 -8.102648 -8.618713 -8.532315 -6.399297 -45.88049 -8.036114 -7.762061 -7.605369 -7.506845 -7.487020 -7.521945 -7.602847 -7.745996 -7.936629 -8.144382 -8.389814 -8.658610 -8.954250 -9.274299 -9.632701 -10.03172 -10.46588 -10.27598 -7.928342 -45.88049 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.56560 -65.97543 -63.30695 -60.56487 -57.75328 -54.87589 -51.93601 -48.93663 -45.88049 4.101643 4.049873 3.935467 3.767940 3.551610 3.305274 3.030637 2.734438 2.424577 2.111964 1.808889 1.525548 1.282931 1.094530 0.9613897 0.8781794 0.8311604 0.8079114 0.7983293 -50.22493 4.973627 4.759497 4.494952 4.193812 3.866441 3.523251 3.165619 2.802163 2.440174 2.093674 1.772074 1.502079 1.313447 1.220761 1.220455 1.292366 1.411083 1.558001 1.721562 -50.22493 5.492005 5.116819 4.718821 4.302197 3.871441 3.439737 3.007416 2.575946 2.152994 1.748821 1.375731 1.062221 0.8618701 0.8066437 0.8980434 1.099882 1.370179 1.679778 2.012989 -50.22493 5.720846 5.248444 4.767934 4.278033 3.782757 3.288865 2.800599 2.319297 1.848294 1.384612 0.9476782 0.5618904 0.2865615 0.1930525 0.3195037 0.6244969 1.037881 1.507777 2.010132 -50.22493 5.743307 5.220041 4.690017 4.158618 3.623335 3.093851 2.568626 2.055174 1.547171 1.048997 0.5639943 0.1147457 -0.2597502 -0.4561056 -0.3703558 -4.3102875E-03 0.5382907 1.166004 1.837353 -50.22493 5.611041 5.065349 4.510312 3.958499 3.404259 2.853953 2.308864 1.768713 1.242744 0.7218240 0.2144718 -0.2757424 -0.7212637 -1.044010 -1.077566 -0.7177129 -7.0324704E-02 0.7105306 1.550610 -50.22493 5.354012 4.808088 4.247385 3.690731 3.127901 2.569209 2.010558 1.461995 0.9236977 0.3916746 -0.1273286 -0.6354077 -1.119506 -1.531733 -1.729598 -1.463877 -0.7544774 0.1709198 1.179094 -50.22493 4.996525 4.465179 3.912755 3.360979 2.799654 2.235238 1.677286 1.124782 0.5832220 4.7318790E-02 -0.4755497 -0.9866480 -1.486529 -1.948503 -2.283118 -2.191058 -1.490120 -0.4361451 0.7387512 -50.22493 4.556284 4.048307 3.512759 2.971653 2.416435 1.860321 1.305166 0.7553720 0.2187812 -0.3184192 -0.8386876 -1.346177 -1.844206 -2.330768 -2.742984 -2.851203 -2.250917 -1.097056 0.2419596 -50.22493 4.039765 3.560497 3.045915 2.524120 1.985120 1.439157 0.8953573 0.3535807 -0.1773796 -0.7057701 -1.220840 -1.717544 -2.211623 -2.697915 -3.151134 -3.418731 -3.004479 -1.797258 -0.2984438 -50.22493 3.443918 3.000850 2.516481 2.018811 1.500248 0.9715363 0.4420515 -8.5021742E-02 -0.6057689 -1.122112 -1.623279 -2.111613 -2.597359 -3.069468 -3.535571 -3.908713 -3.724634 -2.529923 -0.8784863 -50.22493 2.768931 2.368481 1.919506 1.451295 0.9581175 0.4502468 -5.8520418E-02 -0.5654837 -1.069468 -1.566968 -2.055716 -2.532538 -3.000232 -3.462111 -3.923758 -4.351191 -4.395405 -3.298662 -1.506008 -50.22493 2.006494 1.653015 1.245613 0.8131352 0.3504423 -0.1288318 -0.6113912 -1.094188 -1.574781 -2.055113 -2.525756 -2.982153 -3.438853 -3.882679 -4.339874 -4.785315 -5.013395 -4.098971 -2.183254 -50.22493 1.137877 0.8403596 0.4807525 9.0244547E-02 -0.3341305 -0.7779127 -1.229030 -1.684020 -2.138771 -2.593652 -3.043015 -3.483006 -3.919160 -4.350607 -4.791257 -5.245471 -5.597383 -4.925944 -2.909292 -50.22493 0.1357142 -9.7572215E-02 -0.3996010 -0.7412266 -1.119430 -1.520171 -1.931635 -2.350614 -2.775333 -3.205006 -3.630903 -4.049896 -4.468558 -4.878346 -5.308320 -5.764154 -6.199136 -5.789516 -3.698211 -50.22493 -1.052709 -1.208334 -1.442056 -1.722951 -2.042290 -2.390681 -2.753470 -3.133419 -3.524754 -3.923872 -4.323417 -4.718097 -5.115028 -5.509736 -5.929651 -6.390516 -6.879508 -6.710800 -4.562939 -50.22493 -2.529909 -2.589752 -2.739976 -2.942789 -3.191938 -3.474489 -3.776961 -4.110342 -4.460173 -4.823254 -5.187942 -5.557553 -5.935952 -6.319159 -6.734900 -7.207167 -7.740960 -7.743771 -5.539446 -50.22493 -4.559908 -4.491241 -4.527685 -4.625354 -4.780946 -4.977111 -5.202112 -5.474668 -5.771928 -6.087979 -6.415314 -6.753638 -7.114597 -7.494512 -7.912493 -8.401238 -8.949911 -8.982368 -6.684548 -50.22493 -8.144150 -7.864991 -7.710142 -7.606239 -7.592971 -7.649473 -7.757382 -7.936917 -8.153387 -8.400262 -8.666368 -8.956495 -9.272307 -9.621167 -9.989303 -10.41150 -10.85861 -10.79341 -8.294980 -50.22493 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -66.33177 -63.24642 -60.08984 -56.86493 -53.57571 -50.22493 4.377836 4.326908 4.211662 4.040637 3.820033 3.561870 3.275005 2.962551 2.634002 2.302441 1.972851 1.669770 1.411069 1.209763 1.069784 0.9840877 0.9366339 0.9142933 0.9054831 -54.65804 5.322156 5.090693 4.809711 4.491196 4.142178 3.779579 3.401259 3.017051 2.637968 2.265461 1.920723 1.634036 1.434749 1.341316 1.349243 1.434722 1.568630 1.731497 1.910918 -54.65804 5.885742 5.479574 5.052471 4.603332 4.143392 3.683848 3.224386 2.770748 2.323698 1.892139 1.490958 1.156964 0.9402487 0.8846936 0.9928194 1.221348 1.521241 1.861583 2.225864 -54.65804 6.136668 5.625063 5.107053 4.580761 4.050126 3.525701 3.007870 2.501459 1.999118 1.509136 1.045212 0.6302361 0.3273036 0.2191588 0.3611107 0.7028459 1.159638 1.675233 2.224009 -54.65804 6.165281 5.597256 5.028705 4.456804 3.886098 3.323104 2.766790 2.222034 1.685151 1.158893 0.6504355 0.1704095 -0.2390649 -0.4682404 -0.3834988 1.9726288E-02 0.6186995 1.307098 2.040297 -54.65804 6.026905 5.437573 4.841912 4.250783 3.659243 3.075835 2.494401 1.925759 1.365093 0.8194059 0.2870952 -0.2284072 -0.7090717 -1.073869 -1.135148 -0.7527202 -4.0520936E-02 0.8159123 1.733364 -54.65804 5.758172 5.170125 4.570373 3.974351 3.374461 2.778274 2.184930 1.602777 1.032506 0.4747280 -6.7857914E-02 -0.6021533 -1.114231 -1.567789 -1.810451 -1.551908 -0.7790508 0.2357675 1.336913 -54.65804 5.386242 4.814035 4.224854 3.632836 3.033113 2.433077 1.835464 1.253025 0.6779593 0.1121422 -0.4334808 -0.9700837 -1.494043 -1.985488 -2.373370 -2.320013 -1.572014 -0.4170528 0.8664128 -54.65804 4.928614 4.382128 3.809486 3.230045 2.637383 2.041353 1.451711 0.8691155 0.2956543 -0.2705274 -0.8141228 -1.345678 -1.865372 -2.374254 -2.832780 -2.999259 -2.387561 -1.125805 0.3373120 -54.65804 4.390533 3.875873 3.326447 2.765637 2.188550 1.605465 1.026396 0.4502460 -0.1184352 -0.6766742 -1.212152 -1.738125 -2.246640 -2.757818 -3.240838 -3.565431 -3.181744 -1.867912 -0.2296522 -54.65804 3.770373 3.294435 2.776477 2.242460 1.685866 1.119816 0.5556533 -8.5399179E-03 -0.5650181 -1.109767 -1.636082 -2.147498 -2.650134 -3.143591 -3.635040 -4.050982 -3.936814 -2.656681 -0.8517973 -54.65804 3.068731 2.638225 2.158198 1.654521 1.123703 0.5799900 3.4263633E-02 -0.5097657 -1.048981 -1.577658 -2.088154 -2.588732 -3.073349 -3.553855 -4.036108 -4.496889 -4.620136 -3.473196 -1.514673 -54.65804 2.277740 1.897032 1.459929 0.9923916 0.4933422 -2.1600664E-02 -0.5414785 -1.063022 -1.579170 -2.089434 -2.585154 -3.063017 -3.530713 -3.993847 -4.467881 -4.937038 -5.238247 -4.316756 -2.225078 -54.65804 1.375790 1.053377 0.6677274 0.2424725 -0.2172256 -0.6964515 -1.182721 -1.676731 -2.169407 -2.655980 -3.124444 -3.585200 -4.034352 -4.479122 -4.940716 -5.410634 -5.822596 -5.185093 -2.989190 -54.65804 0.3357762 8.1279039E-02 -0.2458631 -0.6189733 -1.031392 -1.467035 -1.912751 -2.372463 -2.833003 -3.289904 -3.734110 -4.171946 -4.605685 -5.031927 -5.479506 -5.948203 -6.429219 -6.089273 -3.820924 -54.65804 -0.8976923 -1.070029 -1.327390 -1.636156 -1.989578 -2.368240 -2.765412 -3.183856 -3.610689 -4.035456 -4.452479 -4.867635 -5.277994 -5.687017 -6.124490 -6.597219 -7.119699 -7.043810 -4.731389 -54.65804 -2.429370 -2.499430 -2.669600 -2.898139 -3.176347 -3.487129 -3.826823 -4.197600 -4.580884 -4.967006 -5.350360 -5.733301 -6.128885 -6.523939 -6.960133 -7.441433 -8.004366 -8.114539 -5.762189 -54.65804 -4.528165 -4.462978 -4.518589 -4.635432 -4.812355 -5.031909 -5.296097 -5.600218 -5.928374 -6.271616 -6.613158 -6.963043 -7.347920 -7.736621 -8.181275 -8.673625 -9.247528 -9.410363 -6.967005 -54.65804 -8.232015 -7.948976 -7.800417 -7.709908 -7.702709 -7.767693 -7.913114 -8.116635 -8.359685 -8.644764 -8.926462 -9.226672 -9.567560 -9.928694 -10.32865 -10.76716 -11.23831 -11.30640 -8.657970 -54.65804 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.85119 -65.40922 -61.89404 -58.30923 -54.65804 4.649801 4.600101 4.483178 4.309707 4.084378 3.817078 3.516664 3.188515 2.840913 2.488005 2.136184 1.812126 1.535859 1.321323 1.174904 1.086018 1.038478 1.016711 1.008530 -59.17545 5.667618 5.417915 5.118086 4.780814 4.414706 4.028921 3.633190 3.228133 2.827496 2.434708 2.067947 1.762971 1.553902 1.460350 1.477554 1.576725 1.726406 1.905377 2.100838 -59.17545 6.274361 5.836034 5.378679 4.900770 4.409403 3.922738 3.436769 2.957495 2.488313 2.031464 1.604101 1.247197 1.012079 0.9560913 1.081342 1.336250 1.666223 2.037683 2.433460 -59.17545 6.547622 5.995597 5.441547 4.877352 4.313496 3.755592 3.208631 2.674593 2.145431 1.633029 1.139875 0.6979670 0.3643866 0.2435384 0.4008085 0.7787603 1.279835 1.841808 2.437693 -59.17545 6.582619 5.969779 5.360992 4.750818 4.142828 3.545601 2.956954 2.382094 1.817984 1.266016 0.7346494 0.2265597 -0.2162436 -0.4791327 -0.3978963 4.3329872E-02 0.6992472 1.449382 2.245422 -59.17545 6.438128 5.803704 5.169044 4.536972 3.908500 3.288242 2.673507 2.074680 1.484566 0.9138379 0.3579140 -0.1835571 -0.6936719 -1.099201 -1.193093 -0.7932442 -1.5651904E-02 0.9173691 1.913434 -59.17545 6.157166 5.526933 4.887768 4.251460 3.613446 2.979091 2.352854 1.739597 1.134381 0.5531136 -1.3965758E-02 -0.5702931 -1.107774 -1.597270 -1.885246 -1.647819 -0.8126589 0.2927659 1.488369 -59.17545 5.770327 5.158302 4.530674 3.898288 3.259091 2.623821 1.991871 1.373310 0.7645646 0.1754076 -0.3942913 -0.9534359 -1.495687 -2.017794 -2.444699 -2.449039 -1.660785 -0.4041062 0.9897795 -59.17545 5.296055 4.710683 4.100223 3.480631 2.851216 2.219182 1.591862 0.9745163 0.3659290 -0.2221690 -0.7924979 -1.345023 -1.882402 -2.410873 -2.905908 -3.141540 -2.528877 -1.160634 0.4287208 -59.17545 4.735619 4.184896 3.600850 3.002159 2.385988 1.767011 1.150134 0.5394559 -6.2266782E-02 -0.6468030 -1.207750 -1.752706 -2.276791 -2.806355 -3.315527 -3.707375 -3.366456 -1.951963 -0.1719501 -59.17545 4.092637 3.584047 3.032110 2.460292 1.866490 1.264258 0.6612257 6.3490286E-02 -0.5297091 -1.101250 -1.649778 -2.181036 -2.693971 -3.213498 -3.723114 -4.188054 -4.146450 -2.789353 -0.8279419 -59.17545 3.365014 2.904023 2.392483 1.852803 1.284736 0.7056061 0.1203401 -0.4610981 -1.036273 -1.591215 -2.122051 -2.640216 -3.138906 -3.638736 -4.142647 -4.638182 -4.838226 -3.653504 -1.526119 -59.17545 2.545114 2.137778 1.670578 1.168022 0.6324395 8.1426963E-02 -0.4777228 -1.036585 -1.589526 -2.121094 -2.635072 -3.137461 -3.612613 -4.101187 -4.590874 -5.091736 -5.451931 -4.541368 -2.271827 -59.17545 1.611877 1.265346 0.8506908 0.3927729 -0.1032011 -0.6167208 -1.142724 -1.673592 -2.201225 -2.709477 -3.197389 -3.677311 -4.138827 -4.609422 -5.087255 -5.582288 -6.033931 -5.449905 -3.074295 -59.17545 0.5366012 0.2613033 -9.2198618E-02 -0.4970658 -0.9446296 -1.413952 -1.901594 -2.398293 -2.892411 -3.369614 -3.830847 -4.291055 -4.734407 -5.189713 -5.647550 -6.136566 -6.642715 -6.387665 -3.946911 -59.17545 -0.7383190 -0.9264112 -1.209127 -1.549150 -1.934539 -2.348214 -2.786390 -3.241697 -3.698989 -4.146512 -4.576813 -5.012312 -5.437486 -5.873005 -6.317471 -6.804372 -7.348930 -7.368155 -4.898827 -59.17545 -2.320154 -2.401626 -2.596407 -2.852676 -3.160312 -3.502328 -3.880541 -4.286182 -4.701983 -5.113945 -5.508750 -5.913746 -6.318638 -6.741570 -7.181257 -7.675847 -8.260219 -8.467840 -5.976053 -59.17545 -4.492302 -4.433439 -4.502098 -4.645108 -4.848150 -5.095003 -5.391173 -5.726733 -6.083066 -6.452820 -6.810700 -7.190507 -7.576087 -7.995439 -8.442506 -8.943042 -9.540998 -9.815284 -7.249517 -59.17545 -8.315885 -8.029886 -7.879074 -7.811410 -7.822245 -7.898835 -8.059176 -8.294584 -8.571433 -8.872185 -9.184916 -9.516743 -9.872407 -10.25502 -10.66936 -11.11734 -11.61359 -11.78155 -9.018907 -59.17545 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -67.01834 -63.13252 -59.17545 4.914869 4.867041 4.750568 4.579292 4.345053 4.068562 3.755370 3.411282 3.044521 2.669527 2.298240 1.952437 1.656543 1.429990 1.275683 1.183888 1.135983 1.114438 1.106788 -63.77322 6.007661 5.740926 5.424916 5.066458 4.680246 4.275168 3.857335 3.433641 3.012545 2.597269 2.210078 1.885283 1.664701 1.570684 1.596428 1.709306 1.874833 2.069816 2.281474 -63.77322 6.659812 6.190089 5.700359 5.190794 4.672668 4.153792 3.643912 3.139342 2.646031 2.167472 1.716784 1.332656 1.081070 1.025342 1.167620 1.449679 1.810385 2.213341 2.641076 -63.77322 6.955299 6.360804 5.769114 5.170158 4.570106 3.979314 3.402266 2.839695 2.288864 1.752696 1.234004 0.7636516 0.4010279 0.2669431 0.4378833 0.8529609 1.399111 2.008134 2.651849 -63.77322 6.993689 6.336451 5.688542 5.038187 4.394654 3.759619 3.140530 2.536674 1.946187 1.372274 0.8148464 0.2825960 -0.1940176 -0.4885954 -0.4166934 6.1073083E-02 0.7744241 1.587160 2.446977 -63.77322 6.843862 6.165498 5.489730 4.818279 4.150045 3.492745 2.847578 2.215583 1.599325 1.002727 0.4239895 -0.1398465 -0.6770169 -1.117993 -1.254942 -0.8390536 2.2304200E-03 1.013179 2.089022 -63.77322 6.551268 5.878026 5.200124 4.521137 3.844790 3.174803 2.514756 1.868868 1.231940 0.6274823 3.7501555E-02 -0.5365505 -1.097189 -1.613654 -1.956517 -1.747023 -0.8528330 0.3446885 1.636123 -63.77322 6.149771 5.496832 4.829742 4.156214 3.480278 2.807929 2.142082 1.486465 0.8467292 0.2356150 -0.3600842 -0.9330505 -1.495183 -2.040817 -2.511504 -2.578279 -1.758865 -0.3990545 1.106712 -63.77322 5.657163 5.032745 4.384626 3.726605 3.058515 2.391635 1.726308 1.072495 0.4339422 -0.1796394 -0.7721320 -1.338343 -1.895761 -2.442281 -2.971676 -3.275356 -2.677783 -1.204049 0.5131997 -63.77322 5.074933 4.489644 3.869215 3.233093 2.579829 1.921802 1.268553 0.6208268 -1.3616882E-02 -0.6208773 -1.205488 -1.759267 -2.308027 -2.850590 -3.392599 -3.835367 -3.552287 -2.045871 -0.1226322 -63.77322 4.409844 3.869117 3.283169 2.673911 2.041714 1.403219 0.7611331 0.1243213 -0.4988776 -1.094318 -1.663429 -2.206007 -2.739100 -3.277070 -3.811392 -4.312466 -4.342068 -2.923672 -0.8046012 -63.77322 3.658269 3.166114 2.621486 2.046222 1.441288 0.8245873 0.2014049 -0.4203785 -1.024051 -1.599323 -2.153292 -2.679097 -3.204056 -3.722434 -4.248166 -4.765326 -5.031448 -3.837920 -1.541603 -63.77322 2.809000 2.374527 1.877537 1.338902 0.7682608 0.1808071 -0.4180028 -1.016350 -1.597749 -2.150146 -2.682859 -3.198629 -3.702815 -4.207874 -4.712435 -5.228976 -5.638313 -4.768921 -2.324177 -63.77322 1.845890 1.475968 1.033026 0.5396953 9.0948353E-03 -0.5417590 -1.109528 -1.678748 -2.232820 -2.760632 -3.270204 -3.764281 -4.254678 -4.739277 -5.226179 -5.729989 -6.215635 -5.712546 -3.163596 -63.77322 0.7370911 0.4432504 6.1459132E-02 -0.3761983 -0.8591379 -1.365981 -1.895710 -2.428319 -2.954088 -3.449623 -3.931254 -4.405149 -4.876053 -5.343588 -5.807989 -6.300611 -6.826446 -6.675797 -4.075550 -63.77322 -0.5746339 -0.7797182 -1.089081 -1.461074 -1.881821 -2.331611 -2.809508 -3.299056 -3.788999 -4.254066 -4.709497 -5.159288 -5.608448 -6.053678 -6.500246 -6.985518 -7.542275 -7.675526 -5.068880 -63.77322 -2.207903 -2.303269 -2.518163 -2.806233 -3.147751 -3.523056 -3.936249 -4.373529 -4.819383 -5.248768 -5.674180 -6.096831 -6.520620 -6.947786 -7.385553 -7.878479 -8.471851 -8.795390 -6.189917 -63.77322 -4.448459 -4.396526 -4.481064 -4.651758 -4.885834 -5.160839 -5.484588 -5.851666 -6.239208 -6.618875 -7.013524 -7.403560 -7.811476 -8.231199 -8.672693 -9.177207 -9.784807 -10.18832 -7.529134 -63.77322 -8.369987 -8.080860 -7.939334 -7.894421 -7.933802 -8.023658 -8.194323 -8.462481 -8.765121 -9.082171 -9.428469 -9.786584 -10.16308 -10.55567 -10.96703 -11.42695 -11.94273 -12.22163 -9.375615 -63.77322 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.04135 -63.77322 5.176029 5.129686 5.018070 4.847327 4.605776 4.315145 3.990922 3.628512 3.251011 2.849898 2.453681 2.087654 1.774205 1.533788 1.371107 1.276152 1.227486 1.206000 1.198840 -68.44775 6.344812 6.056931 5.726188 5.350817 4.939647 4.513791 4.076297 3.636483 3.195019 2.754011 2.343522 2.003766 1.771208 1.676847 1.711093 1.838057 2.019353 2.230465 2.458537 -68.44775 7.043342 6.538690 6.018694 5.473929 4.927664 4.381451 3.844225 3.319203 2.801210 2.295266 1.823215 1.415103 1.147983 1.090806 1.250867 1.560716 1.952670 2.387422 2.847587 -68.44775 7.359491 6.722171 6.089427 5.455383 4.822349 4.195602 3.593752 3.001337 2.424187 1.863607 1.327257 0.8281605 0.4399152 0.2916951 0.4770070 0.9304984 1.523217 2.179904 2.872171 -68.44775 7.401075 6.696768 6.009080 5.320608 4.638843 3.970752 3.319750 2.682532 2.065552 1.472796 0.8929766 0.3369569 -0.1683670 -0.4946794 -0.4330226 8.2276464E-02 0.8552484 1.731381 2.655957 -68.44775 7.243106 6.520944 5.805567 5.092812 4.387898 3.692206 3.013106 2.346456 1.706418 1.089304 0.4883776 -9.5061496E-02 -0.6557317 -1.134456 -1.315962 -0.8921525 1.3334382E-02 1.102642 2.259466 -68.44775 6.939375 6.223722 5.506122 4.787048 4.070692 3.363183 2.667963 1.986901 1.328592 0.6964466 8.8250585E-02 -0.5047414 -1.082753 -1.627919 -2.025159 -1.848872 -0.9013957 0.3884066 1.777128 -68.44775 6.523339 5.829602 5.122821 4.409234 3.693299 2.984403 2.283104 1.593976 0.9260575 0.2909758 -0.3229075 -0.9120703 -1.493720 -2.060028 -2.571758 -2.702100 -1.865647 -0.4038154 1.215490 -68.44775 6.011353 5.349137 4.663131 3.965215 3.258689 2.555575 1.855787 1.162785 0.4973105 -0.1396834 -0.7491906 -1.332204 -1.907098 -2.476390 -3.031538 -3.387874 -2.825878 -1.248331 0.5987093 -68.44775 5.409536 4.788937 4.131292 3.456642 2.767704 2.073274 1.378687 0.6939049 3.2234278E-02 -0.5962842 -1.198582 -1.769531 -2.337550 -2.897163 -3.462714 -3.940470 -3.734788 -2.142033 -7.3395111E-02 -68.44775 4.722181 4.147925 3.528046 2.882200 2.212512 1.535482 0.8539358 0.1797342 -0.4676597 -1.083834 -1.672695 -2.232713 -2.787294 -3.339264 -3.887466 -4.415210 -4.538053 -3.073494 -0.7951055 -68.44775 3.946476 3.424122 2.846552 2.233703 1.593332 0.9386650 0.2743567 -0.3817460 -1.012429 -1.606530 -2.180938 -2.726302 -3.272641 -3.806310 -4.338073 -4.869887 -5.217653 -4.032238 -1.565571 -68.44775 3.069151 2.608098 2.080630 1.506443 0.8988410 0.2744772 -0.3681886 -1.000542 -1.608049 -2.178976 -2.730251 -3.267329 -3.798038 -4.307045 -4.819425 -5.346037 -5.814889 -5.001139 -2.381756 -68.44775 2.077920 1.684800 1.212456 0.6854786 0.1169171 -0.4735417 -1.082952 -1.685189 -2.266759 -2.812156 -3.346290 -3.861412 -4.369070 -4.857875 -5.347823 -5.861386 -6.385967 -5.977632 -3.258307 -68.44775 0.9384404 0.6233905 0.2141300 -0.2572451 -0.7764355 -1.324034 -1.891098 -2.459063 -3.009377 -3.530151 -4.034632 -4.529055 -5.013577 -5.478508 -5.948997 -6.449269 -6.999381 -6.960429 -4.207034 -68.44775 -0.4107524 -0.6336914 -0.9680643 -1.373332 -1.832086 -2.320258 -2.835359 -3.359048 -3.869782 -4.361291 -4.841552 -5.308588 -5.770417 -6.213116 -6.662962 -7.156658 -7.732210 -7.980970 -5.242241 -68.44775 -2.093858 -2.200490 -2.438483 -2.758896 -3.136818 -3.547742 -3.994196 -4.466991 -4.931977 -5.386999 -5.838111 -6.278162 -6.715055 -7.140016 -7.575225 -8.079447 -8.686896 -9.120068 -6.406588 -68.44775 -4.391715 -4.347278 -4.450201 -4.650963 -4.917406 -5.225422 -5.583391 -5.986514 -6.388080 -6.796750 -7.211224 -7.624082 -8.040304 -8.463357 -8.906861 -9.428575 -10.04549 -10.54789 -7.804733 -68.44775 -8.405097 -8.115305 -7.986723 -7.971496 -8.030523 -8.149474 -8.355507 -8.640056 -8.965487 -9.319607 -9.684909 -10.06944 -10.45577 -10.86209 -11.28256 -11.75164 -12.27576 -12.63990 -9.730756 -68.44775 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.44775 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.8429193 -0.8571817 -0.8705409 -0.8832629 -0.8951789 -0.9060127 -0.9209652 -0.9352963 -0.9489796 -0.9622047 -0.9744015 -0.9862723 -0.9974906 -1.008807 -1.021189 -1.032405 -1.041832 -1.049315 -1.054152 -2.074072 -0.8684047 -0.8833513 -0.8980114 -0.9114727 -0.9237376 -0.9353330 -0.9508225 -0.9656015 -0.9796939 -0.9927908 -1.005026 -1.016822 -1.027637 -1.038437 -1.050206 -1.060443 -1.068572 -1.073207 -1.078829 -2.074072 -0.8952405 -0.9111688 -0.9263445 -0.9401044 -0.9529182 -0.9651799 -0.9810592 -0.9961084 -1.010457 -1.023347 -1.035574 -1.046917 -1.057223 -1.067516 -1.078600 -1.087743 -1.094550 -1.096585 -1.102683 -2.074072 -0.9265279 -0.9426590 -0.9578672 -0.9719974 -0.9852805 -0.9981356 -1.014283 -1.029496 -1.043485 -1.056378 -1.068565 -1.079584 -1.089152 -1.099159 -1.109286 -1.117325 -1.122811 -1.122409 -1.128762 -2.074072 -0.9604969 -0.9761150 -0.9914525 -1.005801 -1.019618 -1.032721 -1.048884 -1.063870 -1.077752 -1.090682 -1.102438 -1.112925 -1.122037 -1.131375 -1.140490 -1.147313 -1.151465 -1.148880 -1.155192 -2.074072 -0.9946834 -1.010370 -1.025765 -1.040326 -1.054072 -1.067172 -1.083306 -1.097834 -1.111600 -1.124153 -1.135382 -1.145006 -1.153862 -1.162138 -1.170030 -1.175493 -1.178342 -1.173793 -1.179728 -2.074072 -1.033179 -1.048719 -1.064164 -1.078667 -1.092229 -1.105175 -1.120395 -1.134898 -1.148359 -1.160502 -1.170798 -1.180079 -1.188207 -1.195375 -1.201890 -1.205770 -1.207413 -1.201152 -1.206413 -2.074072 -1.075622 -1.090776 -1.106022 -1.120252 -1.133315 -1.145571 -1.160491 -1.174588 -1.187505 -1.198926 -1.208616 -1.217419 -1.224219 -1.230102 -1.235280 -1.237631 -1.235817 -1.230067 -1.234329 -2.074072 -1.123441 -1.138164 -1.153118 -1.166527 -1.179014 -1.190911 -1.205254 -1.218657 -1.230730 -1.240967 -1.250380 -1.258257 -1.263804 -1.268030 -1.271626 -1.272603 -1.267068 -1.262259 -1.265204 -2.074072 -1.176935 -1.190470 -1.204474 -1.217299 -1.229590 -1.240901 -1.254532 -1.266836 -1.277503 -1.287333 -1.295762 -1.301934 -1.305982 -1.308784 -1.310558 -1.310146 -1.301418 -1.297086 -1.298358 -2.074072 -1.234748 -1.247472 -1.260656 -1.272829 -1.283960 -1.294411 -1.306300 -1.317614 -1.327772 -1.336434 -1.342766 -1.347363 -1.349686 -1.350340 -1.350651 -1.346365 -1.337198 -1.332729 -1.331895 -2.074072 -1.301964 -1.313811 -1.325708 -1.336944 -1.346584 -1.354799 -1.365746 -1.376033 -1.384766 -1.391237 -1.395937 -1.398524 -1.399346 -1.398270 -1.396071 -1.386931 -1.378681 -1.373567 -1.370189 -2.074072 -1.380143 -1.390412 -1.400109 -1.408502 -1.416345 -1.423832 -1.433191 -1.440833 -1.447560 -1.452067 -1.454649 -1.455418 -1.454418 -1.451401 -1.443187 -1.433282 -1.425204 -1.418803 -1.412403 -2.074072 -1.468094 -1.476046 -1.483670 -1.490923 -1.496531 -1.500737 -1.507418 -1.512740 -1.516583 -1.518942 -1.519058 -1.517875 -1.514577 -1.506860 -1.495265 -1.484952 -1.476169 -1.467866 -1.457783 -2.074072 -1.575696 -1.580951 -1.585553 -1.589639 -1.592346 -1.594141 -1.597943 -1.600447 -1.601316 -1.600874 -1.598607 -1.594616 -1.585424 -1.573884 -1.562492 -1.551354 -1.540594 -1.529639 -2.171946 -2.074072 -1.706813 -1.708781 -1.709896 -1.710437 -1.710161 -1.709165 -1.707161 -1.706697 -1.704302 -1.700848 -1.692944 -1.682480 -1.671017 -1.659076 -1.646680 -1.634025 -1.620574 -1.605828 -2.161164 -2.074072 -1.874894 -1.872843 -1.870518 -1.867907 -1.863548 -1.858985 -1.853519 -1.843723 -1.833247 -1.821697 -1.810796 -1.798907 -1.786111 -1.772308 -1.757858 -1.742109 -1.724986 -1.704931 -2.149946 -2.074072 -2.114592 -2.103086 -2.093857 -2.083430 -2.072534 -2.061212 -2.049002 -2.036070 -2.022424 -2.007935 -1.992657 -1.977268 -1.960122 -1.942415 -1.923476 -1.902878 -1.879190 -2.200255 -2.138295 -2.074072 -2.525557 -2.509853 -2.493639 -2.477862 -2.460311 -2.442219 -2.423560 -2.404679 -2.384542 -2.363665 -2.341695 -2.318299 -2.292933 -2.264892 -2.325068 -2.276829 -2.227595 -2.177387 -2.126211 -2.074072 -2.729980 -2.700882 -2.671146 -2.640779 -2.609786 -2.578174 -2.546193 -2.513117 -2.479679 -2.445645 -2.411026 -2.375827 -2.340055 -2.303716 -2.266815 -2.229358 -2.191342 -2.152785 -2.113693 -2.074072 -0.5940138 -0.6212198 -0.6479700 -0.6811662 -0.7123014 -0.7425046 -0.7709134 -0.7982724 -0.8238982 -0.8498780 -0.8754266 -0.8992103 -0.9218464 -0.9427397 -0.9619044 -0.9800219 -0.9970024 -1.011947 -1.021842 -4.355299 -0.6071644 -0.6386659 -0.6713207 -0.7093120 -0.7452365 -0.7790738 -0.8104598 -0.8401279 -0.8676047 -0.8948441 -0.9212255 -0.9453366 -0.9676569 -0.9875253 -1.005250 -1.021365 -1.035964 -1.047444 -1.053614 -4.355299 -0.6303366 -0.6669728 -0.7050335 -0.7458746 -0.7847467 -0.8207200 -0.8548790 -0.8860949 -0.9150499 -0.9432591 -0.9697760 -0.9941068 -1.015717 -1.034406 -1.050649 -1.064833 -1.076914 -1.084739 -1.087110 -4.355299 -0.6684737 -0.7090232 -0.7505313 -0.7941247 -0.8343128 -0.8725917 -0.9080838 -0.9407615 -0.9707317 -0.9994172 -1.026289 -1.050597 -1.071380 -1.089060 -1.103742 -1.116071 -1.125855 -1.129937 -1.128485 -4.355299 -0.7188837 -0.7626367 -0.8066756 -0.8505784 -0.8929334 -0.9322312 -0.9687669 -1.002394 -1.032999 -1.061776 -1.088854 -1.112777 -1.132754 -1.149460 -1.162501 -1.173248 -1.180728 -1.181035 -1.175743 -4.355299 -0.7830703 -0.8284973 -0.8727607 -0.9181855 -0.9606730 -1.001124 -1.038656 -1.072794 -1.103624 -1.132810 -1.159867 -1.182999 -1.202594 -1.218356 -1.230058 -1.239309 -1.244367 -1.241058 -1.231954 -4.355299 -0.8557599 -0.9013976 -0.9461797 -0.9910428 -1.033806 -1.074531 -1.112045 -1.146462 -1.177558 -1.206810 -1.233034 -1.255501 -1.274491 -1.289083 -1.299822 -1.307301 -1.309694 -1.302750 -1.289691 -4.355299 -0.9380460 -0.9829699 -1.027235 -1.071491 -1.113653 -1.153667 -1.190866 -1.225061 -1.256677 -1.285549 -1.310767 -1.332624 -1.350722 -1.364074 -1.373810 -1.379836 -1.378657 -1.368567 -1.351370 -4.355299 -1.028829 -1.072931 -1.116108 -1.158709 -1.199606 -1.238389 -1.275223 -1.309312 -1.340464 -1.368259 -1.392966 -1.413962 -1.430817 -1.443839 -1.452091 -1.456053 -1.451035 -1.437946 -1.416366 -4.355299 -1.128629 -1.170452 -1.211538 -1.252132 -1.290725 -1.328683 -1.365224 -1.398446 -1.427778 -1.454867 -1.479061 -1.498872 -1.514490 -1.526427 -1.533548 -1.534445 -1.525523 -1.509176 -1.483000 -4.355299 -1.237934 -1.277360 -1.315638 -1.354251 -1.391917 -1.428393 -1.462886 -1.494497 -1.522774 -1.549055 -1.572209 -1.590569 -1.605921 -1.616454 -1.621494 -1.618216 -1.605864 -1.585964 -1.555031 -4.355299 -1.356748 -1.393778 -1.431069 -1.468748 -1.504386 -1.537810 -1.569533 -1.600045 -1.627043 -1.651857 -1.673537 -1.692494 -1.706338 -1.715037 -1.716395 -1.708502 -1.693053 -1.669056 -1.633055 -4.355299 -1.491242 -1.525256 -1.559659 -1.594238 -1.627104 -1.658769 -1.688697 -1.716515 -1.741341 -1.764538 -1.786123 -1.803798 -1.816061 -1.821221 -1.816878 -1.805020 -1.786420 -1.757484 -1.715826 -4.355299 -1.646298 -1.674684 -1.702912 -1.734418 -1.765751 -1.795997 -1.823210 -1.847639 -1.871413 -1.892422 -1.911808 -1.926709 -1.935415 -1.934978 -1.925508 -1.909610 -1.886134 -1.851732 -1.803926 -4.355299 -1.827239 -1.851649 -1.878044 -1.904604 -1.929425 -1.957040 -1.984539 -2.007844 -2.028081 -2.044836 -2.059382 -2.068640 -2.070269 -2.064825 -2.051713 -2.031098 -2.001075 -1.960319 -1.905775 -4.355299 -2.053886 -2.073122 -2.095376 -2.118604 -2.141740 -2.164155 -2.184548 -2.202991 -2.218625 -2.229654 -2.235951 -2.237242 -2.232711 -2.222395 -2.204768 -2.176648 -2.139717 -2.090847 -2.029194 -4.355299 -2.362307 -2.374928 -2.387259 -2.402065 -2.418660 -2.433084 -2.446994 -2.456243 -2.461318 -2.464424 -2.464129 -2.459894 -2.449243 -2.430757 -2.403931 -2.367593 -2.320741 -2.262626 -2.193492 -4.355299 -2.802126 -2.804153 -2.806623 -2.812855 -2.818532 -2.821924 -2.823866 -2.824787 -2.821866 -2.815371 -2.803241 -2.787266 -2.764767 -2.734211 -2.694759 -2.645071 -2.585616 -2.517444 -2.440491 -4.355299 -3.590308 -3.580219 -3.569675 -3.557831 -3.544685 -3.528777 -3.510804 -3.490548 -3.465693 -3.435712 -3.400080 -3.358150 -3.309959 -3.255842 -3.196424 -3.130315 -3.057414 -2.978318 -2.892590 -4.355299 -5.857482 -5.798649 -5.737289 -5.673451 -5.607182 -5.538528 -5.467557 -5.394563 -5.318845 -5.241196 -5.161430 -5.079592 -4.995950 -4.909839 -4.822037 -4.732336 -4.640759 -4.547373 -4.452210 -4.355299 -0.2834751 -0.3327462 -0.3804179 -0.4257468 -0.4702952 -0.5163480 -0.5601245 -0.6013024 -0.6396956 -0.6764413 -0.7119263 -0.7460721 -0.7783719 -0.8078390 -0.8338516 -0.8564680 -0.8760204 -0.8919498 -0.9034889 -6.924547 -0.2542022 -0.3146752 -0.3721618 -0.4270576 -0.4819363 -0.5364106 -0.5872473 -0.6345477 -0.6784493 -0.7195834 -0.7579835 -0.7943074 -0.8263254 -0.8540412 -0.8771603 -0.8955401 -0.9099460 -0.9195881 -0.9236849 -6.924547 -0.2561876 -0.3244669 -0.3902436 -0.4539631 -0.5169307 -0.5782789 -0.6347998 -0.6871303 -0.7361327 -0.7808899 -0.8222786 -0.8596199 -0.8914167 -0.9172432 -0.9374602 -0.9517885 -0.9611040 -0.9647527 -0.9613671 -6.924547 -0.2822514 -0.3563356 -0.4295940 -0.5007818 -0.5697635 -0.6358755 -0.6971467 -0.7540774 -0.8069618 -0.8550428 -0.8987861 -0.9363370 -0.9675589 -0.9916707 -1.008910 -1.019394 -1.023680 -1.021499 -1.010602 -6.924547 -0.3287556 -0.4076055 -0.4857590 -0.5613438 -0.6349081 -0.7048286 -0.7702826 -0.8309772 -0.8863998 -0.9368808 -0.9815831 -1.019260 -1.049001 -1.071288 -1.085405 -1.092159 -1.091436 -1.083283 -1.064883 -6.924547 -0.3972572 -0.4794203 -0.5602283 -0.6388857 -0.7150904 -0.7885213 -0.8577566 -0.9215513 -0.9795984 -1.031293 -1.076202 -1.113253 -1.142139 -1.162385 -1.173818 -1.177081 -1.171583 -1.157566 -1.131732 -6.924547 -0.4869936 -0.5704694 -0.6526595 -0.7333013 -0.8122693 -0.8883047 -0.9597139 -1.025902 -1.086312 -1.139032 -1.183857 -1.220581 -1.248347 -1.266906 -1.276173 -1.276303 -1.266493 -1.246925 -1.213759 -6.924547 -0.5939624 -0.6765814 -0.7600222 -0.8424324 -0.9225380 -0.9993501 -1.071439 -1.138719 -1.199803 -1.253430 -1.298135 -1.333840 -1.360370 -1.377130 -1.384462 -1.381499 -1.367672 -1.342396 -1.301896 -6.924547 -0.7186509 -0.8007398 -0.8843836 -0.9671010 -1.046970 -1.123044 -1.194881 -1.261546 -1.322633 -1.376320 -1.421094 -1.456118 -1.480945 -1.496622 -1.502375 -1.496467 -1.479189 -1.447660 -1.399928 -6.924547 -0.8636857 -0.9433439 -1.024047 -1.104686 -1.183718 -1.258331 -1.328241 -1.393280 -1.453296 -1.506724 -1.550690 -1.584623 -1.608455 -1.623073 -1.626904 -1.618211 -1.597626 -1.559699 -1.504676 -6.924547 -1.029419 -1.103579 -1.179484 -1.256625 -1.332843 -1.405420 -1.472397 -1.535437 -1.593561 -1.645173 -1.687559 -1.720315 -1.744262 -1.758028 -1.759525 -1.748319 -1.723657 -1.679216 -1.616978 -6.924547 -1.213578 -1.281936 -1.352333 -1.424238 -1.496124 -1.565175 -1.630326 -1.689425 -1.744577 -1.793424 -1.834193 -1.866815 -1.890716 -1.902616 -1.902344 -1.889628 -1.858966 -1.808107 -1.738312 -6.924547 -1.417686 -1.480055 -1.543142 -1.610582 -1.677894 -1.741720 -1.802441 -1.857552 -1.907996 -1.954763 -1.994871 -2.027101 -2.048961 -2.060353 -2.058447 -2.041946 -2.004578 -1.947649 -1.869641 -6.924547 -1.646546 -1.702467 -1.758761 -1.819418 -1.880206 -1.937217 -1.991789 -2.043051 -2.090796 -2.135341 -2.174479 -2.203822 -2.224291 -2.234354 -2.231086 -2.207083 -2.162508 -2.098975 -2.012367 -6.924547 -1.911901 -1.957816 -2.003465 -2.054826 -2.107294 -2.160276 -2.210453 -2.258434 -2.303908 -2.344761 -2.379885 -2.407015 -2.425738 -2.433933 -2.423039 -2.390455 -2.339285 -2.267165 -2.171185 -6.924547 -2.215612 -2.253406 -2.293012 -2.335104 -2.382662 -2.430927 -2.477520 -2.520214 -2.559553 -2.594681 -2.626369 -2.650868 -2.662875 -2.659817 -2.638705 -2.597901 -2.538044 -2.455667 -2.348549 -6.924547 -2.612032 -2.641697 -2.674673 -2.709887 -2.747687 -2.785764 -2.823257 -2.862780 -2.898800 -2.927152 -2.946829 -2.957201 -2.954490 -2.939845 -2.910798 -2.859936 -2.786861 -2.691459 -2.571904 -6.924547 -3.187632 -3.205491 -3.228564 -3.253936 -3.282167 -3.307921 -3.332633 -3.355825 -3.372624 -3.388438 -3.392865 -3.389235 -3.374073 -3.345178 -3.298945 -3.232546 -3.142001 -3.028582 -2.895798 -6.924547 -4.220209 -4.216935 -4.219285 -4.224311 -4.229186 -4.233208 -4.235223 -4.233908 -4.227869 -4.216229 -4.197978 -4.165687 -4.119914 -4.056859 -3.975042 -3.874594 -3.756029 -3.622173 -3.475671 -6.924547 -9.427989 -9.339032 -9.243958 -9.143654 -9.038064 -8.927367 -8.811703 -8.691274 -8.566213 -8.436684 -8.302842 -8.164797 -8.022717 -7.876703 -7.726888 -7.573389 -7.416293 -7.255732 -7.092026 -6.924547 4.8262395E-02 -2.0599503E-02 -8.9150369E-02 -0.1552736 -0.2183597 -0.2808414 -0.3417284 -0.3975402 -0.4478905 -0.4947654 -0.5377536 -0.5772577 -0.6135554 -0.6464726 -0.6765349 -0.7017269 -0.7219687 -0.7374722 -0.7479515 -9.740750 0.1350613 4.7239311E-02 -3.7180666E-02 -0.1195017 -0.1981195 -0.2738074 -0.3455846 -0.4105309 -0.4690025 -0.5213051 -0.5669944 -0.6076644 -0.6433499 -0.6736015 -0.6982817 -0.7158611 -0.7269673 -0.7319051 -0.7305652 -9.740750 0.1634748 6.2442802E-02 -3.6697511E-02 -0.1320704 -0.2231609 -0.3110727 -0.3911970 -0.4632647 -0.5284232 -0.5854237 -0.6344768 -0.6766560 -0.7113268 -0.7391477 -0.7585369 -0.7689392 -0.7712007 -0.7659033 -0.7529737 -9.740750 0.1493785 3.7855141E-02 -7.1649291E-02 -0.1782773 -0.2805600 -0.3759987 -0.4633219 -0.5426285 -0.6126737 -0.6731547 -0.7253217 -0.7691655 -0.8035858 -0.8288432 -0.8431960 -0.8467526 -0.8404222 -0.8250874 -0.8006656 -9.740750 0.1000632 -1.8702932E-02 -0.1358461 -0.2512463 -0.3599376 -0.4611804 -0.5559640 -0.6402286 -0.7142491 -0.7782722 -0.8336533 -0.8783166 -0.9128201 -0.9355782 -0.9450291 -0.9419756 -0.9274088 -0.9021786 -0.8663490 -9.740750 2.1028778E-02 -0.1034998 -0.2268366 -0.3460137 -0.4587850 -0.5658799 -0.6642663 -0.7535376 -0.8314795 -0.8994791 -0.9568652 -1.003175 -1.037596 -1.057527 -1.062559 -1.053435 -1.031110 -0.9961669 -0.9490200 -9.740750 -8.7688148E-02 -0.2145901 -0.3407504 -0.4626284 -0.5786657 -0.6878669 -0.7902021 -0.8827949 -0.9655001 -1.037898 -1.097656 -1.145934 -1.180145 -1.197762 -1.199447 -1.184898 -1.155412 -1.111335 -1.052920 -9.740750 -0.2234607 -0.3483971 -0.4745634 -0.5992457 -0.7161610 -0.8262061 -0.9298152 -1.026430 -1.113806 -1.189209 -1.253346 -1.303245 -1.336576 -1.352907 -1.351794 -1.332943 -1.296880 -1.244361 -1.174662 -9.740750 -0.3825614 -0.5041336 -0.6274296 -0.7507541 -0.8680881 -0.9782029 -1.082162 -1.180920 -1.270471 -1.349983 -1.416918 -1.467892 -1.500283 -1.515233 -1.511515 -1.488840 -1.446585 -1.385792 -1.304928 -9.740750 -0.5667739 -0.6818753 -0.8001422 -0.9196365 -1.035979 -1.147129 -1.250578 -1.348074 -1.440022 -1.522518 -1.590874 -1.642311 -1.674934 -1.688635 -1.683269 -1.657493 -1.609555 -1.540610 -1.448740 -9.740750 -0.7740756 -0.8828751 -0.9935363 -1.108568 -1.222132 -1.331446 -1.434745 -1.530505 -1.622371 -1.705273 -1.773790 -1.826063 -1.859727 -1.872191 -1.865750 -1.837057 -1.784104 -1.707113 -1.604279 -9.740750 -1.006708 -1.108136 -1.211033 -1.319039 -1.426873 -1.532601 -1.635338 -1.729834 -1.817311 -1.897623 -1.966235 -2.019047 -2.053055 -2.066272 -2.058287 -2.026616 -1.969571 -1.883275 -1.769473 -9.740750 -1.267321 -1.359754 -1.454926 -1.553868 -1.655970 -1.756866 -1.855862 -1.946064 -2.028105 -2.104947 -2.172799 -2.225550 -2.261622 -2.275814 -2.265862 -2.231426 -2.169903 -2.074046 -1.949357 -9.740750 -1.559739 -1.642722 -1.731117 -1.821605 -1.914606 -2.006233 -2.097623 -2.182715 -2.259254 -2.331255 -2.397576 -2.451662 -2.487954 -2.502342 -2.490952 -2.454339 -2.384614 -2.278844 -2.142977 -9.740750 -1.900421 -1.970482 -2.047150 -2.125401 -2.206701 -2.288266 -2.370128 -2.448394 -2.520951 -2.589682 -2.653331 -2.705867 -2.740359 -2.754267 -2.742385 -2.698427 -2.618238 -2.503139 -2.354570 -9.740750 -2.297405 -2.351765 -2.413818 -2.480203 -2.546964 -2.620573 -2.695593 -2.769305 -2.836270 -2.898734 -2.957129 -3.005489 -3.036942 -3.050278 -3.031080 -2.974432 -2.881943 -2.755807 -2.593847 -9.740750 -2.777115 -2.821587 -2.876762 -2.933393 -2.989371 -3.051716 -3.115505 -3.180853 -3.239233 -3.295076 -3.344892 -3.388688 -3.412369 -3.408879 -3.373231 -3.302568 -3.197766 -3.055750 -2.877477 -9.740750 -3.477442 -3.502937 -3.538424 -3.583446 -3.628499 -3.674402 -3.727324 -3.780415 -3.829208 -3.868287 -3.901077 -3.918393 -3.918027 -3.895324 -3.845064 -3.756077 -3.630169 -3.466814 -3.269336 -9.740750 -4.719965 -4.720048 -4.727958 -4.742719 -4.761022 -4.783748 -4.805566 -4.829367 -4.850257 -4.862752 -4.867826 -4.856447 -4.825844 -4.768267 -4.679450 -4.552094 -4.386698 -4.190800 -3.973032 -9.740750 -13.37432 -13.25413 -13.12402 -12.98440 -12.83568 -12.67827 -12.51254 -12.33887 -12.15760 -11.96905 -11.77351 -11.57129 -11.36263 -11.14779 -10.92698 -10.70045 -10.46837 -10.23095 -9.988350 -9.740750 0.3514790 0.2739044 0.1896172 0.1064140 2.3489073E-02 -5.7930332E-02 -0.1366106 -0.2104052 -0.2786138 -0.3406169 -0.3950104 -0.4431511 -0.4848606 -0.5208673 -0.5520634 -0.5787860 -0.5997520 -0.6149381 -0.6244277 -12.77138 0.5110671 0.4058096 0.2981738 0.1921580 8.8141218E-02 -1.1523947E-02 -0.1057953 -0.1930741 -0.2713446 -0.3390341 -0.3963732 -0.4445958 -0.4831898 -0.5133369 -0.5354982 -0.5508537 -0.5579779 -0.5576393 -0.5503677 -12.77138 0.5844267 0.4561130 0.3266376 0.2000648 7.8158751E-02 -3.7153691E-02 -0.1454011 -0.2435060 -0.3296245 -0.4027726 -0.4638454 -0.5119705 -0.5480604 -0.5729038 -0.5868780 -0.5911825 -0.5851400 -0.5698556 -0.5462246 -12.77138 0.5944533 0.4476863 0.3009864 0.1584604 2.2084147E-02 -0.1081276 -0.2280167 -0.3341177 -0.4260017 -0.5042698 -0.5683930 -0.6173084 -0.6514925 -0.6714198 -0.6783576 -0.6719658 -0.6531495 -0.6232746 -0.5834501 -12.77138 0.5521598 0.3917681 0.2318602 7.7972196E-02 -6.9707550E-02 -0.2108383 -0.3398918 -0.4527547 -0.5504097 -0.6337368 -0.7006954 -0.7505866 -0.7838802 -0.7996618 -0.8000949 -0.7838385 -0.7526795 -0.7084916 -0.6526645 -12.77138 0.4643650 0.2966380 0.1283483 -3.5332929E-02 -0.1909139 -0.3378834 -0.4715603 -0.5908193 -0.6957393 -0.7835551 -0.8527396 -0.9046474 -0.9372614 -0.9504600 -0.9445826 -0.9191237 -0.8762293 -0.8180684 -0.7463605 -12.77138 0.3365604 0.1657241 -7.3612002E-03 -0.1764408 -0.3363674 -0.4846760 -0.6224750 -0.7477372 -0.8581886 -0.9515316 -1.025525 -1.079482 -1.112014 -1.123838 -1.112619 -1.079341 -1.025514 -0.9538829 -0.8664842 -12.77138 0.1733027 2.6494898E-03 -0.1704207 -0.3393683 -0.4990182 -0.6490375 -0.7894030 -0.9185222 -1.034055 -1.133061 -1.212835 -1.269673 -1.303827 -1.314603 -1.299242 -1.259068 -1.195294 -1.110729 -1.007775 -12.77138 -2.2991631E-02 -0.1888302 -0.3556304 -0.5205902 -0.6796494 -0.8320733 -0.9716163 -1.102817 -1.223451 -1.328284 -1.413782 -1.475937 -1.513029 -1.522786 -1.505126 -1.459554 -1.387179 -1.290354 -1.172130 -12.77138 -0.2458466 -0.4028156 -0.5615199 -0.7226136 -0.8791565 -1.029893 -1.169776 -1.300819 -1.424929 -1.535495 -1.625937 -1.695143 -1.735988 -1.745654 -1.727068 -1.677470 -1.597801 -1.489633 -1.356153 -12.77138 -0.4932889 -0.6422084 -0.7934625 -0.9450460 -1.096316 -1.243972 -1.384031 -1.513745 -1.638183 -1.751708 -1.848586 -1.922469 -1.966730 -1.978379 -1.958883 -1.907024 -1.820777 -1.701886 -1.553207 -12.77138 -0.7723989 -0.9085912 -1.050957 -1.191766 -1.336151 -1.478545 -1.616361 -1.744810 -1.866592 -1.982150 -2.082261 -2.158900 -2.207806 -2.223090 -2.202771 -2.149685 -2.057714 -1.928326 -1.764645 -12.77138 -1.083568 -1.206692 -1.339149 -1.469460 -1.602715 -1.737754 -1.871026 -1.997275 -2.116598 -2.228877 -2.328774 -2.409073 -2.462660 -2.481287 -2.462890 -2.408062 -2.311093 -2.171226 -1.992523 -12.77138 -1.434892 -1.542399 -1.662665 -1.783582 -1.903838 -2.028741 -2.154490 -2.275381 -2.389476 -2.496423 -2.594795 -2.677116 -2.733436 -2.757291 -2.740465 -2.682777 -2.581428 -2.428800 -2.235025 -12.77138 -1.837044 -1.928643 -2.034996 -2.143523 -2.249917 -2.361089 -2.473786 -2.586674 -2.696465 -2.799034 -2.893554 -2.975059 -3.035821 -3.063203 -3.047314 -2.986767 -2.877242 -2.711323 -2.502577 -12.77138 -2.309744 -2.382470 -2.470554 -2.563247 -2.654728 -2.751913 -2.852265 -2.954691 -3.057551 -3.155128 -3.245080 -3.324837 -3.384244 -3.411384 -3.395906 -3.327089 -3.202708 -3.023674 -2.797580 -12.77138 -2.883482 -2.938739 -3.011573 -3.088331 -3.166948 -3.248078 -3.335353 -3.425921 -3.519880 -3.611661 -3.693049 -3.763899 -3.818871 -3.844050 -3.816373 -3.729240 -3.587152 -3.391814 -3.146902 -12.77138 -3.689949 -3.722641 -3.774409 -3.835933 -3.898546 -3.964030 -4.031475 -4.104649 -4.182999 -4.264268 -4.335724 -4.388049 -4.421886 -4.418508 -4.365610 -4.262698 -4.096694 -3.878555 -3.609374 -12.77138 -5.117570 -5.117121 -5.130267 -5.152619 -5.187812 -5.230449 -5.270264 -5.306641 -5.349444 -5.394656 -5.439494 -5.465093 -5.460457 -5.424451 -5.344024 -5.199326 -4.991361 -4.730067 -4.433141 -12.77138 -17.64487 -17.49306 -17.32591 -17.14425 -16.94881 -16.74040 -16.51972 -16.28740 -16.04406 -15.79027 -15.52651 -15.25327 -14.97099 -14.68005 -14.38083 -14.07366 -13.75885 -13.43669 -13.10745 -12.77138 0.6456679 0.5601976 0.4628577 0.3662017 0.2663874 0.1663297 6.9435343E-02 -2.3355080E-02 -0.1097980 -0.1878811 -0.2572893 -0.3162898 -0.3651319 -0.4058928 -0.4393479 -0.4663634 -0.4877110 -0.5025943 -0.5112330 -15.99132 0.8747721 0.7541780 0.6283982 0.5020205 0.3749953 0.2516529 0.1338621 2.3032168E-02 -7.6249599E-02 -0.1630163 -0.2355366 -0.2925701 -0.3360669 -0.3671930 -0.3877909 -0.3988155 -0.4014556 -0.3956603 -0.3823639 -15.99132 0.9966171 0.8447122 0.6891096 0.5354681 0.3845308 0.2399955 0.1044167 -1.9683108E-02 -0.1301563 -0.2246930 -0.2997890 -0.3550196 -0.3936102 -0.4156833 -0.4239763 -0.4197035 -0.4042718 -0.3784629 -0.3436959 -15.99132 1.036134 0.8572778 0.6776326 0.5022899 0.3309634 0.1674368 1.6986594E-02 -0.1189378 -0.2388774 -0.3391145 -0.4162178 -0.4714964 -0.5055566 -0.5200108 -0.5168546 -0.4981417 -0.4651392 -0.4197195 -0.3637116 -15.99132 1.006598 0.8082241 0.6087419 0.4172002 0.2318017 5.4439072E-02 -0.1093491 -0.2578334 -0.3862821 -0.4900436 -0.5700271 -0.6260059 -0.6569950 -0.6654468 -0.6520649 -0.6199220 -0.5700051 -0.5052950 -0.4282330 -15.99132 0.9155917 0.7065580 0.4951191 0.2906589 9.5767103E-02 -9.0482980E-02 -0.2649755 -0.4234443 -0.5593541 -0.6692438 -0.7530009 -0.8100646 -0.8398858 -0.8436449 -0.8218232 -0.7770548 -0.7111738 -0.6275640 -0.5296164 -15.99132 0.7736567 0.5595391 0.3428308 0.1326919 -7.0853688E-02 -0.2628490 -0.4435695 -0.6083165 -0.7506971 -0.8690273 -0.9592471 -1.018215 -1.048942 -1.049511 -1.021773 -0.9658132 -0.8848652 -0.7830748 -0.6644292 -15.99132 0.5881338 0.3736222 0.1582321 -5.4567695E-02 -0.2622059 -0.4581205 -0.6390639 -0.8071116 -0.9571145 -1.083727 -1.181497 -1.247368 -1.279573 -1.279339 -1.247318 -1.181990 -1.087189 -0.9680014 -0.8289090 -15.99132 0.3650523 0.1543541 -5.7920605E-02 -0.2683285 -0.4740380 -0.6689453 -0.8489383 -1.019548 -1.175442 -1.309050 -1.416046 -1.490706 -1.527047 -1.528633 -1.493672 -1.421306 -1.314140 -1.178327 -1.019043 -15.99132 0.1048078 -9.6996464E-02 -0.3025633 -0.5043985 -0.7021089 -0.8939641 -1.074774 -1.245310 -1.403832 -1.543733 -1.659704 -1.742858 -1.787897 -1.791959 -1.755883 -1.678442 -1.560671 -1.408930 -1.229691 -15.99132 -0.1889697 -0.3776281 -0.5716594 -0.7613308 -0.9517599 -1.137720 -1.316048 -1.486389 -1.646122 -1.790920 -1.913453 -2.006488 -2.062134 -2.071310 -2.036443 -1.955954 -1.830076 -1.663449 -1.464586 -15.99132 -0.5138733 -0.6859263 -0.8681644 -1.046528 -1.225305 -1.402140 -1.575296 -1.746137 -1.905758 -2.051372 -2.179582 -2.283141 -2.347914 -2.366494 -2.334818 -2.253987 -2.121795 -1.941824 -1.723322 -15.99132 -0.8760219 -1.029778 -1.197174 -1.362759 -1.527178 -1.694476 -1.861148 -2.026269 -2.184098 -2.328822 -2.460385 -2.568784 -2.642260 -2.670781 -2.642655 -2.563189 -2.425325 -2.232286 -1.994182 -15.99132 -1.281705 -1.415312 -1.566672 -1.720038 -1.870570 -2.024362 -2.178926 -2.335320 -2.490639 -2.633585 -2.763095 -2.875642 -2.957471 -2.993559 -2.975330 -2.896325 -2.753710 -2.547920 -2.290278 -15.99132 -1.748113 -1.860521 -1.993032 -2.128886 -2.263390 -2.400337 -2.541742 -2.687551 -2.834144 -2.973244 -3.100058 -3.213258 -3.298114 -3.344881 -3.334160 -3.254259 -3.106939 -2.885328 -2.607841 -15.99132 -2.297456 -2.382809 -2.492169 -2.608476 -2.726035 -2.844077 -2.969248 -3.101842 -3.238234 -3.371953 -3.492587 -3.604074 -3.693948 -3.745078 -3.738371 -3.657334 -3.498145 -3.258552 -2.961146 -15.99132 -2.964288 -3.023826 -3.108192 -3.202899 -3.301395 -3.401867 -3.510180 -3.625051 -3.748585 -3.875067 -3.991136 -4.096547 -4.181903 -4.231756 -4.225300 -4.130519 -3.948030 -3.690348 -3.369537 -15.99132 -3.874604 -3.904851 -3.962207 -4.032958 -4.112382 -4.192395 -4.280006 -4.377172 -4.481514 -4.590874 -4.698994 -4.795483 -4.868820 -4.901831 -4.867323 -4.743635 -4.538437 -4.254656 -3.906472 -15.99132 -5.449461 -5.452066 -5.467116 -5.500093 -5.545285 -5.596250 -5.650408 -5.717433 -5.790050 -5.863634 -5.934677 -5.996012 -6.038073 -6.033659 -5.966119 -5.813523 -5.562512 -5.232507 -4.850025 -15.99132 -22.20026 -22.01623 -21.81033 -21.58397 -21.33848 -21.07511 -20.79498 -20.49916 -20.18856 -19.86405 -19.52639 -19.17625 -18.81429 -18.44106 -18.05709 -17.66285 -17.25876 -16.84524 -16.42265 -15.99132 0.9508473 0.8568143 0.7489057 0.6359010 0.5197341 0.4055234 0.2922420 0.1816961 7.8073524E-02 -1.6370831E-02 -9.8271914E-02 -0.1681023 -0.2257516 -0.2710755 -0.3069634 -0.3343633 -0.3547171 -0.3689263 -0.3766767 -19.38085 1.247656 1.111529 0.9653140 0.8181034 0.6719923 0.5285585 0.3888878 0.2561325 0.1366580 3.3247683E-02 -5.1477596E-02 -0.1185784 -0.1671283 -0.1993528 -0.2173017 -0.2236822 -0.2201311 -0.2082308 -0.1886100 -19.38085 1.416011 1.236445 1.054275 0.8760769 0.6997666 0.5306231 0.3692276 0.2200207 8.7510012E-02 -2.2996206E-02 -0.1105455 -0.1738897 -0.2133880 -0.2323716 -0.2329223 -0.2185303 -0.1918329 -0.1545002 -0.1080181 -19.38085 1.478170 1.264439 1.053763 0.8491421 0.6463806 0.4522890 0.2705279 0.1053418 -3.7809324E-02 -0.1563817 -0.2479524 -0.3095653 -0.3430305 -0.3511928 -0.3363470 -0.3024892 -0.2535284 -0.1914291 -0.1184474 -19.38085 1.456233 1.221139 0.9863243 0.7598301 0.5387915 0.3257406 0.1252942 -5.5856179E-02 -0.2108294 -0.3374795 -0.4328795 -0.4943215 -0.5244724 -0.5235467 -0.4954027 -0.4435478 -0.3730306 -0.2865413 -0.1872785 -19.38085 1.364826 1.116024 0.8663017 0.6235235 0.3886460 0.1632909 -5.1209677E-02 -0.2447066 -0.4133730 -0.5504020 -0.6492265 -0.7127243 -0.7413743 -0.7339467 -0.6940602 -0.6258540 -0.5346501 -0.4242008 -0.2987970 -19.38085 1.213083 0.9581731 0.7014667 0.4497182 0.2034546 -2.9016742E-02 -0.2501272 -0.4552076 -0.6349245 -0.7813397 -0.8890581 -0.9564750 -0.9844012 -0.9738587 -0.9241782 -0.8416252 -0.7307379 -0.5968956 -0.4454809 -19.38085 1.011016 0.7534814 0.4960457 0.2412192 -8.2707554E-03 -0.2458683 -0.4718835 -0.6835449 -0.8706646 -1.026617 -1.146418 -1.222122 -1.252798 -1.241438 -1.185496 -1.090735 -0.9617325 -0.8052579 -0.6280558 -19.38085 0.7616227 0.5084298 0.2530417 3.5874790E-03 -0.2441135 -0.4837022 -0.7126327 -0.9251922 -1.116727 -1.283508 -1.414531 -1.501028 -1.541188 -1.530949 -1.473717 -1.369368 -1.223971 -1.045992 -0.8433141 -19.38085 0.4682739 0.2267049 -2.1564303E-02 -0.2638002 -0.5043449 -0.7394601 -0.9655889 -1.178912 -1.374555 -1.547746 -1.688513 -1.789078 -1.840338 -1.836760 -1.781173 -1.670276 -1.510536 -1.312176 -1.084354 -19.38085 0.1360519 -9.0911180E-02 -0.3282579 -0.5594366 -0.7883697 -1.012783 -1.234177 -1.448278 -1.643917 -1.820336 -1.972097 -2.084505 -2.148314 -2.158648 -2.107154 -1.993871 -1.822360 -1.604801 -1.352177 -19.38085 -0.2368603 -0.4450365 -0.6656511 -0.8829756 -1.097597 -1.310884 -1.523385 -1.732348 -1.927017 -2.106741 -2.264087 -2.385885 -2.466679 -2.492136 -2.448523 -2.335578 -2.155913 -1.920285 -1.643191 -19.38085 -0.6519704 -0.8375844 -1.039224 -1.240701 -1.438951 -1.637785 -1.837393 -2.039166 -2.232888 -2.408980 -2.569351 -2.704676 -2.799704 -2.841665 -2.811211 -2.702475 -2.517874 -2.266115 -1.964729 -19.38085 -1.120536 -1.278052 -1.456543 -1.638038 -1.818376 -2.001066 -2.188735 -2.377030 -2.561928 -2.735990 -2.899805 -3.042029 -3.148057 -3.205522 -3.187819 -3.087315 -2.898380 -2.630974 -2.305155 -19.38085 -1.649248 -1.777179 -1.930409 -2.091309 -2.253531 -2.415323 -2.583946 -2.758856 -2.936278 -3.107701 -3.267811 -3.413972 -3.529363 -3.596796 -3.598978 -3.504776 -3.312725 -3.029731 -2.679421 -19.38085 -2.265005 -2.361959 -2.485646 -2.619841 -2.760687 -2.902848 -3.053812 -3.213277 -3.378108 -3.541368 -3.697088 -3.840599 -3.960929 -4.042425 -4.054356 -3.964670 -3.767686 -3.464078 -3.088847 -19.38085 -3.010201 -3.076793 -3.170099 -3.276433 -3.393730 -3.514112 -3.643428 -3.784973 -3.933654 -4.084121 -4.233811 -4.375831 -4.498374 -4.581156 -4.594478 -4.503895 -4.286260 -3.958829 -3.556651 -19.38085 -4.010395 -4.044799 -4.107651 -4.184544 -4.273296 -4.370054 -4.476237 -4.595169 -4.724436 -4.861800 -4.999403 -5.130210 -5.248992 -5.324520 -5.319627 -5.197596 -4.949697 -4.594124 -4.160947 -19.38085 -5.719757 -5.717768 -5.734968 -5.773680 -5.825152 -5.887376 -5.959550 -6.042026 -6.136120 -6.244046 -6.351778 -6.445896 -6.521120 -6.568833 -6.523693 -6.363833 -6.071924 -5.668524 -5.194344 -19.38085 -27.00986 -26.79300 -26.54670 -26.27315 -25.97442 -25.65239 -25.30876 -24.94503 -24.56252 -24.16244 -23.74582 -23.31363 -22.86669 -22.40577 -21.93156 -21.44466 -20.94565 -20.43504 -19.91329 -19.38085 1.257548 1.155363 1.040249 0.9135514 0.7817037 0.6495017 0.5185555 0.3918977 0.2716297 0.1616897 6.6019066E-02 -1.4735674E-02 -8.0495454E-02 -0.1317617 -0.1700350 -0.1980557 -0.2178750 -0.2311396 -0.2380933 -22.92415 1.623945 1.471318 1.308612 1.141537 0.9736298 0.8087544 0.6488068 0.4970438 0.3590313 0.2403887 0.1421737 6.7251071E-02 1.3548093E-02 -1.8943997E-02 -3.4208942E-02 -3.5425309E-02 -2.5525413E-02 -7.0460131E-03 1.9000078E-02 -22.92415 1.835939 1.629481 1.421884 1.215144 1.012635 0.8195484 0.6347331 0.4627287 0.3108314 0.1836574 8.5174225E-02 1.5585055E-02 -2.5887216E-02 -3.9838154E-02 -3.2501400E-02 -7.6306583E-03 3.1095739E-02 8.0482036E-02 0.1389546 -22.92415 1.920453 1.673076 1.427507 1.190580 0.9586398 0.7356013 0.5244583 0.3329600 0.1675577 3.0674322E-02 -7.1762376E-02 -0.1404038 -0.1728256 -0.1724620 -0.1450056 -9.5945939E-02 -2.9539231E-02 4.9991027E-02 0.1404875 -22.92415 1.906180 1.631400 1.359734 1.098755 0.8449906 0.5970489 0.3628484 0.1515854 -3.1113937E-02 -0.1761955 -0.2848884 -0.3547834 -0.3812278 -0.3694355 -0.3241149 -0.2521551 -0.1591078 -4.9769469E-02 7.2551228E-02 -22.92415 1.811215 1.521307 1.234999 0.9550083 0.6822472 0.4188575 0.1673411 -6.2286828E-02 -0.2608500 -0.4212718 -0.5383668 -0.6099438 -0.6354387 -0.6153867 -0.5550771 -0.4618128 -0.3432912 -0.2046183 -5.0630722E-02 -22.92415 1.650696 1.353691 1.058836 0.7681215 0.4821297 0.2078591 -5.5206060E-02 -0.2969336 -0.5102466 -0.6867025 -0.8165823 -0.8936924 -0.9216350 -0.8970024 -0.8253944 -0.7131548 -0.5702745 -0.4028616 -0.2173631 -22.92415 1.432650 1.133317 0.8366280 0.5426445 0.2521857 -3.0064084E-02 -0.2989052 -0.5482909 -0.7738288 -0.9636883 -1.104975 -1.196103 -1.229936 -1.205621 -1.125403 -0.9975183 -0.8317445 -0.6363458 -0.4194849 -22.92415 1.160106 0.8671981 0.5710229 0.2814048 -6.8429657E-03 -0.2880960 -0.5616872 -0.8161758 -1.048113 -1.246131 -1.401926 -1.508302 -1.554214 -1.535664 -1.451361 -1.311632 -1.124962 -0.9024742 -0.6544721 -22.92415 0.8378249 0.5563771 0.2678017 -1.3936323E-02 -0.2933354 -0.5700368 -0.8418944 -1.097796 -1.329321 -1.536493 -1.706298 -1.827507 -1.892695 -1.883763 -1.803166 -1.655759 -1.451003 -1.202815 -0.9240294 -22.92415 0.4676077 0.2036112 -7.1143307E-02 -0.3421434 -0.6100268 -0.8760218 -1.138357 -1.389140 -1.621688 -1.834768 -2.014776 -2.152947 -2.237424 -2.245368 -2.174603 -2.024787 -1.804976 -1.532805 -1.223719 -22.92415 4.9273763E-02 -0.1922478 -0.4484957 -0.7037903 -0.9548208 -1.204289 -1.453978 -1.698617 -1.929428 -2.142329 -2.332096 -2.484460 -2.585091 -2.619383 -2.562911 -2.416672 -2.185780 -1.891268 -1.552244 -22.92415 -0.4188094 -0.6327083 -0.8640835 -1.098358 -1.330435 -1.562632 -1.797971 -2.031443 -2.256153 -2.469683 -2.661893 -2.821418 -2.944213 -3.003844 -2.967260 -2.828314 -2.591872 -2.276382 -1.907810 -22.92415 -0.9391543 -1.121906 -1.325880 -1.536697 -1.748637 -1.960397 -2.177325 -2.397988 -2.615589 -2.821799 -3.012545 -3.183981 -3.323946 -3.408369 -3.397573 -3.271388 -3.033778 -2.700128 -2.302167 -22.92415 -1.526797 -1.674912 -1.848591 -2.031730 -2.221481 -2.412208 -2.609782 -2.810927 -3.013705 -3.216285 -3.408172 -3.582315 -3.733017 -3.837025 -3.849357 -3.741029 -3.501986 -3.149930 -2.722209 -22.92415 -2.204173 -2.316961 -2.458287 -2.611374 -2.774170 -2.939637 -3.114523 -3.298922 -3.489866 -3.682876 -3.870460 -4.044814 -4.197730 -4.316402 -4.355611 -4.257570 -4.017039 -3.644124 -3.185991 -22.92415 -3.022856 -3.098201 -3.202244 -3.323680 -3.459206 -3.600922 -3.752279 -3.915225 -4.088804 -4.268258 -4.446473 -4.617852 -4.776880 -4.901602 -4.950502 -4.859454 -4.605321 -4.203819 -3.714710 -22.92415 -4.113148 -4.152402 -4.217616 -4.302734 -4.405625 -4.520671 -4.643442 -4.782070 -4.935957 -5.097316 -5.265900 -5.432169 -5.580735 -5.703990 -5.745023 -5.632523 -5.337510 -4.905119 -4.380191 -22.92415 -5.957595 -5.951573 -5.966650 -6.006122 -6.062301 -6.138342 -6.229236 -6.332298 -6.448169 -6.576559 -6.717536 -6.862903 -6.979993 -7.052408 -7.054884 -6.893669 -6.556091 -6.073252 -5.502515 -22.92415 -32.04919 -31.79889 -31.51079 -31.18741 -30.83246 -30.44838 -30.03749 -29.60185 -29.14323 -28.66321 -28.16316 -27.64430 -27.10769 -26.55429 -25.98497 -25.40049 -24.80156 -24.18881 -23.56283 -22.92415 1.557132 1.451337 1.330483 1.194143 1.048355 0.8990684 0.7499751 0.6048267 0.4682390 0.3435242 0.2328706 0.1407486 6.7164473E-02 1.0201456E-02 -3.1153968E-02 -6.0134627E-02 -7.9538263E-02 -9.1792740E-02 -9.8008707E-02 -26.60814 1.995494 1.827755 1.651165 1.465364 1.277200 1.090165 0.9077875 0.7363598 0.5821207 0.4467240 0.3356071 0.2516736 0.1949718 0.1613860 0.1492290 0.1530179 0.1691905 0.1944560 0.2269994 -26.60814 2.253144 2.019278 1.786574 1.551986 1.323033 1.101891 0.8924564 0.7001448 0.5291376 0.3847112 0.2739962 0.1984904 0.1573352 0.1468486 0.1626886 0.1982359 0.2488045 0.3105355 0.3811812 -26.60814 2.361386 2.077826 1.799087 1.529530 1.265038 1.010353 0.7726889 0.5564525 0.3690524 0.2151224 9.8572403E-02 2.6330637E-02 -4.3343524E-03 4.3860902E-03 4.4860423E-02 0.1101983 0.1940699 0.2915632 0.3999451 -26.60814 2.354031 2.038813 1.731075 1.431378 1.142534 0.8616423 0.5961370 0.3544906 0.1466928 -1.9376472E-02 -0.1421365 -0.2175905 -0.2418919 -0.2177296 -0.1552204 -6.1875850E-02 5.4293543E-02 0.1871973 0.3331541 -26.60814 2.256425 1.924193 1.598011 1.278906 0.9702607 0.6692128 0.3824378 0.1193621 -0.1086758 -0.2936038 -0.4280612 -0.5105779 -0.5330800 -0.4992298 -0.4175496 -0.2984992 -0.1512945 1.6523775E-02 0.1999357 -26.60814 2.085820 1.744480 1.410382 1.082631 0.7581789 0.4416109 0.1412160 -0.1359170 -0.3824976 -0.5841031 -0.7383716 -0.8323311 -0.8578073 -0.8196473 -0.7230461 -0.5803446 -0.4036281 -0.2013989 1.9330686E-02 -26.60814 1.850057 1.509721 1.173716 0.8412690 0.5118423 0.1869105 -0.1220219 -0.4090311 -0.6674924 -0.8881062 -1.060973 -1.171046 -1.208339 -1.171359 -1.065374 -0.9024742 -0.6980170 -0.4621995 -0.2043288 -26.60814 1.556051 1.223427 0.8884439 0.5591124 0.2320326 -9.1236375E-02 -0.4045411 -0.6947667 -0.9642089 -1.199778 -1.386948 -1.518309 -1.575143 -1.545793 -1.436960 -1.259076 -1.029137 -0.7607456 -0.4659740 -26.60814 1.205234 0.8863198 0.5597600 0.2390319 -7.8966551E-02 -0.3945663 -0.7035584 -0.9973011 -1.270669 -1.512658 -1.714250 -1.867450 -1.947134 -1.934701 -1.828879 -1.642411 -1.390055 -1.090367 -0.7589467 -26.60814 0.7988026 0.5006154 0.1913184 -0.1169063 -0.4203900 -0.7249188 -1.025897 -1.315791 -1.585451 -1.831777 -2.046521 -2.217452 -2.324614 -2.336439 -2.244244 -2.055601 -1.785253 -1.456150 -1.088511 -26.60814 0.3415272 6.8742581E-02 -0.2182889 -0.5093048 -0.7971100 -1.085232 -1.371140 -1.648368 -1.915806 -2.164133 -2.383854 -2.570046 -2.702931 -2.744853 -2.676251 -2.493140 -2.209531 -1.853471 -1.450182 -26.60814 -0.1695526 -0.4131675 -0.6746668 -0.9424803 -1.208838 -1.474954 -1.742998 -2.008459 -2.268466 -2.512626 -2.735718 -2.930826 -3.083255 -3.163236 -3.124182 -2.955192 -2.663996 -2.283322 -1.844801 -26.60814 -0.7406479 -0.9501153 -1.179815 -1.419697 -1.662677 -1.906994 -2.155164 -2.402699 -2.650422 -2.891523 -3.110143 -3.308731 -3.483611 -3.595411 -3.592108 -3.441657 -3.151199 -2.747793 -2.274477 -26.60814 -1.382933 -1.553986 -1.749722 -1.958121 -2.174577 -2.393818 -2.619729 -2.849063 -3.079420 -3.308593 -3.527338 -3.732020 -3.916920 -4.056943 -4.088531 -3.965767 -3.678836 -3.255522 -2.747167 -26.60814 -2.122471 -2.252099 -2.408810 -2.582771 -2.769078 -2.962739 -3.163030 -3.368634 -3.584247 -3.805643 -4.018075 -4.221484 -4.412477 -4.568164 -4.634768 -4.538127 -4.255213 -3.810230 -3.266249 -26.60814 -3.010471 -3.099468 -3.212765 -3.347601 -3.500420 -3.667796 -3.844678 -4.026063 -4.221071 -4.428339 -4.634026 -4.829824 -5.019978 -5.192875 -5.278636 -5.199021 -4.910207 -4.434031 -3.853174 -26.60814 -4.188887 -4.232990 -4.301139 -4.393899 -4.510197 -4.643547 -4.790128 -4.944506 -5.113937 -5.303949 -5.500565 -5.690588 -5.879382 -6.044767 -6.139262 -6.046186 -5.715514 -5.199771 -4.578173 -26.60814 -6.158002 -6.150553 -6.164901 -6.201985 -6.266242 -6.356066 -6.462605 -6.582436 -6.716727 -6.871133 -7.045477 -7.223204 -7.389112 -7.509557 -7.549777 -7.406800 -7.021406 -6.452063 -5.779770 -26.60814 -37.29813 -37.01380 -36.68185 -36.30683 -35.89286 -35.44353 -34.96193 -34.45071 -33.91216 -33.34826 -32.76072 -32.15103 -31.52052 -30.87035 -30.20156 -29.51509 -28.81177 -28.09239 -27.35763 -26.60814 1.851480 1.742907 1.617253 1.472542 1.316439 1.152474 0.9845799 0.8225574 0.6685580 0.5275265 0.4035268 0.2991461 0.2169255 0.1551371 0.1103738 8.0722883E-02 6.1600707E-02 5.0180268E-02 4.4634830E-02 -30.42189 2.360520 2.177727 1.987192 1.785891 1.580335 1.371389 1.168602 0.9780924 0.8048813 0.6541424 0.5305051 0.4390865 0.3781431 0.3455222 0.3361633 0.3453224 0.3679000 0.3999616 0.4391038 -30.42189 2.662793 2.401692 2.144898 1.885831 1.629350 1.381605 1.148569 0.9338712 0.7439162 0.5828874 0.4599228 0.3791376 0.3385080 0.3330556 0.3574957 0.4037867 0.4664940 0.5408119 0.6238828 -30.42189 2.796045 2.476696 2.166993 1.863647 1.566271 1.280708 1.014113 0.7735580 0.5661939 0.3922951 0.2637447 0.1862603 0.1595310 0.1766554 0.2312806 0.3128868 0.4145257 0.5303946 0.6570774 -30.42189 2.797864 2.442495 2.097111 1.759623 1.434153 1.118226 0.8215561 0.5529859 0.3201033 0.1308324 -8.5877711E-03 -8.8966891E-02 -0.1091929 -7.3603272E-02 7.3094796E-03 0.1222502 0.2617801 0.4188136 0.5889785 -30.42189 2.698846 2.321446 1.957098 1.598822 1.249802 0.9118062 0.5940788 0.2996424 4.2975817E-02 -0.1683939 -0.3256534 -0.4155317 -0.4364933 -0.3878046 -0.2844905 -0.1384972 3.7727267E-02 0.2355515 0.4491190 -30.42189 2.516123 2.132041 1.757853 1.389736 1.026234 0.6721810 0.3370527 2.4839584E-02 -0.2515146 -0.4857940 -0.6656172 -0.7746657 -0.8018404 -0.7487922 -0.6277148 -0.4537586 -0.2423193 -4.2607230E-03 0.2526348 -30.42189 2.264131 1.881638 1.504492 1.134354 0.7667167 0.4034848 5.7833869E-02 -0.2640689 -0.5583192 -0.8101429 -1.015189 -1.150261 -1.190500 -1.142291 -1.009457 -0.8114346 -0.5669450 -0.2893990 1.0691151E-02 -30.42189 1.947021 1.574369 1.202508 0.8350713 0.4697522 0.1079677 -0.2400812 -0.5694306 -0.8720022 -1.141010 -1.367766 -1.527191 -1.595501 -1.559610 -1.423874 -1.207220 -0.9324689 -0.6165400 -0.2734962 -30.42189 1.568281 1.213929 0.8527966 0.4941368 0.1382581 -0.2152653 -0.5603011 -0.8893356 -1.198313 -1.477525 -1.716860 -1.902858 -2.004884 -1.990922 -1.863333 -1.635894 -1.334411 -0.9815779 -0.5958959 -30.42189 1.131936 0.8008673 0.4575520 0.1129288 -0.2282987 -0.5689570 -0.9033852 -1.228877 -1.538369 -1.817697 -2.066126 -2.275908 -2.408596 -2.429280 -2.318609 -2.089945 -1.766647 -1.378808 -0.9508032 -30.42189 0.6395178 0.3351666 1.6012292E-02 -0.3085419 -0.6316419 -0.9560853 -1.276087 -1.590038 -1.889966 -2.169749 -2.425550 -2.647013 -2.811295 -2.870750 -2.792470 -2.571986 -2.234017 -1.813870 -1.344057 -30.42189 8.8301003E-02 -0.1837818 -0.4751557 -0.7748752 -1.077035 -1.380551 -1.678242 -1.973877 -2.266310 -2.543427 -2.796565 -3.025518 -3.214330 -3.315924 -3.279863 -3.078598 -2.733200 -2.284205 -1.773280 -30.42189 -0.5286599 -0.7649603 -1.022656 -1.291150 -1.565724 -1.844089 -2.121143 -2.399096 -2.676726 -2.943464 -3.194767 -3.423909 -3.630262 -3.773326 -3.782222 -3.611506 -3.267272 -2.792179 -2.240493 -30.42189 -1.222808 -1.417836 -1.636887 -1.870505 -2.115503 -2.368244 -2.620276 -2.874074 -3.133522 -3.390198 -3.633253 -3.866589 -4.083655 -4.256657 -4.316147 -4.181636 -3.848839 -3.351004 -2.758955 -30.42189 -2.022082 -2.172732 -2.348274 -2.541145 -2.751932 -2.974171 -3.200369 -3.429273 -3.667499 -3.912796 -4.151922 -4.379821 -4.599777 -4.796038 -4.892978 -4.804584 -4.480157 -3.958817 -3.325455 -30.42189 -2.978625 -3.080958 -3.209039 -3.358904 -3.532327 -3.721230 -3.918128 -4.124297 -4.339124 -4.567167 -4.797414 -5.021667 -5.239587 -5.449379 -5.581654 -5.523809 -5.200104 -4.647721 -3.971672 -30.42189 -4.233746 -4.287555 -4.365839 -4.466535 -4.596240 -4.748833 -4.912500 -5.087184 -5.277146 -5.484048 -5.705247 -5.926390 -6.144267 -6.355141 -6.499074 -6.442466 -6.081734 -5.482781 -4.761052 -30.42189 -6.319001 -6.312998 -6.333065 -6.372095 -6.440749 -6.543822 -6.667719 -6.801649 -6.952771 -7.131357 -7.332561 -7.542838 -7.746592 -7.924375 -8.009381 -7.897807 -7.468409 -6.811744 -6.034566 -30.42189 -42.73994 -42.42098 -42.04388 -41.61479 -41.13913 -40.62158 -40.06607 -39.47590 -38.85392 -38.20252 -37.52378 -36.81950 -36.09124 -35.34039 -34.56819 -33.77573 -32.96401 -32.13393 -31.28631 -30.42189 2.142165 2.031268 1.902520 1.751125 1.584223 1.407298 1.224872 1.045003 0.8739656 0.7167839 0.5787591 0.4632601 0.3727800 0.3056491 0.2586152 0.2279849 0.2091475 0.1985891 0.1936641 -34.35604 2.720111 2.522893 2.319281 2.102102 1.879892 1.653686 1.431557 1.222397 1.030729 0.8638667 0.7304708 0.6310650 0.5681525 0.5367849 0.5310888 0.5460597 0.5751780 0.6141369 0.6599531 -34.35604 3.067519 2.777467 2.494816 2.211439 1.930653 1.657973 1.400917 1.165243 0.9537473 0.7768793 0.6432104 0.5564914 0.5168233 0.5176862 0.5507100 0.6085041 0.6834899 0.7705176 0.8662441 -34.35604 3.224833 2.867865 2.526033 2.191984 1.862755 1.545483 1.251461 0.9868493 0.7564638 0.5645492 0.4230063 0.3422839 0.3191353 0.3466051 0.4150764 0.5135191 0.6333479 0.7679133 0.9133157 -34.35604 3.235474 2.839199 2.457957 2.083660 1.718943 1.370376 1.043313 0.7473859 0.4899832 0.2755056 0.1202502 3.3941384E-02 1.9229071E-02 6.7004390E-02 0.1668480 0.3036942 0.4672658 0.6490035 0.8439708 -34.35604 3.135930 2.715544 2.311586 1.912888 1.523979 1.150972 0.7999239 0.4783747 0.1926691 -5.0324418E-02 -0.2273336 -0.3270013 -0.3443848 -0.2826402 -0.1560951 1.6989524E-02 0.2230603 0.4515954 0.6960990 -34.35604 2.943396 2.515086 2.099485 1.691380 1.288864 0.8982199 0.5320177 0.1871545 -0.1222204 -0.3885339 -0.5974299 -0.7204558 -0.7503963 -0.6831661 -0.5368602 -0.3308890 -8.3830670E-02 0.1909929 0.4849830 -34.35604 2.672467 2.248656 1.831222 1.421695 1.015083 0.6190302 0.2386623 -0.1193352 -0.4441894 -0.7329903 -0.9699937 -1.128728 -1.180415 -1.119495 -0.9610022 -0.7269378 -0.4410805 -0.1206826 0.2227171 -34.35604 2.332638 1.922024 1.512103 1.107138 0.7049161 0.3073856 -7.6456949E-02 -0.4400998 -0.7766138 -1.078882 -1.342294 -1.536224 -1.619116 -1.578947 -1.417839 -1.162629 -0.8413262 -0.4764546 -8.3828077E-02 -34.35604 1.928835 1.539069 1.143660 0.7472431 0.3542651 -3.5578348E-02 -0.4131161 -0.7788525 -1.119048 -1.432050 -1.712187 -1.932969 -2.058552 -2.050879 -1.900273 -1.632570 -1.280361 -0.8725682 -0.4310137 -34.35604 1.465232 1.100455 0.7235300 0.3433006 -3.5240065E-02 -0.4105574 -0.7784955 -1.136389 -1.478255 -1.795321 -2.078501 -2.323476 -2.490857 -2.524860 -2.400149 -2.131947 -1.754566 -1.305995 -0.8159046 -34.35604 0.9406831 0.6047179 0.2530099 -0.1042620 -0.4652668 -0.8228092 -1.174593 -1.521659 -1.857108 -2.166002 -2.453531 -2.713333 -2.911413 -2.996126 -2.910005 -2.655006 -2.260586 -1.774022 -1.235794 -34.35604 0.3522800 5.0490186E-02 -0.2706397 -0.6005802 -0.9392012 -1.277237 -1.608479 -1.934692 -2.254289 -2.560808 -2.848104 -3.108561 -3.333885 -3.464300 -3.434668 -3.205956 -2.805238 -2.284661 -1.699004 -34.35604 -0.3064354 -0.5710471 -0.8569204 -1.154790 -1.464567 -1.774598 -2.080021 -2.385559 -2.691593 -2.987659 -3.264584 -3.528861 -3.765346 -3.940818 -3.969651 -3.782265 -3.385022 -2.835025 -2.202567 -34.35604 -1.051634 -1.272467 -1.515577 -1.774789 -2.050021 -2.331723 -2.612246 -2.893593 -3.176706 -3.458687 -3.727809 -3.985946 -4.235770 -4.442694 -4.529408 -4.393137 -4.012007 -3.435539 -2.756646 -34.35604 -1.907644 -2.078407 -2.274263 -2.491280 -2.727767 -2.975290 -3.225370 -3.480905 -3.741510 -4.007305 -4.268507 -4.523005 -4.776474 -5.006959 -5.141692 -5.063076 -4.701100 -4.101175 -3.375329 -34.35604 -2.929234 -3.045085 -3.188610 -3.357728 -3.550709 -3.762631 -3.980825 -4.207168 -4.446866 -4.695371 -4.944172 -5.193136 -5.447371 -5.690353 -5.868469 -5.833229 -5.482429 -4.851869 -4.077561 -34.35604 -4.260734 -4.320367 -4.407074 -4.524601 -4.670933 -4.839364 -5.022085 -5.216308 -5.428331 -5.657340 -5.892838 -6.139374 -6.389293 -6.645643 -6.835823 -6.817912 -6.436323 -5.753849 -4.928449 -34.35604 -6.459852 -6.455487 -6.473528 -6.521985 -6.607985 -6.717072 -6.852945 -7.004774 -7.177937 -7.374685 -7.596479 -7.832002 -8.067665 -8.302833 -8.453171 -8.368039 -7.909912 -7.161889 -6.276152 -34.35604 -48.36032 -48.00617 -47.58243 -47.09713 -46.55729 -45.96873 -45.33632 -44.66409 -43.95544 -43.21322 -42.43989 -41.63754 -40.80801 -39.95292 -39.07369 -38.17160 -37.24780 -36.30333 -35.33912 -34.35604 2.428889 2.318881 2.184703 2.026006 1.850777 1.660102 1.463902 1.267432 1.077928 0.9045581 0.7510487 0.6241617 0.5243179 0.4518740 0.4021803 0.3703535 0.3518697 0.3420007 0.3376133 -38.40252 3.076948 2.863620 2.645041 2.414443 2.174782 1.932217 1.693226 1.465000 1.254866 1.074353 0.9289590 0.8237190 0.7578372 0.7280883 0.7270940 0.7478874 0.7837266 0.8296011 0.8821526 -38.40252 3.466970 3.147036 2.839647 2.531182 2.225646 1.930977 1.653239 1.395162 1.164772 0.9729742 0.8295603 0.7390705 0.7015586 0.7092367 0.7524722 0.8221461 0.9097809 1.009753 1.118383 -38.40252 3.648010 3.253271 2.877186 2.510602 2.151675 1.806942 1.484834 1.196938 0.9427573 0.7318240 0.5792100 0.4935413 0.4748575 0.5131128 0.5959180 0.7120449 0.8504012 1.003941 1.168437 -38.40252 3.668395 3.228715 2.809708 2.399712 1.999809 1.617598 1.262214 0.9408807 0.6534843 0.4166804 0.2447810 0.1523965 0.1417632 0.2034965 0.3219999 0.4820015 0.6700633 0.8769316 1.097256 -38.40252 3.565737 3.102328 2.659223 2.222579 1.792881 1.387011 1.005312 0.6542779 0.3385526 6.6393614E-02 -0.1342940 -0.2450098 -0.2590723 -0.1831329 -3.3921003E-02 0.1671721 0.4038178 0.6637300 0.9398817 -38.40252 3.364472 2.893257 2.436758 1.987016 1.547401 1.123899 0.7234353 0.3503008 8.9497613E-03 -0.2938045 -0.5295111 -0.6722829 -0.7034644 -0.6244493 -0.4520085 -0.2132036 7.0328757E-02 0.3827761 0.7147508 -38.40252 3.076980 2.611208 2.153187 1.705156 1.261720 0.8310031 0.4184583 2.8534902E-02 -0.3302235 -0.6533972 -0.9255156 -1.108346 -1.172704 -1.102670 -0.9186708 -0.6478460 -0.3196951 4.4570073E-02 0.4323098 -38.40252 2.713864 2.266076 1.818650 1.375466 0.9354174 0.5064746 8.8617556E-02 -0.3097290 -0.6775505 -1.015455 -1.312777 -1.539459 -1.647730 -1.603289 -1.419905 -1.125250 -0.7559382 -0.3408959 0.1024796 -38.40252 2.287601 1.862386 1.430690 0.9983512 0.5683047 0.1452918 -0.2676863 -0.6645692 -1.037714 -1.381610 -1.696247 -1.958393 -2.111225 -2.112687 -1.943778 -1.636327 -1.231179 -0.7669547 -0.2681735 -38.40252 1.798127 1.399309 0.9892552 0.5732149 0.1570385 -0.2525696 -0.6521263 -1.043085 -1.413447 -1.761009 -2.082962 -2.361819 -2.564017 -2.618308 -2.483615 -2.176264 -1.742473 -1.231298 -0.6774851 -38.40252 1.243338 0.8750100 0.4923145 9.9536225E-02 -0.2974052 -0.6894016 -1.071827 -1.447827 -1.812665 -2.155740 -2.472122 -2.766918 -3.005083 -3.115568 -3.032079 -2.743334 -2.290388 -1.735515 -1.127133 -38.40252 0.6202384 0.2868852 -6.4074822E-02 -0.4272961 -0.7992945 -1.169030 -1.531462 -1.888590 -2.237359 -2.567065 -2.882806 -3.182220 -3.441520 -3.607847 -3.586692 -3.335483 -2.876332 -2.282001 -1.619599 -38.40252 -7.9872116E-02 -0.3719620 -0.6854790 -1.014673 -1.356928 -1.699219 -2.034801 -2.365562 -2.697239 -3.017526 -3.321623 -3.616007 -3.894611 -4.100138 -4.151433 -3.954496 -3.503525 -2.875742 -2.160173 -38.40252 -0.8717085 -1.116727 -1.385745 -1.674302 -1.977970 -2.287729 -2.595365 -2.903158 -3.213153 -3.515142 -3.810613 -4.095231 -4.379240 -4.620313 -4.736025 -4.605589 -4.176636 -3.519788 -2.751393 -38.40252 -1.780723 -1.971594 -2.189602 -2.431969 -2.694833 -2.969322 -3.243962 -3.523730 -3.811153 -4.095284 -4.375949 -4.653650 -4.938639 -5.202982 -5.378290 -5.316740 -4.923570 -4.241901 -3.420927 -38.40252 -2.867193 -2.997451 -3.157300 -3.348403 -3.565224 -3.798747 -4.039538 -4.288031 -4.548450 -4.816006 -5.083024 -5.352737 -5.636417 -5.914710 -6.133376 -6.132746 -5.760200 -5.047346 -4.171900 -38.40252 -4.273033 -4.341423 -4.439589 -4.570911 -4.736794 -4.926756 -5.126705 -5.340084 -5.573374 -5.820241 -6.073356 -6.338315 -6.622836 -6.913566 -7.156662 -7.179155 -6.786162 -6.018795 -5.086803 -38.40252 -6.570523 -6.577007 -6.603260 -6.657914 -6.753145 -6.885197 -7.032839 -7.200051 -7.395576 -7.614118 -7.848350 -8.104698 -8.373528 -8.653044 -8.867286 -8.819325 -8.343725 -7.503372 -6.505474 -38.40252 -54.14704 -53.75711 -53.28526 -52.74177 -52.13534 -51.47317 -50.76107 -50.00387 -49.20554 -48.36943 -47.49835 -46.59473 -45.66068 -44.69806 -43.70848 -42.69341 -41.65416 -40.59190 -39.50769 -38.40252 2.709035 2.601343 2.465032 2.299037 2.113868 1.911940 1.700503 1.486703 1.279740 1.087258 0.9177864 0.7771184 0.6680866 0.5890486 0.5363005 0.5035858 0.4851898 0.4757637 0.4718195 -42.55429 3.429147 3.201919 2.967026 2.720377 2.464985 2.206120 1.949823 1.702402 1.474998 1.278815 1.121344 1.008989 0.9407398 0.9126071 0.9162709 0.9429897 0.9856567 1.038389 1.097736 -42.55429 3.863201 3.512712 3.177360 2.843919 2.514485 2.196739 1.899407 1.620405 1.369825 1.162795 1.008702 0.9154334 0.8794942 0.8945546 0.9487097 1.030450 1.130973 1.244017 1.365764 -42.55429 4.065702 3.632266 3.221586 2.822471 2.432466 2.061796 1.717137 1.402529 1.124984 0.8952973 0.7316340 0.6428577 0.6285035 0.6777738 0.7767945 0.9108753 1.068156 1.240969 1.424951 -42.55429 4.095355 3.612388 3.154584 2.706238 2.272911 1.861970 1.477881 1.129089 0.8129869 0.5519090 0.3647315 0.2648967 0.2596880 0.3350913 0.4735735 0.6574156 0.8704845 1.102887 1.349101 -42.55429 3.990542 3.482831 2.997994 2.523295 2.059341 1.619850 1.207744 0.8275999 0.4790459 0.1795857 -4.5074336E-02 -0.1682608 -0.1808736 -9.0059407E-02 8.2174465E-02 0.3127177 0.5804641 0.8722468 1.180737 -42.55429 3.778188 3.264045 2.767444 2.280027 1.801869 1.345702 0.9120879 0.5085210 0.1367474 -0.1982827 -0.4652061 -0.6285859 -0.6630377 -0.5725037 -0.3748368 -0.1020311 0.2187733 0.5695503 0.9403481 -42.55429 3.474853 2.969723 2.472750 1.983191 1.504010 1.039832 0.5931126 0.1745259 -0.2157666 -0.5741698 -0.8782459 -1.091717 -1.168248 -1.094110 -0.8835942 -0.5747595 -0.2034970 0.2055263 0.6386090 -42.55429 3.093577 2.606847 2.121178 1.638881 1.162852 0.6994114 0.2508358 -0.1786811 -0.5794072 -0.9477624 -1.281481 -1.540138 -1.674539 -1.633774 -1.428506 -1.093273 -0.6752905 -0.2090898 0.2861718 -42.55429 2.643890 2.182578 1.714664 1.244379 0.7773715 0.3225487 -0.1228108 -0.5522874 -0.9531027 -1.329381 -1.675134 -1.974100 -2.163970 -2.176851 -1.994760 -1.646628 -1.187510 -0.6656909 -0.1084227 -42.55429 2.129283 1.695701 1.251587 0.8004010 0.3465371 -9.6184514E-02 -0.5278832 -0.9473783 -1.347007 -1.719437 -2.074696 -2.397110 -2.631325 -2.710421 -2.572037 -2.227408 -1.735746 -1.160674 -0.5417035 -42.55429 1.545614 1.144781 0.7286398 0.3013504 -0.1318053 -0.5552364 -0.9689583 -1.373335 -1.761912 -2.131553 -2.483478 -2.812385 -3.087288 -3.230420 -3.158268 -2.838307 -2.326057 -1.701437 -1.021329 -42.55429 0.8879889 0.5253575 0.1425750 -0.2536018 -0.6596808 -1.060047 -1.450642 -1.836292 -2.212039 -2.568315 -2.907520 -3.240679 -3.536279 -3.739830 -3.741107 -3.470760 -2.952874 -2.283622 -1.542927 -42.55429 0.1497327 -0.1690216 -0.5111514 -0.8713444 -1.245948 -1.618329 -1.983360 -2.344688 -2.697329 -3.039606 -3.369529 -3.691730 -4.003534 -4.247448 -4.329783 -4.129600 -3.625708 -2.918187 -2.117692 -42.55429 -0.6845433 -0.9541613 -1.249419 -1.568179 -1.904456 -2.241616 -2.574438 -2.909186 -3.241728 -3.564720 -3.881292 -4.196779 -4.505961 -4.780012 -4.933970 -4.817167 -4.344436 -3.605908 -2.746265 -42.55429 -1.646480 -1.855978 -2.097479 -2.366771 -2.657606 -2.957784 -3.257373 -3.561304 -3.870534 -4.176791 -4.475690 -4.777596 -5.087608 -5.380356 -5.593117 -5.560194 -5.135144 -4.369371 -3.450715 -42.55429 -2.790944 -2.935486 -3.116822 -3.328577 -3.569588 -3.827513 -4.087800 -4.359272 -4.642818 -4.927905 -5.213714 -5.507408 -5.814225 -6.120705 -6.372799 -6.420035 -6.031218 -5.235089 -4.255927 -42.55429 -4.267403 -4.342729 -4.459023 -4.607049 -4.791316 -4.996570 -5.214272 -5.451555 -5.706791 -5.974484 -6.245095 -6.528947 -6.840528 -7.158151 -7.441246 -7.522227 -7.127413 -6.276281 -5.234199 -42.55429 -6.664695 -6.662884 -6.705579 -6.776395 -6.886517 -7.022949 -7.183305 -7.374884 -7.588798 -7.834845 -8.089374 -8.362972 -8.671437 -8.981038 -9.244888 -9.259918 -8.768619 -7.837499 -6.724725 -42.55429 -60.08942 -59.66315 -59.14202 -58.53813 -57.86289 -57.12461 -56.33022 -55.48533 -54.59453 -53.66164 -52.68988 -51.68201 -50.64043 -49.56722 -48.46447 -47.33333 -46.17526 -44.99208 -43.78473 -42.55429 2.979384 2.876001 2.741252 2.570761 2.375848 2.162604 1.937178 1.705376 1.478844 1.268063 1.082097 0.9268649 0.8073108 0.7218753 0.6659937 0.6324658 0.6140042 0.6049493 0.6013686 -46.80515 3.773249 3.534261 3.284109 3.022038 2.749845 2.475746 2.201228 1.934190 1.688318 1.476140 1.306211 1.185581 1.115057 1.088370 1.096634 1.129747 1.179058 1.238674 1.304869 -46.80515 4.255143 3.873471 3.510560 3.149781 2.797101 2.457812 2.139165 1.837659 1.568674 1.346272 1.182111 1.084481 1.051139 1.073805 1.139042 1.233205 1.346795 1.473060 1.608136 -46.80515 4.479568 4.007150 3.559098 3.126873 2.707886 2.310224 1.942328 1.601587 1.300723 1.052782 0.8763906 0.7850290 0.7744111 0.8357357 0.9514732 1.103871 1.280383 1.472803 1.676628 -46.80515 4.516842 3.989687 3.492442 3.006567 2.539416 2.099775 1.689746 1.311062 0.9679162 0.6832523 0.4787069 0.3737523 0.3715799 0.4609331 0.6213630 0.8294084 1.067921 1.326330 1.598947 -46.80515 4.409427 3.857310 3.330760 2.815814 2.318747 1.847928 1.405656 0.9964191 0.6174043 0.2882705 4.0941767E-02 -9.6333556E-02 -0.1083991 -3.5411159E-03 0.1935527 0.4540176 0.7534556 1.077700 1.419188 -46.80515 4.186234 3.629213 3.090783 2.564960 2.052577 1.561773 1.097052 0.6638016 0.2606679 -0.1036720 -0.4016659 -0.5881709 -0.6309619 -0.5279884 -0.3043294 3.5864098E-03 0.3623426 0.7520984 1.162519 -46.80515 3.866902 3.321707 2.785982 2.257857 1.740419 1.243299 0.7647560 0.3152833 -0.1023103 -0.4912618 -0.8312322 -1.075575 -1.168552 -1.091470 -0.8556061 -0.5081739 -9.2840612E-02 0.3618043 0.8411726 -46.80515 3.468711 2.943650 2.419901 1.896199 1.384293 0.8881989 0.4066755 -4.9587436E-02 -0.4779157 -0.8795425 -1.246403 -1.541927 -1.701213 -1.671539 -1.444477 -1.068150 -0.6006708 -8.2243986E-02 0.4660087 -46.80515 2.997761 2.497705 1.994447 1.484771 0.9823539 0.4932709 1.9835683E-02 -0.4377660 -0.8673471 -1.271102 -1.654867 -1.985893 -2.212612 -2.245279 -2.052961 -1.663995 -1.150470 -0.5698807 4.7102850E-02 -46.80515 2.457236 1.987763 1.509307 1.020728 0.5335609 5.7827797E-02 -0.4040087 -0.8523439 -1.276316 -1.677754 -2.060796 -2.419390 -2.693761 -2.804167 -2.667186 -2.287114 -1.736660 -1.096389 -0.4109168 -46.80515 1.845424 1.411429 0.9627104 0.5006461 3.3283543E-02 -0.4229443 -0.8659264 -1.299529 -1.711479 -2.104291 -2.484966 -2.849593 -3.158756 -3.341833 -3.284904 -2.938838 -2.366355 -1.670394 -0.9169473 -46.80515 1.156237 0.7632748 0.3505478 -8.0772109E-02 -0.5200650 -0.9519086 -1.373023 -1.784346 -2.182331 -2.564854 -2.930346 -3.292674 -3.621918 -3.861313 -3.896341 -3.612666 -3.036447 -2.290428 -1.469705 -46.80515 0.3819722 3.5289023E-02 -0.3350430 -0.7294175 -1.135337 -1.537814 -1.930924 -2.319820 -2.697542 -3.057747 -3.414079 -3.768093 -4.101559 -4.383509 -4.501338 -4.305098 -3.748874 -2.960003 -2.072654 -46.80515 -0.4949424 -0.7865877 -1.109988 -1.459611 -1.826515 -2.194070 -2.552942 -2.911274 -3.268376 -3.611653 -3.948956 -4.294372 -4.626937 -4.929063 -5.121953 -5.024859 -4.512669 -3.690260 -2.737169 -46.80515 -1.504545 -1.734336 -2.001610 -2.296709 -2.616202 -2.940471 -3.265159 -3.594909 -3.928740 -4.253127 -4.574754 -4.904360 -5.230846 -5.547102 -5.793955 -5.798625 -5.348472 -4.497861 -3.479129 -46.80515 -2.708796 -2.865115 -3.068093 -3.304333 -3.572073 -3.846230 -4.133387 -4.430496 -4.739062 -5.041014 -5.342199 -5.661919 -5.982728 -6.311396 -6.597694 -6.692140 -6.299036 -5.418808 -4.333247 -46.80515 -4.261357 -4.337246 -4.467663 -4.637786 -4.844054 -5.062657 -5.304276 -5.563661 -5.842647 -6.123672 -6.410746 -6.722879 -7.044592 -7.386585 -7.706991 -7.848316 -7.463697 -6.528366 -5.373333 -46.80515 -6.751464 -6.735810 -6.785805 -6.875169 -7.008791 -7.155014 -7.336774 -7.549500 -7.788029 -8.048727 -8.323215 -8.621621 -8.952212 -9.289301 -9.599944 -9.681849 -9.191365 -8.170018 -6.939447 -46.80515 -66.17808 -65.71491 -65.14263 -64.47697 -63.73074 -62.91404 -62.03490 -61.09977 -60.11386 -59.08150 -58.00633 -56.89144 -55.73952 -54.55289 -53.33361 -52.08351 -50.80422 -49.49720 -48.16378 -46.80515 3.243381 3.143686 3.011681 2.840969 2.637415 2.414093 2.173411 1.924382 1.678754 1.448473 1.245686 1.075141 0.9441898 0.8527642 0.7936669 0.7591588 0.7406431 0.7319546 0.7286759 -51.14960 4.110176 3.859278 3.597636 3.319317 3.032593 2.742197 2.449122 2.163383 1.899201 1.671251 1.488565 1.359581 1.286308 1.261981 1.275232 1.314722 1.370833 1.437376 1.510492 -51.14960 4.640625 4.230151 3.838492 3.451699 3.074183 2.714055 2.373331 2.050710 1.762596 1.525341 1.350916 1.247728 1.217396 1.248299 1.324930 1.432043 1.558786 1.698438 1.847057 -51.14960 4.889550 4.376601 3.892588 3.424665 2.977294 2.553883 2.161374 1.795077 1.473121 1.205749 1.017723 0.9207724 0.9152492 0.9893078 1.122137 1.293377 1.489470 1.701769 1.925791 -51.14960 4.933090 4.362845 3.823310 3.300649 2.800795 2.331896 1.895983 1.490062 1.119548 0.8108867 0.5883503 0.4754775 0.4759097 0.5808486 0.7633894 0.9960829 1.260517 1.545376 1.844879 -51.14960 4.822687 4.225344 3.657347 3.102753 2.572143 2.069812 1.600586 1.161653 0.7545285 0.3965975 0.1231898 -2.8469995E-02 -4.2707674E-02 7.6820888E-02 0.3003647 0.5911638 0.9228685 1.280167 1.655264 -51.14960 4.588364 3.988621 3.408576 2.842831 2.296731 1.774765 1.278786 0.8172807 0.3857054 -1.1006384E-02 -0.3387510 -0.5507529 -0.6039371 -0.4903660 -0.2396144 0.1038144 0.5011615 0.9306291 1.381419 -51.14960 4.254386 3.668162 3.091973 2.525277 1.974538 1.441891 0.9335792 0.4561732 8.7633077E-03 -0.4091217 -0.7834932 -1.059481 -1.175755 -1.095583 -0.8355666 -0.4484564 1.1634710E-02 0.5127035 1.039235 -51.14960 3.838243 3.274057 2.713117 2.151038 1.601190 1.073050 0.5617226 7.6587044E-02 -0.3753894 -0.8079718 -1.210054 -1.541282 -1.729629 -1.712497 -1.467214 -1.050148 -0.5319803 3.9648708E-02 0.6418896 -51.14960 3.347730 2.810224 2.268477 1.721410 1.183333 0.6626458 0.1578024 -0.3240715 -0.7798464 -1.211925 -1.628333 -1.992746 -2.253954 -2.316458 -2.116430 -1.687342 -1.118348 -0.4778773 0.1999648 -51.14960 2.781654 2.276569 1.762472 1.238325 0.7158408 0.2102568 -0.2829319 -0.7576811 -1.206690 -1.634068 -2.048107 -2.433599 -2.749226 -2.892547 -2.766742 -2.352028 -1.742640 -1.035867 -0.2826757 -51.14960 2.142074 1.676220 1.193785 0.6970891 0.1964072 -0.2918535 -0.7670663 -1.225838 -1.663228 -2.078075 -2.487047 -2.880914 -3.220104 -3.443454 -3.411130 -3.043826 -2.411047 -1.642309 -0.8141935 -51.14960 1.423115 1.000898 0.5563464 9.0355858E-02 -0.3828951 -0.8455248 -1.297054 -1.735396 -2.153464 -2.556800 -2.957027 -3.337985 -3.696266 -3.972464 -4.045720 -3.755830 -3.123034 -2.298755 -1.396455 -51.14960 0.6134353 0.2412342 -0.1604019 -0.5873697 -1.026898 -1.456979 -1.878097 -2.293319 -2.695708 -3.077394 -3.457086 -3.833468 -4.189662 -4.505073 -4.665405 -4.481706 -3.876139 -3.005039 -2.029278 -51.14960 -0.3026015 -0.6181990 -0.9697784 -1.349673 -1.747736 -2.139964 -2.531338 -2.915080 -3.293631 -3.657046 -4.019207 -4.381326 -4.735301 -5.064464 -5.297592 -5.231446 -4.684694 -3.777100 -2.728716 -51.14960 -1.359823 -1.608190 -1.901122 -2.227305 -2.574008 -2.921366 -3.275686 -3.628842 -3.984848 -4.324861 -4.668268 -5.019394 -5.359170 -5.698707 -5.983693 -6.031140 -5.564375 -4.629408 -3.508566 -51.14960 -2.622278 -2.790272 -3.013305 -3.276410 -3.566659 -3.866752 -4.179643 -4.499907 -4.825754 -5.144958 -5.463440 -5.805262 -6.137835 -6.483312 -6.807703 -6.952400 -6.567538 -5.603512 -4.409288 -51.14960 -4.242650 -4.320700 -4.465467 -4.657559 -4.882334 -5.126516 -5.391010 -5.671152 -5.964036 -6.263334 -6.566084 -6.901309 -7.234020 -7.598001 -7.953379 -8.161885 -7.794589 -6.772173 -5.501859 -51.14960 -6.814509 -6.801280 -6.850574 -6.958604 -7.101147 -7.276336 -7.479410 -7.712537 -7.974041 -8.248789 -8.546636 -8.879309 -9.223232 -9.588904 -9.933291 -10.08273 -9.599563 -8.488126 -7.137218 -51.14960 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.83352 -67.86732 -66.83953 -65.75603 -64.62168 -63.44077 -62.21600 -60.95110 -59.64840 -58.31017 -56.93842 -55.53519 -54.10138 -52.63915 -51.14960 3.501156 3.407562 3.278119 3.106830 2.899753 2.665010 2.410558 2.144111 1.879112 1.630493 1.406683 1.221307 1.080237 0.9823923 0.9202814 0.8848363 0.8663230 0.8579878 0.8549783 -55.58271 4.442252 4.177839 3.903965 3.614079 3.311409 3.006005 2.694095 2.389367 2.109223 1.862184 1.666141 1.529707 1.454683 1.433206 1.451718 1.497733 1.560729 1.634286 1.714396 -55.58271 5.019818 4.579781 4.162350 3.747833 3.347350 2.965952 2.602013 2.260143 1.953191 1.698172 1.512459 1.405734 1.378710 1.418856 1.507295 1.627387 1.767483 1.920691 2.083053 -55.58271 5.293530 4.741852 4.220471 3.718361 3.241070 2.793141 2.375199 1.986152 1.638015 1.352803 1.152865 1.050644 1.051208 1.138761 1.289152 1.479775 1.695672 1.928137 2.172700 -55.58271 5.345485 4.730200 4.149673 3.588667 3.057541 2.559431 2.099037 1.662645 1.266726 0.9327624 0.6942501 0.5709479 0.5763153 0.6974235 0.9024948 1.160446 1.451301 1.762997 2.089864 -55.58271 5.230071 4.588565 3.977392 3.384476 2.820218 2.288179 1.788813 1.322596 0.8860610 0.5012325 0.2021371 3.3142742E-02 1.6040213E-02 0.1511563 0.4008192 0.7224279 1.087061 1.477932 1.887249 -55.58271 4.985050 4.341784 3.720051 3.115782 2.536029 1.980417 1.455231 0.9644871 0.5067921 8.0737405E-02 -0.2778745 -0.5155299 -0.5818456 -0.4594288 -0.1807301 0.1986627 0.6353549 1.105152 1.597050 -55.58271 4.637086 4.008519 3.393150 2.786446 2.200250 1.636335 1.095745 0.5937738 0.1208364 -0.3297298 -0.7337227 -1.042715 -1.183990 -1.105123 -0.8215527 -0.3944075 0.1113675 0.6595829 1.234135 -55.58271 4.203684 3.599452 2.998495 2.398477 1.814298 1.251110 0.7116510 0.2025422 -0.2765950 -0.7365412 -1.169691 -1.533013 -1.757813 -1.756496 -1.497115 -1.038932 -0.4692719 0.1563830 0.8135982 -55.58271 3.692248 3.116504 2.537222 1.952134 1.379295 0.8269207 0.2928189 -0.2146552 -0.6940678 -1.154560 -1.597349 -1.994587 -2.288903 -2.384577 -2.181317 -1.713726 -1.087967 -0.3865173 0.3532955 -55.58271 3.102096 2.561944 2.010701 1.450895 0.8948019 0.3564005 -0.1652699 -0.6660910 -1.138551 -1.591330 -2.034232 -2.441825 -2.792799 -2.979923 -2.871526 -2.427205 -1.758526 -0.9843746 -0.1622392 -55.58271 2.435189 1.937401 1.421419 0.8886477 0.3546730 -0.1646285 -0.6697873 -1.155207 -1.612934 -2.054259 -2.486407 -2.900098 -3.275831 -3.539798 -3.541152 -3.159170 -2.466006 -1.623623 -0.7195410 -55.58271 1.687193 1.235382 0.7595415 0.2585984 -0.2478154 -0.7407967 -1.220398 -1.687713 -2.126087 -2.548592 -2.975040 -3.377189 -3.760368 -4.076816 -4.189529 -3.904135 -3.215040 -2.311353 -1.325979 -55.58271 0.8445553 0.4450378 1.3752470E-02 -0.4474415 -0.9168803 -1.377250 -1.827529 -2.268823 -2.689179 -3.094688 -3.499851 -3.890032 -4.272456 -4.615103 -4.821690 -4.660059 -4.009553 -3.054521 -1.988768 -55.58271 -0.1105829 -0.4483409 -0.8283899 -1.241158 -1.667342 -2.089961 -2.508394 -2.921244 -3.314549 -3.695570 -4.084556 -4.460093 -4.836031 -5.192049 -5.461740 -5.434125 -4.860004 -3.866243 -2.720891 -55.58271 -1.212892 -1.478116 -1.797100 -2.154549 -2.529343 -2.905699 -3.284771 -3.663091 -4.031139 -4.392935 -4.760977 -5.127257 -5.486273 -5.845716 -6.157203 -6.255612 -5.782118 -4.762152 -3.537799 -55.58271 -2.527934 -2.707378 -2.952527 -3.243072 -3.556050 -3.883798 -4.221924 -4.566065 -4.906529 -5.247003 -5.593565 -5.942923 -6.294085 -6.653219 -7.002717 -7.201225 -6.833239 -5.788111 -4.484024 -55.58271 -4.212179 -4.297648 -4.456005 -4.671330 -4.913783 -5.185250 -5.474977 -5.775472 -6.086267 -6.402234 -6.734357 -7.078983 -7.430480 -7.797807 -8.187333 -8.447025 -8.113786 -7.012681 -5.625374 -55.58271 -6.872479 -6.853915 -6.912900 -7.035670 -7.192533 -7.394802 -7.623211 -7.873233 -8.151978 -8.452448 -8.771242 -9.118101 -9.472538 -9.853319 -10.23757 -10.45192 -10.00408 -8.804233 -7.329497 -55.58271 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.98605 -67.64945 -66.26910 -64.84782 -63.38812 -61.89219 -60.36201 -58.79934 -57.20576 -55.58271 3.754847 3.667161 3.541607 3.370502 3.159405 2.915619 2.646477 2.362765 2.078089 1.809444 1.566142 1.364818 1.213239 1.108465 1.043678 1.007212 0.9887337 0.9806700 0.9778915 -60.10012 4.770023 4.492507 4.205672 3.902673 3.588297 3.264853 2.936649 2.613055 2.313772 2.051677 1.841490 1.697313 1.621763 1.603280 1.627491 1.680223 1.750234 1.830897 1.918093 -60.10012 5.393723 4.923021 4.478476 4.040322 3.614874 3.213437 2.826325 2.463212 2.138237 1.867108 1.668882 1.558421 1.535659 1.585434 1.685996 1.819301 1.972903 2.139871 2.316185 -60.10012 5.691705 5.100004 4.544072 4.006244 3.500834 3.027604 2.583517 2.170221 1.799807 1.497440 1.281990 1.175914 1.183024 1.285065 1.453481 1.663762 1.899735 2.152685 2.418113 -60.10012 5.752325 5.092851 4.470074 3.872505 3.308338 2.782135 2.293846 1.832361 1.410879 1.051582 0.7949434 0.6616672 0.6723548 0.8099008 1.038066 1.322158 1.639681 1.978653 2.333337 -60.10012 5.633023 4.945369 4.292105 3.660404 3.063133 2.498932 1.972075 1.479945 1.016369 0.6025395 0.2789814 8.9632213E-02 7.0088618E-02 0.2202099 0.4962832 0.8496412 1.247676 1.672638 2.116745 -60.10012 5.376729 4.689609 4.025412 3.382621 2.767812 2.179867 1.627499 1.112131 0.6241786 0.1705613 -0.2181291 -0.4835635 -0.5656471 -0.4352776 -0.1294882 0.2865725 0.7632187 1.274002 1.807693 -60.10012 5.014102 4.343829 3.687221 3.041419 2.419283 1.824955 1.257834 0.7280018 0.2306145 -0.2494121 -0.6815528 -1.023858 -1.192080 -1.120749 -0.8135641 -0.3461540 0.2058738 0.8019799 1.425377 -60.10012 4.564740 3.918748 3.277615 2.638754 2.022207 1.426920 0.8573385 0.3242614 -0.1796274 -0.6678153 -1.126148 -1.521394 -1.782818 -1.804251 -1.533929 -1.033901 -0.4119434 0.2685193 0.9816495 -60.10012 4.031120 3.416631 2.800292 2.179194 1.570356 0.9859242 0.4228760 -0.1089449 -0.6111423 -1.100918 -1.564921 -1.989313 -2.321156 -2.454293 -2.256507 -1.752150 -1.069102 -0.3058772 0.4969603 -60.10012 3.418164 2.843792 2.256000 1.657830 1.068468 0.4980140 -5.3840224E-02 -0.5766898 -1.072082 -1.553073 -2.012712 -2.446892 -2.827965 -3.063897 -2.977016 -2.506775 -1.778268 -0.9355733 -4.3254111E-02 -60.10012 2.724678 2.194324 1.645028 1.075782 0.5088593 -4.1244555E-02 -0.5753154 -1.086626 -1.565219 -2.031548 -2.482168 -2.915165 -3.322998 -3.625758 -3.669329 -3.277543 -2.525713 -1.608385 -0.6269884 -60.10012 1.947523 1.467456 0.9582270 0.4232136 -0.1136052 -0.6389519 -1.148237 -1.639022 -2.099687 -2.543760 -2.986598 -3.412796 -3.818049 -4.169041 -4.329193 -4.055904 -3.313182 -2.329089 -1.259214 -60.10012 1.073331 0.6489148 0.1853727 -0.3089418 -0.8093465 -1.301307 -1.780772 -2.242612 -2.682886 -3.109461 -3.538161 -3.942675 -4.347318 -4.718036 -4.971634 -4.840603 -4.148318 -3.109012 -1.951673 -60.10012 8.1155941E-02 -0.2778019 -0.6864946 -1.132701 -1.588747 -2.042017 -2.486645 -2.919785 -3.337056 -3.738724 -4.149246 -4.539730 -4.928916 -5.311486 -5.617216 -5.634818 -5.037951 -3.958736 -2.714824 -60.10012 -1.062227 -1.344554 -1.690377 -2.078139 -2.480496 -2.889585 -3.293749 -3.692816 -4.083084 -4.467176 -4.854089 -5.229512 -5.606179 -5.982552 -6.324212 -6.470523 -5.998507 -4.893658 -3.563920 -60.10012 -2.428181 -2.620897 -2.887546 -3.204963 -3.545106 -3.902467 -4.265312 -4.629183 -4.992567 -5.352658 -5.718148 -6.075387 -6.441487 -6.815250 -7.187356 -7.435648 -7.091493 -5.963281 -4.547008 -60.10012 -4.181396 -4.270700 -4.444640 -4.679423 -4.950213 -5.247132 -5.557498 -5.883278 -6.209900 -6.547244 -6.895254 -7.240557 -7.611962 -7.993986 -8.404925 -8.717351 -8.432329 -7.253459 -5.747367 -60.10012 -6.933773 -6.902814 -6.968198 -7.100842 -7.283021 -7.505701 -7.751989 -8.034388 -8.331523 -8.648408 -8.990262 -9.339749 -9.720365 -10.10954 -10.52817 -10.80545 -10.40417 -9.117715 -7.517717 -60.10012 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.56238 -66.93990 -65.28062 -63.58645 -61.85910 -60.10012 4.001112 3.922091 3.801051 3.634435 3.417006 3.163931 2.880499 2.579259 2.275313 1.985370 1.722578 1.505455 1.341502 1.230350 1.162548 1.124999 1.106500 1.098597 1.096009 -64.69788 5.092845 4.802335 4.505374 4.188134 3.859765 3.520624 3.173191 2.832735 2.515078 2.235604 2.011477 1.860228 1.783750 1.768434 1.798674 1.858121 1.935280 2.023060 2.117423 -64.69788 5.763117 5.263828 4.790486 4.325737 3.879619 3.453843 3.046602 2.662340 2.318363 2.032575 1.821942 1.708044 1.690904 1.750644 1.863893 2.010622 2.178002 2.358906 2.549379 -64.69788 6.086424 5.452642 4.859821 4.290687 3.754193 3.256970 2.786045 2.349251 1.959343 1.637847 1.407286 1.298260 1.312850 1.430061 1.617244 1.847529 2.103906 2.377631 2.664250 -64.69788 6.152014 5.448688 4.786123 4.150055 3.554100 2.998215 2.483774 1.998698 1.551488 1.169572 0.8906502 0.7487410 0.7643360 0.9193162 1.171560 1.482108 1.826710 2.193347 2.576286 -64.69788 6.029713 5.297921 4.599788 3.931459 3.298722 2.704102 2.151500 1.633636 1.143856 0.7008801 0.3520934 0.1418049 0.1185528 0.2826987 0.5858425 0.9717739 1.403504 1.863087 2.342535 -64.69788 5.763709 5.031293 4.325620 3.642334 2.993015 2.375298 1.796158 1.256974 0.7394534 0.2597239 -0.1569639 -0.4521836 -0.5536696 -0.4176942 -8.4915251E-02 0.3683969 0.8855371 1.437935 2.014081 -64.69788 5.386926 4.673156 3.974853 3.289338 2.634566 2.007915 1.415733 0.8598852 0.3350974 -0.1691425 -0.6292217 -1.002299 -1.205197 -1.143437 -0.8142678 -0.3062906 0.2926358 0.9374058 1.610401 -64.69788 4.919771 4.232122 3.550423 2.875244 2.223872 1.598050 0.9993120 0.4418031 -8.7273695E-02 -0.6008223 -1.079857 -1.506182 -1.807671 -1.854482 -1.577159 -1.036777 -0.3621802 0.3739379 1.143858 -64.69788 4.364261 3.713246 3.057869 2.400851 1.758656 1.138368 0.5487464 -6.2807933E-03 -0.5332148 -1.045053 -1.528941 -1.979707 -2.353407 -2.520771 -2.339115 -1.799449 -1.059211 -0.2334657 0.6333604 -64.69788 3.729098 3.120460 2.496920 1.861419 1.237144 0.6352653 5.4799587E-02 -0.4925016 -1.007510 -1.513721 -1.988939 -2.450734 -2.859525 -3.136487 -3.082722 -2.589059 -1.800257 -0.8881257 7.5436249E-02 -64.69788 3.010629 2.448246 1.862655 1.258624 0.6603760 7.6717779E-02 -0.4849274 -1.018698 -1.518092 -2.009204 -2.476684 -2.930350 -3.361519 -3.702677 -3.794671 -3.399456 -2.589359 -1.596473 -0.5365968 -64.69788 2.204496 1.695668 1.153968 0.5835245 1.6443335E-02 -0.5421353 -1.079115 -1.589303 -2.072096 -2.545247 -2.996764 -3.443968 -3.870400 -4.253402 -4.462429 -4.211094 -3.417785 -2.352841 -1.197263 -64.69788 1.299113 0.8499706 0.3569753 -0.1726821 -0.7041326 -1.228758 -1.734613 -2.217584 -2.677977 -3.130787 -3.571413 -3.997484 -4.414511 -4.813211 -5.106483 -5.017364 -4.290473 -3.166917 -1.916670 -64.69788 0.2731297 -0.1064593 -0.5450850 -1.022614 -1.510448 -1.995185 -2.465277 -2.919058 -3.358283 -3.787354 -4.202992 -4.614841 -5.014865 -5.420640 -5.758352 -5.827333 -5.217416 -4.053795 -2.709999 -64.69788 -0.9089587 -1.210506 -1.582184 -1.999441 -2.433668 -2.873175 -3.304900 -3.723736 -4.134953 -4.540063 -4.935877 -5.326727 -5.711855 -6.113416 -6.478982 -6.671393 -6.213037 -5.027249 -3.590760 -64.69788 -2.326148 -2.533713 -2.822425 -3.164056 -3.537602 -3.920260 -4.308055 -4.693942 -5.074999 -5.454815 -5.828407 -6.198218 -6.570377 -6.967755 -7.358871 -7.647610 -7.340916 -6.138280 -4.608517 -64.69788 -4.146413 -4.239186 -4.428405 -4.680054 -4.980000 -5.300738 -5.636416 -5.979984 -6.333293 -6.682585 -7.038959 -7.395509 -7.771579 -8.171744 -8.600150 -8.954920 -8.734501 -7.490426 -5.864228 -64.69788 -6.977901 -6.938354 -7.008382 -7.152366 -7.363796 -7.605155 -7.875190 -8.166925 -8.489544 -8.822920 -9.180459 -9.538544 -9.923637 -10.34262 -10.77773 -11.11909 -10.78967 -9.426601 -7.699524 -64.69788 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.45850 -66.59509 -64.69788 4.242345 4.172897 4.061019 3.898219 3.674550 3.408602 3.112552 2.792009 2.474802 2.159467 1.874530 1.642007 1.466330 1.348509 1.277376 1.238819 1.220227 1.212436 1.210025 -69.07755 5.411504 5.107337 4.800551 4.472446 4.126117 3.770531 3.405587 3.049749 2.713890 2.413729 2.174451 2.019050 1.941078 1.929573 1.965795 2.032163 2.116470 2.211413 2.313039 -69.07755 6.130126 5.599790 5.099343 4.605402 4.137354 3.690072 3.260353 2.859836 2.495832 2.189637 1.968962 1.853749 1.842280 1.912322 2.038736 2.199134 2.380462 2.575438 2.780280 -69.07755 6.475965 5.802120 5.168903 4.567756 4.004202 3.479038 2.988839 2.526866 2.113796 1.772425 1.533536 1.422756 1.447016 1.580817 1.787867 2.038610 2.315794 2.610580 2.918713 -69.07755 6.546742 5.797949 5.094395 4.423667 3.792883 3.212563 2.671018 2.158980 1.684018 1.283352 0.9840279 0.8331971 0.8540478 1.027676 1.304883 1.642267 2.014431 2.409100 2.820726 -69.07755 6.419170 5.643463 4.903286 4.196038 3.531371 2.905477 2.325859 1.779974 1.265288 0.7996072 0.4217251 0.1899157 0.1598401 0.3372405 0.6684077 1.087011 1.552998 2.047626 2.562958 -69.07755 6.144576 5.367757 4.619950 3.898637 3.213898 2.564682 1.958091 1.394491 0.8538953 0.3475965 -9.6122369E-02 -0.4241686 -0.5461025 -0.4088230 -4.8457265E-02 0.4427318 1.000756 1.595315 2.214576 -69.07755 5.755046 4.997410 4.256814 3.533366 2.842414 2.183756 1.565551 0.9888998 0.4337387 -8.9733094E-02 -0.5762699 -0.9819878 -1.218274 -1.173086 -0.8234876 -0.2755000 0.3708124 1.064879 1.788240 -69.07755 5.268835 4.539926 3.818557 3.104850 2.417468 1.761452 1.138331 0.5545806 -5.5000407E-04 -0.5320355 -1.034226 -1.489044 -1.823730 -1.907524 -1.620330 -1.039718 -0.3117753 0.4808784 1.308466 -69.07755 4.692803 4.003853 3.309334 2.613948 1.940467 1.289807 0.6684823 9.1854863E-02 -0.4602045 -0.9897943 -1.494669 -1.970579 -2.372117 -2.587627 -2.421959 -1.848941 -1.051107 -0.1617932 0.7700095 -69.07755 4.033999 3.390037 2.731158 2.060779 1.402695 0.7681307 0.1583426 -0.4101459 -0.9480263 -1.472939 -1.969439 -2.448055 -2.883305 -3.207091 -3.191400 -2.683533 -1.836115 -0.8536039 0.1822572 -69.07755 3.291421 2.698127 2.077008 1.436662 0.8060520 0.1903272 -0.4003540 -0.9526569 -1.476431 -1.988408 -2.471670 -2.938359 -3.392933 -3.777259 -3.914329 -3.527377 -2.662845 -1.593282 -0.4537381 -69.07755 2.457059 1.920143 1.345739 0.7419912 0.1397640 -0.4480191 -1.013533 -1.544814 -2.050529 -2.543411 -3.006701 -3.466415 -3.920848 -4.328204 -4.586288 -4.365561 -3.528400 -2.381309 -1.138745 -69.07755 1.522929 1.049144 0.5244507 -3.5751425E-02 -0.6022895 -1.157863 -1.690479 -2.196889 -2.677867 -3.146693 -3.596994 -4.040241 -4.477006 -4.901670 -5.230329 -5.190872 -4.438614 -3.229918 -1.885333 -69.07755 0.4649856 6.2302243E-02 -0.4050822 -0.9141427 -1.435544 -1.950940 -2.446604 -2.922380 -3.380219 -3.828576 -4.251694 -4.677701 -5.099375 -5.518824 -5.889428 -6.012805 -5.400759 -4.152008 -2.706733 -69.07755 -0.7563668 -1.076247 -1.475781 -1.920962 -2.390285 -2.855392 -3.315342 -3.757809 -4.181249 -4.605317 -5.011335 -5.412302 -5.821358 -6.228799 -6.618348 -6.866494 -6.432380 -5.164172 -3.618919 -69.07755 -2.223795 -2.442868 -2.755876 -3.122109 -3.524862 -3.936868 -4.347564 -4.754168 -5.150313 -5.548100 -5.932195 -6.315340 -6.709802 -7.111127 -7.509604 -7.854217 -7.596015 -6.316510 -4.670902 -69.07755 -4.103958 -4.201437 -4.405001 -4.679820 -5.007393 -5.358267 -5.712935 -6.075907 -6.438940 -6.813757 -7.179727 -7.550347 -7.935165 -8.357883 -8.781556 -9.193605 -9.040711 -7.723729 -5.974814 -69.07755 -7.014557 -6.970694 -7.042149 -7.204791 -7.437951 -7.713912 -8.004156 -8.322146 -8.645947 -9.011677 -9.382193 -9.755388 -10.15738 -10.59598 -11.03410 -11.42609 -11.17394 -9.734963 -7.878604 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -0.5305336 -1.357123 -1.368409 -1.378976 -1.389022 -1.398269 -1.406482 -1.420982 -1.435144 -1.448907 -1.462343 -1.474784 -1.487181 -1.498935 -1.511758 -1.527709 -1.543059 -1.557098 -1.569480 -1.579153 -1.674184 -1.368994 -1.380544 -1.392027 -1.402496 -1.411752 -1.420439 -1.435323 -1.449782 -1.463771 -1.476786 -1.489384 -1.501566 -1.512832 -1.525150 -1.540582 -1.555067 -1.567822 -1.575597 -1.589697 -1.674184 -1.382342 -1.394573 -1.406310 -1.416694 -1.426244 -1.435429 -1.450564 -1.465130 -1.479223 -1.491978 -1.504427 -1.516121 -1.526819 -1.538688 -1.553523 -1.567087 -1.578566 -1.582459 -1.600197 -1.674184 -1.398330 -1.410569 -1.421985 -1.432516 -1.442380 -1.451942 -1.467157 -1.481749 -1.495157 -1.508043 -1.520242 -1.531472 -1.541369 -1.553073 -1.567114 -1.579717 -1.589939 -1.590522 -1.611251 -1.674184 -1.416082 -1.427630 -1.439042 -1.449673 -1.459847 -1.469498 -1.484586 -1.498531 -1.512006 -1.524707 -1.536387 -1.546991 -1.556388 -1.567468 -1.580682 -1.592233 -1.601266 -1.599215 -1.622189 -1.674184 -1.434356 -1.445822 -1.457211 -1.467949 -1.477986 -1.487518 -1.502408 -1.515832 -1.529017 -1.541224 -1.552265 -1.561918 -1.571187 -1.581312 -1.593432 -1.603779 -1.611829 -1.607796 -1.632235 -1.674184 -1.455013 -1.466223 -1.477586 -1.488150 -1.497909 -1.507141 -1.520823 -1.534320 -1.547020 -1.558650 -1.568593 -1.578007 -1.586604 -1.595836 -1.606717 -1.615302 -1.622717 -1.617363 -1.642498 -1.674184 -1.478220 -1.489117 -1.500139 -1.510376 -1.519240 -1.527738 -1.541276 -1.554164 -1.566195 -1.577053 -1.586305 -1.595265 -1.602633 -1.610724 -1.620478 -1.627527 -1.629758 -1.627929 -1.652964 -1.674184 -1.504449 -1.514810 -1.525411 -1.534509 -1.543037 -1.550979 -1.563769 -1.575842 -1.586954 -1.596454 -1.605571 -1.613613 -1.619977 -1.626560 -1.634619 -1.640603 -1.637190 -1.639767 -1.663882 -1.674184 -1.533941 -1.542931 -1.552543 -1.561253 -1.569259 -1.576452 -1.588333 -1.599340 -1.608888 -1.618147 -1.626300 -1.632848 -1.637816 -1.643164 -1.649207 -1.654346 -1.646707 -1.652603 -1.674924 -1.674184 -1.565799 -1.574148 -1.582834 -1.590682 -1.597565 -1.603764 -1.613811 -1.623770 -1.633038 -1.641217 -1.647544 -1.652720 -1.656313 -1.659303 -1.664192 -1.663871 -1.657727 -1.665636 -1.685194 -1.674184 -1.602753 -1.610081 -1.617509 -1.624243 -1.629754 -1.633836 -1.643160 -1.652089 -1.660017 -1.666260 -1.671141 -1.674679 -1.677306 -1.678499 -1.680856 -1.673410 -1.671565 -1.680266 -1.696007 -1.674184 -1.645617 -1.651432 -1.657023 -1.661240 -1.665081 -1.668575 -1.676495 -1.683016 -1.689316 -1.693813 -1.696956 -1.699043 -1.699687 -1.699785 -1.693293 -1.686846 -1.687802 -1.695861 -1.706725 -1.674184 -1.693786 -1.697639 -1.701361 -1.704650 -1.706582 -1.707308 -1.713120 -1.717694 -1.721549 -1.724277 -1.725142 -1.725264 -1.724544 -1.718658 -1.708566 -1.704157 -1.706092 -1.712083 -1.716780 -1.674184 -1.752771 -1.754401 -1.755361 -1.756071 -1.755425 -1.754165 -1.757497 -1.759611 -1.760568 -1.760484 -1.759556 -1.757771 -1.749483 -1.739609 -1.732827 -1.729566 -1.729812 -1.731955 -1.777019 -1.674184 -1.825016 -1.823706 -1.821989 -1.819649 -1.816908 -1.813947 -1.810154 -1.809581 -1.807981 -1.805934 -1.798738 -1.789128 -1.780144 -1.772829 -1.767184 -1.763405 -1.760248 -1.756212 -1.765224 -1.674184 -1.917956 -1.913358 -1.908670 -1.904013 -1.898321 -1.892900 -1.887124 -1.876234 -1.865250 -1.854343 -1.845855 -1.837692 -1.829906 -1.822346 -1.815336 -1.807648 -1.798761 -1.785955 -1.753005 -1.674184 -2.050664 -2.036827 -2.026088 -2.014889 -2.003691 -1.992658 -1.981519 -1.970280 -1.959090 -1.947750 -1.936294 -1.925578 -1.913314 -1.900969 -1.887474 -1.872111 -1.852807 -1.804316 -1.740362 -1.674184 -2.285412 -2.270320 -2.254919 -2.240245 -2.223840 -2.207053 -2.189838 -2.172560 -2.154038 -2.134829 -2.114521 -2.092717 -2.068779 -2.041861 -1.930142 -1.880890 -1.830654 -1.779454 -1.727296 -1.674184 -2.330092 -2.300994 -2.271259 -2.240891 -2.209898 -2.178286 -2.146305 -2.113229 -2.079792 -2.045757 -2.011137 -1.975939 -1.940167 -1.903828 -1.866927 -1.829471 -1.791454 -1.752897 -1.713805 -1.674184 -1.269198 -1.288753 -1.308035 -1.336785 -1.363442 -1.389421 -1.413616 -1.436657 -1.457745 -1.481618 -1.508021 -1.533414 -1.558276 -1.582153 -1.604677 -1.629844 -1.656849 -1.684170 -1.707334 -2.912270 -1.269044 -1.292201 -1.316608 -1.349304 -1.380345 -1.409442 -1.436124 -1.461054 -1.483305 -1.508629 -1.536023 -1.561753 -1.586628 -1.609763 -1.631153 -1.654957 -1.680358 -1.703932 -1.726438 -2.912270 -1.278677 -1.306158 -1.335477 -1.370652 -1.404248 -1.434932 -1.463877 -1.489873 -1.513384 -1.539830 -1.567524 -1.593702 -1.618043 -1.640283 -1.660573 -1.683244 -1.707033 -1.726945 -1.748572 -2.912270 -1.300318 -1.331130 -1.363381 -1.401037 -1.435277 -1.467815 -1.497627 -1.524317 -1.549084 -1.576067 -1.603996 -1.630356 -1.654108 -1.675512 -1.694713 -1.716283 -1.738825 -1.755227 -1.775817 -2.912270 -1.332560 -1.366121 -1.400471 -1.437798 -1.473467 -1.506528 -1.536584 -1.564278 -1.589660 -1.616761 -1.644885 -1.670947 -1.693910 -1.714497 -1.732608 -1.753480 -1.774857 -1.787997 -1.807437 -2.912270 -1.375429 -1.410214 -1.444093 -1.481989 -1.517361 -1.550469 -1.581234 -1.609358 -1.634856 -1.661894 -1.689969 -1.715173 -1.737773 -1.757537 -1.774759 -1.794996 -1.815150 -1.825480 -1.843676 -2.912270 -1.425332 -1.459812 -1.493530 -1.530432 -1.565073 -1.598241 -1.628882 -1.656987 -1.682349 -1.709390 -1.736401 -1.760824 -1.782854 -1.801832 -1.818619 -1.837802 -1.856729 -1.864564 -1.881205 -2.912270 -1.481988 -1.515200 -1.547824 -1.583186 -1.617068 -1.649405 -1.679473 -1.706849 -1.732431 -1.758809 -1.784549 -1.808111 -1.829243 -1.847341 -1.863785 -1.882421 -1.897432 -1.905210 -1.919850 -2.912270 -1.543878 -1.575345 -1.606247 -1.639979 -1.672362 -1.703245 -1.732330 -1.759382 -1.784030 -1.808694 -1.833545 -1.856015 -1.876138 -1.894181 -1.909715 -1.927371 -1.937877 -1.946284 -1.958305 -2.912270 -1.610496 -1.639704 -1.668527 -1.700007 -1.730036 -1.759415 -1.787800 -1.813532 -1.835917 -1.859279 -1.883048 -1.904342 -1.923303 -1.940783 -1.955702 -1.971519 -1.978021 -1.986440 -1.995176 -2.912270 -1.682735 -1.709402 -1.735417 -1.764463 -1.792993 -1.820603 -1.846567 -1.870222 -1.890965 -1.912886 -1.935343 -1.955089 -1.973928 -1.990399 -2.004176 -2.015291 -2.020504 -2.028258 -2.033110 -2.912270 -1.759776 -1.783606 -1.807959 -1.835399 -1.861431 -1.885863 -1.908831 -1.930722 -1.949623 -1.969882 -1.990592 -2.010594 -2.028278 -2.043422 -2.054614 -2.059883 -2.065447 -2.071475 -2.071599 -2.912270 -1.845096 -1.865620 -1.886544 -1.910686 -1.933481 -1.955752 -1.976581 -1.995636 -2.012411 -2.030711 -2.051056 -2.069985 -2.086336 -2.099068 -2.103392 -2.106665 -2.112180 -2.115007 -2.109100 -2.912270 -1.940655 -1.956025 -1.971321 -1.992040 -2.012647 -2.032998 -2.051334 -2.067326 -2.082774 -2.099100 -2.117576 -2.134339 -2.148315 -2.155205 -2.154872 -2.156901 -2.160136 -2.158511 -2.145231 -2.912270 -2.048311 -2.059408 -2.072226 -2.088487 -2.103526 -2.121026 -2.138896 -2.153837 -2.166471 -2.179396 -2.193992 -2.206588 -2.212995 -2.215207 -2.214961 -2.213899 -2.212223 -2.204435 -2.182146 -2.912270 -2.180760 -2.186943 -2.195623 -2.208478 -2.221506 -2.234816 -2.246753 -2.257456 -2.266525 -2.275332 -2.282540 -2.286657 -2.288873 -2.289441 -2.287503 -2.280164 -2.271965 -2.255047 -2.222234 -2.912270 -2.362197 -2.362196 -2.362699 -2.368646 -2.376136 -2.382800 -2.389294 -2.391520 -2.390621 -2.391561 -2.393955 -2.395800 -2.395051 -2.390539 -2.381475 -2.367082 -2.347000 -2.318392 -2.273306 -2.912270 -2.622932 -2.612756 -2.603464 -2.601088 -2.598948 -2.595905 -2.592781 -2.589503 -2.584397 -2.577680 -2.568763 -2.562536 -2.552974 -2.538794 -2.518939 -2.491505 -2.455588 -2.411062 -2.351688 -2.912270 -3.096193 -3.078784 -3.061449 -3.043603 -3.025857 -3.006633 -2.988370 -2.971234 -2.951433 -2.928780 -2.902648 -2.872519 -2.838091 -2.799781 -2.759345 -2.712045 -2.656152 -2.591372 -2.513522 -2.912270 -4.414452 -4.355619 -4.294259 -4.230421 -4.164152 -4.095498 -4.024528 -3.951532 -3.875814 -3.798166 -3.718400 -3.636562 -3.552920 -3.466809 -3.379006 -3.289306 -3.197729 -3.104343 -3.009180 -2.912270 -1.031641 -1.074865 -1.116094 -1.153494 -1.190613 -1.232629 -1.272020 -1.308211 -1.341237 -1.371968 -1.403162 -1.436596 -1.469668 -1.501781 -1.532425 -1.561787 -1.592444 -1.622342 -1.652090 -4.241012 -0.9931909 -1.046591 -1.096393 -1.141774 -1.188444 -1.237870 -1.283198 -1.324832 -1.362309 -1.396647 -1.430856 -1.467013 -1.500405 -1.531483 -1.560019 -1.586199 -1.612975 -1.637620 -1.661999 -4.241012 -0.9844130 -1.044454 -1.100845 -1.154286 -1.208311 -1.263417 -1.313491 -1.358908 -1.400559 -1.438023 -1.475601 -1.513127 -1.546891 -1.576906 -1.603436 -1.626789 -1.649953 -1.670193 -1.689313 -4.241012 -0.9980465 -1.062303 -1.125103 -1.185365 -1.244509 -1.303374 -1.356945 -1.405695 -1.450229 -1.491148 -1.531552 -1.569605 -1.603390 -1.632567 -1.657056 -1.678065 -1.697869 -1.714390 -1.728414 -4.241012 -1.029371 -1.097861 -1.164999 -1.228946 -1.291783 -1.353079 -1.409348 -1.460834 -1.507578 -1.551315 -1.593031 -1.631667 -1.664702 -1.692949 -1.715458 -1.734424 -1.751244 -1.764226 -1.773371 -4.241012 -1.079697 -1.151173 -1.220005 -1.286260 -1.350566 -1.413629 -1.472334 -1.525944 -1.575364 -1.620477 -1.662577 -1.701114 -1.734113 -1.761002 -1.782229 -1.799457 -1.813782 -1.823804 -1.828422 -4.241012 -1.148301 -1.219635 -1.288999 -1.355869 -1.421278 -1.485452 -1.545048 -1.600677 -1.652000 -1.697797 -1.739878 -1.778440 -1.810758 -1.836883 -1.857298 -1.873123 -1.885795 -1.893733 -1.894244 -4.241012 -1.230731 -1.300033 -1.368944 -1.436075 -1.501233 -1.565029 -1.624998 -1.681105 -1.732522 -1.778817 -1.820716 -1.858631 -1.890098 -1.915373 -1.935316 -1.950071 -1.961297 -1.967853 -1.964501 -4.241012 -1.326057 -1.393030 -1.460552 -1.526331 -1.590070 -1.652600 -1.711705 -1.766474 -1.817073 -1.862974 -1.904583 -1.941474 -1.971716 -1.996874 -2.016733 -2.030646 -2.041476 -2.046116 -2.039196 -4.241012 -1.435368 -1.498655 -1.561905 -1.624442 -1.686587 -1.746576 -1.802789 -1.855325 -1.904339 -1.949194 -1.989084 -2.024284 -2.053963 -2.078883 -2.098201 -2.111648 -2.122823 -2.125273 -2.114675 -4.241012 -1.558184 -1.615374 -1.673226 -1.731292 -1.789213 -1.845915 -1.898400 -1.948011 -1.994610 -2.036683 -2.073798 -2.106996 -2.136507 -2.161571 -2.179974 -2.192939 -2.204274 -2.204165 -2.189873 -4.241012 -1.692853 -1.743364 -1.794711 -1.846683 -1.899196 -1.951188 -2.000697 -2.045880 -2.088066 -2.126556 -2.161148 -2.192946 -2.221815 -2.245760 -2.264429 -2.278621 -2.287960 -2.285278 -2.266619 -4.241012 -1.838057 -1.881708 -1.925360 -1.971886 -2.018786 -2.064430 -2.107996 -2.148376 -2.185123 -2.220074 -2.252868 -2.283416 -2.309502 -2.333536 -2.352507 -2.367035 -2.373148 -2.368102 -2.343621 -4.241012 -1.995162 -2.031955 -2.068800 -2.107984 -2.147237 -2.184749 -2.220989 -2.256194 -2.289382 -2.320942 -2.351446 -2.378624 -2.403358 -2.426514 -2.447148 -2.458036 -2.460186 -2.451662 -2.419989 -4.241012 -2.170180 -2.196953 -2.223231 -2.253255 -2.283871 -2.315924 -2.346261 -2.376415 -2.406285 -2.433813 -2.460197 -2.484934 -2.508084 -2.531370 -2.547748 -2.552968 -2.551651 -2.536556 -2.495394 -4.241012 -2.357831 -2.376035 -2.395664 -2.416856 -2.442333 -2.469720 -2.495473 -2.519816 -2.542909 -2.565449 -2.589161 -2.612637 -2.632076 -2.646954 -2.655829 -2.655484 -2.647730 -2.622741 -2.568140 -4.241012 -2.593735 -2.603249 -2.615582 -2.630461 -2.647686 -2.666023 -2.684623 -2.705972 -2.726058 -2.742923 -2.758292 -2.772166 -2.780687 -2.787100 -2.789809 -2.781181 -2.759889 -2.719920 -2.648328 -4.241012 -2.935741 -2.933186 -2.935277 -2.940023 -2.948616 -2.957938 -2.966865 -2.976137 -2.982665 -2.990644 -2.994137 -2.997211 -2.996204 -2.991113 -2.979061 -2.954711 -2.912333 -2.849600 -2.757249 -4.241012 -3.563632 -3.543196 -3.528255 -3.515270 -3.502843 -3.491212 -3.482363 -3.473014 -3.463553 -3.451410 -3.436508 -3.414626 -3.389262 -3.356670 -3.312056 -3.252976 -3.175667 -3.080157 -2.962902 -4.241012 -6.744454 -6.655498 -6.560423 -6.460120 -6.354529 -6.243833 -6.128168 -6.007740 -5.882678 -5.753149 -5.619308 -5.481262 -5.339182 -5.193169 -5.043353 -4.889854 -4.732759 -4.572197 -4.408491 -4.241012 -0.7268364 -0.7928897 -0.8578465 -0.9193783 -0.9755628 -1.032329 -1.090421 -1.142687 -1.188725 -1.230710 -1.268039 -1.304524 -1.338457 -1.370873 -1.404439 -1.435665 -1.465693 -1.494130 -1.522019 -5.652469 -0.6327222 -0.7169074 -0.7970566 -0.8730017 -0.9435462 -1.013395 -1.081745 -1.142268 -1.195737 -1.242197 -1.281869 -1.319434 -1.353285 -1.384747 -1.414195 -1.439057 -1.461292 -1.480187 -1.497509 -5.652469 -0.5949773 -0.6918067 -0.7849206 -0.8727723 -0.9557375 -1.037312 -1.112722 -1.179368 -1.238341 -1.288406 -1.331184 -1.370194 -1.403589 -1.434335 -1.459943 -1.479190 -1.494272 -1.504495 -1.512156 -5.652469 -0.5986240 -0.7042973 -0.8069301 -0.9058020 -0.9997157 -1.087780 -1.169025 -1.241616 -1.303842 -1.356821 -1.402412 -1.443123 -1.477599 -1.507431 -1.529578 -1.543956 -1.552611 -1.554978 -1.553667 -5.652469 -0.6348189 -0.7468507 -0.8567294 -0.9638781 -1.063202 -1.155635 -1.242798 -1.318315 -1.383492 -1.439292 -1.487934 -1.529816 -1.566159 -1.594914 -1.614038 -1.624047 -1.627112 -1.622298 -1.612630 -5.652469 -0.6991166 -0.8158281 -0.9307377 -1.040398 -1.142336 -1.239127 -1.327664 -1.406224 -1.473877 -1.532812 -1.583385 -1.628098 -1.665805 -1.693165 -1.709849 -1.716448 -1.714787 -1.703569 -1.686220 -5.652469 -0.7907250 -0.9082715 -1.023813 -1.134252 -1.237991 -1.334688 -1.424718 -1.504794 -1.575289 -1.637559 -1.690557 -1.738629 -1.777213 -1.803685 -1.819126 -1.823433 -1.818069 -1.802127 -1.777707 -5.652469 -0.9054125 -1.018947 -1.132588 -1.243580 -1.345510 -1.440958 -1.530211 -1.612006 -1.685612 -1.749586 -1.807509 -1.857697 -1.896257 -1.922978 -1.937957 -1.941303 -1.933430 -1.915094 -1.884108 -5.652469 -1.037527 -1.146437 -1.255172 -1.361725 -1.461871 -1.554867 -1.642293 -1.724531 -1.798666 -1.866745 -1.926897 -1.977817 -2.016343 -2.043124 -2.058292 -2.061224 -2.051816 -2.032282 -1.995610 -5.652469 -1.188642 -1.288473 -1.390070 -1.490850 -1.587064 -1.678376 -1.763222 -1.842533 -1.918547 -1.988544 -2.049149 -2.099691 -2.138525 -2.165370 -2.181573 -2.185245 -2.175539 -2.155807 -2.114363 -5.652469 -1.353931 -1.445046 -1.537401 -1.631408 -1.722400 -1.809352 -1.891756 -1.968655 -2.043071 -2.111607 -2.170826 -2.220794 -2.259662 -2.286937 -2.303645 -2.308101 -2.299841 -2.280557 -2.234823 -5.652469 -1.534739 -1.616055 -1.698664 -1.784225 -1.867442 -1.948943 -2.028962 -2.102895 -2.171176 -2.234846 -2.291725 -2.340250 -2.379102 -2.407195 -2.424152 -2.429174 -2.425534 -2.404313 -2.354459 -5.652469 -1.732300 -1.802139 -1.874487 -1.950127 -2.026989 -2.101451 -2.175029 -2.242684 -2.303981 -2.361331 -2.414068 -2.461233 -2.501019 -2.529283 -2.546007 -2.552937 -2.554122 -2.530681 -2.477056 -5.652469 -1.946616 -2.005379 -2.069384 -2.135368 -2.201320 -2.265061 -2.328197 -2.388164 -2.441604 -2.491886 -2.541325 -2.586762 -2.624768 -2.653444 -2.671066 -2.683516 -2.683662 -2.657627 -2.599495 -5.652469 -2.188968 -2.233403 -2.283656 -2.336051 -2.388558 -2.439982 -2.491418 -2.541018 -2.588702 -2.634693 -2.678305 -2.719042 -2.753690 -2.782720 -2.805623 -2.817882 -2.813036 -2.785289 -2.718684 -5.652469 -2.454726 -2.482836 -2.516818 -2.554396 -2.591592 -2.633668 -2.676888 -2.719607 -2.757665 -2.795297 -2.833025 -2.868561 -2.899677 -2.932951 -2.955346 -2.960157 -2.947591 -2.913973 -2.836082 -5.652469 -2.749083 -2.765982 -2.792110 -2.818989 -2.844771 -2.874462 -2.905473 -2.938151 -2.965978 -2.996099 -3.026940 -3.062584 -3.092023 -3.112211 -3.123562 -3.120409 -3.100163 -3.050965 -2.953724 -5.652469 -3.165281 -3.161726 -3.168446 -3.184113 -3.199210 -3.214148 -3.235750 -3.259059 -3.280276 -3.296929 -3.316362 -3.333767 -3.346207 -3.353400 -3.352961 -3.335640 -3.294782 -3.219117 -3.092476 -5.652469 -3.907288 -3.880873 -3.863259 -3.852156 -3.843811 -3.839977 -3.839396 -3.840880 -3.841009 -3.838990 -3.837429 -3.831668 -3.822143 -3.802165 -3.768141 -3.712731 -3.625362 -3.501583 -3.336663 -5.652469 -9.286039 -9.165846 -9.035739 -8.896114 -8.747401 -8.589987 -8.424263 -8.250593 -8.069317 -7.880767 -7.685230 -7.483010 -7.274344 -7.059507 -6.838700 -6.612168 -6.380087 -6.142666 -5.900068 -5.652469 -0.4246037 -0.4991536 -0.5822446 -0.6637400 -0.7433273 -0.8188981 -0.8947713 -0.9646239 -1.028877 -1.086987 -1.136588 -1.180734 -1.218902 -1.252069 -1.282429 -1.313251 -1.342241 -1.368794 -1.393224 -7.138974 -0.2606948 -0.3629655 -0.4688333 -0.5722972 -0.6719686 -0.7648365 -0.8551874 -0.9382421 -1.012446 -1.075707 -1.128223 -1.172398 -1.207852 -1.235903 -1.258746 -1.280114 -1.296476 -1.308279 -1.316390 -7.138974 -0.1803904 -0.3055610 -0.4322508 -0.5549111 -0.6707893 -0.7785846 -0.8818788 -0.9752858 -1.056656 -1.123990 -1.179690 -1.223205 -1.256322 -1.280009 -1.296805 -1.308638 -1.313429 -1.311652 -1.304690 -7.138974 -0.1627154 -0.3060051 -0.4488641 -0.5860023 -0.7149937 -0.8372087 -0.9515907 -1.052441 -1.137980 -1.209895 -1.267691 -1.311881 -1.343121 -1.363204 -1.375790 -1.378975 -1.373248 -1.358924 -1.337839 -7.138974 -0.1956184 -0.3516597 -0.5062383 -0.6531900 -0.7929037 -0.9260860 -1.048931 -1.154578 -1.244594 -1.320667 -1.380332 -1.425290 -1.456256 -1.474193 -1.483323 -1.479387 -1.464180 -1.438300 -1.404085 -7.138974 -0.2711419 -0.4330501 -0.5944219 -0.7502548 -0.8977406 -1.036646 -1.162172 -1.271762 -1.367413 -1.445867 -1.507677 -1.554157 -1.585664 -1.604358 -1.609744 -1.600001 -1.576634 -1.540333 -1.493952 -7.138974 -0.3829829 -0.5462207 -0.7114951 -0.8722357 -1.023454 -1.161909 -1.288672 -1.402180 -1.500016 -1.582309 -1.647374 -1.696232 -1.729296 -1.749943 -1.753048 -1.739236 -1.709416 -1.664239 -1.606952 -7.138974 -0.5264114 -0.6885802 -0.8531544 -1.012646 -1.160708 -1.298096 -1.425311 -1.538745 -1.638669 -1.723949 -1.792930 -1.845006 -1.882912 -1.904663 -1.906868 -1.890464 -1.856022 -1.803804 -1.736839 -7.138974 -0.7000158 -0.8563754 -1.012931 -1.164729 -1.309336 -1.446224 -1.568479 -1.680888 -1.782751 -1.870429 -1.943758 -2.001848 -2.044418 -2.067406 -2.070902 -2.054044 -2.017339 -1.960340 -1.885566 -7.138974 -0.8959353 -1.040287 -1.185224 -1.330777 -1.469542 -1.599590 -1.718782 -1.828030 -1.929685 -2.020921 -2.098016 -2.163204 -2.209464 -2.234512 -2.240638 -2.225457 -2.189108 -2.130997 -2.049567 -7.138974 -1.106608 -1.240517 -1.375198 -1.507187 -1.636515 -1.760405 -1.875110 -1.979538 -2.079682 -2.172361 -2.254584 -2.321778 -2.370663 -2.399232 -2.407877 -2.396129 -2.361999 -2.306082 -2.219194 -7.138974 -1.338778 -1.455690 -1.577413 -1.696016 -1.814951 -1.929420 -2.038635 -2.139264 -2.235758 -2.327998 -2.409829 -2.476762 -2.528178 -2.559949 -2.571295 -2.563549 -2.533671 -2.482089 -2.391308 -7.138974 -1.586848 -1.687705 -1.796342 -1.901140 -2.006028 -2.111006 -2.213723 -2.310091 -2.400375 -2.485700 -2.563487 -2.630229 -2.682287 -2.716913 -2.731396 -2.727487 -2.704188 -2.657992 -2.564211 -7.138974 -1.856974 -1.939106 -2.032443 -2.126195 -2.217378 -2.309950 -2.402345 -2.489697 -2.570734 -2.647265 -2.719206 -2.782943 -2.835407 -2.871623 -2.889072 -2.888524 -2.877132 -2.831006 -2.734544 -7.138974 -2.154526 -2.218894 -2.296205 -2.374830 -2.450346 -2.526260 -2.602346 -2.678083 -2.751011 -2.818336 -2.882743 -2.941742 -2.992691 -3.030261 -3.049335 -3.057073 -3.051686 -3.004648 -2.905667 -7.138974 -2.488953 -2.531691 -2.587266 -2.646582 -2.704296 -2.764633 -2.824162 -2.885232 -2.948621 -3.008317 -3.062813 -3.114832 -3.161273 -3.198577 -3.225324 -3.238106 -3.226479 -3.179509 -3.070464 -7.138974 -2.861539 -2.884760 -2.920940 -2.960521 -3.003179 -3.046623 -3.091400 -3.136144 -3.185544 -3.235944 -3.280664 -3.322143 -3.365674 -3.409966 -3.435741 -3.436895 -3.416445 -3.361354 -3.235430 -7.138974 -3.346658 -3.345218 -3.361043 -3.384397 -3.406913 -3.431991 -3.456506 -3.484563 -3.517938 -3.558567 -3.598330 -3.631705 -3.663194 -3.687259 -3.697705 -3.691991 -3.652469 -3.572632 -3.412156 -7.138974 -4.185396 -4.152966 -4.135837 -4.125290 -4.123912 -4.128395 -4.130587 -4.131902 -4.139142 -4.152296 -4.168784 -4.182327 -4.188603 -4.188097 -4.174949 -4.133027 -4.047538 -3.902867 -3.688854 -7.138974 -12.01246 -11.86065 -11.69350 -11.51184 -11.31640 -11.10799 -10.88731 -10.65499 -10.41165 -10.15786 -9.894099 -9.620863 -9.338585 -9.047643 -8.748418 -8.441248 -8.126436 -7.804278 -7.475043 -7.138974 -0.1268308 -0.2082641 -0.3066566 -0.4028152 -0.5004491 -0.5963078 -0.6896553 -0.7800560 -0.8630554 -0.9360812 -1.001125 -1.056402 -1.101871 -1.139375 -1.170774 -1.197854 -1.225403 -1.250005 -1.271461 -8.693932 0.1045474 -1.2765177E-02 -0.1380701 -0.2629435 -0.3867472 -0.5051156 -0.6195028 -0.7273518 -0.8216181 -0.9036834 -0.9724164 -1.025621 -1.066120 -1.094534 -1.114168 -1.127292 -1.137332 -1.141762 -1.141010 -8.693932 0.2301208 8.1644401E-02 -7.2362475E-02 -0.2229597 -0.3694002 -0.5091525 -0.6411387 -0.7604785 -0.8655267 -0.9556580 -1.026807 -1.078215 -1.113718 -1.133772 -1.142247 -1.142497 -1.136013 -1.121610 -1.100185 -8.693932 0.2757999 0.1003296 -7.6140188E-02 -0.2471620 -0.4135969 -0.5724273 -0.7178150 -0.8476882 -0.9624929 -1.058453 -1.130699 -1.182190 -1.212984 -1.226479 -1.225084 -1.213867 -1.191964 -1.159760 -1.118695 -8.693932 0.2546926 6.0722452E-02 -0.1343147 -0.3210954 -0.5016555 -0.6732149 -0.8297544 -0.9720488 -1.095579 -1.194028 -1.268752 -1.320088 -1.348190 -1.356785 -1.347669 -1.326620 -1.290692 -1.241757 -1.182039 -8.693932 0.1760712 -2.8152866E-02 -0.2346180 -0.4340298 -0.6226539 -0.8007696 -0.9677175 -1.119585 -1.249009 -1.351631 -1.429243 -1.480453 -1.507780 -1.513303 -1.499816 -1.469687 -1.421497 -1.357117 -1.279771 -8.693932 4.9453270E-02 -0.1594637 -0.3711213 -0.5743498 -0.7689033 -0.9525449 -1.125177 -1.281263 -1.413255 -1.522435 -1.603429 -1.656127 -1.684638 -1.688674 -1.674251 -1.637321 -1.578749 -1.500762 -1.407060 -8.693932 -0.1185863 -0.3272762 -0.5355058 -0.7395265 -0.9376699 -1.124575 -1.295440 -1.449984 -1.587023 -1.699970 -1.785779 -1.844232 -1.874931 -1.882103 -1.868196 -1.827258 -1.761024 -1.671868 -1.563626 -8.693932 -0.3207045 -0.5231069 -0.7273007 -0.9286164 -1.124051 -1.306799 -1.471706 -1.626311 -1.763626 -1.878866 -1.971097 -2.036475 -2.072418 -2.087058 -2.074890 -2.033479 -1.963001 -1.865644 -1.745168 -8.693932 -0.5544949 -0.7472932 -0.9437996 -1.135181 -1.318569 -1.493624 -1.655650 -1.804079 -1.938865 -2.056153 -2.153022 -2.224731 -2.271893 -2.292064 -2.283387 -2.244213 -2.172758 -2.070219 -1.939928 -8.693932 -0.8177744 -0.9956762 -1.176638 -1.351439 -1.524832 -1.689481 -1.841784 -1.984872 -2.116835 -2.234073 -2.332956 -2.413167 -2.470903 -2.497613 -2.494788 -2.460382 -2.392524 -2.289203 -2.152233 -8.693932 -1.101828 -1.258986 -1.424329 -1.584366 -1.740609 -1.890415 -2.033579 -2.172134 -2.298849 -2.413008 -2.514815 -2.601934 -2.665679 -2.701359 -2.705692 -2.679389 -2.619108 -2.522158 -2.380570 -8.693932 -1.407449 -1.543036 -1.687900 -1.828948 -1.967602 -2.104710 -2.237129 -2.365081 -2.485778 -2.596991 -2.697742 -2.783750 -2.850658 -2.893434 -2.904870 -2.886796 -2.836172 -2.750118 -2.606098 -8.693932 -1.734062 -1.845093 -1.970739 -2.096058 -2.216650 -2.336996 -2.454601 -2.571124 -2.684939 -2.789063 -2.881994 -2.964900 -3.032110 -3.078931 -3.099689 -3.089396 -3.050735 -2.978757 -2.834600 -8.693932 -2.094546 -2.181169 -2.284119 -2.388731 -2.490122 -2.591439 -2.692967 -2.794705 -2.894293 -2.988087 -3.072513 -3.148489 -3.212564 -3.261613 -3.289176 -3.285934 -3.266551 -3.200315 -3.056064 -8.693932 -2.497803 -2.555462 -2.631982 -2.712920 -2.793636 -2.872384 -2.953243 -3.037478 -3.121820 -3.203964 -3.278145 -3.345453 -3.404003 -3.452550 -3.484413 -3.497823 -3.486310 -3.421351 -3.276832 -8.693932 -2.951184 -2.979706 -3.026172 -3.080726 -3.137562 -3.194857 -3.256256 -3.320237 -3.388000 -3.456151 -3.517737 -3.575291 -3.625032 -3.672886 -3.719777 -3.737590 -3.714962 -3.652450 -3.493458 -8.693932 -3.509112 -3.508330 -3.526946 -3.553371 -3.585424 -3.618521 -3.657044 -3.699648 -3.745151 -3.794696 -3.847629 -3.900546 -3.949180 -3.992380 -4.024282 -4.026453 -3.996455 -3.913363 -3.720756 -8.693932 -4.421904 -4.388633 -4.369308 -4.362362 -4.363797 -4.366908 -4.373525 -4.390285 -4.411442 -4.435054 -4.461919 -4.490376 -4.518024 -4.537582 -4.548463 -4.532744 -4.457627 -4.305599 -4.043972 -8.693932 -14.90287 -14.71884 -14.51295 -14.28659 -14.04110 -13.77773 -13.49760 -13.20177 -12.89118 -12.56667 -12.22900 -11.87887 -11.51690 -11.14367 -10.75970 -10.36546 -9.961380 -9.547857 -9.125261 -8.693932 0.1760808 8.5420951E-02 -2.2711538E-02 -0.1376171 -0.2544589 -0.3654154 -0.4747284 -0.5825413 -0.6831500 -0.7750247 -0.8531916 -0.9196463 -0.9752898 -1.018249 -1.052307 -1.079224 -1.103047 -1.125447 -1.144300 -10.31178 0.4745643 0.3417100 0.1944945 4.5913950E-02 -9.8320901E-02 -0.2377935 -0.3737579 -0.5032839 -0.6203678 -0.7211751 -0.8020095 -0.8669289 -0.9139558 -0.9448187 -0.9619919 -0.9692436 -0.9709096 -0.9675101 -0.9582979 -10.31178 0.6471918 0.4691529 0.2864117 0.1095921 -6.3208587E-02 -0.2285904 -0.3861001 -0.5327699 -0.6631045 -0.7698097 -0.8546351 -0.9169048 -0.9550632 -0.9733554 -0.9743367 -0.9624448 -0.9428723 -0.9149582 -0.8791826 -10.31178 0.7147380 0.5025933 0.2939604 9.2936203E-02 -0.1058336 -0.2955231 -0.4737270 -0.6365957 -0.7760965 -0.8906114 -0.9802476 -1.040495 -1.072909 -1.080824 -1.067696 -1.038424 -0.9989977 -0.9478911 -0.8867396 -10.31178 0.7007675 0.4689358 0.2382791 1.6067429E-02 -0.2002250 -0.4089926 -0.6063098 -0.7838085 -0.9334005 -1.056800 -1.150569 -1.209728 -1.238840 -1.238613 -1.213983 -1.170259 -1.111980 -1.038828 -0.9532965 -10.31178 0.6221918 0.3774493 0.1323688 -0.1048641 -0.3348387 -0.5565467 -0.7665339 -0.9531157 -1.116656 -1.250378 -1.345737 -1.406418 -1.433494 -1.427906 -1.394271 -1.338756 -1.263465 -1.169579 -1.060711 -10.31178 0.4864193 0.2359684 -1.5320597E-02 -0.2614271 -0.5027867 -0.7300431 -0.9426712 -1.140486 -1.314268 -1.454377 -1.555668 -1.618495 -1.644338 -1.636889 -1.596825 -1.532767 -1.442524 -1.329550 -1.198426 -10.31178 0.3026845 5.0381374E-02 -0.2020688 -0.4514397 -0.6938022 -0.9221839 -1.139595 -1.342983 -1.520810 -1.665202 -1.775017 -1.842827 -1.871483 -1.864816 -1.824824 -1.754600 -1.652705 -1.523124 -1.371519 -10.31178 7.4242063E-02 -0.1738892 -0.4241320 -0.6654380 -0.9032689 -1.133351 -1.352263 -1.552756 -1.728577 -1.878958 -1.993540 -2.069057 -2.106238 -2.103754 -2.070009 -1.997474 -1.887931 -1.745262 -1.575568 -10.31178 -0.1957886 -0.4308880 -0.6708631 -0.9043029 -1.135020 -1.358874 -1.569556 -1.764464 -1.939389 -2.088290 -2.207020 -2.292259 -2.339310 -2.349766 -2.323998 -2.254259 -2.141934 -1.990605 -1.806045 -10.31178 -0.4976309 -0.7165815 -0.9452882 -1.167151 -1.383987 -1.590731 -1.791162 -1.980054 -2.146675 -2.292718 -2.415567 -2.506706 -2.566338 -2.594520 -2.578526 -2.517143 -2.407564 -2.252868 -2.057510 -10.31178 -0.8340831 -1.033411 -1.242308 -1.445119 -1.642851 -1.834107 -2.018103 -2.193354 -2.352883 -2.495644 -2.616660 -2.713294 -2.788180 -2.828955 -2.825511 -2.775422 -2.674750 -2.522620 -2.320932 -10.31178 -1.200366 -1.372902 -1.557858 -1.740334 -1.915833 -2.085549 -2.251009 -2.413689 -2.564806 -2.698241 -2.819026 -2.923815 -3.004142 -3.055848 -3.068126 -3.033237 -2.948360 -2.808660 -2.605347 -10.31178 -1.597497 -1.738443 -1.894216 -2.049381 -2.201460 -2.351306 -2.500157 -2.644092 -2.782063 -2.910177 -3.027917 -3.129822 -3.210763 -3.269629 -3.293976 -3.275681 -3.209183 -3.089723 -2.887670 -10.31178 -2.021714 -2.128363 -2.255208 -2.385801 -2.514167 -2.639600 -2.766763 -2.894811 -3.019732 -3.136469 -3.242033 -3.337832 -3.417145 -3.476201 -3.512158 -3.508747 -3.462834 -3.367350 -3.169619 -10.31178 -2.489996 -2.562030 -2.655542 -2.755883 -2.858601 -2.960086 -3.064494 -3.171407 -3.277124 -3.378160 -3.471554 -3.556687 -3.630316 -3.688892 -3.730024 -3.740468 -3.724943 -3.638868 -3.445727 -10.31178 -3.014800 -3.052586 -3.110145 -3.176632 -3.249217 -3.323298 -3.401443 -3.486168 -3.572446 -3.655708 -3.734160 -3.805971 -3.872651 -3.928113 -3.972759 -4.009387 -3.996585 -3.915776 -3.718425 -10.31178 -3.639859 -3.644070 -3.668438 -3.701375 -3.741616 -3.786617 -3.837288 -3.894462 -3.956090 -4.020331 -4.081392 -4.141248 -4.205716 -4.267528 -4.314283 -4.336711 -4.315094 -4.226347 -4.000492 -10.31178 -4.629031 -4.589676 -4.570338 -4.565595 -4.566898 -4.574619 -4.591757 -4.617236 -4.648313 -4.687569 -4.729100 -4.766909 -4.804938 -4.850605 -4.881063 -4.886233 -4.833223 -4.680051 -4.370383 -10.31178 -17.94079 -17.72392 -17.47762 -17.20407 -16.90534 -16.58332 -16.23969 -15.87595 -15.49345 -15.09336 -14.67675 -14.24455 -13.79762 -13.33670 -12.86248 -12.37559 -11.87658 -11.36596 -10.84422 -10.31178 0.4782652 0.3769971 0.2619913 0.1344655 2.4179765E-03 -0.1296186 -0.2583147 -0.3809050 -0.4975825 -0.6043332 -0.6980746 -0.7767631 -0.8406277 -0.8910699 -0.9284644 -0.9562602 -0.9777583 -0.9977362 -1.014199 -11.98777 0.8452519 0.6931678 0.5301325 0.3624739 0.1939534 2.9790916E-02 -0.1258469 -0.2743163 -0.4094635 -0.5263880 -0.6239398 -0.6975064 -0.7512063 -0.7840923 -0.7999294 -0.8022804 -0.7956986 -0.7841945 -0.7666993 -11.98777 1.060809 0.8542337 0.6468897 0.4395175 0.2365806 4.6543170E-02 -0.1346964 -0.3043664 -0.4545200 -0.5818370 -0.6804053 -0.7502362 -0.7935215 -0.8091366 -0.8037107 -0.7814831 -0.7478952 -0.7062967 -0.6564557 -11.98777 1.152086 0.9058441 0.6608543 0.4237109 0.1946329 -2.4206454E-02 -0.2320520 -0.4208378 -0.5855880 -0.7227817 -0.8244756 -0.8944542 -0.9292657 -0.9314100 -0.9069241 -0.8621767 -0.8030502 -0.7326373 -0.6515937 -11.98777 1.147767 0.8743284 0.6038004 0.3459442 9.6619129E-02 -0.1472475 -0.3774080 -0.5865812 -0.7684531 -0.9119800 -1.020289 -1.091983 -1.120627 -1.112332 -1.071471 -1.006144 -0.9232996 -0.8250394 -0.7136468 -11.98777 1.064944 0.7766843 0.4944483 0.2195362 -4.8746228E-02 -0.3073652 -0.5552935 -0.7826235 -0.9779060 -1.135287 -1.252113 -1.324513 -1.352116 -1.336199 -1.282737 -1.199477 -1.095191 -0.9705091 -0.8296911 -11.98777 0.9194540 0.6265382 0.3365704 5.1257204E-02 -0.2290760 -0.4991731 -0.7587234 -0.9955685 -1.202420 -1.374722 -1.502798 -1.578335 -1.607700 -1.588138 -1.526748 -1.430230 -1.306332 -1.157103 -0.9880013 -11.98777 0.7212144 0.4260081 0.1345131 -0.1532369 -0.4388421 -0.7166214 -0.9790410 -1.219851 -1.437162 -1.619848 -1.753951 -1.840789 -1.873891 -1.855891 -1.790214 -1.685850 -1.545581 -1.374137 -1.178324 -11.98777 0.4703853 0.1822211 -0.1086233 -0.3933291 -0.6763187 -0.9495896 -1.213227 -1.457676 -1.678090 -1.862144 -2.005290 -2.101378 -2.143977 -2.133389 -2.070237 -1.963707 -1.811648 -1.621249 -1.400924 -11.98777 0.1729670 -0.1044720 -0.3884270 -0.6644853 -0.9348869 -1.201430 -1.461509 -1.703438 -1.916530 -2.102528 -2.250943 -2.354452 -2.412456 -2.413089 -2.363467 -2.259581 -2.102081 -1.897642 -1.656080 -11.98777 -0.1701096 -0.4300827 -0.6977325 -0.9602931 -1.218545 -1.472413 -1.718574 -1.947431 -2.154876 -2.337162 -2.485558 -2.598600 -2.669936 -2.690573 -2.659342 -2.565729 -2.410115 -2.198443 -1.940257 -11.98777 -0.5537742 -0.7895553 -1.037580 -1.282982 -1.521570 -1.753209 -1.979889 -2.195746 -2.391079 -2.563802 -2.713064 -2.830554 -2.913258 -2.960832 -2.948223 -2.872831 -2.727724 -2.517115 -2.248309 -11.98777 -0.9769135 -1.183845 -1.403718 -1.622930 -1.836855 -2.045914 -2.250204 -2.445092 -2.626138 -2.791419 -2.933691 -3.051544 -3.150517 -3.213581 -3.221725 -3.166802 -3.040971 -2.840052 -2.567430 -11.98777 -1.433119 -1.604848 -1.792796 -1.983050 -2.169038 -2.349611 -2.529043 -2.705018 -2.871041 -3.021914 -3.158750 -3.280093 -3.381179 -3.455669 -3.485831 -3.454207 -3.356768 -3.180487 -2.911117 -11.98777 -1.925514 -2.056782 -2.207641 -2.362682 -2.520245 -2.674974 -2.830017 -2.981217 -3.128357 -3.269657 -3.397995 -3.509682 -3.606875 -3.686152 -3.729760 -3.721232 -3.653414 -3.510850 -3.248825 -11.98777 -2.456175 -2.547321 -2.661163 -2.781806 -2.906261 -3.031223 -3.159237 -3.288701 -3.415711 -3.537689 -3.651731 -3.753489 -3.841063 -3.916957 -3.971019 -3.981873 -3.948030 -3.835687 -3.583248 -11.98777 -3.051069 -3.099574 -3.170176 -3.252679 -3.342956 -3.436999 -3.534909 -3.636598 -3.740487 -3.842220 -3.939194 -4.027159 -4.103935 -4.173569 -4.231677 -4.267941 -4.260957 -4.159042 -3.915155 -11.98777 -3.751434 -3.756906 -3.784609 -3.825907 -3.878123 -3.940052 -4.006819 -4.078900 -4.155087 -4.229837 -4.307882 -4.382649 -4.448493 -4.521150 -4.590224 -4.633039 -4.611413 -4.518846 -4.251589 -11.98777 -4.816897 -4.772035 -4.749769 -4.743059 -4.745404 -4.763025 -4.794101 -4.831637 -4.874845 -4.922501 -4.975489 -5.035512 -5.087840 -5.135239 -5.191810 -5.218181 -5.182321 -5.031341 -4.672960 -11.98777 -21.11281 -20.86250 -20.57441 -20.25103 -19.89608 -19.51200 -19.10111 -18.66547 -18.20685 -17.72684 -17.22679 -16.70792 -16.17131 -15.61792 -15.04859 -14.46411 -13.86518 -13.25243 -12.62645 -11.98777 0.7686042 0.6611791 0.5401886 0.4033893 0.2584935 0.1104534 -3.7247170E-02 -0.1817163 -0.3144482 -0.4358753 -0.5446244 -0.6365719 -0.7103655 -0.7676237 -0.8096215 -0.8392113 -0.8601709 -0.8774894 -0.8918908 -13.71782 1.207867 1.038874 0.8615462 0.6756318 0.4878512 0.3013682 0.1197351 -4.9642429E-02 -0.2002871 -0.3343780 -0.4456932 -0.5316831 -0.5900242 -0.6259341 -0.6400979 -0.6381881 -0.6247867 -0.6049931 -0.5794597 -13.71782 1.470523 1.235369 1.002706 0.7682424 0.5393296 0.3180878 0.1096251 -7.8991190E-02 -0.2485783 -0.3932944 -0.5067864 -0.5857871 -0.6305245 -0.6451550 -0.6325515 -0.6000596 -0.5534673 -0.4980748 -0.4343294 -13.71782 1.586960 1.303356 1.025234 0.7560818 0.4915515 0.2377863 4.4377181E-03 -0.2090160 -0.3956329 -0.5511289 -0.6716076 -0.7477013 -0.7836375 -0.7801421 -0.7443328 -0.6834970 -0.6052508 -0.5153093 -0.4144316 -13.71782 1.590788 1.276082 0.9696192 0.6704967 0.3826159 0.1067061 -0.1542374 -0.3933159 -0.6002906 -0.7686872 -0.8944435 -0.9743305 -1.005252 -0.9872641 -0.9308953 -0.8441402 -0.7360449 -0.6123996 -0.4751229 -13.71782 1.506535 1.175362 0.8506862 0.5334860 0.2300091 -6.5599889E-02 -0.3480834 -0.6076021 -0.8349617 -1.020787 -1.156069 -1.243100 -1.272105 -1.245739 -1.172054 -1.062611 -0.9270033 -0.7710014 -0.5981137 -13.71782 1.351318 1.011525 0.6800231 0.3581041 3.9196033E-02 -0.2723509 -0.5677592 -0.8415840 -1.085663 -1.283713 -1.437629 -1.534958 -1.565587 -1.535839 -1.450538 -1.321721 -1.161803 -0.9751323 -0.7676387 -13.71782 1.133711 0.7963611 0.4658145 0.1387079 -0.1855680 -0.5049093 -0.8094276 -1.091460 -1.342170 -1.556853 -1.726211 -1.834797 -1.876082 -1.848213 -1.758309 -1.616283 -1.435723 -1.221052 -0.9804084 -13.71782 0.8628025 0.5338077 0.2037837 -0.1204348 -0.4425314 -0.7610015 -1.067873 -1.347925 -1.606641 -1.832114 -2.009069 -2.132165 -2.188010 -2.169081 -2.082105 -1.935741 -1.739203 -1.500031 -1.228422 -13.71782 0.5372730 0.2214312 -0.1003069 -0.4166757 -0.7299463 -1.038078 -1.335795 -1.617134 -1.875709 -2.099915 -2.281919 -2.416753 -2.488095 -2.486413 -2.409174 -2.268352 -2.062537 -1.803533 -1.503890 -13.71782 0.1586308 -0.1372157 -0.4426184 -0.7453925 -1.040362 -1.334421 -1.622664 -1.895751 -2.142775 -2.361526 -2.545276 -2.685673 -2.775779 -2.795560 -2.742734 -2.614100 -2.408750 -2.137308 -1.814307 -13.71782 -0.2668995 -0.5372499 -0.8177267 -1.100159 -1.378453 -1.654082 -1.922569 -2.174430 -2.409908 -2.618923 -2.795397 -2.940380 -3.044209 -3.090427 -3.068545 -2.961810 -2.767813 -2.494274 -2.154572 -13.71782 -0.7349159 -0.9745802 -1.228691 -1.485987 -1.738832 -1.986163 -2.228847 -2.460425 -2.676301 -2.870247 -3.040688 -3.182549 -3.294653 -3.371161 -3.377631 -3.301291 -3.130099 -2.866917 -2.519367 -13.71782 -1.248151 -1.451292 -1.669663 -1.893190 -2.115443 -2.333603 -2.546713 -2.750571 -2.946299 -3.127515 -3.283454 -3.421359 -3.543561 -3.633473 -3.667352 -3.621488 -3.485417 -3.246062 -2.901854 -13.71782 -1.802199 -1.961768 -2.140310 -2.324678 -2.511157 -2.695829 -2.880751 -3.059755 -3.230322 -3.392147 -3.541600 -3.673954 -3.789062 -3.885931 -3.938962 -3.925345 -3.830839 -3.634510 -3.301631 -13.71782 -2.401828 -2.511936 -2.645016 -2.789059 -2.938926 -3.091643 -3.244061 -3.394042 -3.543035 -3.688280 -3.820408 -3.938344 -4.043865 -4.135466 -4.200425 -4.213057 -4.158324 -4.012559 -3.697310 -13.71782 -3.065291 -3.127692 -3.211446 -3.309426 -3.418169 -3.536427 -3.658226 -3.777124 -3.897079 -4.019388 -4.134115 -4.235125 -4.324936 -4.408509 -4.479081 -4.512620 -4.506699 -4.386459 -4.088318 -13.71782 -3.842873 -3.852796 -3.885682 -3.932792 -3.998999 -4.077579 -4.163786 -4.251125 -4.339949 -4.433051 -4.525616 -4.611041 -4.688799 -4.761228 -4.847324 -4.904655 -4.896346 -4.790712 -4.481307 -13.71782 -4.983904 -4.933670 -4.910992 -4.901525 -4.909356 -4.938044 -4.979324 -5.027688 -5.080971 -5.141124 -5.210906 -5.282592 -5.350569 -5.408919 -5.472346 -5.525100 -5.506486 -5.359350 -4.954820 -13.71782 -24.40780 -24.12347 -23.79152 -23.41650 -23.00253 -22.55321 -22.07160 -21.56038 -21.02183 -20.45794 -19.87039 -19.26071 -18.63019 -17.98002 -17.31123 -16.62476 -15.92145 -15.20206 -14.46731 -13.71782 1.051872 0.9382266 0.8103326 0.6649828 0.5111348 0.3506006 0.1853124 2.4288476E-02 -0.1291871 -0.2683139 -0.3909312 -0.4960712 -0.5809723 -0.6448690 -0.6917365 -0.7230743 -0.7440510 -0.7594939 -0.7721173 -15.49837 1.561703 1.373754 1.181601 0.9805479 0.7769074 0.5697340 0.3678018 0.1770347 3.5137124E-03 -0.1464348 -0.2721963 -0.3677864 -0.4341896 -0.4708794 -0.4842285 -0.4780179 -0.4583927 -0.4306862 -0.3973494 -15.49837 1.868893 1.605173 1.348000 1.089935 0.8345836 0.5872241 0.3536009 0.1379297 -5.1505335E-02 -0.2145469 -0.3424735 -0.4308651 -0.4787922 -0.4906290 -0.4715882 -0.4293851 -0.3706879 -0.3014219 -0.2239610 -15.49837 2.012653 1.692754 1.383794 1.081529 0.7849807 0.4996129 0.2330066 -5.9268530E-03 -0.2125585 -0.3894670 -0.5245625 -0.6112734 -0.6461166 -0.6371655 -0.5891080 -0.5127201 -0.4162458 -0.3065121 -0.1858353 -15.49837 2.028081 1.672947 1.328763 0.9925793 0.6678262 0.3530331 5.9492026E-02 -0.2048830 -0.4371319 -0.6290592 -0.7757277 -0.8647075 -0.8942688 -0.8683178 -0.7953808 -0.6873118 -0.5546638 -0.4054023 -0.2421541 -15.49837 1.944085 1.567184 1.204341 0.8474666 0.4999182 0.1658663 -0.1454940 -0.4358051 -0.6906943 -0.9046709 -1.067950 -1.164744 -1.196138 -1.158395 -1.065091 -0.9288305 -0.7624274 -0.5746451 -0.3694991 -15.49837 1.777603 1.394669 1.022079 0.6557640 0.2966229 -5.0487965E-02 -0.3798478 -0.6868953 -0.9610260 -1.195663 -1.376465 -1.491065 -1.528550 -1.487411 -1.379139 -1.219173 -1.022042 -0.7974270 -0.5512146 -15.49837 1.544213 1.162997 0.7881448 0.4224131 6.0774729E-02 -0.2963546 -0.6356962 -0.9525914 -1.242737 -1.489307 -1.690668 -1.827790 -1.875733 -1.840306 -1.725026 -1.547121 -1.324043 -1.065065 -0.7790632 -15.49837 1.248436 0.8772728 0.5102526 0.1477001 -0.2125533 -0.5681363 -0.9105590 -1.233478 -1.526471 -1.785012 -2.002386 -2.156315 -2.227128 -2.203612 -2.092206 -1.905014 -1.662233 -1.372619 -1.048824 -15.49837 0.8949748 0.5429234 0.1859600 -0.1680245 -0.5190724 -0.8676061 -1.205353 -1.522464 -1.817306 -2.080802 -2.302393 -2.470948 -2.565099 -2.563272 -2.467144 -2.283805 -2.028545 -1.713717 -1.355153 -15.49837 0.4868169 0.1576467 -0.1819576 -0.5225824 -0.8593429 -1.192398 -1.514663 -1.824707 -2.114895 -2.370510 -2.588842 -2.765847 -2.877839 -2.906111 -2.832495 -2.667462 -2.410131 -2.077326 -1.688246 -15.49837 2.6532302E-02 -0.2768789 -0.5931793 -0.9120220 -1.226512 -1.540169 -1.845693 -2.139269 -2.410810 -2.655343 -2.866840 -3.040893 -3.170312 -3.225540 -3.192290 -3.054264 -2.809503 -2.470163 -2.057411 -15.49837 -0.4858287 -0.7559122 -1.041430 -1.332441 -1.624207 -1.913864 -2.191261 -2.457193 -2.709634 -2.937053 -3.134483 -3.304615 -3.439960 -3.524141 -3.532901 -3.432358 -3.215164 -2.885121 -2.458876 -15.49837 -1.046430 -1.279325 -1.529657 -1.786512 -2.044738 -2.301251 -2.548707 -2.785521 -3.010801 -3.218506 -3.404063 -3.560325 -3.699068 -3.806298 -3.847391 -3.789624 -3.614400 -3.311396 -2.884877 -15.49837 -1.659189 -1.846147 -2.052955 -2.267866 -2.487347 -2.707441 -2.920033 -3.125287 -3.324660 -3.510969 -3.677148 -3.829265 -3.963407 -4.075092 -4.142529 -4.123136 -4.001364 -3.746572 -3.335691 -15.49837 -2.325924 -2.460250 -2.615844 -2.781768 -2.958719 -3.141091 -3.320041 -3.491508 -3.661246 -3.827595 -3.981096 -4.116486 -4.236974 -4.344404 -4.421234 -4.438369 -4.367244 -4.177247 -3.789752 -15.49837 -3.059465 -3.137078 -3.237900 -3.352864 -3.483553 -3.624076 -3.766237 -3.907487 -4.046862 -4.185993 -4.319393 -4.437216 -4.540334 -4.635119 -4.716842 -4.761049 -4.741641 -4.601912 -4.240644 -15.49837 -3.908835 -3.927607 -3.971506 -4.029671 -4.108786 -4.206541 -4.309511 -4.412911 -4.519014 -4.628510 -4.736724 -4.835779 -4.924838 -5.007225 -5.094299 -5.172043 -5.172134 -5.050810 -4.694750 -15.49837 -5.133217 -5.080401 -5.058873 -5.050509 -5.063018 -5.104712 -5.160607 -5.220308 -5.282626 -5.358110 -5.443281 -5.530884 -5.610742 -5.684417 -5.751760 -5.825715 -5.817335 -5.669580 -5.220047 -15.49837 -27.81642 -27.49746 -27.12036 -26.69127 -26.21561 -25.69806 -25.14254 -24.55238 -23.93040 -23.27900 -22.60027 -21.89598 -21.16772 -20.41687 -19.64467 -18.85221 -18.04049 -17.21041 -16.36279 -15.49837 1.329675 1.209076 1.077057 0.9248464 0.7599619 0.5873050 0.4100176 0.2327801 6.1925374E-02 -9.6401028E-02 -0.2350717 -0.3527583 -0.4478544 -0.5201170 -0.5706090 -0.6044301 -0.6257150 -0.6396946 -0.6506824 -17.32631 1.907403 1.702189 1.495819 1.277918 1.057607 0.8348889 0.6150060 0.4053367 0.2107848 3.9719053E-02 -9.7767860E-02 -0.2044810 -0.2763489 -0.3154165 -0.3270310 -0.3165638 -0.2908096 -0.2555458 -0.2145250 -17.32631 2.261727 1.967106 1.682830 1.400106 1.121919 0.8516631 0.5947782 0.3569474 0.1414615 -3.9496444E-02 -0.1806640 -0.2784196 -0.3299175 -0.3383076 -0.3128185 -0.2603284 -0.1894458 -0.1065971 -1.5414657E-02 -17.32631 2.431374 2.072084 1.730335 1.398277 1.071943 0.7562299 0.4621940 0.1961203 -3.5892464E-02 -0.2312938 -0.3819792 -0.4758207 -0.5121661 -0.4953139 -0.4356525 -0.3434268 -0.2286300 -9.9003620E-02 4.1622721E-02 -17.32631 2.456743 2.059902 1.680208 1.308467 0.9457068 0.5986724 0.2727031 -2.1917792E-02 -0.2773168 -0.4953842 -0.6604816 -0.7610371 -0.7894756 -0.7545012 -0.6651201 -0.5360957 -0.3791173 -0.2036338 -1.4173341E-02 -17.32631 2.373876 1.954169 1.551947 1.155142 0.7682278 0.3974073 5.0086163E-02 -0.2652820 -0.5481727 -0.7935867 -0.9797636 -1.092415 -1.123864 -1.077399 -0.9633501 -0.8005638 -0.6034500 -0.3833039 -0.1455278 -17.32631 2.199701 1.771989 1.357786 0.9513730 0.5511613 0.1651617 -0.1930174 -0.5311013 -0.8364555 -1.103648 -1.318247 -1.449791 -1.493899 -1.443649 -1.312999 -1.121397 -0.8871757 -0.6238934 -0.3385173 -17.32631 1.947943 1.524716 1.108661 0.7009791 0.2987140 -8.9117140E-02 -0.4617426 -0.8126833 -1.133022 -1.419100 -1.653886 -1.815855 -1.880197 -1.836598 -1.697934 -1.484524 -1.217816 -0.9136531 -0.5817369 -17.32631 1.629215 1.218773 0.8110287 0.4104117 1.4580486E-02 -0.3760392 -0.7524253 -1.109485 -1.439388 -1.732118 -1.985220 -2.175201 -2.264147 -2.240813 -2.105829 -1.880535 -1.588649 -1.247296 -0.8706256 -17.32631 1.249266 0.8602356 0.4692947 7.7680714E-02 -0.3101345 -0.6938125 -1.064944 -1.422245 -1.749816 -2.046663 -2.309058 -2.514477 -2.634387 -2.639676 -2.523274 -2.298837 -1.992062 -1.619130 -1.200512 -17.32631 0.8146356 0.4512144 7.7467814E-02 -0.2983870 -0.6725374 -1.042498 -1.401927 -1.745347 -2.069254 -2.364125 -2.619874 -2.832997 -2.977015 -3.017228 -2.932422 -2.727317 -2.417150 -2.020890 -1.564637 -17.32631 0.3224383 -1.2840703E-02 -0.3621114 -0.7155542 -1.071456 -1.419784 -1.758278 -2.086905 -2.398541 -2.675939 -2.921968 -3.131629 -3.288302 -3.364173 -3.318444 -3.150072 -2.852686 -2.444704 -1.957224 -17.32631 -0.2273233 -0.5293152 -0.8476201 -1.170527 -1.499857 -1.825895 -2.140554 -2.442420 -2.726795 -2.988534 -3.218564 -3.415509 -3.579251 -3.677839 -3.687545 -3.564521 -3.300135 -2.899053 -2.391135 -17.32631 -0.8334810 -1.095922 -1.376531 -1.665309 -1.962920 -2.255888 -2.536097 -2.806016 -3.063333 -3.300653 -3.510545 -3.696682 -3.850592 -3.974512 -4.026312 -3.956681 -3.742535 -3.372330 -2.859536 -17.32631 -1.500046 -1.716390 -1.951506 -2.196016 -2.450663 -2.704901 -2.948820 -3.183025 -3.407578 -3.620417 -3.809380 -3.975978 -4.130064 -4.258896 -4.337695 -4.315475 -4.165008 -3.848633 -3.350882 -17.32631 -2.230775 -2.389790 -2.569863 -2.763622 -2.969612 -3.179139 -3.384254 -3.583553 -3.774364 -3.959208 -4.130683 -4.284054 -4.423498 -4.546677 -4.635085 -4.653828 -4.567086 -4.331470 -3.864104 -17.32631 -3.035518 -3.129265 -3.248177 -3.385514 -3.538453 -3.702308 -3.865842 -4.027517 -4.188806 -4.346765 -4.493836 -4.627067 -4.746215 -4.855517 -4.947412 -4.995291 -4.963329 -4.806831 -4.377880 -17.32631 -3.959734 -3.985231 -4.038179 -4.114079 -4.212348 -4.324760 -4.445617 -4.566721 -4.690296 -4.816669 -4.937047 -5.048034 -5.146477 -5.247359 -5.335821 -5.420223 -5.428559 -5.298836 -4.893279 -17.32631 -5.261932 -5.210149 -5.186610 -5.186763 -5.214673 -5.260638 -5.328101 -5.402385 -5.480968 -5.565905 -5.662872 -5.761701 -5.851682 -5.941313 -6.028867 -6.104701 -6.113710 -5.966439 -5.471571 -17.32631 -31.33059 -30.97644 -30.55270 -30.06740 -29.52756 -28.93900 -28.30659 -27.63436 -26.92570 -26.18349 -25.41016 -24.60781 -23.77828 -22.92319 -22.04396 -21.14187 -20.21807 -19.27360 -18.30939 -17.32631 1.604093 1.479422 1.339492 1.179834 1.009009 0.8231487 0.6332287 0.4420686 0.2540831 7.8864299E-02 -7.8343779E-02 -0.2096198 -0.3153895 -0.3949980 -0.4501878 -0.4864210 -0.5078970 -0.5208192 -0.5303562 -19.19886 2.250045 2.024981 1.802066 1.572117 1.334108 1.094990 0.8600211 0.6324937 0.4183019 0.2303700 7.5306237E-02 -4.0379800E-02 -0.1183219 -0.1592868 -0.1681976 -0.1532622 -0.1212215 -7.8589022E-02 -2.9994922E-02 -19.19886 2.647603 2.321118 2.012463 1.703968 1.400542 1.109670 0.8341545 0.5740622 0.3372797 0.1358602 -1.9470062E-02 -0.1250048 -0.1783931 -0.1840422 -0.1503004 -8.7248586E-02 -3.9650626E-03 9.2420407E-02 0.1973676 -19.19886 2.843079 2.445443 2.068492 1.703207 1.348282 1.007870 0.6872298 0.3975178 0.1386282 -8.0093972E-02 -0.2449448 -0.3473895 -0.3840698 -0.3601561 -0.2883424 -0.1795402 -4.6158992E-02 0.1032369 0.2638958 -19.19886 2.880599 2.438853 2.020494 1.613722 1.218341 0.8395143 0.4861425 0.1651176 -0.1233822 -0.3642923 -0.5477712 -0.6578948 -0.6877567 -0.6415795 -0.5359339 -0.3845634 -0.2026980 -9.5359242E-04 0.2149909 -19.19886 2.795377 2.331581 1.890531 1.457221 1.030880 0.6282371 0.2495120 -9.7914048E-02 -0.4100699 -0.6847146 -0.8954063 -1.023974 -1.057453 -1.000311 -0.8666949 -0.6768604 -0.4486695 -0.1956274 7.5123906E-02 -19.19886 2.613536 2.143005 1.688260 1.240700 0.8041883 0.3843783 -1.0583297E-02 -0.3758676 -0.7120731 -1.013663 -1.256506 -1.413516 -1.462767 -1.405812 -1.252241 -1.028662 -0.7570719 -0.4543660 -0.1293829 -19.19886 2.347014 1.881113 1.424441 0.9784734 0.5381619 0.1132342 -0.2903523 -0.6722460 -1.023904 -1.343400 -1.616364 -1.804218 -1.884381 -1.837379 -1.676689 -1.427271 -1.116740 -0.7666230 -0.3883269 -19.19886 2.005149 1.557211 1.111333 0.6704467 0.2353425 -0.1855339 -0.5953862 -0.9849835 -1.345351 -1.675835 -1.963293 -2.185584 -2.303668 -2.280041 -2.125462 -1.861880 -1.519802 -1.125695 -0.6956273 -19.19886 1.602829 1.177323 0.7478510 0.3198577 -0.1042342 -0.5208920 -0.9257564 -1.314506 -1.678089 -2.006642 -2.302708 -2.550032 -2.698907 -2.715883 -2.582726 -2.320384 -1.958506 -1.526124 -1.046845 -19.19886 1.141175 0.7427061 0.3359589 -7.6278552E-02 -0.4871895 -0.8907713 -1.283217 -1.663641 -2.017309 -2.343300 -2.639230 -2.887852 -3.066455 -3.124490 -3.030633 -2.787508 -2.421461 -1.959444 -1.435013 -19.19886 0.6196844 0.2510166 -0.1291047 -0.5180796 -0.9104872 -1.296351 -1.667921 -2.027236 -2.370461 -2.685903 -2.963859 -3.209587 -3.400810 -3.496868 -3.451614 -3.251870 -2.899937 -2.421559 -1.858551 -19.19886 3.5248514E-02 -0.2985718 -0.6477012 -1.006986 -1.371703 -1.730795 -2.078575 -2.415255 -2.735137 -3.024171 -3.286072 -3.517290 -3.708925 -3.833700 -3.840656 -3.700586 -3.387048 -2.912130 -2.321239 -19.19886 -0.6140508 -0.9059982 -1.215613 -1.537709 -1.870074 -2.199339 -2.515156 -2.814732 -3.103641 -3.368198 -3.604364 -3.815783 -4.002555 -4.138576 -4.199107 -4.121633 -3.868674 -3.426605 -2.824887 -19.19886 -1.329870 -1.572634 -1.836889 -2.115767 -2.403427 -2.690369 -2.966426 -3.229882 -3.483294 -3.716910 -3.930132 -4.116547 -4.290324 -4.438284 -4.527261 -4.505882 -4.328760 -3.950437 -3.361208 -19.19886 -2.120906 -2.303333 -2.510067 -2.733783 -2.969811 -3.209508 -3.440813 -3.664968 -3.883038 -4.085186 -4.271494 -4.441197 -4.599300 -4.740211 -4.842203 -4.860792 -4.764164 -4.480005 -3.929955 -19.19886 -2.996779 -3.107838 -3.245692 -3.407110 -3.586084 -3.773486 -3.959506 -4.142555 -4.323848 -4.498532 -4.659562 -4.806337 -4.941792 -5.065996 -5.167756 -5.217194 -5.181608 -5.001478 -4.502279 -19.19886 -3.992558 -4.027301 -4.092954 -4.184935 -4.302683 -4.436855 -4.574603 -4.713968 -4.856766 -4.996367 -5.128047 -5.250087 -5.361995 -5.473201 -5.575793 -5.653123 -5.673305 -5.533811 -5.079271 -19.19886 -5.363172 -5.316663 -5.300663 -5.309512 -5.346948 -5.410807 -5.487451 -5.574393 -5.672333 -5.773295 -5.873249 -5.981391 -6.084575 -6.188569 -6.293852 -6.367299 -6.393701 -6.248595 -5.710330 -19.19886 -34.94338 -34.55346 -34.08160 -33.53811 -32.93168 -32.26951 -31.55741 -30.80021 -30.00189 -29.16577 -28.29469 -27.39107 -26.45702 -25.49439 -24.50482 -23.48975 -22.45050 -21.38824 -20.30404 -19.19886 1.870529 1.744022 1.600494 1.433933 1.252285 1.058328 0.8548711 0.6477980 0.4440847 0.2490608 7.5249292E-02 -7.2924018E-02 -0.1894186 -0.2772990 -0.3376427 -0.3757105 -0.3977451 -0.4101526 -0.4184313 -21.11357 2.588126 2.345681 2.105590 1.858172 1.606554 1.352494 1.100844 0.8555945 0.6233827 0.4175410 0.2473520 0.1201152 3.6908899E-02 -5.1318132E-03 -1.1656607E-02 8.2175713E-03 4.6743076E-02 9.6501477E-02 0.1526188 -21.11357 3.030629 2.671751 2.333342 2.000900 1.674643 1.361330 1.067530 0.7876165 0.5291452 0.3098223 0.1384657 2.6611935E-02 -2.8832557E-02 -3.0448426E-02 1.2278093E-02 8.6525999E-02 0.1825473 0.2924650 0.4112342 -21.11357 3.249102 2.810717 2.399497 2.002060 1.616524 1.251277 0.9103157 0.5938572 0.3102775 6.9745466E-02 -0.1105243 -0.2198710 -0.2563691 -0.2256290 -0.1393401 -1.3451159E-02 0.1388484 0.3081152 0.4890235 -21.11357 3.296829 2.811458 2.354009 1.908912 1.480833 1.075729 0.6943313 0.3459399 2.8071141E-02 -0.2409322 -0.4413359 -0.5627260 -0.5921854 -0.5370721 -0.4136546 -0.2393798 -3.2346800E-02 0.1957082 0.4384083 -21.11357 3.211468 2.702567 2.219253 1.748233 1.289675 0.8541532 0.4455830 6.9179632E-02 -0.2776441 -0.5785267 -0.8140525 -0.9584470 -0.9966649 -0.9285688 -0.7747517 -0.5562717 -0.2965216 -1.0526614E-02 0.2936237 -21.11357 3.019572 2.505165 2.010579 1.526486 1.051646 0.5995352 0.1713567 -0.2262383 -0.5911464 -0.9233692 -1.196896 -1.378028 -1.436389 -1.372179 -1.197074 -0.9405689 -0.6310763 -0.2885111 7.6609790E-02 -21.11357 2.737781 2.232724 1.737328 1.249437 0.7735143 0.3144135 -0.1254491 -0.5345267 -0.9157246 -1.267898 -1.572743 -1.795299 -1.890616 -1.844534 -1.661302 -1.375069 -1.020445 -0.6236707 -0.1983680 -21.11357 2.379320 1.891719 1.407035 0.9266818 0.4543984 -2.9946060E-03 -0.4419273 -0.8615459 -1.252573 -1.612765 -1.938998 -2.193640 -2.338846 -2.323500 -2.151551 -1.848662 -1.456457 -1.008988 -0.5248718 -21.11357 1.953179 1.491179 1.024606 0.5565134 9.4793022E-02 -0.3520216 -0.7887334 -1.208674 -1.600067 -1.963741 -2.291637 -2.574808 -2.761628 -2.791966 -2.649268 -2.348495 -1.930937 -1.438363 -0.8977178 -21.11357 1.466145 1.031522 0.5891798 0.1423587 -0.3055215 -0.7415818 -1.165674 -1.576163 -1.962807 -2.315185 -2.644385 -2.937427 -3.147619 -3.229373 -3.133097 -2.856023 -2.431850 -1.903271 -1.309922 -21.11357 0.9147124 0.5139635 0.1002204 -0.3233077 -0.7513201 -1.169326 -1.575174 -1.966268 -2.335352 -2.679187 -2.995247 -3.276073 -3.503248 -3.625006 -3.588117 -3.360109 -2.952708 -2.402830 -1.763258 -21.11357 0.2972648 -6.5789573E-02 -0.4470935 -0.8402947 -1.241720 -1.634346 -2.012141 -2.379668 -2.730226 -3.050414 -3.338802 -3.605170 -3.829156 -3.979556 -3.996732 -3.841974 -3.478508 -2.929199 -2.254061 -21.11357 -0.3903559 -0.7105080 -1.051643 -1.406544 -1.773004 -2.134129 -2.482893 -2.818306 -3.132752 -3.424184 -3.687706 -3.926026 -4.140051 -4.298533 -4.371010 -4.290697 -4.000072 -3.483969 -2.790942 -21.11357 -1.152490 -1.421472 -1.713524 -2.025536 -2.350624 -2.668989 -2.974097 -3.269430 -3.549271 -3.806477 -4.039922 -4.253164 -4.443698 -4.608996 -4.712960 -4.698549 -4.497026 -4.054646 -3.370839 -21.11357 -2.001036 -2.205718 -2.438982 -2.693780 -2.962541 -3.231544 -3.490628 -3.741265 -3.982193 -4.206464 -4.407761 -4.595442 -4.772701 -4.926894 -5.041285 -5.069372 -4.959645 -4.621751 -3.981494 -21.11357 -2.941901 -3.070547 -3.233362 -3.419293 -3.624363 -3.837254 -4.044862 -4.250664 -4.454109 -4.645677 -4.821468 -4.985298 -5.139157 -5.273916 -5.382443 -5.443467 -5.405225 -5.193992 -4.616406 -21.11357 -4.011112 -4.054508 -4.138062 -4.248759 -4.386831 -4.538554 -4.693344 -4.856206 -5.018573 -5.176794 -5.319837 -5.454493 -5.586078 -5.704152 -5.810917 -5.888978 -5.916761 -5.774159 -5.256650 -21.11357 -5.463986 -5.411049 -5.406122 -5.428843 -5.483284 -5.558495 -5.645150 -5.750258 -5.862916 -5.984155 -6.098505 -6.208209 -6.332408 -6.448680 -6.557418 -6.644465 -6.670555 -6.530799 -5.946835 -21.11357 -38.64869 -38.22243 -37.70129 -37.09740 -36.42216 -35.68388 -34.88949 -34.04460 -33.15380 -32.22091 -31.24915 -30.24129 -29.19971 -28.12650 -27.02374 -25.89260 -24.73454 -23.55135 -22.34400 -21.11357 2.124056 1.996685 1.853360 1.684422 1.495065 1.288645 1.073389 0.8490722 0.6263106 0.4121676 0.2186068 5.3451449E-02 -7.8106329E-02 -0.1755553 -0.2416373 -0.2822104 -0.3052387 -0.3174390 -0.3248259 -23.06822 2.916329 2.658820 2.403530 2.142227 1.872984 1.605081 1.336754 1.071557 0.8218294 0.5964656 0.4106538 0.2701619 0.1800452 0.1360662 0.1317202 0.1569906 0.2016611 0.2583890 0.3219203 -23.06822 3.408471 3.017132 2.651515 2.290800 1.942060 1.608833 1.294087 0.9932016 0.7148969 0.4771438 0.2920386 0.1699231 0.1123188 0.1148206 0.1664612 0.2523081 0.3611918 0.4845927 0.6172774 -23.06822 3.651250 3.173130 2.723403 2.293211 1.879981 1.488638 1.126079 0.7851837 0.4772014 0.2172316 1.9991806E-02 -9.6858554E-02 -0.1342834 -9.5088370E-02 6.0165958E-03 0.1495445 0.3210855 0.5104323 0.7117962 -23.06822 3.708207 3.177172 2.680369 2.198251 1.737040 1.304416 0.8996891 0.5217526 0.1778276 -0.1153927 -0.3366246 -0.4671210 -0.4983003 -0.4335481 -0.2897647 -9.1936946E-02 0.1407126 0.3954328 0.6652539 -23.06822 3.620944 3.067382 2.542186 2.031018 1.540043 1.075482 0.6371498 0.2330622 -0.1430458 -0.4744420 -0.7340696 -0.8956635 -0.9386117 -0.8616835 -0.6852793 -0.4377322 -0.1459814 0.1733479 0.5113579 -23.06822 3.419679 2.861755 2.325026 1.802979 1.295341 0.8089041 0.3506584 -7.5519562E-02 -0.4716773 -0.8323531 -1.136875 -1.343643 -1.416312 -1.344536 -1.147009 -0.8564347 -0.5085107 -0.1258018 0.2800155 -23.06822 3.122654 2.576882 2.043010 1.517183 1.003037 0.5118442 4.0553212E-02 -0.3997934 -0.8071623 -1.188916 -1.528471 -1.783519 -1.899555 -1.855142 -1.651175 -1.327882 -0.9285855 -0.4845082 -1.1531484E-02 -23.06822 2.747728 2.221904 1.698875 1.177057 0.6698227 0.1792610 -0.2932159 -0.7387484 -1.156958 -1.548828 -1.908149 -2.201477 -2.372140 -2.372395 -2.183493 -1.841624 -1.399065 -0.8973311 -0.3584098 -23.06822 2.301113 1.799756 1.297667 0.7907015 0.2927532 -0.1887098 -0.6529869 -1.101117 -1.520391 -1.912131 -2.279919 -2.594713 -2.817065 -2.869344 -2.720891 -2.382080 -1.909134 -1.355407 -0.7526120 -23.06822 1.788003 1.317680 0.8402926 0.3552666 -0.1255220 -0.5946174 -1.048811 -1.488192 -1.900805 -2.285022 -2.642742 -2.971964 -3.221475 -3.332364 -3.239673 -2.931334 -2.447881 -1.851547 -1.188354 -23.06822 1.208935 0.7741624 0.3276305 -0.1308115 -0.5932002 -1.043676 -1.479841 -1.902930 -2.298347 -2.666872 -3.013427 -3.332873 -3.592814 -3.747440 -3.722511 -3.470742 -3.007112 -2.383622 -1.666302 -23.06822 0.5603141 0.1660238 -0.2458098 -0.6741801 -1.109402 -1.535538 -1.946813 -2.342194 -2.717534 -3.067285 -3.385799 -3.684520 -3.939564 -4.115959 -4.155648 -3.986667 -3.574413 -2.948481 -2.187809 -23.06822 -0.1644627 -0.5130218 -0.8832318 -1.274694 -1.674383 -2.067116 -2.446060 -2.812968 -3.157520 -3.471250 -3.763845 -4.034906 -4.269583 -4.452902 -4.538099 -4.459342 -4.132856 -3.540390 -2.754507 -23.06822 -0.9719781 -1.264618 -1.585873 -1.930156 -2.288464 -2.641849 -2.977411 -3.300557 -3.608924 -3.889498 -4.145748 -4.386819 -4.597927 -4.772430 -4.891626 -4.883698 -4.662689 -4.153168 -3.371792 -23.06822 -1.870801 -2.099132 -2.361382 -2.645853 -2.947182 -3.245426 -3.532552 -3.811730 -4.079275 -4.322085 -4.544788 -4.752332 -4.942368 -5.106776 -5.230595 -5.268314 -5.151254 -4.764826 -4.027752 -23.06822 -2.879173 -3.024025 -3.211346 -3.425157 -3.660949 -3.893601 -4.127316 -4.359092 -4.584491 -4.792059 -4.981314 -5.164850 -5.328904 -5.473214 -5.587107 -5.652490 -5.618800 -5.379556 -4.718768 -23.06822 -4.028031 -4.075971 -4.175058 -4.307951 -4.469625 -4.637300 -4.814909 -4.997840 -5.180879 -5.351552 -5.507865 -5.659100 -5.798630 -5.921362 -6.032135 -6.114820 -6.147307 -6.007020 -5.425177 -23.06822 -5.556280 -5.495097 -5.495789 -5.533612 -5.610092 -5.697990 -5.803596 -5.925224 -6.054016 -6.186468 -6.312804 -6.435060 -6.567181 -6.689487 -6.804871 -6.898982 -6.929785 -6.804071 -6.177450 -23.06822 -42.44114 -41.97798 -41.40569 -40.74004 -39.99380 -39.17710 -38.29797 -37.36283 -36.37693 -35.34457 -34.26939 -33.15451 -32.00258 -30.81595 -29.59668 -28.34658 -27.06729 -25.76027 -24.42684 -23.06822 2.369241 2.238895 2.097131 1.929418 1.735085 1.520691 1.289789 1.050965 0.8061288 0.5742618 0.3579986 0.1731142 2.5442919E-02 -8.1745423E-02 -0.1539267 -0.1976051 -0.2217502 -0.2338694 -0.2406052 -25.06082 3.234505 2.961396 2.693817 2.418585 2.137444 1.852846 1.567024 1.282460 1.012877 0.7690530 0.5625012 0.4070998 0.3079219 0.2619707 0.2597407 0.2896854 0.3405056 0.4041112 0.4749235 -25.06082 3.778283 3.356190 2.962392 2.577672 2.204107 1.850618 1.515624 1.191500 0.8963769 0.6373202 0.4362331 0.3020667 0.2418854 0.2488693 0.3096004 0.4074002 0.5291507 0.6660824 0.8127307 -25.06082 4.048409 3.528996 3.043970 2.578000 2.136583 1.721777 1.333390 0.9707724 0.6398048 0.3557401 0.1423029 1.3443301E-02 -2.4409942E-02 2.3582688E-02 0.1393923 0.3008746 0.4918954 0.7013775 0.9234101 -25.06082 4.113782 3.539402 2.999655 2.480947 1.988754 1.526083 1.098788 0.6956205 0.3216872 3.0513890E-03 -0.2392194 -0.3820662 -0.4157876 -0.3395097 -0.1761472 4.5528121E-02 0.3041748 0.5858009 0.8830404 -25.06082 4.025189 3.425236 2.858958 2.308799 1.783523 1.289957 0.8273516 0.3916575 -1.2133359E-02 -0.3720223 -0.6584968 -0.8366517 -0.8860896 -0.7992646 -0.5988401 -0.3216666 2.6068059E-03 0.3556902 0.7279827 -25.06082 3.813319 3.212833 2.634266 2.071661 1.532195 1.016421 0.5252295 7.0949249E-02 -0.3532979 -0.7459287 -1.078632 -1.311232 -1.398240 -1.322081 -1.101019 -0.7760427 -0.3892129 3.4173086E-02 0.4812053 -25.06082 3.503003 2.915553 2.340831 1.777856 1.231012 0.7030319 0.2018539 -0.2668732 -0.7042204 -1.112850 -1.484378 -1.769930 -1.912631 -1.870829 -1.647435 -1.286004 -0.8415395 -0.3497072 0.1715326 -25.06082 3.110208 2.545452 1.985586 1.425198 0.8793787 0.3565314 -0.1468698 -0.6219824 -1.062518 -1.483624 -1.876006 -2.204077 -2.405712 -2.423063 -2.221683 -1.841997 -1.348581 -0.7917578 -0.1973962 -25.06082 2.645185 2.106111 1.564812 1.020195 0.4862578 -2.8383650E-02 -0.5245096 -0.9962245 -1.440795 -1.859343 -2.259012 -2.607776 -2.863618 -2.946331 -2.793732 -2.418244 -1.889169 -1.273206 -0.6074911 -25.06082 2.106462 1.600020 1.086757 0.5652096 4.7554232E-02 -0.4509434 -0.9363869 -1.401718 -1.838700 -2.249206 -2.640210 -2.997704 -3.286599 -3.427936 -3.347791 -3.010197 -2.468542 -1.803139 -1.069482 -25.06082 1.499827 1.032246 0.5505542 5.7482775E-02 -0.4381996 -0.9206976 -1.388489 -1.837224 -2.259884 -2.652879 -3.030517 -3.381649 -3.670581 -3.859802 -3.855980 -3.589659 -3.069319 -2.371132 -1.575481 -25.06082 0.8203427 0.3965838 -4.7407929E-02 -0.5105919 -0.9793327 -1.436299 -1.879500 -2.304479 -2.702714 -3.076784 -3.432797 -3.754365 -4.036641 -4.242656 -4.308190 -4.134113 -3.676039 -2.972038 -2.125072 -25.06082 6.0278997E-02 -0.3143111 -0.7154174 -1.140103 -1.574819 -1.997380 -2.406582 -2.802925 -3.176152 -3.515133 -3.834324 -4.131203 -4.387302 -4.594180 -4.700174 -4.629375 -4.270132 -3.601239 -2.721672 -25.06082 -0.7868792 -1.105199 -1.455861 -1.831985 -2.223176 -2.604991 -2.976928 -3.329246 -3.662490 -3.965895 -4.248415 -4.509982 -4.738258 -4.927145 -5.063170 -5.068821 -4.831797 -4.253273 -3.372731 -25.06082 -1.736283 -1.985938 -2.276586 -2.595753 -2.928149 -3.253212 -3.573081 -3.878265 -4.170072 -4.431467 -4.674148 -4.903327 -5.100241 -5.277420 -5.413681 -5.465926 -5.344051 -4.907581 -4.072021 -25.06082 -2.809158 -2.970298 -3.181366 -3.424728 -3.687057 -3.949598 -4.209604 -4.464112 -4.708616 -4.930688 -5.134931 -5.337058 -5.508906 -5.662011 -5.783499 -5.858266 -5.829638 -5.560941 -4.816730 -25.06082 -4.032163 -4.086486 -4.201923 -4.358470 -4.540717 -4.733571 -4.934371 -5.136122 -5.334193 -5.518769 -5.688579 -5.857062 -6.000195 -6.131690 -6.243095 -6.334708 -6.370148 -6.227793 -5.581972 -25.06082 -5.631079 -5.573296 -5.575269 -5.631809 -5.718518 -5.828534 -5.955991 -6.094769 -6.239724 -6.379880 -6.519976 -6.660018 -6.789718 -6.919412 -7.037278 -7.140090 -7.177355 -7.064770 -6.397356 -25.06082 -46.31595 -45.81533 -45.19081 -44.46160 -43.64208 -42.74475 -41.77854 -40.75076 -39.66726 -38.53291 -37.35199 -36.12723 -34.86233 -33.55962 -32.22139 -30.84964 -29.44642 -28.01260 -26.55038 -25.06082 2.606015 2.475552 2.333580 2.167923 1.973659 1.752905 1.508721 1.251134 0.9895735 0.7337871 0.4958158 0.2894993 0.1249611 6.4064842E-03 -7.2316915E-02 -0.1192504 -0.1445691 -0.1567276 -0.1629376 -27.08958 3.546932 3.254984 2.975282 2.690264 2.397079 2.099897 1.793745 1.491731 1.202045 0.9371014 0.7091783 0.5373473 0.4285125 0.3803700 0.3800436 0.4147810 0.4717999 0.5423092 0.6203918 -27.08958 4.140084 3.686538 3.267074 2.857356 2.463469 2.088615 1.730886 1.388020 1.071196 0.7923532 0.5720962 0.4246569 0.3603955 0.3723666 0.4421883 0.5517922 0.6865548 0.8370998 0.9978007 -27.08958 4.438705 3.879424 3.358075 2.859883 2.388931 1.949341 1.538666 1.150948 0.7976889 0.4913768 0.2598105 0.1178513 8.0065742E-02 0.1375046 0.2685654 0.4487245 0.6594449 0.8892860 1.132231 -27.08958 4.515312 3.895401 3.315378 2.758474 2.234634 1.745685 1.292232 0.8633793 0.4637052 0.1187694 -0.1451607 -0.3046682 -0.3386137 -0.2509236 -6.7560188E-02 0.1786485 0.4637609 0.7725304 1.097581 -27.08958 4.423520 3.779157 3.169267 2.580754 2.023547 1.499043 1.009693 0.5486761 0.1162023 -0.2731114 -0.5871308 -0.7849183 -0.8419350 -0.7448141 -0.5211938 -0.2140719 0.1433089 0.5304734 0.9375154 -27.08958 4.202323 3.557125 2.937271 2.336522 1.762562 1.215801 0.6971076 0.2139756 -0.2376949 -0.6596455 -1.022133 -1.278740 -1.382477 -1.302772 -1.056589 -0.6965625 -0.2699895 0.1945302 0.6833754 -27.08958 3.878355 3.248590 2.634171 2.030866 1.450850 0.8921089 0.3588271 -0.1360244 -0.5998691 -1.040806 -1.438779 -1.755706 -1.926136 -1.891725 -1.649736 -1.250360 -0.7599362 -0.2198968 0.3502517 -27.08958 3.469021 2.863635 2.264152 1.666940 1.086545 0.5290107 -4.4934824E-03 -0.5050077 -0.9729728 -1.419025 -1.839739 -2.198600 -2.436908 -2.472268 -2.262057 -1.844047 -1.298631 -0.6861699 -3.5594221E-02 -27.08958 2.983459 2.406324 1.827611 1.244688 0.6758630 0.1276729 -0.3992286 -0.8965728 -1.363226 -1.808511 -2.235065 -2.616532 -2.904499 -3.020288 -2.870497 -2.461494 -1.875867 -1.196688 -0.4673330 -27.08958 2.421395 1.879315 1.328412 0.7703500 0.2178229 -0.3150277 -0.8279257 -1.318338 -1.777981 -2.214879 -2.636464 -3.016599 -3.338319 -3.519058 -3.457120 -3.094776 -2.494149 -1.758919 -0.9539970 -27.08958 1.786665 1.286530 0.7702342 0.2398055 -0.2888980 -0.8017003 -1.298813 -1.774319 -2.218894 -2.640715 -3.044028 -3.416077 -3.740650 -3.964717 -3.989273 -3.712719 -3.134641 -2.360703 -1.485868 -27.08958 1.077110 0.6229432 0.1478068 -0.3499098 -0.8513631 -1.338832 -1.811461 -2.267361 -2.688581 -3.084126 -3.469128 -3.814664 -4.123331 -4.362998 -4.456473 -4.285710 -3.782126 -2.998803 -2.064729 -27.08958 0.2848516 -0.1171388 -0.5482094 -1.007250 -1.473332 -1.928373 -2.368723 -2.792812 -3.187118 -3.553101 -3.901388 -4.216194 -4.499010 -4.728102 -4.861898 -4.800470 -4.413784 -3.667028 -2.692989 -27.08958 -0.6020722 -0.9438755 -1.324543 -1.735227 -2.156111 -2.569685 -2.971474 -3.355934 -3.708503 -4.033408 -4.345441 -4.624365 -4.873294 -5.082198 -5.229449 -5.251676 -5.004671 -4.356331 -3.375067 -27.08958 -1.599961 -1.868146 -2.186460 -2.539148 -2.903952 -3.260981 -3.609204 -3.942328 -4.250818 -4.535858 -4.803849 -5.048897 -5.258467 -5.447329 -5.591713 -5.659881 -5.538660 -5.053540 -4.117722 -27.08958 -2.730025 -2.907029 -3.143618 -3.418411 -3.707265 -3.999789 -4.289417 -4.566997 -4.827290 -5.069741 -5.297106 -5.507501 -5.691564 -5.850388 -5.979616 -6.061543 -6.039870 -5.744734 -4.912416 -27.08958 -4.027216 -4.092029 -4.223670 -4.404986 -4.607817 -4.827667 -5.053493 -5.274329 -5.488091 -5.689080 -5.880297 -6.058802 -6.208699 -6.340383 -6.460345 -6.552792 -6.594961 -6.453104 -5.737387 -27.08958 -5.708625 -5.648920 -5.659725 -5.730806 -5.831852 -5.965513 -6.116002 -6.269889 -6.429115 -6.587739 -6.740098 -6.894539 -7.028156 -7.159764 -7.284972 -7.387414 -7.438603 -7.337056 -6.618557 -27.08958 -50.26885 -49.73021 -49.05212 -48.25715 -47.36290 -46.38283 -45.32735 -44.20464 -43.02122 -41.78249 -40.49292 -39.15633 -37.77597 -36.35469 -34.89499 -33.39907 -31.86889 -30.30622 -28.71263 -27.08958 2.838805 2.705044 2.565522 2.400527 2.206973 1.982346 1.730729 1.454388 1.176012 0.8963675 0.6353403 0.4070060 0.2255221 9.4553590E-02 9.7387908E-03 -4.0487666E-02 -6.6945441E-02 -7.9202846E-02 -8.4977157E-02 -29.15287 3.853011 3.543430 3.248853 2.952844 2.650313 2.343916 2.020682 1.699338 1.390941 1.100672 0.8528836 0.6628645 0.5444864 0.4927444 0.4944465 0.5340926 0.5973571 0.6748685 0.7602412 -29.15287 4.496203 4.008480 3.562001 3.129653 2.717841 2.323722 1.942737 1.582428 1.240610 0.9428374 0.7013205 0.5395000 0.4707647 0.4868421 0.5658613 0.6874632 0.8353193 0.9996673 1.174550 -29.15287 4.821689 4.221116 3.665215 3.135997 2.638095 2.173194 1.740554 1.327438 0.9487935 0.6239557 0.3689860 0.2134851 0.1736490 0.2403373 0.3866453 0.5854632 0.8160453 1.066506 1.330581 -29.15287 4.909977 4.245476 3.625492 3.032598 2.475654 1.961733 1.481669 1.024196 0.6031442 0.2304130 -5.7115968E-02 -0.2344165 -0.2711139 -0.1728701 3.0591657E-02 0.3020042 0.6136787 0.9499393 1.303136 -29.15287 4.817173 4.127008 3.474950 2.847460 2.259776 1.704152 1.184250 0.7020755 0.2428283 -0.1765239 -0.5173577 -0.7407630 -0.8071008 -0.7017786 -0.4555811 -0.1179834 0.2727954 0.6943624 1.136614 -29.15287 4.586572 3.896865 3.234156 2.597144 1.987999 1.406809 0.8646437 0.3576431 -0.1244450 -0.5741088 -0.9661257 -1.250088 -1.372403 -1.289789 -1.020253 -0.6246034 -0.1577449 0.3483694 0.8795680 -29.15287 4.248151 3.576617 2.922271 2.278975 1.662136 1.075665 0.5162133 -7.2060558E-03 -0.4963042 -0.9664340 -1.390905 -1.738568 -1.936719 -1.914828 -1.654411 -1.216560 -0.6795679 -9.0760268E-02 0.5289890 -29.15287 3.824229 3.176679 2.536234 1.900916 1.289149 0.6997041 0.1352043 -0.3904382 -0.8835701 -1.357358 -1.801461 -2.190019 -2.462377 -2.522816 -2.307064 -1.849605 -1.251499 -0.5829202 0.1246343 -29.15287 3.316185 2.700200 2.084952 1.466394 0.8610279 0.2801816 -0.2766859 -0.7993435 -1.288476 -1.762457 -2.209456 -2.616512 -2.939748 -3.092698 -2.952475 -2.511420 -1.868623 -1.125869 -0.3320003 -29.15287 2.731986 2.155584 1.567610 0.9705737 0.3843660 -0.1812317 -0.7252094 -1.237313 -1.719834 -2.184786 -2.623415 -3.030311 -3.381796 -3.607519 -3.566543 -3.184470 -2.525263 -1.719396 -0.8421724 -29.15287 2.070091 1.536474 0.9866309 0.4194531 -0.1430801 -0.6865270 -1.212685 -1.713874 -2.179978 -2.627379 -3.050848 -3.444910 -3.802130 -4.060064 -4.119544 -3.837555 -3.204360 -2.353945 -1.398850 -29.15287 1.330709 0.8478407 0.3386961 -0.1929877 -0.7251676 -1.245111 -1.747497 -2.227745 -2.672641 -3.091591 -3.497189 -3.869478 -4.202480 -4.472135 -4.600054 -4.440632 -3.891176 -3.028481 -2.005989 -29.15287 0.5068224 7.9351567E-02 -0.3845227 -0.8765897 -1.373676 -1.861004 -2.332015 -2.778382 -3.195421 -3.586364 -3.962254 -4.294633 -4.601943 -4.855391 -5.018248 -4.971868 -4.558693 -3.735213 -2.665268 -29.15287 -0.4182387 -0.7818406 -1.191578 -1.636151 -2.088338 -2.533803 -2.964579 -3.373336 -3.753147 -4.102035 -4.438917 -4.734966 -5.000749 -5.229825 -5.390935 -5.433619 -5.176476 -4.461244 -3.378633 -29.15287 -1.458646 -1.745875 -2.092271 -2.477576 -2.873195 -3.266480 -3.643034 -3.999953 -4.332930 -4.642046 -4.932229 -5.186572 -5.413706 -5.608330 -5.766087 -5.847782 -5.728017 -5.194101 -4.156357 -29.15287 -2.645439 -2.839492 -3.101137 -3.406291 -3.725925 -4.050032 -4.366308 -4.667630 -4.949159 -5.210866 -5.454459 -5.669355 -5.866531 -6.032835 -6.169547 -6.258276 -6.242578 -5.917510 -4.996242 -29.15287 -4.019302 -4.094685 -4.245270 -4.447495 -4.678346 -4.924376 -5.170322 -5.413662 -5.643753 -5.861256 -6.066183 -6.244381 -6.408094 -6.542456 -6.665288 -6.761156 -6.806173 -6.666911 -5.886305 -29.15287 -5.785552 -5.722097 -5.742067 -5.822145 -5.944003 -6.098351 -6.264904 -6.441881 -6.618647 -6.787453 -6.954995 -7.107648 -7.253211 -7.379271 -7.516130 -7.624100 -7.685548 -7.595367 -6.835324 -29.15287 -54.29601 -53.71881 -52.98590 -52.12375 -51.15263 -50.08783 -48.94099 -47.72118 -46.43563 -45.09027 -43.69000 -42.23901 -40.74087 -39.19867 -37.61513 -35.99266 -34.33337 -32.63920 -30.91185 -29.15287 3.062389 2.929636 2.788598 2.629259 2.429080 2.205498 1.950059 1.660629 1.360985 1.057760 0.7709723 0.5198696 0.3200827 0.1774500 8.5261256E-02 3.1443052E-02 3.7709810E-03 -8.7780645E-03 -1.4256047E-02 -31.24921 4.154720 3.824586 3.518427 3.205786 2.894677 2.579184 2.247456 1.909070 1.578161 1.265103 0.9943593 0.7879627 0.6607001 0.6061280 0.6105145 0.6552133 0.7251071 0.8096576 0.9023657 -31.24921 4.845835 4.326781 3.848166 3.390979 2.962513 2.555324 2.154773 1.771437 1.408417 1.086499 0.8229602 0.6471699 0.5752646 0.5947782 0.6832740 0.8169957 0.9782798 1.156587 1.345796 -31.24921 5.200801 4.554648 3.961747 3.403603 2.883168 2.395561 1.937219 1.499933 1.097018 0.7489262 0.4710459 0.3029010 0.2614321 0.3368975 0.4989398 0.7167801 0.9675624 1.238907 1.524368 -31.24921 5.295942 4.586879 3.928242 3.301997 2.714602 2.172454 1.665701 1.183409 0.7342688 0.3358143 2.0580789E-02 -0.1743739 -0.2177837 -0.1105672 0.1126655 0.4091328 0.7475740 1.111618 1.493287 -31.24921 5.203329 4.469704 3.774621 3.111923 2.489892 1.903356 1.357358 0.8473136 0.3616448 -8.6371534E-02 -0.4538458 -0.7036880 -0.7839350 -0.6744629 -0.4064673 -3.7934061E-02 0.3862146 0.8425980 1.320475 -31.24921 4.966145 4.230905 3.528260 2.850986 2.207331 1.595633 1.024718 0.4937760 -1.6641455E-02 -0.4912289 -0.9089847 -1.223558 -1.369635 -1.289100 -0.9975269 -0.5661544 -5.8794223E-02 0.4893539 1.063422 -31.24921 4.614603 3.900033 3.203707 2.521167 1.870380 1.250291 0.6651729 0.1166428 -0.3992964 -0.8919454 -1.342595 -1.718166 -1.950534 -1.941376 -1.663165 -1.186023 -0.6017373 3.6541991E-02 0.7064886 -31.24921 4.173656 3.484028 2.802859 2.130170 1.482911 0.8620768 0.2691502 -0.2808618 -0.7985743 -1.297279 -1.760746 -2.177777 -2.487627 -2.573246 -2.354237 -1.858450 -1.207329 -0.4818964 0.2832950 -31.24921 3.643762 2.990496 2.335386 1.680150 1.041198 0.4248512 -0.1586406 -0.7045420 -1.218525 -1.714116 -2.180263 -2.613735 -2.975557 -3.159725 -3.038457 -2.565775 -1.866238 -1.059419 -0.2003845 -31.24921 3.036603 2.425140 1.800574 1.166730 0.5454512 -5.1702280E-02 -0.6245852 -1.161408 -1.663394 -2.153350 -2.609137 -3.043949 -3.422803 -3.685873 -3.678785 -3.280497 -2.564145 -1.687085 -0.7369878 -31.24921 2.348692 1.783231 1.196898 0.5949525 4.6492735E-04 -0.5771033 -1.130332 -1.654215 -2.141501 -2.615195 -3.056802 -3.473839 -3.855083 -4.147816 -4.248550 -3.968596 -3.282767 -2.356063 -1.320209 -31.24921 1.580815 1.068761 0.5265722 -4.1027986E-02 -0.6032296 -1.156095 -1.686257 -2.187373 -2.655787 -3.105171 -3.522592 -3.918933 -4.274885 -4.573441 -4.739131 -4.599118 -4.008056 -3.067055 -1.955762 -31.24921 0.7251623 0.2720346 -0.2210239 -0.7480299 -1.276175 -1.796777 -2.295717 -2.765679 -3.204922 -3.624034 -4.015788 -4.372715 -4.694798 -4.975363 -5.164963 -5.139511 -4.705022 -3.805704 -2.638907 -31.24921 -0.2337739 -0.6189712 -1.058870 -1.535737 -2.021005 -2.499482 -2.957594 -3.389936 -3.794804 -4.172976 -4.519837 -4.839024 -5.119319 -5.371181 -5.548033 -5.608100 -5.347011 -4.569085 -3.383632 -31.24921 -1.315646 -1.624112 -1.997465 -2.413762 -2.843075 -3.269519 -3.676402 -4.056669 -4.412856 -4.744639 -5.047684 -5.319684 -5.557490 -5.769806 -5.936344 -6.027318 -5.913439 -5.338589 -4.196936 -31.24921 -2.557658 -2.770186 -3.057361 -3.390671 -3.745340 -4.098437 -4.441512 -4.766301 -5.069308 -5.349198 -5.603826 -5.826738 -6.027550 -6.212038 -6.355848 -6.445868 -6.435954 -6.093347 -5.077895 -31.24921 -4.007041 -4.091410 -4.263269 -4.486720 -4.746198 -5.017538 -5.287652 -5.546285 -5.798426 -6.028002 -6.241492 -6.427607 -6.594802 -6.740156 -6.867428 -6.962588 -7.011693 -6.876725 -6.029653 -31.24921 -5.850621 -5.786227 -5.816958 -5.909978 -6.057067 -6.231137 -6.417006 -6.605178 -6.799079 -6.982153 -7.160622 -7.317511 -7.464958 -7.604917 -7.736960 -7.850753 -7.923587 -7.846222 -7.047346 -31.24921 -58.39398 -57.77769 -56.98871 -56.05777 -55.00801 -53.85657 -52.61637 -51.29741 -49.90762 -48.45348 -46.94035 -45.37278 -43.75464 -42.08929 -40.37968 -38.62841 -36.83777 -35.00983 -33.14642 -31.24921 3.278955 3.146724 3.008142 2.846785 2.637854 2.416543 2.160081 1.867654 1.543107 1.214356 0.9026474 0.6288967 0.4087703 0.2531094 0.1522861 9.4708338E-02 6.5570801E-02 5.2540667E-02 4.7325268E-02 -33.37725 4.450034 4.099494 3.776307 3.447591 3.122806 2.804461 2.468329 2.114940 1.760309 1.421933 1.129369 0.9076855 0.7685967 0.7112673 0.7174433 0.7674457 0.8438697 0.9354373 1.035558 -33.37725 5.192434 4.636330 4.124957 3.638553 3.197941 2.776701 2.363539 1.955646 1.571056 1.226068 0.9422865 0.7532194 0.6774081 0.7006964 0.7993054 0.9456344 1.120592 1.312975 1.516713 -33.37725 5.572118 4.881678 4.246683 3.661763 3.118287 2.614491 2.128355 1.666166 1.239561 0.8672189 0.5700204 0.3858711 0.3422025 0.4257786 0.6041104 0.8411806 1.112495 1.404938 1.712076 -33.37725 5.674782 4.919407 4.221600 3.563519 2.950012 2.377238 1.843318 1.334695 0.8591201 0.4364528 9.0924971E-02 -0.1272065 -0.1823928 -6.9902100E-02 0.1722477 0.4932404 0.8586404 1.250691 1.661202 -33.37725 5.581090 4.804088 4.069344 3.372323 2.714173 2.096020 1.523436 0.9881539 0.4764056 4.7286828E-03 -0.3957104 -0.6745268 -0.7769653 -0.6687950 -0.3800895 1.8219028E-02 0.4759380 0.9673938 1.481359 -33.37725 5.338608 4.561087 3.817244 3.099501 2.420108 1.777133 1.180568 0.6244921 9.1282688E-02 -0.4103347 -0.8537686 -1.202538 -1.377604 -1.306709 -0.9947155 -0.5283450 1.9369038E-02 0.6098747 1.227370 -33.37725 4.977926 4.218277 3.478271 2.757644 2.070992 1.419829 0.8077340 0.2385988 -0.3081919 -0.8186159 -1.293065 -1.699778 -1.963351 -1.972048 -1.676913 -1.161274 -0.5292195 0.1590277 0.8798586 -33.37725 4.517237 3.785077 3.064003 2.352765 1.669844 1.018029 0.4009498 -0.1760768 -0.7191055 -1.234796 -1.721583 -2.166798 -2.506787 -2.630106 -2.407204 -1.875314 -1.171076 -0.3882108 0.4353295 -33.37725 3.966131 3.274521 2.579796 1.885897 1.215426 0.5689517 -4.6655793E-02 -0.6138946 -1.152431 -1.666371 -2.155020 -2.612369 -2.998697 -3.229205 -3.128315 -2.628568 -1.872874 -1.001284 -7.6347642E-02 -33.37725 3.334564 2.687239 2.027209 1.358619 0.7033085 7.3587179E-02 -0.5283976 -1.086497 -1.611988 -2.122326 -2.599194 -3.049993 -3.454606 -3.760309 -3.788515 -3.381304 -2.609532 -1.660342 -0.6365753 -33.37725 2.622274 2.025681 1.403668 0.7653863 0.1387334 -0.4708306 -1.053428 -1.597067 -2.109671 -2.604276 -3.061646 -3.493772 -3.900038 -4.233232 -4.369560 -4.100431 -3.367058 -2.362436 -1.245013 -33.37725 1.825967 1.285313 0.7107458 0.1099632 -0.4875957 -1.070056 -1.630120 -2.152802 -2.644111 -3.113864 -3.545315 -3.957950 -4.344791 -4.667714 -4.868111 -4.753023 -4.129063 -3.108189 -1.907591 -33.37725 0.9417359 0.4633730 -6.1602972E-02 -0.6196825 -1.183533 -1.735163 -2.261204 -2.755339 -3.216379 -3.654333 -4.059613 -4.438607 -4.783893 -5.088922 -5.302084 -5.304208 -4.855398 -3.880125 -2.616437 -33.37725 -5.0382774E-02 -0.4598038 -0.9287310 -1.436913 -1.956025 -2.466209 -2.951218 -3.408055 -3.834226 -4.235632 -4.594971 -4.931409 -5.234477 -5.502376 -5.698748 -5.775837 -5.518692 -4.677927 -3.390706 -33.37725 -1.173284 -1.501495 -1.903923 -2.349233 -2.814520 -3.269886 -3.707862 -4.114659 -4.486691 -4.839466 -5.155275 -5.441876 -5.701515 -5.919859 -6.090985 -6.199798 -6.098284 -5.480465 -4.237929 -33.37725 -2.469203 -2.696985 -3.011952 -3.373681 -3.760798 -4.145311 -4.513182 -4.859869 -5.179863 -5.479693 -5.745153 -5.979384 -6.192757 -6.381988 -6.519870 -6.622424 -6.623612 -6.262161 -5.157677 -33.37725 -3.988695 -4.082588 -4.273275 -4.525108 -4.813443 -5.113092 -5.402112 -5.679850 -5.938218 -6.188810 -6.409390 -6.604634 -6.776816 -6.933981 -7.044814 -7.144606 -7.206991 -7.070234 -6.165982 -33.37725 -5.908469 -5.844246 -5.881484 -5.995384 -6.162366 -6.362243 -6.565611 -6.773823 -6.968074 -7.170759 -7.353941 -7.516392 -7.668879 -7.814120 -7.933288 -8.046632 -8.135680 -8.074129 -7.250971 -33.37725 -62.55962 -61.90395 -61.05744 -60.05618 -58.92605 -57.68614 -56.35068 -54.93060 -53.43458 -51.86963 -50.24158 -48.55534 -46.81510 -45.02449 -43.18669 -41.30449 -39.38035 -37.41648 -35.41485 -33.37725 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.1250684 -0.8429193 -0.8583804 -0.8726891 -0.8871758 -0.9006252 -0.9119613 -0.9353285 -0.9586550 -0.9817949 -1.004791 -1.025447 -1.047242 -1.068131 -1.091150 -1.121540 -1.151766 -1.180423 -1.206698 -1.228088 -1.268719 -0.8684047 -0.8831097 -0.8994303 -0.9143894 -0.9272342 -0.9396322 -0.9635984 -0.9874179 -1.011021 -1.032469 -1.054158 -1.075636 -1.095590 -1.117653 -1.147182 -1.175946 -1.202358 -1.222863 -1.247126 -1.268719 -0.8952405 -0.9114740 -0.9278924 -0.9420361 -0.9555812 -0.9689035 -0.9933277 -1.017389 -1.041268 -1.062134 -1.083688 -1.104237 -1.123137 -1.144426 -1.172933 -1.200159 -1.224320 -1.239939 -1.266079 -1.268719 -0.9265279 -0.9424003 -0.9574512 -0.9720578 -0.9860833 -1.000324 -1.024889 -1.048984 -1.070782 -1.092762 -1.114017 -1.133817 -1.150730 -1.172301 -1.199419 -1.224976 -1.246889 -1.257833 -1.285470 -1.268719 -0.9604969 -0.9741562 -0.9895405 -1.004081 -1.018951 -1.033444 -1.057711 -1.079891 -1.102600 -1.124444 -1.144738 -1.163450 -1.179605 -1.200224 -1.225841 -1.249415 -1.269169 -1.276062 -1.304390 -1.268719 -0.9946834 -1.008581 -1.023569 -1.038695 -1.053357 -1.067697 -1.091649 -1.112785 -1.135128 -1.156180 -1.175431 -1.191666 -1.208459 -1.227227 -1.251319 -1.272544 -1.290325 -1.293626 -1.321779 -1.268719 -1.033179 -1.046174 -1.061458 -1.076340 -1.090558 -1.104514 -1.125325 -1.147441 -1.168999 -1.189191 -1.205531 -1.222373 -1.238095 -1.255218 -1.277156 -1.295512 -1.311619 -1.311750 -1.338856 -1.268719 -1.075622 -1.088250 -1.102979 -1.117220 -1.129301 -1.141847 -1.163136 -1.184237 -1.204674 -1.223419 -1.238640 -1.254815 -1.268029 -1.283598 -1.303262 -1.319115 -1.328535 -1.330391 -1.355525 -1.268719 -1.123441 -1.135042 -1.148979 -1.160545 -1.172665 -1.184243 -1.204145 -1.223861 -1.242650 -1.257877 -1.273986 -1.288818 -1.300135 -1.312983 -1.329602 -1.343220 -1.346149 -1.349792 -1.371956 -1.268719 -1.176935 -1.185509 -1.197667 -1.208975 -1.220229 -1.230536 -1.248818 -1.266411 -1.281194 -1.297252 -1.311801 -1.323245 -1.332712 -1.343073 -1.356444 -1.367940 -1.364542 -1.369474 -1.387572 -1.268719 -1.234748 -1.242646 -1.253134 -1.262950 -1.272179 -1.280820 -1.294306 -1.309918 -1.325441 -1.339717 -1.350095 -1.359744 -1.366688 -1.372822 -1.383821 -1.388425 -1.383854 -1.388542 -1.401307 -1.268719 -1.301964 -1.308049 -1.316278 -1.324099 -1.330626 -1.334180 -1.347341 -1.360988 -1.374336 -1.384059 -1.392470 -1.399173 -1.404247 -1.407734 -1.412946 -1.409247 -1.405079 -1.408313 -1.414090 -1.268719 -1.380143 -1.383618 -1.388402 -1.390474 -1.393792 -1.397253 -1.407886 -1.416033 -1.426241 -1.433547 -1.438715 -1.442476 -1.444706 -1.445499 -1.439224 -1.432023 -1.427811 -1.427553 -1.425077 -1.268719 -1.468094 -1.467866 -1.469103 -1.470271 -1.470063 -1.467500 -1.474112 -1.479204 -1.484713 -1.488738 -1.489769 -1.490540 -1.489411 -1.482167 -1.469412 -1.457986 -1.451579 -1.446141 -1.433427 -1.268719 -1.575696 -1.571593 -1.566961 -1.563166 -1.557400 -1.551969 -1.553921 -1.554460 -1.554456 -1.553545 -1.551000 -1.547295 -1.537850 -1.523082 -1.507359 -1.492996 -1.480769 -1.467098 -1.415274 -1.268719 -1.706813 -1.697012 -1.687892 -1.678290 -1.668273 -1.659021 -1.648946 -1.644973 -1.639201 -1.634070 -1.623450 -1.610631 -1.592722 -1.574310 -1.555565 -1.537863 -1.516779 -1.491594 -1.404492 -1.268719 -1.874894 -1.859318 -1.844410 -1.830586 -1.814646 -1.800974 -1.787697 -1.767752 -1.750405 -1.728589 -1.709427 -1.688845 -1.667109 -1.643593 -1.620248 -1.592091 -1.559688 -1.519163 -1.393275 -1.268719 -2.114592 -2.086149 -2.064935 -2.040141 -2.014786 -1.989487 -1.963207 -1.935843 -1.908152 -1.879138 -1.848863 -1.821484 -1.786503 -1.751387 -1.712314 -1.669115 -1.617913 -1.491600 -1.381624 -1.268719 -2.525558 -2.488681 -2.450871 -2.416910 -2.375901 -2.333868 -2.290731 -2.248437 -2.201792 -2.153841 -2.103348 -2.049738 -1.991633 -1.927220 -1.756410 -1.662188 -1.566286 -1.468732 -1.369539 -1.268719 -2.729980 -2.665080 -2.598778 -2.531085 -2.462012 -2.391573 -2.320023 -2.246644 -2.172182 -2.096405 -2.019321 -1.940942 -1.861279 -1.780347 -1.698156 -1.614718 -1.530032 -1.444130 -1.357021 -1.268719 -0.5940138 -0.6116205 -0.6307744 -0.6693694 -0.7050378 -0.7420909 -0.7768027 -0.8105723 -0.8410568 -0.8759487 -0.9159539 -0.9548067 -0.9929634 -1.030172 -1.065681 -1.106360 -1.152053 -1.200707 -1.244527 -2.506804 -0.6071644 -0.6283090 -0.6554704 -0.6980041 -0.7409329 -0.7824224 -0.8204315 -0.8566889 -0.8885129 -0.9260604 -0.9675186 -1.006389 -1.044685 -1.080222 -1.113332 -1.151133 -1.193596 -1.236239 -1.275468 -2.506804 -0.6303366 -0.6581085 -0.6930745 -0.7384462 -0.7848067 -0.8272890 -0.8690904 -0.9069428 -0.9410140 -0.9805523 -1.022434 -1.061972 -1.099028 -1.132978 -1.163858 -1.199461 -1.238730 -1.275377 -1.309989 -2.506804 -0.6684738 -0.7004331 -0.7395138 -0.7892650 -0.8347803 -0.8804887 -0.9235619 -0.9625294 -0.9993529 -1.039867 -1.081687 -1.122000 -1.158000 -1.190533 -1.219448 -1.253057 -1.290021 -1.320783 -1.350903 -2.506804 -0.7188837 -0.7557526 -0.7982448 -0.8455737 -0.8934902 -0.9400517 -0.9835041 -1.024496 -1.062759 -1.103752 -1.146027 -1.185948 -1.220677 -1.252067 -1.279289 -1.311805 -1.346897 -1.372148 -1.398035 -2.506804 -0.7830703 -0.8219194 -0.8625693 -0.9107595 -0.9582332 -1.004825 -1.049720 -1.091698 -1.130478 -1.171291 -1.214268 -1.252575 -1.287289 -1.317692 -1.343914 -1.375788 -1.408847 -1.429479 -1.451458 -2.506804 -0.8557599 -0.8940480 -0.9346430 -0.9817068 -1.027862 -1.074558 -1.119471 -1.161666 -1.200256 -1.241789 -1.283027 -1.320719 -1.355112 -1.384642 -1.410975 -1.441628 -1.472856 -1.489354 -1.507309 -2.506804 -0.9380460 -0.9742386 -1.013786 -1.058521 -1.103484 -1.148743 -1.192761 -1.233770 -1.273490 -1.314429 -1.353839 -1.390790 -1.424386 -1.453169 -1.479629 -1.510257 -1.536934 -1.551803 -1.565385 -2.506804 -1.028829 -1.062535 -1.099490 -1.141490 -1.184172 -1.226927 -1.269232 -1.310289 -1.349053 -1.387058 -1.425633 -1.461710 -1.494489 -1.524463 -1.550164 -1.579816 -1.601357 -1.615559 -1.623976 -2.506804 -1.128629 -1.158572 -1.192021 -1.230250 -1.269171 -1.309487 -1.350980 -1.390397 -1.425392 -1.461750 -1.499388 -1.534262 -1.566193 -1.596108 -1.621854 -1.648963 -1.665699 -1.678710 -1.681127 -2.506804 -1.237934 -1.263476 -1.292023 -1.325838 -1.362227 -1.400251 -1.437890 -1.473901 -1.506641 -1.541361 -1.577276 -1.610212 -1.643197 -1.672464 -1.696919 -1.718574 -1.732684 -1.743776 -1.739507 -2.506804 -1.356748 -1.377137 -1.402372 -1.433116 -1.465300 -1.497885 -1.531021 -1.564367 -1.594627 -1.626879 -1.660149 -1.694409 -1.725994 -1.753786 -1.774763 -1.789867 -1.802732 -1.810221 -1.797978 -2.506804 -1.491242 -1.506734 -1.526112 -1.550504 -1.576594 -1.605332 -1.635327 -1.664507 -1.691293 -1.720338 -1.753434 -1.785776 -1.815361 -1.840065 -1.852938 -1.863857 -1.875629 -1.876818 -1.854002 -2.506804 -1.646298 -1.653385 -1.664129 -1.682758 -1.704325 -1.728923 -1.754092 -1.777923 -1.802981 -1.828571 -1.857776 -1.886218 -1.912382 -1.929929 -1.936370 -1.942797 -1.949099 -1.941825 -1.905746 -2.506804 -1.827239 -1.826945 -1.832364 -1.842920 -1.855270 -1.873854 -1.896838 -1.917781 -1.936819 -1.955778 -1.978412 -2.000622 -2.017235 -2.027851 -2.031576 -2.030856 -2.026237 -2.007073 -1.954072 -2.506804 -2.053886 -2.044116 -2.041714 -2.044927 -2.051749 -2.061746 -2.073817 -2.086094 -2.098171 -2.110043 -2.122249 -2.133134 -2.141515 -2.145738 -2.144053 -2.129389 -2.111299 -2.073398 -2.000159 -2.506804 -2.362307 -2.340939 -2.322942 -2.312155 -2.307818 -2.305674 -2.307702 -2.307780 -2.305171 -2.304638 -2.306686 -2.309534 -2.308782 -2.300830 -2.283098 -2.253585 -2.210331 -2.147786 -2.049932 -2.506804 -2.802126 -2.763608 -2.728615 -2.703629 -2.683648 -2.665312 -2.649953 -2.636483 -2.621612 -2.605117 -2.585076 -2.569250 -2.548784 -2.519175 -2.477797 -2.419779 -2.342492 -2.246654 -2.118946 -2.506804 -3.590308 -3.536023 -3.484146 -3.433760 -3.387726 -3.340817 -3.295384 -3.252510 -3.206328 -3.155972 -3.099793 -3.036007 -2.963009 -2.881097 -2.793447 -2.691942 -2.569806 -2.429717 -2.263746 -2.506804 -5.857482 -5.726281 -5.589515 -5.447282 -5.299685 -5.146824 -4.988782 -4.825903 -4.657535 -4.484524 -4.306737 -4.124269 -3.937417 -3.745591 -3.549622 -3.349344 -3.144806 -2.936155 -2.723469 -2.506804 -0.2834751 -0.3221168 -0.3639694 -0.4034590 -0.4460218 -0.5006676 -0.5552018 -0.6075467 -0.6575930 -0.7051470 -0.7542689 -0.8076466 -0.8597997 -0.9102205 -0.9582121 -1.004037 -1.052608 -1.101922 -1.154257 -3.835547 -0.2542022 -0.3035064 -0.3554462 -0.4045682 -0.4609466 -0.5258422 -0.5886343 -0.6493624 -0.7065148 -0.7600896 -0.8142782 -0.8713646 -0.9239861 -0.9725502 -1.016283 -1.055480 -1.095813 -1.134325 -1.173851 -3.835547 -0.2561878 -0.3124367 -0.3716820 -0.4327488 -0.4990283 -0.5717235 -0.6418638 -0.7086013 -0.7726342 -0.8315747 -0.8913631 -0.9506212 -1.003872 -1.050826 -1.090651 -1.124158 -1.156957 -1.186292 -1.213533 -3.835547 -0.2822514 -0.3427586 -0.4107421 -0.4808728 -0.5546104 -0.6325849 -0.7081220 -0.7805493 -0.8491297 -0.9140108 -0.9779642 -1.038623 -1.092359 -1.138059 -1.174444 -1.203438 -1.229454 -1.251088 -1.266621 -3.835547 -0.3287556 -0.3949040 -0.4680274 -0.5431989 -0.6222848 -0.7042673 -0.7839474 -0.8604530 -0.9329593 -1.002081 -1.068495 -1.130313 -1.183609 -1.228182 -1.261458 -1.286795 -1.307031 -1.321431 -1.325939 -3.835547 -0.3972572 -0.4671119 -0.5423166 -0.6206967 -0.7023991 -0.7869497 -0.8701901 -0.9499015 -1.026014 -1.097341 -1.164807 -1.227233 -1.281129 -1.324074 -1.355744 -1.378545 -1.394180 -1.402756 -1.397296 -3.835547 -0.4869936 -0.5567122 -0.6321654 -0.7120787 -0.7955049 -0.8815084 -0.9655620 -1.047601 -1.125804 -1.198612 -1.266505 -1.329584 -1.383132 -1.425498 -1.456836 -1.478140 -1.491162 -1.495925 -1.481855 -3.835547 -0.5939624 -0.6614941 -0.7368288 -0.8170971 -0.9003625 -0.9854375 -1.069015 -1.150588 -1.228798 -1.301995 -1.370471 -1.433057 -1.485711 -1.527721 -1.559532 -1.580199 -1.592235 -1.594289 -1.572590 -3.835547 -0.7186511 -0.7838749 -0.8576499 -0.9357540 -1.016365 -1.098812 -1.180188 -1.259060 -1.335419 -1.408182 -1.476402 -1.537537 -1.588713 -1.631793 -1.665075 -1.685791 -1.699233 -1.698074 -1.670105 -3.835547 -0.8636857 -0.9251698 -0.9934337 -1.066400 -1.143157 -1.221161 -1.298089 -1.373011 -1.446662 -1.517607 -1.582705 -1.641242 -1.692134 -1.735963 -1.770212 -1.791879 -1.808130 -1.804214 -1.770476 -3.835547 -1.029419 -1.083428 -1.144032 -1.210185 -1.280480 -1.352673 -1.423871 -1.494718 -1.563933 -1.629677 -1.689860 -1.745188 -1.796387 -1.842025 -1.876193 -1.899781 -1.917768 -1.911155 -1.872470 -3.835547 -1.213578 -1.258486 -1.310450 -1.367841 -1.430090 -1.495557 -1.561779 -1.625246 -1.686964 -1.745962 -1.801324 -1.854401 -1.905496 -1.950153 -1.986292 -2.014691 -2.030956 -2.022551 -1.978439 -3.835547 -1.417686 -1.452458 -1.493848 -1.543168 -1.597840 -1.653831 -1.710120 -1.764700 -1.817138 -1.870189 -1.921863 -1.972993 -2.020107 -2.065420 -2.104244 -2.134413 -2.147590 -2.138746 -2.087084 -3.835547 -1.646546 -1.671104 -1.702744 -1.740933 -1.783290 -1.826299 -1.870769 -1.916252 -1.962384 -2.009022 -2.057791 -2.102520 -2.146596 -2.191423 -2.233585 -2.259647 -2.268948 -2.257881 -2.196323 -3.835547 -1.911901 -1.921237 -1.936789 -1.960114 -1.988104 -2.020843 -2.055768 -2.093153 -2.133536 -2.173467 -2.213467 -2.252756 -2.293249 -2.337422 -2.373704 -2.392751 -2.399559 -2.380215 -2.303495 -3.835547 -2.215612 -2.207886 -2.210533 -2.219735 -2.237829 -2.261735 -2.287309 -2.314292 -2.342435 -2.371846 -2.405155 -2.439921 -2.472225 -2.504011 -2.529753 -2.542006 -2.539830 -2.505091 -2.402860 -3.835547 -2.612032 -2.587973 -2.574357 -2.568956 -2.571414 -2.577115 -2.586776 -2.602287 -2.620315 -2.639146 -2.658366 -2.678089 -2.693527 -2.711362 -2.728026 -2.727095 -2.702149 -2.638196 -2.499999 -3.835547 -3.187632 -3.137725 -3.101237 -3.074271 -3.055621 -3.041484 -3.031775 -3.026144 -3.020300 -3.020831 -3.019851 -3.021636 -3.020406 -3.018176 -3.009038 -2.979243 -2.911984 -2.797374 -2.610818 -3.835547 -4.220209 -4.137120 -4.067605 -4.007507 -3.952975 -3.901035 -3.857467 -3.819134 -3.783221 -3.748007 -3.712043 -3.670686 -3.624889 -3.569229 -3.493735 -3.388345 -3.239994 -3.045227 -2.796848 -3.835547 -9.427989 -9.229338 -9.017789 -8.794415 -8.559289 -8.312727 -8.055031 -7.786590 -7.507679 -7.218656 -6.919851 -6.611496 -6.293975 -5.967504 -5.632383 -5.288882 -4.937187 -4.577610 -4.210558 -3.835547 4.8262395E-02 -6.3710674E-03 -7.0427731E-02 -0.1362024 -0.1991654 -0.2672835 -0.3433575 -0.4157093 -0.4833924 -0.5486480 -0.6086539 -0.6697419 -0.7284203 -0.7844279 -0.8403370 -0.8913559 -0.9395951 -0.9858026 -1.033889 -5.247004 0.1350613 6.1245102E-02 -2.0082695E-02 -0.1038184 -0.1848487 -0.2712795 -0.3624366 -0.4476488 -0.5279184 -0.6017718 -0.6675076 -0.7320945 -0.7915972 -0.8458953 -0.8944391 -0.9332781 -0.9656823 -0.9919714 -1.016814 -5.247004 0.1634748 7.6887235E-02 -1.9298322E-02 -0.1177892 -0.2156535 -0.3183480 -0.4197699 -0.5152468 -0.6055033 -0.6868238 -0.7599998 -0.8296330 -0.8901645 -0.9438365 -0.9860265 -1.014417 -1.032439 -1.040547 -1.044038 -5.247004 0.1493785 5.3791083E-02 -5.2655857E-02 -0.1641887 -0.2774503 -0.3887134 -0.4984546 -0.6040461 -0.7007570 -0.7888942 -0.8695216 -0.9443373 -1.008844 -1.062671 -1.099983 -1.119835 -1.125276 -1.117030 -1.100707 -5.247004 0.1000632 -1.2110650E-03 -0.1151754 -0.2366714 -0.3562195 -0.4737686 -0.5919483 -0.7025658 -0.8053969 -0.9003317 -0.9885774 -1.067951 -1.137498 -1.191999 -1.226025 -1.239036 -1.234056 -1.211210 -1.176585 -5.247004 2.1028895E-02 -8.4920056E-02 -0.2040338 -0.3277410 -0.4504740 -0.5733531 -0.6935012 -0.8087922 -0.9165646 -1.017939 -1.111191 -1.196947 -1.271097 -1.326165 -1.358376 -1.366829 -1.353654 -1.318102 -1.266742 -5.247004 -8.7688148E-02 -0.1950140 -0.3137079 -0.4371898 -0.5618604 -0.6843945 -0.8059436 -0.9231903 -1.035143 -1.141600 -1.239527 -1.331280 -1.409414 -1.466249 -1.499046 -1.505709 -1.487059 -1.442681 -1.376270 -5.247004 -0.2234607 -0.3269914 -0.4424238 -0.5652499 -0.6867794 -0.8078956 -0.9279828 -1.046211 -1.160765 -1.268757 -1.372374 -1.468151 -1.548364 -1.608356 -1.643420 -1.651441 -1.630407 -1.582177 -1.502533 -5.247004 -0.3825614 -0.4812125 -0.5909435 -0.7077990 -0.8260414 -0.9437655 -1.060831 -1.177452 -1.290628 -1.400725 -1.506383 -1.603173 -1.684590 -1.746750 -1.785547 -1.796250 -1.775436 -1.726448 -1.636217 -5.247004 -0.5667739 -0.6562710 -0.7578349 -0.8678481 -0.9804540 -1.093718 -1.205682 -1.316685 -1.428441 -1.538470 -1.642359 -1.737309 -1.818824 -1.882476 -1.926562 -1.942184 -1.924592 -1.877468 -1.779634 -5.247004 -0.7740756 -0.8535406 -0.9451236 -1.046783 -1.151231 -1.256792 -1.362492 -1.467609 -1.575494 -1.680814 -1.779489 -1.870702 -1.950477 -2.016195 -2.063520 -2.084397 -2.073337 -2.030078 -1.926782 -5.247004 -1.006708 -1.074582 -1.154305 -1.244702 -1.338543 -1.435230 -1.534549 -1.633326 -1.731445 -1.828104 -1.919626 -2.004412 -2.082205 -2.149429 -2.198930 -2.224468 -2.225266 -2.182799 -2.075690 -5.247004 -1.267321 -1.320613 -1.386450 -1.464285 -1.548283 -1.635737 -1.725141 -1.811796 -1.898061 -1.983097 -2.064687 -2.144029 -2.220785 -2.285918 -2.336623 -2.368562 -2.381071 -2.340705 -2.232211 -5.247004 -1.559739 -1.597778 -1.650903 -1.716330 -1.786441 -1.858423 -1.933402 -2.005294 -2.076349 -2.148406 -2.224210 -2.298005 -2.367173 -2.430533 -2.482491 -2.525269 -2.540676 -2.503225 -2.393434 -5.247004 -1.900421 -1.921117 -1.954835 -2.001256 -2.052870 -2.106018 -2.163116 -2.218018 -2.278231 -2.343063 -2.406655 -2.469839 -2.531382 -2.590885 -2.648151 -2.691705 -2.705325 -2.674027 -2.556226 -5.247004 -2.297405 -2.293474 -2.302418 -2.325967 -2.354643 -2.392466 -2.438986 -2.482937 -2.524937 -2.573293 -2.625944 -2.677195 -2.729476 -2.788308 -2.840143 -2.876102 -2.884814 -2.850840 -2.718941 -5.247004 -2.777115 -2.750939 -2.738522 -2.743249 -2.752900 -2.769065 -2.794079 -2.820506 -2.845179 -2.875422 -2.912391 -2.955169 -2.995443 -3.034988 -3.070681 -3.097790 -3.099359 -3.044495 -2.876730 -5.247004 -3.477442 -3.415240 -3.365255 -3.338438 -3.319551 -3.308301 -3.311351 -3.314703 -3.317449 -3.322438 -3.335287 -3.350008 -3.366655 -3.385659 -3.404392 -3.409302 -3.379425 -3.273526 -3.038698 -5.247004 -4.719965 -4.607462 -4.501972 -4.422809 -4.353572 -4.296499 -4.252011 -4.216673 -4.181714 -4.149501 -4.123215 -4.102119 -4.081460 -4.056450 -4.020532 -3.956588 -3.829755 -3.608757 -3.273408 -5.247004 -13.37432 -13.10635 -12.81652 -12.50562 -12.17437 -11.82358 -11.45401 -11.06646 -10.66164 -10.24031 -9.803072 -9.350635 -8.883519 -8.402364 -7.907616 -7.399848 -6.879457 -6.346932 -5.802646 -5.247004 0.3514790 0.3026900 0.2257486 0.1416581 5.3883485E-02 -3.3579152E-02 -0.1292770 -0.2236101 -0.3159825 -0.4045618 -0.4841826 -0.5590680 -0.6267473 -0.6875859 -0.7433147 -0.7971464 -0.8458314 -0.8895382 -0.9314303 -6.733509 0.5110670 0.4308528 0.3280813 0.2170031 0.1036237 -7.6352833E-03 -0.1249386 -0.2403997 -0.3505935 -0.4506306 -0.5390944 -0.6177156 -0.6839482 -0.7379203 -0.7811078 -0.8166866 -0.8402165 -0.8532876 -0.8599209 -6.733509 0.5844267 0.4790961 0.3524699 0.2176819 8.3832897E-02 -4.8553366E-02 -0.1847675 -0.3171071 -0.4409359 -0.5517527 -0.6507280 -0.7336788 -0.8007523 -0.8506474 -0.8845392 -0.9031653 -0.9038371 -0.8885785 -0.8624016 -6.733509 0.5944534 0.4695174 0.3250104 0.1735966 2.3112312E-02 -0.1277785 -0.2795928 -0.4239932 -0.5565922 -0.6791689 -0.7871830 -0.8776406 -0.9481682 -0.9971991 -1.026526 -1.031115 -1.011641 -0.9704250 -0.9134660 -6.733509 0.5521599 0.4142790 0.2577670 9.5725827E-02 -6.7084193E-02 -0.2310056 -0.3927927 -0.5442072 -0.6860273 -0.8185557 -0.9350514 -1.034085 -1.111576 -1.163770 -1.191449 -1.186309 -1.149908 -1.085322 -0.9998944 -6.733509 0.4643650 0.3208813 0.1585611 -1.1633691E-02 -0.1823541 -0.3514843 -0.5154264 -0.6716320 -0.8222207 -0.9604504 -1.085153 -1.193149 -1.279166 -1.339369 -1.367226 -1.356179 -1.306729 -1.221831 -1.110280 -6.733509 0.3365604 0.1924084 2.8094437E-02 -0.1447301 -0.3166956 -0.4837422 -0.6474873 -0.8079549 -0.9598086 -1.104230 -1.236625 -1.352980 -1.448252 -1.517870 -1.549193 -1.536861 -1.478939 -1.377731 -1.243087 -6.733509 0.1733027 3.0975435E-02 -0.1303519 -0.2985705 -0.4643009 -0.6282098 -0.7911023 -0.9489322 -1.101977 -1.249379 -1.387116 -1.510992 -1.616792 -1.694608 -1.732229 -1.722604 -1.661393 -1.548901 -1.394496 -6.733509 -2.2991752E-02 -0.1583194 -0.3098928 -0.4681286 -0.6279889 -0.7882677 -0.9430529 -1.097641 -1.250405 -1.397409 -1.539019 -1.669852 -1.782792 -1.867198 -1.913908 -1.911523 -1.852858 -1.735046 -1.565718 -6.733509 -0.2458466 -0.3686288 -0.5083894 -0.6585099 -0.8094396 -0.9602278 -1.108316 -1.257240 -1.405477 -1.552140 -1.694183 -1.828218 -1.944753 -2.034551 -2.090405 -2.098713 -2.048301 -1.933857 -1.753292 -6.733509 -0.4932889 -0.6038679 -0.7317901 -0.8679361 -1.007471 -1.149805 -1.289338 -1.428568 -1.571828 -1.715024 -1.854301 -1.985314 -2.101271 -2.195143 -2.258042 -2.278284 -2.239738 -2.136266 -1.948745 -6.733509 -0.7723989 -0.8655016 -0.9776150 -1.100448 -1.228227 -1.358177 -1.487339 -1.618042 -1.752622 -1.887632 -2.019153 -2.143067 -2.256286 -2.351028 -2.418959 -2.450230 -2.426520 -2.338906 -2.149624 -6.733509 -1.083568 -1.158220 -1.253640 -1.360442 -1.472239 -1.590308 -1.708812 -1.827647 -1.948688 -2.070443 -2.190232 -2.306436 -2.412961 -2.506721 -2.576956 -2.616770 -2.611326 -2.541505 -2.354439 -6.733509 -1.434892 -1.487927 -1.563141 -1.654341 -1.751089 -1.852333 -1.954455 -2.057086 -2.160974 -2.267487 -2.373938 -2.479156 -2.579417 -2.667545 -2.738465 -2.783519 -2.802959 -2.743409 -2.561982 -6.733509 -1.837044 -1.869571 -1.922563 -1.992168 -2.067574 -2.146583 -2.226997 -2.310874 -2.398047 -2.487529 -2.579726 -2.672690 -2.762264 -2.844054 -2.910590 -2.967724 -2.999911 -2.951048 -2.778885 -6.733509 -2.309744 -2.314327 -2.339347 -2.381341 -2.431548 -2.487531 -2.545602 -2.607778 -2.677822 -2.749637 -2.824257 -2.900350 -2.978004 -3.048588 -3.118374 -3.177431 -3.207520 -3.174099 -2.997944 -6.733509 -2.883482 -2.856118 -2.850474 -2.864186 -2.887991 -2.917148 -2.950755 -2.988270 -3.035053 -3.084840 -3.138077 -3.191874 -3.256581 -3.322183 -3.379297 -3.424226 -3.450590 -3.417169 -3.221724 -6.733509 -3.689949 -3.619763 -3.572279 -3.549658 -3.538501 -3.532951 -3.528871 -3.531835 -3.548614 -3.569973 -3.597655 -3.625064 -3.663630 -3.701508 -3.736040 -3.771718 -3.777508 -3.712709 -3.447688 -6.733509 -5.117570 -4.977216 -4.857304 -4.762588 -4.686283 -4.622625 -4.567011 -4.517672 -4.480999 -4.454383 -4.440416 -4.429065 -4.423831 -4.426024 -4.425215 -4.408313 -4.340118 -4.140218 -3.735475 -6.733509 -17.64487 -17.30646 -16.93421 -16.52961 -16.09412 -15.62932 -15.13673 -14.61770 -14.07362 -13.50576 -12.91521 -12.30309 -11.67039 -11.01799 -10.34677 -9.657512 -8.950899 -8.227626 -7.488311 -6.733509 0.6456679 0.6013685 0.5142426 0.4199712 0.3161957 0.2072447 9.2993125E-02 -2.5806354E-02 -0.1431195 -0.2531539 -0.3574092 -0.4507180 -0.5314271 -0.6010526 -0.6608771 -0.7125785 -0.7614592 -0.8033369 -0.8403502 -8.288466 0.8747721 0.7895676 0.6714500 0.5423983 0.4059214 0.2660670 0.1206479 -2.6211947E-02 -0.1650805 -0.2957006 -0.4128780 -0.5092062 -0.5874535 -0.6449826 -0.6854854 -0.7108374 -0.7248655 -0.7248023 -0.7139853 -8.288466 0.9966171 0.8753493 0.7248030 0.5642710 0.3997532 0.2316367 6.1011739E-02 -0.1059366 -0.2663212 -0.4165555 -0.5458357 -0.6485715 -0.7263396 -0.7758344 -0.8002368 -0.8024840 -0.7840999 -0.7446654 -0.6888986 -8.288466 1.036134 0.8857443 0.7102643 0.5261309 0.3381896 0.1474901 -4.1168716E-02 -0.2253080 -0.4044172 -0.5705496 -0.7105726 -0.8248941 -0.9058972 -0.9538924 -0.9676899 -0.9518389 -0.9044319 -0.8282366 -0.7297613 -8.288466 1.006598 0.8367519 0.6422971 0.4420256 0.2391304 3.5477500E-02 -0.1664018 -0.3667701 -0.5601022 -0.7345457 -0.8880298 -1.013453 -1.103825 -1.156600 -1.167131 -1.139300 -1.067531 -0.9577079 -0.8189297 -8.288466 0.9155917 0.7363368 0.5321242 0.3214715 0.1118419 -9.8241001E-02 -0.3098683 -0.5191339 -0.7187131 -0.9016649 -1.066224 -1.201838 -1.305179 -1.367922 -1.383783 -1.348825 -1.258535 -1.118959 -0.9425102 -8.288466 0.7736567 0.5918128 0.3849202 0.1733650 -4.0194813E-02 -0.2530795 -0.4676622 -0.6773542 -0.8766795 -1.067911 -1.239108 -1.385529 -1.502794 -1.578085 -1.606755 -1.571685 -1.469177 -1.305294 -1.094501 -8.288466 0.5881338 0.4096864 0.2074637 -2.6727838E-03 -0.2157826 -0.4264740 -0.6349304 -0.8389937 -1.039867 -1.231256 -1.407867 -1.566111 -1.694823 -1.787235 -1.831277 -1.803780 -1.697317 -1.516391 -1.276166 -8.288466 0.3650523 0.1943457 -1.1884477E-03 -0.2049754 -0.4114068 -0.6123284 -0.8107484 -1.010860 -1.205872 -1.394675 -1.575714 -1.740652 -1.880191 -1.989674 -2.049190 -2.036267 -1.935248 -1.745816 -1.482420 -8.288466 0.1048078 -5.3854503E-02 -0.2378506 -0.4293679 -0.6215005 -0.8122178 -1.001723 -1.190758 -1.377796 -1.564198 -1.744888 -1.912149 -2.061523 -2.181141 -2.254751 -2.259374 -2.171452 -1.982156 -1.702477 -8.288466 -0.1889697 -0.3313260 -0.4977517 -0.6728024 -0.8523223 -1.029647 -1.205269 -1.383231 -1.563753 -1.743459 -1.919253 -2.086059 -2.238796 -2.364149 -2.449571 -2.472672 -2.405690 -2.227899 -1.940636 -8.288466 -0.5138733 -0.6357539 -0.7844776 -0.9430664 -1.104186 -1.264836 -1.428149 -1.596705 -1.766405 -1.935309 -2.102895 -2.264905 -2.413500 -2.541951 -2.634819 -2.675853 -2.634268 -2.483378 -2.195493 -8.288466 -0.8760219 -0.9755685 -1.101786 -1.240191 -1.383853 -1.529538 -1.679034 -1.832908 -1.988070 -2.144003 -2.298587 -2.449040 -2.589878 -2.715070 -2.811486 -2.864893 -2.848157 -2.732530 -2.451804 -8.288466 -1.281705 -1.355581 -1.458503 -1.578252 -1.704019 -1.830446 -1.959489 -2.095188 -2.232090 -2.371772 -2.508233 -2.644535 -2.773228 -2.892266 -2.989194 -3.049898 -3.057696 -2.980510 -2.715113 -8.288466 -1.748113 -1.796557 -1.873141 -1.967058 -2.068645 -2.170775 -2.276297 -2.388864 -2.502860 -2.622368 -2.740285 -2.858431 -2.974012 -3.082487 -3.174766 -3.237884 -3.278205 -3.224415 -2.978151 -8.288466 -2.297456 -2.312134 -2.355244 -2.418721 -2.490405 -2.562624 -2.639822 -2.725714 -2.814463 -2.912189 -3.010844 -3.108061 -3.204686 -3.300231 -3.383704 -3.460965 -3.511933 -3.476040 -3.253628 -8.288466 -2.964288 -2.937194 -2.939014 -2.967421 -3.003150 -3.041132 -3.089839 -3.144831 -3.204667 -3.275023 -3.347929 -3.421533 -3.495545 -3.577359 -3.662743 -3.733310 -3.774309 -3.762981 -3.538732 -8.288466 -3.874604 -3.791918 -3.739888 -3.722522 -3.717067 -3.710471 -3.716238 -3.732400 -3.752831 -3.783855 -3.831163 -3.877989 -3.927692 -3.987112 -4.046770 -4.096051 -4.136020 -4.112729 -3.837841 -8.288466 -5.449461 -5.285173 -5.143812 -5.047585 -4.965722 -4.888046 -4.822574 -4.777550 -4.743204 -4.719786 -4.710565 -4.708375 -4.717809 -4.733000 -4.762717 -4.787596 -4.778646 -4.642992 -4.198314 -8.288466 -22.20026 -21.79006 -21.33156 -20.82730 -20.27995 -19.69212 -19.06624 -18.40465 -17.70946 -16.98258 -16.22579 -15.44063 -14.62858 -13.79097 -12.92898 -12.04370 -11.13613 -10.20719 -9.257704 -8.288466 0.9508474 0.9039813 0.8103068 0.6997612 0.5780098 0.4542211 0.3234761 0.1837822 4.3911204E-02 -9.2191234E-02 -0.2152521 -0.3266116 -0.4250535 -0.5049527 -0.5710101 -0.6244590 -0.6699912 -0.7096995 -0.7425753 -9.906311 1.247657 1.152684 1.014452 0.8634963 0.7069542 0.5442995 0.3745965 0.1996031 2.7935864E-02 -0.1314527 -0.2694395 -0.3887459 -0.4813610 -0.5465678 -0.5850812 -0.6020938 -0.6028715 -0.5886343 -0.5608950 -9.906311 1.416011 1.270309 1.092069 0.9065796 0.7155185 0.5188739 0.3172650 0.1128925 -8.6002834E-02 -0.2646878 -0.4224601 -0.5517865 -0.6419079 -0.6948454 -0.7098620 -0.6929861 -0.6516048 -0.5858387 -0.5001991 -9.906311 1.478170 1.296198 1.089536 0.8767318 0.6571162 0.4329635 0.2048076 -2.3969611E-02 -0.2410218 -0.4418634 -0.6211316 -0.7635940 -0.8620968 -0.9120445 -0.9128006 -0.8689975 -0.7901992 -0.6763427 -0.5353806 -9.906311 1.456233 1.253380 1.024918 0.7916321 0.5548779 0.3118494 6.3991144E-02 -0.1804836 -0.4136454 -0.6339974 -0.8312131 -0.9886537 -1.102671 -1.158947 -1.156225 -1.096024 -0.9850885 -0.8268287 -0.6330467 -9.906311 1.364826 1.150196 0.9096066 0.6641454 0.4163597 0.1622171 -9.4451420E-02 -0.3454784 -0.5935346 -0.8288301 -1.035193 -1.209971 -1.340420 -1.412193 -1.415520 -1.349717 -1.214210 -1.016210 -0.7724552 -9.906311 1.213083 0.9960985 0.7509599 0.4998648 0.2451646 -9.5154122E-03 -0.2654179 -0.5231071 -0.7773023 -1.015844 -1.232690 -1.419907 -1.565282 -1.658248 -1.676095 -1.615721 -1.464313 -1.232660 -0.9422194 -9.906311 1.011016 0.7963540 0.5526356 0.3011304 4.9591225E-02 -0.2002745 -0.4555540 -0.7119083 -0.9620830 -1.200181 -1.422836 -1.618179 -1.779625 -1.892581 -1.936917 -1.890326 -1.734789 -1.478183 -1.146270 -9.906311 0.7616227 0.5550030 0.3176650 7.5612776E-02 -0.1690105 -0.4140351 -0.6625234 -0.9084066 -1.149957 -1.385983 -1.605210 -1.806347 -1.981982 -2.113144 -2.187872 -2.163550 -2.016429 -1.746487 -1.380277 -9.906311 0.4682739 0.2759502 5.2342482E-02 -0.1799445 -0.4135806 -0.6473266 -0.8811208 -1.116051 -1.347847 -1.572555 -1.787265 -1.991365 -2.173036 -2.323713 -2.423036 -2.426936 -2.300158 -2.030730 -1.639855 -9.906311 0.1360519 -3.9100491E-02 -0.2469796 -0.4640164 -0.6813790 -0.8969749 -1.118142 -1.337540 -1.554636 -1.767572 -1.977828 -2.175282 -2.360658 -2.524168 -2.640127 -2.674008 -2.577156 -2.322776 -1.919216 -9.906311 -0.2368603 -0.3912208 -0.5777805 -0.7743559 -0.9737598 -1.171158 -1.372298 -1.573160 -1.777009 -1.980159 -2.176878 -2.367768 -2.550909 -2.715743 -2.842258 -2.900218 -2.839186 -2.613775 -2.210688 -9.906311 -0.6519704 -0.7818392 -0.9441814 -1.118524 -1.293829 -1.468879 -1.649008 -1.833789 -2.022590 -2.209403 -2.393084 -2.573496 -2.745541 -2.905012 -3.036274 -3.112346 -3.089622 -2.911630 -2.522843 -9.906311 -1.120536 -1.219312 -1.350893 -1.498015 -1.648088 -1.800882 -1.962214 -2.124743 -2.292286 -2.462096 -2.629440 -2.792408 -2.949239 -3.097684 -3.225773 -3.312904 -3.322521 -3.201674 -2.837679 -9.906311 -1.649248 -1.712604 -1.811007 -1.930852 -2.054516 -2.179593 -2.314116 -2.452485 -2.595164 -2.743035 -2.887808 -3.031187 -3.171047 -3.302776 -3.424302 -3.514369 -3.551558 -3.486056 -3.157332 -9.906311 -2.265005 -2.289820 -2.349986 -2.433617 -2.523750 -2.616852 -2.719690 -2.828532 -2.940528 -3.060660 -3.182351 -3.305412 -3.423652 -3.535962 -3.644723 -3.734941 -3.806525 -3.769989 -3.482510 -9.906311 -3.010201 -2.989274 -3.003910 -3.041777 -3.090652 -3.144856 -3.207351 -3.282813 -3.365174 -3.452733 -3.545043 -3.639688 -3.734477 -3.825336 -3.922197 -4.021879 -4.092322 -4.083148 -3.825595 -9.906311 -4.010395 -3.926347 -3.882619 -3.865172 -3.861252 -3.866235 -3.880968 -3.908338 -3.945901 -3.993098 -4.046263 -4.111530 -4.182732 -4.252938 -4.329391 -4.403947 -4.468858 -4.474301 -4.196776 -9.906311 -5.719757 -5.532501 -5.388890 -5.278486 -5.192341 -5.118440 -5.052299 -5.004593 -4.973001 -4.962810 -4.960755 -4.970357 -4.989986 -5.020855 -5.060352 -5.115149 -5.159461 -5.096967 -4.634317 -9.906311 -27.00986 -26.52653 -25.97804 -25.36846 -24.70200 -23.98269 -23.21426 -22.40007 -21.54316 -20.64625 -19.71177 -18.74190 -17.73858 -16.70357 -15.63842 -14.54457 -13.42331 -12.27580 -11.10314 -9.906311 1.257548 1.204391 1.107390 0.9864764 0.8506164 0.7040272 0.5510822 0.3948689 0.2358608 8.0830425E-02 -6.4671092E-02 -0.1944807 -0.3066417 -0.4006268 -0.4739899 -0.5303068 -0.5738761 -0.6109101 -0.6400519 -11.58230 1.623945 1.514624 1.360412 1.191449 1.008709 0.8186845 0.6254410 0.4262303 0.2307313 4.7127869E-02 -0.1186339 -0.2545641 -0.3626838 -0.4349288 -0.4737704 -0.4827851 -0.4691916 -0.4396450 -0.3950325 -11.58230 1.835939 1.666104 1.461438 1.245590 1.022133 0.7974859 0.5666859 0.3316977 0.1042904 -0.1091916 -0.2948013 -0.4450895 -0.5541321 -0.6098015 -0.6180280 -0.5835684 -0.5159186 -0.4225752 -0.3071220 -11.58230 1.920453 1.708469 1.465263 1.217294 0.9664226 0.7102296 0.4469591 0.1845321 -7.0795529E-02 -0.3109687 -0.5199214 -0.6948735 -0.8147882 -0.8695410 -0.8586487 -0.7898794 -0.6740859 -0.5206273 -0.3368742 -11.58230 1.906180 1.666780 1.400311 1.133009 0.8630405 0.5832194 0.2994880 1.4104798E-02 -0.2644587 -0.5204915 -0.7548573 -0.9553912 -1.093821 -1.160617 -1.144870 -1.052621 -0.8966660 -0.6867996 -0.4369899 -11.58230 1.811215 1.558863 1.281850 1.000726 0.7174198 0.4264966 0.1289892 -0.1702660 -0.4587350 -0.7329654 -0.9871057 -1.204750 -1.369900 -1.457851 -1.453081 -1.351475 -1.165815 -0.9052227 -0.5921517 -11.58230 1.650696 1.395938 1.112904 0.8254651 0.5364528 0.2399058 -6.2748805E-02 -0.3629079 -0.6575075 -0.9420140 -1.207848 -1.438636 -1.626849 -1.742001 -1.762328 -1.669552 -1.465267 -1.161752 -0.7891616 -11.58230 1.432650 1.180208 0.8991222 0.6115887 0.3215626 2.5786275E-02 -0.2714597 -0.5682438 -0.8640442 -1.148889 -1.413315 -1.657331 -1.860586 -2.004724 -2.056320 -1.989096 -1.780745 -1.444324 -1.017398 -11.58230 1.160106 0.9180319 0.6420805 0.3595065 7.6266997E-02 -0.2098852 -0.4997596 -0.7914320 -1.078522 -1.353317 -1.616116 -1.860887 -2.075269 -2.244561 -2.332094 -2.302045 -2.106954 -1.750997 -1.277229 -11.58230 0.8378249 0.6091212 0.3449011 7.3541664E-02 -0.1960219 -0.4708873 -0.7494522 -1.028456 -1.299657 -1.564733 -1.818781 -2.057478 -2.280056 -2.463130 -2.588749 -2.599285 -2.434866 -2.077173 -1.567462 -11.58230 0.4676077 0.2573445 1.0829959E-02 -0.2443003 -0.4986141 -0.7566076 -1.016386 -1.276694 -1.534815 -1.784054 -2.024987 -2.259197 -2.477809 -2.672498 -2.823563 -2.874668 -2.753358 -2.415427 -1.884773 -11.58230 4.9273763E-02 -0.1379202 -0.3616059 -0.5953086 -0.8278503 -1.063254 -1.303532 -1.543758 -1.782427 -2.014486 -2.245567 -2.468518 -2.679021 -2.878290 -3.039922 -3.125523 -3.054041 -2.756416 -2.223490 -11.58230 -0.4188094 -0.5764922 -0.7706268 -0.9782753 -1.186318 -1.397347 -1.613561 -1.830315 -2.049356 -2.267389 -2.480927 -2.690912 -2.892541 -3.082390 -3.246196 -3.351790 -3.329834 -3.087294 -2.572293 -11.58230 -0.9391543 -1.062990 -1.224738 -1.401768 -1.580699 -1.762746 -1.952768 -2.149242 -2.347250 -2.542943 -2.737801 -2.932911 -3.118454 -3.292532 -3.451970 -3.566789 -3.588217 -3.420962 -2.943695 -11.58230 -1.526797 -1.610674 -1.734604 -1.875287 -2.023020 -2.176553 -2.338248 -2.507645 -2.679123 -2.851475 -3.023475 -3.195458 -3.361984 -3.518551 -3.663317 -3.779484 -3.831960 -3.742487 -3.316167 -11.58230 -2.204173 -2.243573 -2.325768 -2.426521 -2.537024 -2.654690 -2.781195 -2.917474 -3.060120 -3.201296 -3.344765 -3.491806 -3.638128 -3.771658 -3.897616 -4.010108 -4.091580 -4.060080 -3.692733 -11.58230 -3.022856 -3.008238 -3.039774 -3.091780 -3.156325 -3.229311 -3.313683 -3.407547 -3.513256 -3.623524 -3.735624 -3.850819 -3.968737 -4.078704 -4.185035 -4.299626 -4.396989 -4.392221 -4.090203 -11.58230 -4.113148 -4.024411 -3.989496 -3.978654 -3.982623 -3.999722 -4.031152 -4.074483 -4.130614 -4.192009 -4.263271 -4.341260 -4.426675 -4.519635 -4.608506 -4.706128 -4.782831 -4.818517 -4.525349 -11.58230 -5.957595 -5.746020 -5.598600 -5.482890 -5.388316 -5.310585 -5.259942 -5.222920 -5.198900 -5.195045 -5.205704 -5.229409 -5.260571 -5.302530 -5.357654 -5.423880 -5.505264 -5.511856 -5.044804 -11.58230 -32.04919 -31.49139 -30.84948 -30.12888 -29.33651 -28.47794 -27.55838 -26.58248 -25.55432 -24.47751 -23.35522 -22.19024 -20.98506 -19.74187 -18.46263 -17.14911 -15.80294 -14.42554 -13.01825 -11.58230 1.557132 1.499883 1.399982 1.271239 1.123001 0.9600084 0.7849672 0.6034107 0.4264723 0.2534696 8.8218823E-02 -6.1148938E-02 -0.1894607 -0.2960491 -0.3785893 -0.4394088 -0.4832441 -0.5169793 -0.5428553 -13.31235 1.995494 1.871186 1.703604 1.516567 1.313161 1.097331 0.8719710 0.6478349 0.4326661 0.2249945 3.7149105E-02 -0.1223245 -0.2420409 -0.3240458 -0.3621684 -0.3640974 -0.3375712 -0.2918568 -0.2305196 -13.31235 2.253144 2.057917 1.827018 1.583706 1.331548 1.070289 0.8058889 0.5471094 0.2922531 5.0425466E-02 -0.1657152 -0.3398671 -0.4619523 -0.5261900 -0.5263039 -0.4736885 -0.3803815 -0.2584436 -0.1130364 -13.31235 2.361386 2.116431 1.839106 1.559214 1.270093 0.9756257 0.6823880 0.3883050 0.1019945 -0.1708080 -0.4203149 -0.6207328 -0.7634779 -0.8260673 -0.8055505 -0.7095673 -0.5560467 -0.3613998 -0.1343262 -13.31235 2.354031 2.078264 1.775570 1.468946 1.159474 0.8463576 0.5271813 0.2069828 -0.1048594 -0.4030021 -0.6757647 -0.9116342 -1.085151 -1.163569 -1.139479 -1.014782 -0.8102792 -0.5468258 -0.2401268 -13.31235 2.256425 1.966345 1.648312 1.328177 1.010156 0.6819903 0.3475095 1.2154796E-02 -0.3158886 -0.6310700 -0.9236250 -1.189185 -1.393741 -1.505721 -1.496264 -1.362529 -1.120284 -0.7944027 -0.4107340 -13.31235 2.085820 1.790497 1.467670 1.145217 0.8191741 0.4840248 0.1437444 -0.1971069 -0.5315851 -0.8508781 -1.161267 -1.445467 -1.675007 -1.825022 -1.849506 -1.726298 -1.463706 -1.083951 -0.6269459 -13.31235 1.850057 1.559415 1.239888 0.9159362 0.5899901 0.2541772 -8.5142381E-02 -0.4230279 -0.7523133 -1.076325 -1.390423 -1.678278 -1.929989 -2.111902 -2.183352 -2.093539 -1.830704 -1.410076 -0.8852099 -13.31235 1.556051 1.276126 0.9624894 0.6430750 0.3231552 -5.3258850E-03 -0.3358756 -0.6639242 -0.9889675 -1.308458 -1.612741 -1.900706 -2.160401 -2.367561 -2.483983 -2.447942 -2.206385 -1.761842 -1.177299 -13.31235 1.205234 0.9407029 0.6379618 0.3303652 2.2958539E-02 -0.2906943 -0.6067547 -0.9261190 -1.239971 -1.543895 -1.838920 -2.118056 -2.374913 -2.599630 -2.750618 -2.775340 -2.576206 -2.128649 -1.495680 -13.31235 0.7988026 0.5549133 0.2719334 -1.7636111E-02 -0.3057236 -0.6033474 -0.9042696 -1.206446 -1.500404 -1.789056 -2.070431 -2.335845 -2.588224 -2.815211 -2.997924 -3.073026 -2.933677 -2.510321 -1.846044 -13.31235 0.3415272 0.1235503 -0.1335460 -0.4010558 -0.6691033 -0.9447160 -1.224443 -1.502485 -1.777665 -2.045699 -2.309101 -2.564737 -2.804656 -3.029983 -3.226921 -3.340134 -3.265708 -2.895125 -2.222776 -13.31235 -0.1695526 -0.3563909 -0.5841278 -0.8235633 -1.064729 -1.312584 -1.567624 -1.822043 -2.072572 -2.318439 -2.566460 -2.806137 -3.032213 -3.251022 -3.445745 -3.583313 -3.567938 -3.272095 -2.619695 -13.31235 -0.7406479 -0.8901584 -1.081697 -1.287889 -1.498528 -1.715207 -1.939371 -2.167736 -2.394190 -2.620700 -2.844562 -3.066745 -3.279356 -3.480457 -3.665573 -3.808543 -3.842733 -3.632366 -3.031461 -13.31235 -1.382933 -1.488991 -1.639990 -1.806044 -1.979435 -2.162231 -2.355526 -2.556379 -2.755170 -2.953345 -3.155276 -3.354816 -3.545246 -3.727127 -3.893733 -4.034225 -4.101644 -3.988756 -3.459488 -13.31235 -2.122471 -2.175460 -2.280196 -2.402533 -2.533767 -2.678511 -2.834988 -2.999096 -3.166704 -3.334589 -3.504998 -3.674968 -3.843338 -4.000404 -4.146005 -4.275188 -4.363119 -4.334557 -3.891881 -13.31235 -3.010471 -3.002789 -3.052012 -3.120981 -3.200201 -3.296259 -3.409045 -3.527799 -3.653963 -3.785911 -3.920078 -4.059288 -4.196357 -4.325892 -4.448535 -4.566394 -4.683642 -4.691809 -4.338689 -13.31235 -4.188887 -4.096057 -4.071297 -4.068767 -4.080347 -4.111046 -4.164642 -4.230589 -4.305543 -4.389455 -4.472909 -4.567526 -4.672231 -4.775252 -4.881861 -4.989871 -5.090456 -5.138425 -4.832774 -13.31235 -6.158002 -5.927470 -5.776351 -5.652441 -5.551474 -5.479132 -5.437198 -5.416933 -5.413037 -5.422272 -5.443357 -5.471305 -5.524039 -5.581155 -5.642019 -5.724624 -5.827610 -5.885572 -5.433610 -13.31235 -37.29813 -36.66456 -35.92517 -35.08880 -34.16412 -33.15903 -32.08046 -30.93451 -29.72646 -28.46083 -27.14158 -25.77215 -24.35558 -22.89454 -21.39141 -19.84832 -18.26720 -16.64980 -14.99769 -13.31235 1.851480 1.789547 1.682978 1.547140 1.390647 1.213952 1.020089 0.8203416 0.6190497 0.4250726 0.2421413 7.3845640E-02 -7.2742142E-02 -0.1911279 -0.2835653 -0.3485683 -0.3932260 -0.4245926 -0.4476815 -15.09291 2.360520 2.218607 2.035855 1.832860 1.611820 1.371879 1.122593 0.8726396 0.6284069 0.3997954 0.1892303 1.1013552E-02 -0.1273721 -0.2144308 -0.2541118 -0.2488079 -0.2097677 -0.1479516 -7.0135824E-02 -15.09291 2.662793 2.439349 2.183803 1.915947 1.634479 1.342798 1.047652 0.7549052 0.4739318 0.2034062 -3.9610602E-02 -0.2401134 -0.3802196 -0.4498576 -0.4445611 -0.3754042 -0.2572595 -0.1058712 6.9411099E-02 -15.09291 2.796045 2.516413 2.208103 1.895230 1.571798 1.241694 0.9091434 0.5851046 0.2706029 -3.6079500E-02 -0.3170493 -0.5537925 -0.7164554 -0.7907151 -0.7598379 -0.6383561 -0.4477712 -0.2104857 6.0247343E-02 -15.09291 2.797864 2.485313 2.144839 1.802667 1.455137 1.100196 0.7447861 0.3963493 5.1838815E-02 -0.2808486 -0.5959325 -0.8685826 -1.072419 -1.171491 -1.140544 -0.9846377 -0.7318200 -0.4131490 -4.8867706E-02 -15.09291 2.698846 2.367870 2.011834 1.654506 1.292886 0.9258047 0.5593419 0.1917812 -0.1682642 -0.5221963 -0.8600282 -1.162359 -1.411602 -1.550268 -1.544958 -1.379864 -1.080544 -0.6868138 -0.2314558 -15.09291 2.516123 2.181816 1.818998 1.456418 1.090041 0.7197043 0.3438218 -2.9570973E-02 -0.3982309 -0.7611477 -1.107490 -1.433651 -1.713470 -1.901043 -1.940335 -1.794605 -1.469953 -1.011140 -0.4681321 -15.09291 2.264131 1.933229 1.572460 1.212054 0.8486350 0.4770071 0.1011368 -0.2721975 -0.6418660 -1.001652 -1.352222 -1.687591 -1.981135 -2.210159 -2.305954 -2.205284 -1.884379 -1.375209 -0.7499672 -15.09291 1.947021 1.627166 1.275838 0.9222990 0.5657727 0.2007303 -0.1687325 -0.5367189 -0.8958638 -1.253421 -1.599972 -1.925652 -2.228933 -2.480344 -2.631851 -2.595547 -2.309215 -1.770891 -1.071949 -15.09291 1.568281 1.267697 0.9300877 0.5894735 0.2449598 -0.1091025 -0.4655575 -0.8186979 -1.168393 -1.515769 -1.848876 -2.164191 -2.461526 -2.723119 -2.915796 -2.954020 -2.727566 -2.188084 -1.428352 -15.09291 1.131936 0.8552125 0.5373721 0.2139353 -0.1125020 -0.4473622 -0.7871844 -1.125584 -1.459184 -1.785858 -2.104420 -2.405186 -2.689003 -2.953985 -3.166315 -3.270442 -3.121229 -2.612187 -1.809697 -15.09291 0.6395178 0.3895949 9.8609559E-02 -0.2004463 -0.5034981 -0.8169378 -1.136738 -1.454202 -1.763761 -2.070779 -2.368713 -2.651337 -2.925447 -3.178378 -3.406217 -3.550487 -3.483747 -3.040688 -2.222469 -15.09291 8.8301003E-02 -0.1272741 -0.3873715 -0.6571000 -0.9328985 -1.220629 -1.511859 -1.803311 -2.088786 -2.371596 -2.645612 -2.914544 -3.169927 -3.414033 -3.639059 -3.804691 -3.807342 -3.459687 -2.661913 -15.09291 -0.5286599 -0.7038124 -0.9263465 -1.160880 -1.402744 -1.658360 -1.919205 -2.180361 -2.439078 -2.695613 -2.950112 -3.194505 -3.433527 -3.664068 -3.873415 -4.044297 -4.097959 -3.857592 -3.120288 -15.09291 -1.222808 -1.349832 -1.529788 -1.722961 -1.924079 -2.141406 -2.367456 -2.596506 -2.827590 -3.055863 -3.283031 -3.504946 -3.722426 -3.929619 -4.122259 -4.281972 -4.367413 -4.235736 -3.597252 -15.09291 -2.022082 -2.091949 -2.219722 -2.362849 -2.518842 -2.692856 -2.879194 -3.071493 -3.267234 -3.464361 -3.661924 -3.852595 -4.042608 -4.224667 -4.392704 -4.538965 -4.640793 -4.608728 -4.081934 -15.09291 -2.978625 -2.980872 -3.045014 -3.129140 -3.230261 -3.351137 -3.488733 -3.636915 -3.788607 -3.944118 -4.105831 -4.262266 -4.418755 -4.571435 -4.712760 -4.845510 -4.965694 -4.989907 -4.577567 -15.09291 -4.233746 -4.147744 -4.130116 -4.134462 -4.160318 -4.212548 -4.285964 -4.373356 -4.472007 -4.577254 -4.688619 -4.798015 -4.915313 -5.037300 -5.158642 -5.284624 -5.398985 -5.450781 -5.128792 -15.09291 -6.319001 -6.086078 -5.929529 -5.796210 -5.696144 -5.633930 -5.607432 -5.602474 -5.612906 -5.643926 -5.682842 -5.734370 -5.793612 -5.866873 -5.940768 -6.039021 -6.146170 -6.232075 -5.805581 -15.09291 -42.73994 -42.02928 -41.18919 -40.23180 -39.16869 -38.01028 -36.76546 -35.44184 -34.04597 -32.58338 -31.05883 -29.47647 -27.83987 -26.15221 -24.41631 -22.63467 -20.80956 -18.94301 -17.03689 -15.09291 2.142165 2.072692 1.960971 1.818423 1.650869 1.460975 1.255280 1.038577 0.8179877 0.6008687 0.3977458 0.2113977 4.8528619E-02 -8.5031800E-02 -0.1848493 -0.2552044 -0.3010465 -0.3305327 -0.3511066 -16.92084 2.720111 2.559422 2.360712 2.139050 1.898633 1.640208 1.370830 1.098896 0.8286546 0.5719442 0.3429300 0.1432926 -8.9941360E-03 -0.1053072 -0.1447475 -0.1318702 -8.0084093E-02 -2.4534734E-03 9.1752090E-02 -16.92084 3.067519 2.814015 2.530001 2.235457 1.928124 1.609381 1.286548 0.9661168 0.6504864 0.3551919 8.6096026E-02 -0.1406030 -0.3009872 -0.3762970 -0.3668959 -0.2794572 -0.1357210 4.5059524E-02 0.2504574 -16.92084 3.224833 2.906992 2.566218 2.222616 1.867013 1.501780 1.137589 0.7796149 0.4329334 9.8932475E-02 -0.2149945 -0.4815119 -0.6719601 -0.7551666 -0.7184936 -0.5709714 -0.3421514 -6.1282832E-02 0.2537026 -16.92084 3.235474 2.883335 2.507022 2.130336 1.743846 1.352976 0.9613273 0.5791490 0.2072691 -0.1596827 -0.5088617 -0.8225119 -1.058095 -1.180406 -1.147470 -0.9629520 -0.6611026 -0.2850216 0.1376839 -16.92084 3.135930 2.764502 2.369604 1.973763 1.572649 1.166344 0.7627122 0.3687464 -2.4166640E-02 -0.4118991 -0.7853356 -1.130489 -1.417979 -1.595887 -1.598528 -1.405756 -1.048500 -0.5845835 -5.6312483E-02 -16.92084 2.943396 2.567153 2.164109 1.763330 1.355969 0.9459683 0.5398177 0.1346626 -0.2687880 -0.6641808 -1.049979 -1.412091 -1.738511 -1.969712 -2.035284 -1.870992 -1.484117 -0.9434050 -0.3129261 -16.92084 2.672467 2.301420 1.900932 1.502498 1.098837 0.6941171 0.2838742 -0.1221648 -0.5275280 -0.9264438 -1.307959 -1.680171 -2.024441 -2.297195 -2.430482 -2.328582 -1.946774 -1.345833 -0.6183187 -16.92084 2.332638 1.975032 1.585266 1.196989 0.8035546 0.4016899 -2.5447772E-03 -0.4038256 -0.8042394 -1.195474 -1.573913 -1.943008 -2.284208 -2.583240 -2.773279 -2.754431 -2.419849 -1.784038 -0.9681998 -16.92084 1.928835 1.592677 1.220449 0.8457152 0.4650136 7.3275588E-02 -0.3204719 -0.7113978 -1.096257 -1.478385 -1.848170 -2.201331 -2.537899 -2.840305 -3.071205 -3.133784 -2.883184 -2.247169 -1.356822 -16.92084 1.465232 1.154335 0.8040484 0.4483492 8.4361695E-02 -0.2894834 -0.6676841 -1.039927 -1.411209 -1.777196 -2.127262 -2.465342 -2.787966 -3.084180 -3.334128 -3.466693 -3.315846 -2.720906 -1.776895 -16.92084 0.9406831 0.6596327 0.3358701 5.6226435E-03 -0.3355125 -0.6860615 -1.042461 -1.396893 -1.746961 -2.087720 -2.417973 -2.736154 -3.040548 -3.328997 -3.578426 -3.756315 -3.703662 -3.189513 -2.221132 -16.92084 0.3522800 0.1080712 -0.1834784 -0.4827044 -0.7943074 -1.119740 -1.449987 -1.777982 -2.100328 -2.417787 -2.722774 -3.018471 -3.307850 -3.575974 -3.825451 -4.019165 -4.046272 -3.649049 -2.700066 -16.92084 -0.3064354 -0.5080097 -0.7605460 -1.023491 -1.300375 -1.591556 -1.889273 -2.186961 -2.479837 -2.770012 -3.048975 -3.324081 -3.588976 -3.843127 -4.077311 -4.271235 -4.347854 -4.082778 -3.205059 -16.92084 -1.051634 -1.201025 -1.405743 -1.625449 -1.860681 -2.111859 -2.371875 -2.634012 -2.893628 -3.156468 -3.407075 -3.655122 -3.900672 -4.130221 -4.343356 -4.522083 -4.627038 -4.481115 -3.724864 -16.92084 -1.907644 -1.995882 -2.143105 -2.310010 -2.495789 -2.700252 -2.918026 -3.139996 -3.361882 -3.589398 -3.811591 -4.029604 -4.245948 -4.448574 -4.633016 -4.793869 -4.908114 -4.873508 -4.260456 -16.92084 -2.929234 -2.944217 -3.022067 -3.124145 -3.249662 -3.398639 -3.564787 -3.738276 -3.915481 -4.098562 -4.284856 -4.464433 -4.646305 -4.818091 -4.973441 -5.115494 -5.234575 -5.275148 -4.809461 -16.92084 -4.260734 -4.178835 -4.166225 -4.185227 -4.232184 -4.305564 -4.403689 -4.513230 -4.628907 -4.757267 -4.895097 -5.026876 -5.162477 -5.305242 -5.430590 -5.566961 -5.689474 -5.749008 -5.410937 -16.92084 -6.459852 -6.215456 -6.049102 -5.919674 -5.830276 -5.779328 -5.770628 -5.782808 -5.808629 -5.849566 -5.912505 -5.987940 -6.065221 -6.155103 -6.246089 -6.341023 -6.459065 -6.565071 -6.163081 -16.92084 -48.36032 -47.57129 -46.62711 -45.54383 -44.33664 -43.01854 -41.60070 -40.09236 -38.50138 -36.83434 -35.09685 -33.29374 -31.42919 -29.50690 -27.53011 -25.50173 -23.42437 -21.30038 -19.13188 -16.92084 2.428889 2.354574 2.233729 2.082641 1.908266 1.704652 1.486114 1.255891 1.017222 0.7809321 0.5537245 0.3478554 0.1673194 2.0287158E-02 -8.8669911E-02 -0.1643018 -0.2111119 -0.2393257 -0.2576940 -18.79339 3.076948 2.894138 2.676748 2.439699 2.178117 1.899514 1.613958 1.321601 1.029063 0.7499817 0.4931454 0.2756405 0.1069414 1.5566149E-03 -3.5362139E-02 -1.4493504E-02 5.0389424E-02 0.1437479 0.2542725 -18.79339 3.466970 3.180778 2.870238 2.546826 2.209989 1.866533 1.521461 1.173459 0.8314993 0.5060373 0.2099385 -4.0982030E-02 -0.2199071 -0.3047993 -0.2869936 -0.1806816 -1.0807833E-02 0.1996442 0.4354780 -18.79339 3.648010 3.292048 2.916466 2.538269 2.151151 1.756844 1.362159 0.9755433 0.5960293 0.2300328 -0.1132690 -0.4112126 -0.6295042 -0.7271094 -0.6850576 -0.5097745 -0.2420720 8.2432799E-02 0.4421107 -18.79339 3.668395 3.273315 2.859243 2.447646 2.027097 1.600068 1.178556 0.7641705 0.3561641 -3.8379967E-02 -0.4210847 -0.7692908 -1.044597 -1.189337 -1.159399 -0.9430856 -0.5908043 -0.1567024 0.3253355 -18.79339 3.565737 3.152007 2.719096 2.286937 1.845992 1.404975 0.9677662 0.5371408 0.1153703 -0.3022319 -0.7090652 -1.094302 -1.421144 -1.637205 -1.657048 -1.438807 -1.023112 -0.4871784 0.1150847 -18.79339 3.364472 2.946032 2.503797 2.063531 1.619639 1.172178 0.7294675 0.2933661 -0.1434789 -0.5689426 -0.9866562 -1.390030 -1.753832 -2.035310 -2.131335 -1.953127 -1.505358 -0.8804094 -0.1610452 -18.79339 3.076980 2.664272 2.225102 1.790740 1.348226 0.9038215 0.4628844 2.2099772E-02 -0.4174754 -0.8454055 -1.266132 -1.670299 -2.054630 -2.373521 -2.552073 -2.454504 -2.016780 -1.322284 -0.4909864 -18.79339 2.713864 2.319680 1.893361 1.468676 1.035929 0.5986433 0.1598891 -0.2759780 -0.7105210 -1.136997 -1.547311 -1.951460 -2.336397 -2.672672 -2.909497 -2.915056 -2.537194 -1.802399 -0.8678511 -18.79339 2.287601 1.916181 1.508546 1.099802 0.6811330 0.2530135 -0.1762576 -0.6021791 -1.027785 -1.438049 -1.840800 -2.236554 -2.605837 -2.945709 -3.214852 -3.314400 -3.043041 -2.310361 -1.287078 -18.79339 1.798127 1.453644 1.070138 0.6815747 0.2807460 -0.1312057 -0.5456468 -0.9572334 -1.362900 -1.759922 -2.148843 -2.521467 -2.878445 -3.205924 -3.489736 -3.653595 -3.508755 -2.828856 -1.739581 -18.79339 1.243338 0.9318430 0.5764288 0.2136033 -0.1641187 -0.5542580 -0.9461597 -1.337036 -1.724549 -2.101948 -2.463169 -2.819203 -3.153515 -3.466286 -3.745205 -3.951058 -3.920115 -3.343333 -2.222374 -18.79339 0.6202384 0.3472282 2.5373653E-02 -0.3058051 -0.6522949 -1.014714 -1.382196 -1.748249 -2.108664 -2.457568 -2.796239 -3.128007 -3.440611 -3.734895 -4.002233 -4.222352 -4.277391 -3.841600 -2.738729 -18.79339 -7.9872116E-02 -0.3061820 -0.5861151 -0.8798526 -1.191664 -1.520783 -1.855948 -2.187292 -2.516353 -2.838461 -3.148394 -3.455073 -3.748050 -4.017267 -4.271001 -4.484139 -4.585819 -4.306250 -3.285212 -18.79339 -0.8717085 -1.043711 -1.272413 -1.520760 -1.789250 -2.077057 -2.373018 -2.666608 -2.958900 -3.250546 -3.532611 -3.810461 -4.080293 -4.327479 -4.555317 -4.750260 -4.871045 -4.729815 -3.852446 -18.79339 -1.780723 -1.888247 -2.057133 -2.248526 -2.465034 -2.703733 -2.953316 -3.204811 -3.456022 -3.710124 -3.962321 -4.210283 -4.450832 -4.668866 -4.866179 -5.035926 -5.159597 -5.129963 -4.437306 -18.79339 -2.867193 -2.894022 -2.987624 -3.110115 -3.262741 -3.440229 -3.634395 -3.835718 -4.038730 -4.248557 -4.461728 -4.673780 -4.877545 -5.062064 -5.226690 -5.373608 -5.491984 -5.546533 -5.035351 -18.79339 -4.273033 -4.192534 -4.188454 -4.221023 -4.289492 -4.390089 -4.510983 -4.643179 -4.782075 -4.934049 -5.097128 -5.261263 -5.420923 -5.568767 -5.707437 -5.839236 -5.965263 -6.028838 -5.684403 -18.79339 -6.570523 -6.317037 -6.148314 -6.024654 -5.946588 -5.915122 -5.918091 -5.944552 -5.989231 -6.056127 -6.139103 -6.240669 -6.347255 -6.449518 -6.549442 -6.638840 -6.759318 -6.873200 -6.505316 -18.79339 -54.14704 -53.27834 -52.22673 -51.01303 -49.65624 -48.17257 -46.57536 -44.87576 -43.08292 -41.20449 -39.24697 -37.21591 -35.11611 -32.95179 -30.72665 -28.44400 -26.10681 -23.71774 -21.27920 -18.79339 2.709035 2.631679 2.505779 2.346406 2.158431 1.946921 1.715440 1.469765 1.215820 0.9576315 0.7099107 0.4802493 0.2827299 0.1215863 2.8577701E-03 -7.6986939E-02 -0.1254138 -0.1530152 -0.1694518 -20.70810 3.429147 3.227094 2.989878 2.730412 2.451085 2.154684 1.850065 1.538605 1.226758 0.9240825 0.6438050 0.4038756 0.2198407 0.1075687 7.2325915E-02 0.1018927 0.1805370 0.2895100 0.4163810 -20.70810 3.863201 3.543152 3.201840 2.850144 2.485380 2.114700 1.747255 1.376252 1.007695 0.6557853 0.3299217 5.7069071E-02 -0.1430140 -0.2350988 -0.2075053 -8.1376739E-02 0.1157232 0.3563166 0.6228775 -20.70810 4.065702 3.669391 3.259696 2.846967 2.425475 2.001811 1.583138 1.164713 0.7566527 0.3592712 -1.3527281E-02 -0.3407170 -0.5882707 -0.7037972 -0.6515494 -0.4488835 -0.1415088 0.2273441 0.6323477 -20.70810 4.095355 3.656674 3.204879 2.755132 2.299283 1.842732 1.388844 0.9426229 0.5041795 7.6072022E-02 -0.3348518 -0.7180380 -1.029272 -1.204067 -1.176722 -0.9305456 -0.5274385 -3.4762170E-02 0.5073930 -20.70810 3.990542 3.532677 3.059328 2.589928 2.115086 1.637444 1.167738 0.7014408 0.2463985 -0.1968743 -0.6354789 -1.054281 -1.423599 -1.676856 -1.718776 -1.476627 -1.002209 -0.3935360 0.2839175 -20.70810 3.778188 3.316735 2.836549 2.360487 1.876569 1.393991 0.9159490 0.4411307 -2.2082364E-02 -0.4778875 -0.9279881 -1.364596 -1.764431 -2.089597 -2.224500 -2.041846 -1.533988 -0.8227603 -1.2984225E-02 -20.70810 3.474853 3.022902 2.546612 2.072986 1.593220 1.110243 0.6318476 0.1586837 -0.3112884 -0.7696245 -1.223057 -1.662825 -2.076207 -2.443067 -2.665087 -2.584010 -2.095126 -1.304248 -0.3671858 -20.70810 3.093577 2.660463 2.197970 1.736583 1.264553 0.7876926 0.3168175 -0.1558870 -0.6211312 -1.076596 -1.526543 -1.958241 -2.375423 -2.750343 -3.033940 -3.073033 -2.663137 -1.827781 -0.7722893 -20.70810 2.643890 2.236806 1.794038 1.348855 0.8910399 0.4280749 -3.7479073E-02 -0.4999977 -0.9563716 -1.401998 -1.838448 -2.262924 -2.667248 -3.038620 -3.348591 -3.490509 -3.210433 -2.380918 -1.221954 -20.70810 2.129283 1.751599 1.333401 0.9116606 0.4726837 2.4899585E-02 -0.4263401 -0.8747076 -1.316850 -1.743605 -2.168378 -2.578383 -2.958446 -3.318077 -3.632340 -3.835238 -3.706973 -2.945750 -1.708031 -20.70810 1.545614 1.203333 0.8156301 0.4204171 5.8992798E-03 -0.4215397 -0.8523524 -1.277292 -1.700097 -2.109788 -2.513265 -2.898823 -3.259741 -3.597188 -3.905400 -4.137041 -4.137824 -3.506397 -2.229203 -20.70810 0.8879889 0.5879092 0.2368414 -0.1267940 -0.5108302 -0.9103040 -1.313950 -1.714188 -2.112862 -2.496353 -2.870671 -3.234835 -3.570992 -3.886832 -4.175089 -4.417788 -4.504111 -4.042164 -2.782189 -20.70810 0.1497327 -0.1019148 -0.4083917 -0.7324180 -1.081123 -1.447015 -1.819631 -2.186460 -2.548173 -2.905229 -3.251806 -3.587527 -3.900028 -4.189969 -4.461924 -4.693726 -4.821924 -4.538155 -3.370001 -20.70810 -0.6845433 -0.8805872 -1.134113 -1.410347 -1.715917 -2.038939 -2.369348 -2.697562 -3.021935 -3.344649 -3.661163 -3.968582 -4.252829 -4.521525 -4.766541 -4.978200 -5.113680 -4.983647 -3.985052 -20.70810 -1.646480 -1.771076 -1.961969 -2.180836 -2.430156 -2.701213 -2.982578 -3.265663 -3.548722 -3.832282 -4.115566 -4.390914 -4.647885 -4.887629 -5.100380 -5.283077 -5.414200 -5.389191 -4.613095 -20.70810 -2.790944 -2.831166 -2.942249 -3.089168 -3.269111 -3.476134 -3.696887 -3.926048 -4.162621 -4.401170 -4.644049 -4.881109 -5.101730 -5.305156 -5.484417 -5.641727 -5.763233 -5.822422 -5.261529 -20.70810 -4.267403 -4.193290 -4.200443 -4.252060 -4.342110 -4.466870 -4.612737 -4.772330 -4.943243 -5.123351 -5.311525 -5.498630 -5.672523 -5.837760 -5.989782 -6.121408 -6.251537 -6.326069 -5.956708 -20.70810 -6.664695 -6.402028 -6.242966 -6.132314 -6.070760 -6.052484 -6.069800 -6.115808 -6.187652 -6.285229 -6.393775 -6.509034 -6.629491 -6.747737 -6.859390 -6.959109 -7.070635 -7.183931 -6.844807 -20.70810 -60.08942 -59.13979 -57.97777 -56.62893 -55.11746 -53.46255 -51.68013 -49.78312 -47.78210 -45.68583 -43.50169 -41.23599 -38.89417 -36.48096 -34.00080 -31.45693 -28.85265 -26.19145 -23.47578 -20.70810 2.979384 2.898186 2.770805 2.606926 2.408947 2.184357 1.942132 1.680895 1.408403 1.130409 0.8595011 0.6073354 0.3875638 0.2105637 8.0543630E-02 -4.6701836E-03 -5.5422321E-02 -8.3012432E-02 -9.8161444E-02 -22.66275 3.773249 3.553692 3.297920 3.019729 2.717202 2.404313 2.081004 1.749392 1.418671 1.092588 0.7898226 0.5248446 0.3236897 0.2022984 0.1670158 0.2063928 0.2980718 0.4224205 0.5655032 -22.66275 4.255143 3.900949 3.531004 3.146385 2.753519 2.358189 1.964665 1.570842 1.178775 0.8019826 0.4516743 0.1496688 -7.0894830E-02 -0.1707168 -0.1357358 1.1240254E-02 0.2361658 0.5069607 0.8045541 -22.66275 4.479568 4.042903 3.596304 3.148165 2.693564 2.239963 1.793880 1.349531 0.9129959 0.4888925 8.5489579E-02 -0.2714456 -0.5500352 -0.6812299 -0.6220108 -0.3911699 -4.2828359E-02 0.3711870 0.8220845 -22.66275 4.516842 4.033309 3.544067 3.055524 2.563719 2.075703 1.592642 1.114140 0.6491331 0.1916578 -0.2502437 -0.6628045 -1.012560 -1.219326 -1.194274 -0.9190248 -0.4636300 8.8917859E-02 0.6920937 -22.66275 4.409427 3.906905 3.393268 2.885172 2.374353 1.865157 1.359852 0.8616893 0.3776879 -9.8092802E-02 -0.5631320 -1.012756 -1.418332 -1.713290 -1.780446 -1.518796 -0.9844540 -0.3016230 0.4521586 -22.66275 4.186234 3.681818 3.162157 2.648753 2.128615 1.608891 1.096639 0.5878473 9.3856089E-02 -0.3914486 -0.8711050 -1.335485 -1.773327 -2.135596 -2.317224 -2.135499 -1.567693 -0.7692020 0.1323454 -22.66275 3.866902 3.375040 2.862251 2.351573 1.831092 1.312771 0.7982253 0.2885541 -0.2069074 -0.6993020 -1.182002 -1.650660 -2.094053 -2.497638 -2.769881 -2.718145 -2.180824 -1.291559 -0.2471481 -22.66275 3.468711 2.997414 2.498683 1.998115 1.488566 0.9748909 0.4653032 -3.8502548E-02 -0.5347422 -1.024275 -1.504798 -1.964920 -2.407600 -2.822312 -3.147585 -3.230653 -2.796957 -1.859474 -0.6812058 -22.66275 2.997761 2.553140 2.075979 1.594309 1.098465 0.5974099 9.8192208E-02 -0.4007128 -0.8880661 -1.368998 -1.841701 -2.288221 -2.722252 -3.124193 -3.472511 -3.659608 -3.383319 -2.458113 -1.161814 -22.66275 2.457236 2.045858 1.595290 1.137020 0.6621667 0.1761533 -0.3095160 -0.7937523 -1.270220 -1.734662 -2.191205 -2.627002 -3.036587 -3.425741 -3.769420 -4.014238 -3.906588 -3.068092 -1.680023 -22.66275 1.845424 1.472256 1.054705 0.6242846 0.1733591 -0.2918054 -0.7579429 -1.221082 -1.677011 -2.122834 -2.562324 -2.973091 -3.361754 -3.726757 -4.057462 -4.318583 -4.352249 -3.671518 -2.235907 -22.66275 1.156237 0.8271660 0.4491281 5.1503271E-02 -0.3698557 -0.8074543 -1.246658 -1.682106 -2.114097 -2.538962 -2.946803 -3.334131 -3.697923 -4.036048 -4.346732 -4.609824 -4.726211 -4.244431 -2.827189 -22.66275 0.3819722 0.1036085 -0.2290289 -0.5856978 -0.9698076 -1.372854 -1.779303 -2.184082 -2.582286 -2.973015 -3.353854 -3.713422 -4.048716 -4.364459 -4.646958 -4.897543 -5.051411 -4.766108 -3.453245 -22.66275 -0.4949424 -0.7118846 -0.9913158 -1.298609 -1.637510 -1.998495 -2.361809 -2.725753 -3.087327 -3.443767 -3.791056 -4.119231 -4.427088 -4.714816 -4.971205 -5.195525 -5.350697 -5.227591 -4.111624 -22.66275 -1.504545 -1.648610 -1.861105 -2.109382 -2.391283 -2.697604 -3.010146 -3.328377 -3.648356 -3.964479 -4.276362 -4.571178 -4.846406 -5.103009 -5.325599 -5.518026 -5.662288 -5.644355 -4.785487 -22.66275 -2.708796 -2.761601 -2.892459 -3.066033 -3.276713 -3.512779 -3.762683 -4.023868 -4.295734 -4.568620 -4.836401 -5.093737 -5.329834 -5.546387 -5.731894 -5.893708 -6.025885 -6.082514 -5.477604 -22.66275 -4.261357 -4.190265 -4.211946 -4.282560 -4.398349 -4.545369 -4.713419 -4.904216 -5.113198 -5.324256 -5.537042 -5.742267 -5.932936 -6.103871 -6.257153 -6.394632 -6.526988 -6.605854 -6.218789 -22.66275 -6.751464 -6.479483 -6.317604 -6.216684 -6.182597 -6.184402 -6.211783 -6.282247 -6.393899 -6.517266 -6.650838 -6.784064 -6.921288 -7.042929 -7.159660 -7.264282 -7.367463 -7.478189 -7.174251 -22.66275 -66.17808 -65.14626 -63.87022 -62.38247 -60.71137 -58.87998 -56.90680 -54.80663 -52.59152 -50.27135 -47.85444 -45.34786 -42.75769 -40.08922 -37.34713 -34.53554 -31.65816 -28.71828 -25.71890 -22.66275 3.243381 3.154764 3.025511 2.859970 2.655535 2.423171 2.165631 1.891917 1.598324 1.303696 1.006316 0.7286932 0.4864378 0.2928564 0.1511085 5.9504829E-02 6.0721682E-03 -2.1821229E-02 -3.6034700E-02 -24.65536 4.110176 3.871331 3.598794 3.301000 2.981590 2.648408 2.306114 1.956147 1.604989 1.259766 0.9278063 0.6375609 0.4166457 0.2849337 0.2495832 0.2972389 0.4019470 0.5414177 0.7006048 -24.65536 4.640625 4.253785 3.853523 3.439955 3.015442 2.595027 2.176889 1.757673 1.347550 0.9439164 0.5661260 0.2333660 -7.5002741E-03 -0.1179127 -7.6685771E-02 9.1749050E-02 0.3442669 0.6452686 0.9741234 -24.65536 4.889550 4.410836 3.929642 3.442593 2.954989 2.472598 1.995162 1.528959 1.066762 0.6122810 0.1813915 -0.2098843 -0.5153651 -0.6672159 -0.6051987 -0.3460957 4.3763679E-02 0.5028850 1.000254 -24.65536 4.933090 4.405819 3.876307 3.349312 2.822026 2.300834 1.787927 1.284255 0.7861934 0.3004321 -0.1703124 -0.6113449 -0.9961598 -1.235488 -1.221270 -0.9181347 -0.4096494 0.2031597 0.8681168 -24.65536 4.822687 4.274561 3.721481 3.174176 2.625933 2.084818 1.548191 1.016097 0.5010960 -5.0010956E-03 -0.4956909 -0.9710232 -1.409453 -1.748288 -1.842987 -1.564669 -0.9701992 -0.2123598 0.6187810 -24.65536 4.588364 4.041488 3.482421 2.929436 2.373165 1.820842 1.269044 0.7296029 0.2030442 -0.3140700 -0.8166007 -1.307461 -1.773345 -2.176009 -2.405299 -2.231247 -1.605785 -0.7191551 0.2754127 -24.65536 4.254386 3.721755 3.171251 2.622954 2.066324 1.507896 0.9574749 0.4145407 -0.1148897 -0.6366033 -1.144285 -1.636582 -2.111733 -2.545186 -2.870147 -2.850636 -2.271783 -1.284507 -0.1313647 -24.65536 3.838243 3.329018 2.794904 2.256430 1.706359 1.156473 0.6093518 6.9706328E-02 -0.4554609 -0.9801358 -1.485190 -1.971771 -2.439671 -2.884558 -3.251744 -3.384447 -2.937762 -1.899159 -0.5967493 -24.65536 3.347730 2.866999 2.353693 1.834781 1.300898 0.7613983 0.2260900 -0.3060400 -0.8272624 -1.343153 -1.841481 -2.314008 -2.772783 -3.205505 -3.586972 -3.818920 -3.555037 -2.537897 -1.102230 -24.65536 2.781654 2.336773 1.853588 1.358535 0.8446867 0.3231664 -0.1987440 -0.7174441 -1.228246 -1.730970 -2.212163 -2.672089 -3.114411 -3.521407 -3.896250 -4.179087 -4.101862 -3.194587 -1.655130 -24.65536 2.142074 1.739128 1.290301 0.8245379 0.3361306 -0.1656557 -0.6673555 -1.166270 -1.658941 -2.139272 -2.604240 -3.045389 -3.459128 -3.844058 -4.197353 -4.492012 -4.558505 -3.842940 -2.249275 -24.65536 1.423115 1.066490 0.6582155 0.2274588 -0.2308665 -0.7043893 -1.179881 -1.652658 -2.118936 -2.579297 -3.018633 -3.428765 -3.819901 -4.174920 -4.505097 -4.788360 -4.935696 -4.449697 -2.877553 -24.65536 0.6134353 0.3110419 -4.9739901E-02 -0.4390469 -0.8594509 -1.296830 -1.739158 -2.183038 -2.620516 -3.046801 -3.454134 -3.836890 -4.196120 -4.522545 -4.821109 -5.088651 -5.261609 -4.992912 -3.541630 -24.65536 -0.3026015 -0.5419833 -0.8459086 -1.185940 -1.560107 -1.955417 -2.357488 -2.759334 -3.158015 -3.549451 -3.922826 -4.272537 -4.599579 -4.891911 -5.163847 -5.401758 -5.568235 -5.466227 -4.239955 -24.65536 -1.359823 -1.522786 -1.759026 -2.038378 -2.352938 -2.692179 -3.039785 -3.394281 -3.751040 -4.101640 -4.435537 -4.750176 -5.042334 -5.302429 -5.538862 -5.741327 -5.887579 -5.890588 -4.957653 -24.65536 -2.622278 -2.688044 -2.838992 -3.038000 -3.279124 -3.547068 -3.825701 -4.123533 -4.429656 -4.733978 -5.023013 -5.295815 -5.550567 -5.770919 -5.964726 -6.133470 -6.263466 -6.329972 -5.690896 -24.65536 -4.242650 -4.176633 -4.211064 -4.302502 -4.445379 -4.619861 -4.812935 -5.038883 -5.281733 -5.523521 -5.753884 -5.971859 -6.175549 -6.353951 -6.511249 -6.656169 -6.779997 -6.868482 -6.470034 -24.65536 -6.814509 -6.539047 -6.385192 -6.294255 -6.274648 -6.302977 -6.360159 -6.463249 -6.601968 -6.748956 -6.896039 -7.044435 -7.186422 -7.322880 -7.439647 -7.552455 -7.646057 -7.753296 -7.487834 -24.65536 -69.07755 -69.07755 -69.07755 -68.26587 -66.43026 -64.41737 -62.24817 -59.93944 -57.50466 -54.95492 -52.29970 -49.54613 -46.70169 -43.77199 -40.76220 -37.67685 -34.52026 -31.29535 -28.00614 -24.65536 3.501156 3.405674 3.271513 3.104148 2.899179 2.660328 2.392249 2.100187 1.792537 1.474180 1.153074 0.8502440 0.5844194 0.3720260 0.2184113 0.1200660 6.3679449E-02 3.5530999E-02 2.2047415E-02 -26.68411 4.442252 4.180573 3.890806 3.577087 3.239861 2.890641 2.526668 2.159328 1.789465 1.421361 1.061648 0.7462849 0.5029002 0.3599010 0.3236391 0.3793518 0.4968590 0.6516846 0.8269824 -26.68411 5.019818 4.599843 4.170181 3.726182 3.275104 2.826828 2.382584 1.943305 1.509676 1.083027 0.6755484 0.3149094 4.7867354E-02 -7.4191131E-02 -2.7720626E-02 0.1613642 0.4413455 0.7728601 1.133212 -26.68411 5.293530 4.774404 4.256042 3.734051 3.211244 2.698124 2.193582 1.700714 1.213762 0.7325332 0.2739143 -0.1483996 -0.4837156 -0.6591300 -0.5949405 -0.3061967 0.1247707 0.6296289 1.174044 -26.68411 5.345485 4.772501 4.204718 3.637162 3.074361 2.521316 1.975996 1.445465 0.9187407 0.4060480 -9.0860717E-02 -0.5621621 -0.9777973 -1.253511 -1.253139 -0.9229933 -0.3614375 0.3121931 1.039847 -26.68411 5.230071 4.637849 4.043666 3.457123 2.872325 2.297343 1.727188 1.167426 0.6184147 8.4441230E-02 -0.4324213 -0.9302453 -1.399242 -1.778723 -1.907675 -1.619588 -0.9661726 -0.1325932 0.7769704 -26.68411 4.985050 4.395143 3.797218 3.204656 2.611241 2.023381 1.437514 0.8645890 0.3039519 -0.2406405 -0.7660452 -1.279925 -1.772330 -2.214170 -2.484429 -2.325644 -1.645651 -0.6694895 0.4195762 -26.68411 4.637086 4.063330 3.475549 2.887255 2.293431 1.699365 1.109564 0.5348805 -2.9753512E-02 -0.5812917 -1.109453 -1.625920 -2.125747 -2.588434 -2.960339 -2.980450 -2.369283 -1.283605 -2.0146491E-02 -26.68411 4.203684 3.655938 3.084949 2.508248 1.920480 1.330899 0.7478867 0.1737602 -0.3881451 -0.9397643 -1.466629 -1.978080 -2.470022 -2.937070 -3.346136 -3.527374 -3.080900 -1.941293 -0.5126562 -26.68411 3.692248 3.175750 2.627577 2.069241 1.497040 0.9196180 0.3476008 -0.2184945 -0.7755373 -1.320058 -1.839675 -2.343271 -2.818220 -3.276403 -3.687223 -3.963965 -3.732750 -2.624048 -1.047156 -26.68411 3.102096 2.623848 2.106364 1.574450 1.022165 0.4622778 -9.3101278E-02 -0.6477684 -1.193376 -1.725424 -2.233832 -2.717967 -3.178747 -3.609233 -4.010350 -4.325124 -4.296687 -3.328000 -1.635358 -26.68411 2.435189 2.001707 1.521157 1.019328 0.4937912 -4.2831220E-02 -0.5806580 -1.116317 -1.645413 -2.159116 -2.646796 -3.112663 -3.546268 -3.951744 -4.328030 -4.647550 -4.758644 -4.017868 -2.264412 -26.68411 1.687193 1.302652 0.8648838 0.3996519 -9.4601512E-02 -0.6035168 -1.116995 -1.630224 -2.133119 -2.623627 -3.089412 -3.523320 -3.928538 -4.303820 -4.653042 -4.952381 -5.138760 -4.658987 -2.932089 -26.68411 0.8445553 0.5168049 0.1295084 -0.2945139 -0.7509927 -1.225267 -1.703813 -2.186288 -2.662109 -3.121957 -3.550472 -3.955630 -4.329639 -4.670800 -4.990752 -5.268126 -5.469795 -5.222015 -3.636365 -26.68411 -0.1105829 -0.3721241 -0.7023697 -1.074776 -1.483465 -1.913713 -2.351093 -2.795616 -3.231178 -3.651252 -4.044512 -4.414588 -4.756006 -5.064375 -5.351725 -5.600595 -5.786170 -5.704994 -4.373834 -26.68411 -1.212892 -1.393652 -1.654407 -1.963091 -2.313589 -2.685365 -3.068815 -3.464174 -3.856510 -4.234248 -4.585771 -4.918313 -5.223033 -5.496048 -5.749680 -5.960673 -6.116138 -6.134979 -5.137574 -26.68411 -2.527934 -2.605516 -2.779002 -3.006620 -3.278880 -3.578142 -3.896845 -4.232584 -4.570780 -4.898618 -5.205375 -5.489379 -5.759305 -5.990547 -6.200529 -6.372409 -6.508218 -6.579570 -5.912055 -26.68411 -4.212179 -4.153332 -4.208567 -4.323086 -4.490397 -4.692816 -4.925366 -5.184510 -5.456656 -5.726684 -5.971665 -6.196395 -6.415560 -6.601318 -6.774539 -6.918593 -7.042471 -7.140065 -6.733027 -26.68411 -6.872479 -6.595655 -6.452658 -6.380345 -6.377873 -6.425868 -6.520137 -6.653728 -6.816714 -6.992164 -7.154522 -7.305148 -7.461927 -7.607729 -7.739533 -7.852737 -7.941879 -8.053805 -7.804482 -26.68411 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -67.69785 -65.17542 -62.51572 -59.73104 -56.83159 -53.82602 -50.72174 -47.52520 -44.24205 -40.87727 -37.43529 -33.92011 -30.33530 -26.68411 3.754847 3.650228 3.510808 3.340488 3.134357 2.892132 2.619247 2.310523 1.988143 1.645328 1.300860 0.9729156 0.6831275 0.4509343 0.2858829 0.1801319 0.1211660 9.2519306E-02 7.9579264E-02 -28.74740 4.770023 4.484715 4.173368 3.842023 3.489934 3.127182 2.746712 2.359448 1.973057 1.576665 1.196062 0.8535482 0.5877327 0.4310226 0.3939756 0.4574032 0.5881795 0.7585705 0.9500788 -28.74740 5.393723 4.938013 4.477345 4.005346 3.529181 3.054932 2.584540 2.126038 1.665635 1.217710 0.7833083 0.3940439 9.7501896E-02 -3.9790332E-02 1.0855548E-02 0.2191659 0.5267305 0.8890682 1.281211 -28.74740 5.691705 5.130558 4.576036 4.019620 3.464520 2.917797 2.388469 1.867161 1.352621 0.8528988 0.3647437 -8.5813172E-02 -0.4563685 -0.6554374 -0.5916368 -0.2764212 0.1959390 0.7470472 1.339017 -28.74740 5.752325 5.133981 4.527190 3.921681 3.321367 2.737057 2.159672 1.596245 1.047060 0.5085995 -1.2176135E-02 -0.5113041 -0.9588966 -1.271583 -1.288893 -0.9343507 -0.3201263 0.4151542 1.206294 -28.74740 5.633023 4.995385 4.362002 3.734212 3.114796 2.502983 1.897436 1.311287 0.7331364 0.1729648 -0.3683946 -0.8920199 -1.387523 -1.805421 -1.972942 -1.685008 -0.9738774 -6.4259768E-02 0.9247788 -28.74740 5.376729 4.744111 4.106411 3.475276 2.843020 2.216189 1.600147 0.9965764 0.3999633 -0.1695217 -0.7203010 -1.255116 -1.770937 -2.245096 -2.556680 -2.428181 -1.696052 -0.6299236 0.5548509 -28.74740 5.014102 4.400484 3.774832 3.145479 2.512375 1.884725 1.261003 0.6490086 4.9584646E-02 -0.5263825 -1.077886 -1.615868 -2.133840 -2.625600 -3.031952 -3.106874 -2.469336 -1.284719 9.0832010E-02 -28.74740 4.564740 3.977812 3.368767 2.752704 2.128669 1.503164 0.8815289 0.2717314 -0.3261820 -0.8992106 -1.452159 -1.984414 -2.494211 -2.982021 -3.425286 -3.663419 -3.225445 -1.987057 -0.4301334 -28.74740 4.031120 3.478544 2.895742 2.299765 1.687931 1.074191 0.4639568 -0.1377837 -0.7269760 -1.297560 -1.841998 -2.364997 -2.856690 -3.336431 -3.773367 -4.104212 -3.911686 -2.718621 -0.9981992 -28.74740 3.418164 2.907235 2.355141 1.784752 1.195490 0.5992851 4.4447202E-03 -0.5830837 -1.165150 -1.723417 -2.254372 -2.759459 -3.233421 -3.692614 -4.113020 -4.468775 -4.489547 -3.468876 -1.620102 -28.74740 2.724678 2.259926 1.747698 1.210170 0.6471885 7.5456254E-02 -0.5016993 -1.074311 -1.639003 -2.179359 -2.688418 -3.174303 -3.624839 -4.052328 -4.451557 -4.800794 -4.953150 -4.197930 -2.282553 -28.74740 1.947523 1.536052 1.068027 0.5678527 3.7104651E-02 -0.5077542 -1.060066 -1.610706 -2.151191 -2.663502 -3.150160 -3.610646 -4.026143 -4.428648 -4.796193 -5.122269 -5.334109 -4.870861 -2.988661 -28.74740 1.073331 0.7211393 0.3041981 -0.1526979 -0.6449896 -1.153775 -1.672827 -2.192145 -2.703548 -3.187575 -3.638166 -4.063579 -4.452382 -4.821567 -5.156838 -5.451492 -5.670464 -5.448913 -3.732106 -28.74740 8.1155941E-02 -0.2015537 -0.5584233 -0.9628555 -1.407111 -1.871435 -2.351012 -2.834539 -3.305520 -3.747664 -4.159513 -4.551626 -4.906676 -5.241066 -5.536565 -5.801677 -5.996274 -5.933942 -4.508578 -28.74740 -1.062227 -1.260040 -1.546734 -1.887414 -2.271777 -2.681152 -3.106468 -3.540180 -3.964170 -4.364825 -4.733351 -5.082949 -5.402790 -5.697271 -5.958404 -6.178777 -6.338861 -6.362839 -5.310668 -28.74740 -2.428181 -2.519022 -2.717543 -2.975093 -3.280272 -3.612990 -3.970767 -4.345309 -4.714112 -5.065571 -5.384421 -5.687837 -5.967438 -6.222587 -6.434621 -6.608482 -6.746895 -6.807117 -6.125399 -28.74740 -4.181396 -4.131877 -4.203271 -4.345427 -4.541781 -4.774376 -5.040908 -5.333215 -5.634045 -5.925856 -6.188666 -6.435339 -6.657845 -6.861528 -7.032834 -7.172243 -7.293708 -7.385206 -6.987461 -28.74740 -6.933773 -6.656318 -6.516420 -6.469295 -6.489685 -6.560319 -6.678707 -6.842218 -7.033448 -7.225607 -7.407118 -7.577718 -7.746494 -7.896807 -8.033606 -8.142118 -8.232668 -8.325428 -8.112565 -28.74740 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -67.61961 -64.59492 -61.44633 -58.18331 -54.81395 -51.34528 -47.78345 -44.13388 -40.40139 -36.59030 -32.70448 -28.74740 4.001112 3.889086 3.741829 3.573430 3.355659 3.113944 2.841489 2.523744 2.181431 1.815882 1.446012 1.092005 0.7781960 0.5289178 0.3497118 0.2366901 0.1749355 0.1453789 0.1328130 -30.84375 5.092845 4.782444 4.452340 4.096204 3.727587 3.353121 2.962845 2.559919 2.150769 1.730409 1.325088 0.9560162 0.6685396 0.4991076 0.4602768 0.5314858 0.6760340 0.8619142 1.069776 -30.84375 5.763117 5.272643 4.776139 4.273060 3.773998 3.278153 2.785982 2.301831 1.819036 1.344338 0.8862535 0.4665451 0.1447805 -9.0493485E-03 4.3182258E-02 0.2705536 0.6063755 0.9998749 1.424206 -30.84375 6.086424 5.479309 4.886479 4.297646 3.712931 3.134975 2.576708 2.026918 1.487119 0.9642639 0.4513830 -2.6682345E-02 -0.4282796 -0.6531296 -0.5945525 -0.2531315 0.2611571 0.8591530 1.499296 -30.84375 6.152014 5.487983 4.843347 4.200848 3.566403 2.945762 2.337294 1.743190 1.166128 0.6055260 5.9824336E-02 -0.4608155 -0.9412642 -1.289718 -1.336134 -0.9636333 -0.2983606 0.4989768 1.354288 -30.84375 6.029713 5.348531 4.674592 4.008933 3.350758 2.701553 2.064274 1.442932 0.8382333 0.2531300 -0.3101964 -0.8546577 -1.375479 -1.827338 -2.046054 -1.764200 -1.001096 -1.4814314E-02 1.054519 -30.84375 5.763709 5.087563 4.412602 3.739057 3.068424 2.404724 1.753277 1.116579 0.4891042 -0.1033794 -0.6759991 -1.228388 -1.765973 -2.265636 -2.628236 -2.537676 -1.760663 -0.6041171 0.6773737 -30.84375 5.386926 4.732999 4.067745 3.397335 2.726214 2.060760 1.402324 0.7540884 0.1237729 -0.4738457 -1.051173 -1.602599 -2.140944 -2.655584 -3.100446 -3.230915 -2.574888 -1.290021 0.1987650 -30.84375 4.919771 4.293635 3.646547 2.991542 2.328442 1.667204 1.008099 0.3619365 -0.2658874 -0.8645184 -1.438894 -1.984952 -2.515984 -3.023258 -3.498391 -3.790478 -3.371417 -2.034911 -0.3484458 -30.84375 4.364261 3.776937 3.157143 2.522980 1.873935 1.221307 0.5748466 -6.4091414E-02 -0.6861988 -1.278637 -1.846466 -2.380131 -2.897418 -3.392396 -3.861963 -4.232017 -4.086769 -2.818874 -0.9545063 -30.84375 3.729098 3.185122 2.598209 1.990907 1.363311 0.7309841 9.6646510E-02 -0.5298843 -1.141137 -1.723043 -2.275823 -2.794053 -3.289633 -3.769562 -4.215752 -4.602002 -4.672208 -3.615772 -1.612438 -30.84375 3.010629 2.514833 1.969280 1.396386 0.7962598 0.1863619 -0.4278680 -1.040402 -1.633466 -2.195405 -2.728918 -3.224672 -3.702711 -4.151466 -4.573236 -4.943881 -5.129036 -4.383430 -2.310960 -30.84375 2.204496 1.765454 1.267122 0.7306057 0.1651413 -0.4157527 -1.007201 -1.597499 -2.167428 -2.702233 -3.208839 -3.685341 -4.131064 -4.551969 -4.937355 -5.279985 -5.508910 -5.083099 -3.055182 -30.84375 1.299113 0.9231022 0.4780562 -1.3781787E-02 -0.5404862 -1.086749 -1.648174 -2.207424 -2.745723 -3.250771 -3.724720 -4.166926 -4.584466 -4.970840 -5.317790 -5.618709 -5.850688 -5.668816 -3.831965 -30.84375 0.2731297 -2.9192552E-02 -0.4144721 -0.8520550 -1.332646 -1.835078 -2.356861 -2.876934 -3.380892 -3.843457 -4.276442 -4.684867 -5.068411 -5.417046 -5.717896 -5.983700 -6.184914 -6.153991 -4.646135 -30.84375 -0.9089587 -1.125357 -1.438865 -1.811763 -2.232122 -2.679029 -3.146277 -3.615240 -4.072373 -4.492174 -4.885780 -5.253283 -5.595111 -5.897619 -6.159072 -6.378229 -6.539068 -6.584099 -5.486800 -30.84375 -2.326148 -2.433746 -2.653652 -2.943623 -3.284678 -3.653861 -4.048637 -4.456341 -4.857208 -5.225574 -5.572166 -5.891556 -6.187190 -6.447000 -6.655702 -6.825451 -6.961505 -7.032752 -6.337004 -30.84375 -4.146413 -4.106436 -4.196429 -4.367951 -4.596855 -4.861351 -5.159942 -5.483711 -5.813023 -6.119090 -6.411085 -6.672248 -6.909973 -7.111257 -7.275255 -7.411381 -7.526491 -7.624553 -7.234339 -30.84375 -6.977901 -6.699561 -6.572664 -6.550343 -6.601838 -6.698087 -6.840436 -7.039153 -7.252230 -7.460014 -7.666853 -7.860328 -8.034366 -8.185305 -8.309587 -8.412167 -8.501377 -8.590481 -8.408796 -30.84375 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -66.13961 -62.61422 -58.97482 -55.22902 -51.38348 -47.44406 -43.41599 -39.30387 -35.11188 -30.84375 4.242345 4.121008 3.969965 3.792655 3.561975 3.320795 3.050777 2.736198 2.370850 1.980746 1.587536 1.208624 0.8695753 0.6001252 0.4049576 0.2839615 0.2186134 0.1876832 0.1754905 -32.97178 5.411504 5.072233 4.719249 4.339221 3.948086 3.565604 3.171523 2.755179 2.321890 1.877564 1.449166 1.057507 0.7452475 0.5624153 0.5194808 0.5988709 0.7567599 0.9581364 1.182597 -32.97178 6.130126 5.598383 5.066069 4.526953 4.007213 3.492084 2.982312 2.470334 1.964474 1.467741 0.9872013 0.5395032 0.1939549 2.2566078E-02 7.6698564E-02 0.3245267 0.6894481 1.114462 1.571516 -32.97178 6.475965 5.821312 5.186049 4.565711 3.952375 3.347935 2.757515 2.178686 1.615455 1.069913 0.5389448 3.0844828E-02 -0.3983460 -0.6534219 -0.6036356 -0.2372002 0.3199622 0.9652183 1.654231 -32.97178 6.546742 5.833994 5.150666 4.473268 3.806518 3.148110 2.507219 1.880975 1.279776 0.6989821 0.1301233 -0.4127556 -0.9206600 -1.309717 -1.391703 -1.008231 -0.2925059 0.5669563 1.487305 -32.97178 6.419170 5.694265 4.982935 4.278611 3.580931 2.892639 2.221731 1.567628 0.9379243 0.3324048 -0.2536148 -0.8158511 -1.359832 -1.848745 -2.120011 -1.861606 -1.051680 1.0284406E-02 1.160896 -32.97178 6.144576 5.427272 4.712946 3.997881 3.286581 2.585611 1.899761 1.226990 0.5784962 -4.2447750E-02 -0.6323909 -1.203218 -1.759892 -2.285488 -2.697838 -2.654631 -1.846055 -0.6011584 0.7781823 -32.97178 5.755046 5.059936 4.353874 3.643141 2.932102 2.230255 1.535422 0.8542788 0.1950964 -0.4257904 -1.020721 -1.589702 -2.148116 -2.681390 -3.162629 -3.347222 -2.686061 -1.303269 0.3002785 -32.97178 5.268835 4.603535 3.918241 3.222897 2.521146 1.823346 1.130052 0.4444515 -0.2097427 -0.8313963 -1.423416 -1.987881 -2.535964 -3.065504 -3.566204 -3.900230 -3.520930 -2.091617 -0.2742359 -32.97178 4.692803 4.069490 3.411539 2.738571 2.054054 1.365095 0.6773863 2.0511558E-03 -0.6471735 -1.261184 -1.848607 -2.399002 -2.935200 -3.449126 -3.943944 -4.340814 -4.260771 -2.927946 -0.9184596 -32.97178 4.033999 3.456009 2.835064 2.191430 1.526414 0.8558747 0.1826088 -0.4813286 -1.117092 -1.721532 -2.293807 -2.828743 -3.347286 -3.844066 -4.307728 -4.714978 -4.849976 -3.768372 -1.609568 -32.97178 3.291421 2.765117 2.186641 1.576177 0.9410864 0.2935451 -0.3620804 -1.009254 -1.630244 -2.211034 -2.764836 -3.280927 -3.782874 -4.250113 -4.680322 -5.066178 -5.300192 -4.572107 -2.343767 -32.97178 2.457059 1.991065 1.462422 0.8907022 0.2882010 -0.3297510 -0.9656179 -1.589673 -2.185645 -2.740041 -3.266260 -3.765664 -4.240597 -4.668359 -5.062652 -5.417564 -5.675261 -5.290469 -3.123817 -32.97178 1.522929 1.123423 0.6487949 0.1232121 -0.4416458 -1.027179 -1.629893 -2.222402 -2.789016 -3.313190 -3.813532 -4.279212 -4.715865 -5.107658 -5.461539 -5.771515 -6.019826 -5.880118 -3.936214 -32.97178 0.4649856 0.1402744 -0.2727126 -0.7436019 -1.260411 -1.804179 -2.363839 -2.919377 -3.449861 -3.939648 -4.396996 -4.826199 -5.224324 -5.574358 -5.881631 -6.150056 -6.361472 -6.358073 -4.784728 -32.97178 -0.7563668 -0.9919324 -1.331232 -1.737272 -2.195653 -2.682323 -3.188795 -3.693744 -4.173228 -4.619691 -5.037641 -5.424752 -5.777942 -6.078611 -6.339175 -6.564598 -6.727225 -6.785156 -5.661613 -32.97178 -2.223795 -2.345712 -2.590178 -2.913034 -3.291751 -3.699235 -4.130326 -4.573782 -4.995164 -5.389314 -5.758570 -6.092293 -6.396172 -6.654059 -6.859258 -7.031133 -7.159531 -7.235609 -6.541064 -32.97178 -4.103958 -4.073202 -4.183515 -4.386377 -4.648941 -4.949787 -5.285181 -5.643509 -5.986968 -6.318549 -6.627244 -6.905225 -7.144898 -7.345685 -7.502482 -7.637687 -7.741304 -7.833960 -7.463000 -32.97178 -7.014557 -6.734465 -6.618982 -6.624738 -6.701375 -6.831420 -7.011317 -7.231891 -7.460639 -7.696589 -7.915607 -8.117019 -8.288504 -8.446109 -8.563635 -8.664726 -8.743326 -8.818123 -8.670280 -32.97178 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -67.11530 -63.20114 -59.17347 -55.03946 -50.80542 -46.47693 -42.05894 -37.55588 -32.97178 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.446824 -1.721935 -1.736467 -1.749937 -1.762597 -1.774160 -1.784408 -1.800098 -1.814999 -1.829034 -1.842263 -1.854189 -1.865551 -1.875904 -1.886519 -1.898831 -1.910086 -1.919864 -1.928031 -1.934065 -2.590475 -1.749439 -1.764686 -1.779501 -1.792933 -1.804824 -1.815839 -1.832207 -1.847633 -1.862054 -1.875067 -1.887167 -1.898318 -1.908174 -1.918224 -1.929927 -1.940252 -1.948745 -1.953470 -1.961590 -2.590475 -1.779678 -1.796011 -1.811413 -1.825066 -1.837541 -1.849340 -1.866217 -1.881954 -1.896611 -1.909501 -1.921486 -1.932199 -1.941475 -1.951014 -1.962047 -1.971408 -1.978621 -1.980305 -1.990129 -2.590475 -1.813888 -1.830537 -1.845897 -1.859971 -1.873047 -1.885486 -1.902653 -1.918570 -1.932777 -1.945829 -1.957597 -1.967872 -1.976377 -1.985630 -1.995854 -2.004226 -2.010174 -2.009138 -2.020371 -2.590475 -1.851133 -1.867308 -1.882934 -1.897377 -1.911023 -1.923746 -1.940948 -1.956439 -1.970780 -1.983688 -1.995001 -2.004669 -2.012651 -2.021259 -2.030657 -2.037982 -2.042721 -2.039372 -2.051646 -2.590475 -1.890083 -1.906394 -1.922229 -1.937034 -1.950727 -1.963466 -1.980587 -1.995697 -2.009798 -2.022270 -2.032993 -2.041769 -2.049536 -2.057221 -2.065597 -2.071776 -2.075464 -2.070212 -2.083123 -2.590475 -1.932849 -1.949072 -1.965092 -1.979877 -1.993400 -2.005940 -2.022046 -2.037207 -2.050873 -2.062819 -2.072500 -2.081006 -2.088097 -2.094913 -2.102148 -2.106772 -2.109688 -2.102977 -2.116116 -2.590475 -1.979725 -1.995751 -2.011525 -2.026031 -2.038767 -2.050661 -2.066598 -2.081197 -2.094239 -2.105418 -2.114428 -2.122457 -2.128390 -2.134144 -2.140337 -2.143574 -2.142462 -2.137779 -2.150705 -2.590475 -2.031315 -2.046792 -2.062117 -2.075552 -2.087931 -2.099211 -2.114392 -2.128206 -2.140334 -2.150225 -2.159065 -2.166208 -2.171169 -2.175546 -2.180258 -2.182475 -2.176903 -2.175039 -2.187274 -2.590475 -2.087754 -2.101819 -2.116139 -2.129073 -2.140815 -2.151255 -2.165483 -2.178170 -2.188763 -2.198385 -2.206285 -2.212020 -2.215690 -2.218922 -2.221891 -2.223286 -2.214190 -2.214525 -2.225523 -2.590475 -2.148340 -2.161558 -2.174731 -2.186627 -2.197123 -2.206446 -2.218707 -2.230289 -2.240540 -2.249064 -2.255208 -2.259646 -2.262022 -2.263170 -2.265092 -2.262065 -2.253816 -2.255538 -2.264649 -2.590475 -2.215661 -2.227539 -2.239198 -2.249757 -2.258617 -2.265615 -2.277023 -2.287468 -2.296332 -2.302919 -2.307644 -2.310532 -2.311936 -2.311430 -2.311161 -2.302240 -2.297178 -2.299494 -2.305952 -2.590475 -2.290597 -2.300577 -2.310007 -2.317700 -2.324618 -2.330782 -2.340591 -2.348491 -2.355654 -2.360488 -2.363504 -2.364960 -2.364503 -2.362932 -2.355167 -2.346889 -2.344000 -2.345901 -2.348877 -2.590475 -2.372484 -2.380009 -2.387138 -2.393516 -2.398162 -2.401225 -2.408698 -2.414482 -2.419117 -2.422139 -2.422899 -2.422448 -2.420654 -2.413771 -2.402765 -2.396080 -2.394023 -2.394441 -2.392841 -2.590475 -2.467103 -2.471856 -2.475649 -2.478978 -2.480593 -2.481335 -2.486045 -2.489187 -2.490813 -2.491000 -2.489922 -2.487570 -2.478885 -2.468347 -2.460085 -2.454345 -2.450977 -2.448464 -2.682955 -2.590475 -2.576828 -2.577937 -2.578477 -2.578184 -2.577211 -2.575778 -2.573228 -2.573466 -2.572340 -2.570436 -2.563325 -2.553619 -2.544134 -2.535769 -2.528467 -2.522341 -2.516197 -2.508709 -2.673229 -2.590475 -2.709033 -2.706166 -2.703056 -2.699823 -2.695336 -2.690953 -2.685976 -2.675828 -2.665393 -2.654796 -2.646233 -2.637682 -2.629167 -2.620519 -2.612024 -2.602505 -2.591498 -2.576579 -2.663079 -2.590475 -2.882886 -2.870070 -2.860249 -2.849860 -2.839360 -2.828904 -2.818196 -2.807246 -2.796190 -2.784812 -2.773136 -2.762001 -2.749132 -2.735986 -2.721519 -2.705074 -2.684723 -2.712320 -2.652507 -2.590475 -3.160044 -3.145250 -3.130098 -3.115655 -3.099384 -3.082678 -3.065487 -3.048187 -3.029569 -3.010212 -2.989702 -2.967657 -2.943454 -2.916276 -2.836078 -2.788894 -2.740728 -2.691599 -2.641512 -2.590475 -3.246382 -3.217285 -3.187549 -3.157182 -3.126189 -3.094577 -3.062596 -3.029520 -2.996082 -2.962048 -2.927428 -2.892230 -2.856457 -2.820118 -2.783218 -2.745761 -2.707744 -2.669188 -2.630096 -2.590475 -1.397868 -1.423283 -1.448248 -1.482574 -1.514436 -1.545145 -1.573536 -1.600120 -1.624141 -1.649727 -1.676433 -1.701030 -1.723782 -1.744402 -1.762640 -1.781048 -1.798829 -1.814921 -1.827210 -3.828560 -1.407737 -1.437560 -1.468637 -1.507729 -1.544732 -1.579254 -1.610693 -1.639613 -1.665176 -1.692475 -1.720252 -1.745128 -1.767682 -1.787248 -1.803875 -1.820287 -1.835636 -1.847851 -1.857619 -3.828560 -1.429226 -1.464358 -1.501241 -1.543633 -1.583924 -1.620659 -1.654869 -1.685343 -1.712543 -1.741205 -1.769403 -1.794551 -1.816424 -1.834794 -1.849797 -1.864334 -1.877231 -1.885606 -1.892763 -3.828560 -1.465018 -1.504374 -1.545071 -1.590738 -1.632403 -1.671570 -1.707188 -1.738865 -1.767719 -1.797171 -1.825671 -1.850895 -1.871985 -1.889178 -1.902575 -1.915265 -1.925930 -1.930555 -1.935064 -3.828560 -1.513832 -1.556865 -1.600502 -1.646580 -1.690339 -1.730672 -1.767095 -1.800248 -1.830105 -1.859974 -1.888685 -1.913572 -1.933723 -1.949724 -1.961561 -1.972687 -1.981202 -1.982235 -1.984100 -3.828560 -1.575998 -1.621090 -1.665047 -1.712374 -1.756523 -1.797548 -1.835285 -1.869332 -1.899685 -1.929691 -1.958502 -1.982557 -2.002096 -2.016922 -2.027360 -2.037000 -2.043412 -2.041142 -2.040400 -3.828560 -1.648056 -1.693578 -1.738049 -1.785087 -1.829131 -1.870841 -1.909006 -1.943529 -1.974007 -2.004184 -2.032156 -2.055481 -2.074210 -2.087906 -2.097264 -2.105176 -2.109563 -2.104218 -2.100802 -3.828560 -1.730013 -1.774888 -1.818902 -1.865038 -1.908949 -1.950357 -1.988457 -2.022611 -2.053531 -2.083281 -2.110140 -2.132622 -2.150311 -2.162843 -2.171213 -2.177783 -2.178560 -2.171704 -2.165496 -3.828560 -1.820648 -1.864320 -1.907190 -1.952215 -1.995137 -2.035560 -2.072965 -2.107017 -2.137295 -2.165572 -2.191620 -2.213000 -2.229609 -2.241595 -2.248587 -2.253613 -2.250447 -2.242644 -2.233438 -3.828560 -1.919918 -1.961713 -2.002882 -2.046033 -2.086936 -2.126035 -2.162947 -2.195938 -2.224133 -2.251211 -2.276193 -2.296356 -2.311737 -2.322816 -2.328668 -2.331670 -2.324898 -2.315947 -2.303514 -3.828560 -2.029216 -2.068710 -2.107237 -2.147984 -2.187383 -2.224911 -2.259594 -2.290612 -2.317218 -2.342854 -2.366479 -2.385136 -2.400079 -2.409941 -2.414363 -2.413462 -2.405028 -2.394719 -2.378883 -3.828560 -2.148145 -2.184693 -2.221330 -2.260373 -2.297247 -2.331514 -2.363224 -2.392386 -2.417054 -2.440942 -2.462839 -2.481378 -2.495029 -2.503445 -2.505519 -2.499912 -2.491145 -2.479040 -2.459471 -3.828560 -2.279954 -2.313065 -2.346079 -2.381504 -2.414809 -2.446535 -2.475666 -2.501769 -2.524077 -2.545829 -2.567060 -2.584333 -2.596490 -2.602661 -2.599169 -2.591767 -2.582623 -2.567978 -2.544022 -3.828560 -2.427678 -2.454922 -2.481678 -2.513132 -2.543514 -2.572632 -2.598610 -2.621093 -2.641515 -2.660934 -2.679974 -2.694977 -2.704844 -2.706024 -2.698601 -2.690113 -2.679243 -2.661425 -2.632320 -3.828560 -2.593370 -2.615195 -2.638273 -2.664094 -2.688015 -2.713432 -2.737950 -2.758428 -2.775267 -2.790681 -2.805687 -2.816665 -2.819851 -2.817000 -2.809542 -2.798659 -2.784316 -2.762302 -2.726973 -3.828560 -2.789679 -2.804980 -2.822310 -2.843218 -2.863622 -2.883459 -2.901019 -2.916270 -2.928672 -2.939378 -2.946968 -2.949951 -2.949263 -2.944967 -2.936182 -2.920477 -2.901553 -2.873215 -2.830489 -3.828560 -3.040897 -3.047938 -3.055137 -3.067222 -3.080263 -3.091910 -3.102619 -3.108347 -3.110130 -3.112521 -3.114972 -3.115422 -3.111856 -3.103135 -3.088549 -3.067452 -3.039613 -3.002860 -2.951148 -3.828560 -3.376990 -3.371443 -3.366556 -3.368118 -3.369559 -3.369700 -3.369234 -3.368014 -3.364325 -3.358294 -3.349284 -3.341779 -3.330020 -3.312778 -3.289107 -3.257363 -3.216896 -3.167789 -3.104903 -3.828560 -3.929893 -3.914438 -3.898920 -3.882733 -3.866466 -3.848516 -3.831220 -3.814688 -3.795193 -3.772528 -3.746068 -3.715299 -3.679931 -3.640373 -3.598289 -3.549217 -3.491596 -3.425267 -3.346463 -3.828560 -5.330743 -5.271910 -5.210549 -5.146712 -5.080443 -5.011789 -4.940818 -4.867823 -4.792105 -4.714456 -4.634691 -4.552853 -4.469211 -4.383100 -4.295297 -4.205596 -4.114020 -4.020633 -3.925471 -3.828560 -1.071191 -1.118596 -1.164288 -1.206411 -1.248519 -1.295636 -1.340163 -1.381453 -1.419373 -1.454575 -1.489276 -1.524627 -1.557762 -1.587988 -1.614801 -1.638254 -1.659895 -1.678319 -1.693898 -5.157303 -1.036839 -1.095210 -1.150355 -1.201351 -1.253943 -1.309385 -1.360759 -1.408202 -1.451249 -1.490384 -1.528209 -1.565894 -1.599007 -1.627689 -1.651652 -1.671013 -1.687636 -1.699779 -1.708598 -5.157303 -1.033720 -1.099649 -1.162383 -1.222499 -1.283457 -1.345610 -1.402667 -1.454799 -1.502618 -1.545296 -1.586467 -1.625323 -1.658383 -1.685447 -1.706576 -1.722036 -1.733763 -1.740057 -1.742157 -5.157303 -1.054742 -1.125925 -1.196209 -1.264297 -1.331539 -1.398509 -1.460084 -1.516511 -1.567819 -1.614348 -1.658268 -1.697604 -1.730284 -1.755820 -1.774065 -1.785919 -1.792875 -1.793672 -1.789129 -5.157303 -1.095450 -1.172041 -1.247819 -1.320848 -1.392954 -1.463528 -1.528909 -1.588823 -1.643091 -1.692695 -1.738025 -1.777768 -1.809383 -1.833259 -1.848593 -1.856997 -1.859372 -1.854752 -1.843676 -5.157303 -1.157625 -1.238439 -1.317234 -1.393820 -1.468686 -1.542293 -1.611125 -1.674130 -1.731650 -1.783005 -1.828980 -1.868536 -1.899663 -1.921553 -1.934472 -1.939653 -1.937771 -1.928086 -1.910688 -5.157303 -1.240966 -1.323069 -1.403700 -1.482275 -1.559644 -1.635543 -1.706406 -1.772362 -1.832469 -1.885137 -1.931336 -1.970876 -2.001008 -2.021424 -2.032350 -2.034603 -2.029066 -2.014878 -1.991437 -5.157303 -1.341568 -1.422987 -1.504709 -1.584967 -1.663294 -1.740099 -1.812360 -1.879668 -1.940755 -1.994409 -2.040833 -2.079739 -2.108732 -2.127594 -2.136840 -2.136448 -2.127460 -2.109287 -2.080026 -5.157303 -1.459150 -1.539728 -1.621494 -1.701790 -1.779983 -1.856573 -1.929021 -1.995940 -2.056943 -2.110807 -2.157350 -2.195403 -2.222936 -2.240869 -2.248750 -2.245971 -2.234281 -2.211998 -2.177219 -5.157303 -1.595789 -1.673926 -1.752812 -1.831143 -1.908877 -1.983873 -2.054430 -2.119895 -2.179963 -2.233320 -2.278565 -2.315246 -2.341873 -2.358835 -2.365091 -2.360311 -2.346568 -2.320223 -2.280072 -5.157303 -1.751920 -1.825091 -1.899606 -1.974497 -2.049070 -2.121689 -2.189045 -2.252290 -2.310521 -2.361533 -2.404382 -2.439270 -2.465485 -2.481795 -2.486266 -2.479604 -2.463995 -2.433648 -2.388397 -5.157303 -1.926954 -1.994266 -2.063140 -2.132655 -2.202405 -2.270956 -2.335896 -2.395016 -2.449349 -2.497134 -2.537576 -2.571087 -2.596550 -2.611425 -2.615178 -2.608016 -2.589534 -2.555562 -2.505221 -5.157303 -2.120900 -2.181873 -2.243243 -2.307547 -2.371894 -2.434462 -2.493822 -2.548173 -2.597101 -2.641476 -2.680058 -2.712157 -2.735027 -2.749619 -2.752911 -2.745089 -2.723347 -2.686382 -2.630598 -5.157303 -2.335884 -2.390107 -2.444534 -2.501399 -2.557852 -2.611910 -2.663754 -2.712628 -2.757497 -2.798125 -2.834222 -2.862884 -2.884239 -2.897866 -2.902064 -2.891210 -2.866233 -2.826221 -2.764734 -5.157303 -2.579734 -2.623314 -2.666470 -2.713199 -2.760087 -2.807550 -2.852357 -2.895364 -2.935954 -2.971796 -3.003271 -3.029120 -3.048556 -3.062103 -3.063028 -3.048071 -3.020809 -2.976446 -2.908414 -5.157303 -2.848306 -2.881555 -2.916182 -2.952259 -2.992021 -3.032938 -3.071271 -3.106746 -3.139221 -3.168772 -3.196404 -3.220023 -3.235554 -3.241861 -3.237163 -3.218540 -3.187487 -3.137125 -3.060403 -5.157303 -3.176725 -3.198676 -3.223262 -3.250098 -3.278867 -3.308091 -3.336690 -3.366632 -3.393688 -3.415677 -3.433817 -3.447499 -3.452708 -3.451798 -3.442701 -3.418722 -3.378983 -3.319412 -3.231683 -5.157303 -3.622819 -3.628990 -3.639590 -3.652631 -3.669032 -3.685644 -3.701229 -3.716201 -3.727350 -3.738395 -3.743347 -3.745706 -3.741674 -3.730815 -3.710197 -3.674977 -3.620531 -3.545619 -3.443683 -5.157303 -4.363685 -4.347482 -4.336577 -4.327473 -4.318682 -4.310366 -4.304406 -4.297435 -4.289669 -4.278480 -4.263630 -4.240893 -4.213499 -4.177724 -4.129006 -4.065169 -3.982981 -3.882837 -3.761949 -5.157303 -7.660745 -7.571789 -7.476714 -7.376410 -7.270820 -7.160124 -7.044458 -6.924030 -6.798968 -6.669440 -6.535598 -6.397553 -6.255473 -6.109459 -5.959644 -5.806145 -5.649049 -5.488488 -5.324782 -5.157303 -0.7378978 -0.8059350 -0.8732131 -0.9373423 -0.9965256 -1.056663 -1.118389 -1.174625 -1.224943 -1.271311 -1.313000 -1.353266 -1.390173 -1.423893 -1.455826 -1.483086 -1.506328 -1.525242 -1.540483 -6.568760 -0.6451907 -0.7317784 -0.8146880 -0.8937857 -0.9679173 -1.041797 -1.114530 -1.179722 -1.238080 -1.289512 -1.333921 -1.375423 -1.411931 -1.443777 -1.470738 -1.490746 -1.505168 -1.513670 -1.517473 -6.568760 -0.6096272 -0.7093720 -0.8058880 -0.8976085 -0.9849604 -1.071440 -1.152165 -1.224391 -1.289105 -1.344860 -1.392807 -1.435913 -1.471699 -1.501831 -1.524001 -1.537250 -1.543225 -1.541794 -1.534595 -6.568760 -0.6163089 -0.7256239 -0.8324471 -0.9360923 -1.035449 -1.129508 -1.217174 -1.296468 -1.365507 -1.424989 -1.476334 -1.521218 -1.557567 -1.585890 -1.603520 -1.610488 -1.608440 -1.597498 -1.579622 -6.568760 -0.6566887 -0.7732236 -0.8882902 -1.001362 -1.107349 -1.207110 -1.301998 -1.385587 -1.458706 -1.521967 -1.576917 -1.623099 -1.660532 -1.686918 -1.700294 -1.701281 -1.691682 -1.671562 -1.643295 -6.568760 -0.7266307 -0.8489316 -0.9703056 -1.087227 -1.197287 -1.302882 -1.400742 -1.488827 -1.565792 -1.633244 -1.690662 -1.739501 -1.777665 -1.801828 -1.811361 -1.806987 -1.790352 -1.761460 -1.723124 -6.568760 -0.8258766 -0.9503642 -1.073876 -1.193198 -1.306705 -1.413969 -1.515051 -1.606325 -1.687739 -1.759580 -1.820045 -1.871976 -1.910607 -1.933042 -1.939705 -1.930764 -1.907771 -1.871053 -1.822971 -6.568760 -0.9509352 -1.072974 -1.196291 -1.318045 -1.431682 -1.539553 -1.641737 -1.736696 -1.822780 -1.897636 -1.963366 -2.017536 -2.055964 -2.077690 -2.082201 -2.069713 -2.041187 -1.997983 -1.940451 -6.568760 -1.097009 -1.216120 -1.336440 -1.455823 -1.569669 -1.677073 -1.779454 -1.876631 -1.964943 -2.044754 -2.113420 -2.168708 -2.206842 -2.227683 -2.230555 -2.214994 -2.181595 -2.132637 -2.066158 -6.568760 -1.266726 -1.378762 -1.493906 -1.609512 -1.721639 -1.829598 -1.931154 -2.027156 -2.118615 -2.201602 -2.271675 -2.327108 -2.365347 -2.385415 -2.387457 -2.369781 -2.332464 -2.278520 -2.203715 -6.568760 -1.456738 -1.562021 -1.669867 -1.780852 -1.889922 -1.995431 -2.096310 -2.191011 -2.282274 -2.365215 -2.434930 -2.490268 -2.528427 -2.547972 -2.548993 -2.529490 -2.489646 -2.431382 -2.348748 -6.568760 -1.669862 -1.767521 -1.867628 -1.971925 -2.074923 -2.176591 -2.276428 -2.369389 -2.455689 -2.534982 -2.603246 -2.657646 -2.695554 -2.715068 -2.714958 -2.693811 -2.653769 -2.590262 -2.500283 -6.568760 -1.909947 -1.997910 -2.089314 -2.184904 -2.282661 -2.378545 -2.473329 -2.561038 -2.641062 -2.714784 -2.779704 -2.833059 -2.871755 -2.890942 -2.889683 -2.868398 -2.829111 -2.760931 -2.664427 -6.568760 -2.178901 -2.256935 -2.340900 -2.427676 -2.515432 -2.601246 -2.686198 -2.766648 -2.839036 -2.905879 -2.967462 -3.019319 -3.056457 -3.075757 -3.074642 -3.056374 -3.014977 -2.942890 -2.840378 -6.568760 -2.490472 -2.554966 -2.625642 -2.698853 -2.773038 -2.846110 -2.918936 -2.988550 -3.054411 -3.116124 -3.171577 -3.218518 -3.252609 -3.272196 -3.275144 -3.256600 -3.211578 -3.137466 -3.027869 -6.568760 -2.844201 -2.891573 -2.945124 -3.002392 -3.059582 -3.121494 -3.184006 -3.245001 -3.299689 -3.351476 -3.399759 -3.440871 -3.471130 -3.494375 -3.497420 -3.474105 -3.424815 -3.347795 -3.230856 -6.568760 -3.246984 -3.280524 -3.323243 -3.366779 -3.409450 -3.455803 -3.502824 -3.550467 -3.592108 -3.633646 -3.672754 -3.711897 -3.739386 -3.751183 -3.746253 -3.718817 -3.666590 -3.581601 -3.453445 -6.568760 -3.791000 -3.799827 -3.818733 -3.846340 -3.873442 -3.900291 -3.933045 -3.966629 -3.997003 -4.021317 -4.045965 -4.065411 -4.075969 -4.076315 -4.063102 -4.027352 -3.963452 -3.863438 -3.717401 -6.568760 -4.677252 -4.657163 -4.645552 -4.640207 -4.637772 -4.639614 -4.644269 -4.650501 -4.654736 -4.655901 -4.656160 -4.650545 -4.638961 -4.614481 -4.573304 -4.508445 -4.410631 -4.276878 -4.104355 -6.568760 -10.20233 -10.08214 -9.952030 -9.812406 -9.663692 -9.506278 -9.340553 -9.166884 -8.985607 -8.797058 -8.601521 -8.399301 -8.190635 -7.975798 -7.754991 -7.528459 -7.296377 -7.058956 -6.816359 -6.568760 -0.4274693 -0.5027596 -0.5868067 -0.6695214 -0.7506387 -0.8280816 -0.9061597 -0.9786062 -1.045823 -1.107210 -1.160326 -1.208073 -1.249721 -1.285815 -1.317709 -1.346952 -1.371346 -1.390392 -1.404552 -8.055264 -0.2639929 -0.3671827 -0.4742224 -0.5791748 -0.6806930 -0.7758130 -0.8688065 -0.9549352 -1.032591 -1.099571 -1.155919 -1.203879 -1.242728 -1.273303 -1.296900 -1.315569 -1.326510 -1.330229 -1.327768 -8.055264 -0.1844188 -0.3107755 -0.4389707 -0.5634972 -0.6817055 -0.7923232 -0.8989131 -0.9960888 -1.081628 -1.153360 -1.213442 -1.261117 -1.297632 -1.323381 -1.339851 -1.347960 -1.346181 -1.335297 -1.316864 -8.055264 -0.1678679 -0.3127147 -0.4575098 -0.5970702 -0.7290483 -0.8548720 -0.9734452 -1.079046 -1.169705 -1.246902 -1.309887 -1.358675 -1.393421 -1.415089 -1.425935 -1.424150 -1.410332 -1.385435 -1.351501 -8.055264 -0.2024165 -0.3605041 -0.5176368 -0.6677318 -0.8113131 -0.9491331 -1.077370 -1.189036 -1.285400 -1.367918 -1.433753 -1.483896 -1.518410 -1.537234 -1.543066 -1.532507 -1.507307 -1.468940 -1.419983 -8.055264 -0.2803222 -0.4449521 -0.6096852 -0.7696390 -0.9221375 -1.067003 -1.199405 -1.316556 -1.420167 -1.506532 -1.575587 -1.627975 -1.662955 -1.681305 -1.681949 -1.663525 -1.627769 -1.576537 -1.513008 -8.055264 -0.3956390 -0.5624813 -0.7321885 -0.8983407 -1.056063 -1.202103 -1.337493 -1.460532 -1.568280 -1.660217 -1.733895 -1.789370 -1.825825 -1.844750 -1.841426 -1.816403 -1.771179 -1.707946 -1.630452 -8.055264 -0.5441297 -0.7110792 -0.8814855 -1.048031 -1.204400 -1.351285 -1.489289 -1.614553 -1.726621 -1.823535 -1.902771 -1.962184 -2.002877 -2.021840 -2.015643 -1.985090 -1.931571 -1.857354 -1.766486 -8.055264 -0.7251576 -0.8878496 -1.051986 -1.212788 -1.367827 -1.516641 -1.652128 -1.778917 -1.895411 -1.997082 -2.082301 -2.148509 -2.193533 -2.212839 -2.205659 -2.171231 -2.111023 -2.027147 -1.923868 -8.055264 -0.9320046 -1.084584 -1.239131 -1.396027 -1.547793 -1.692460 -1.827587 -1.953852 -2.072960 -2.180466 -2.271312 -2.345392 -2.394360 -2.414914 -2.408073 -2.371543 -2.306510 -2.215141 -2.100102 -8.055264 -1.158551 -1.302930 -1.449667 -1.595605 -1.740741 -1.881984 -2.015459 -2.139663 -2.259669 -2.370973 -2.468518 -2.545950 -2.598097 -2.621281 -2.614825 -2.577770 -2.509356 -2.412529 -2.286464 -8.055264 -1.413678 -1.543684 -1.680120 -1.815230 -1.952820 -2.087515 -2.218183 -2.340897 -2.459424 -2.572279 -2.671298 -2.749956 -2.805084 -2.830908 -2.825198 -2.788425 -2.718421 -2.617797 -2.481806 -8.055264 -1.694667 -1.811234 -1.937190 -2.061073 -2.187226 -2.314842 -2.441287 -2.561739 -2.675827 -2.783530 -2.880171 -2.959810 -3.016170 -3.044376 -3.040330 -3.004274 -2.934999 -2.832007 -2.687142 -8.055264 -2.011089 -2.111519 -2.224428 -2.339342 -2.453562 -2.570773 -2.688581 -2.801503 -2.907525 -3.007363 -3.099023 -3.176493 -3.233521 -3.263247 -3.261141 -3.226286 -3.162266 -3.054997 -2.902450 -8.055264 -2.372572 -2.457147 -2.555779 -2.657042 -2.756576 -2.857853 -2.960154 -3.061857 -3.159827 -3.250260 -3.334293 -3.407034 -3.463071 -3.494142 -3.493747 -3.464912 -3.404206 -3.294051 -3.135621 -8.055264 -2.794482 -2.858013 -2.935388 -3.017350 -3.098577 -3.183292 -3.267823 -3.353679 -3.440459 -3.521549 -3.594324 -3.659243 -3.710585 -3.741706 -3.748271 -3.724459 -3.660671 -3.550880 -3.384627 -8.055264 -3.283801 -3.326164 -3.382136 -3.442008 -3.505316 -3.569816 -3.636117 -3.702167 -3.771711 -3.840158 -3.900075 -3.952391 -3.999452 -4.036802 -4.043871 -4.013668 -3.947505 -3.836352 -3.661092 -8.055264 -3.916215 -3.929426 -3.960181 -3.998603 -4.036596 -4.077166 -4.117302 -4.160672 -4.208314 -4.261644 -4.311647 -4.351871 -4.385056 -4.403682 -4.399724 -4.368733 -4.294613 -4.173491 -3.979762 -8.055264 -4.927618 -4.902590 -4.892949 -4.890012 -4.896347 -4.908441 -4.918265 -4.927027 -4.941114 -4.960212 -4.981269 -4.997362 -5.003401 -4.998690 -4.976247 -4.919997 -4.816527 -4.653788 -4.426259 -8.055264 -12.92875 -12.77694 -12.60979 -12.42813 -12.23269 -12.02428 -11.80360 -11.57128 -11.32794 -11.07415 -10.81039 -10.53715 -10.25488 -9.963933 -9.664708 -9.357539 -9.042727 -8.720569 -8.391334 -8.055264 -0.1275555 -0.2092337 -0.3079671 -0.4046054 -0.5029048 -0.5996637 -0.6941822 -0.7860756 -0.8709241 -0.9461803 -1.013824 -1.071986 -1.120478 -1.160993 -1.194803 -1.222903 -1.247837 -1.266802 -1.280010 -9.610223 0.1037091 -1.3911482E-02 -0.1396464 -0.2651261 -0.3897587 -0.5092286 -0.6250447 -0.7346734 -0.8310993 -0.9157011 -0.9872811 -1.043507 -1.087034 -1.118221 -1.139702 -1.152812 -1.159465 -1.157877 -1.149018 -9.610223 0.2290586 8.0163777E-02 -7.4420780E-02 -0.2258261 -0.3733549 -0.5145436 -0.6483634 -0.7699645 -0.8777021 -0.9709064 -1.045382 -1.100168 -1.138863 -1.161549 -1.171371 -1.170451 -1.159632 -1.138410 -1.108341 -9.610223 0.2743661 9.8313339E-02 -7.8953974E-02 -0.2510681 -0.4189785 -0.5797323 -0.7275488 -0.8603769 -0.9786429 -1.078468 -1.154725 -1.210155 -1.244476 -1.260417 -1.259744 -1.245944 -1.218429 -1.178212 -1.127465 -9.610223 0.2526704 5.7875723E-02 -0.1382726 -0.3265587 -0.5091253 -0.6832891 -0.8431019 -0.9893507 -1.117410 -1.220778 -1.300485 -1.356546 -1.388569 -1.399427 -1.390097 -1.364701 -1.321448 -1.262853 -1.191922 -9.610223 0.1731198 -3.2266032E-02 -0.2402958 -0.4417963 -0.6331597 -0.8148052 -0.9861947 -1.143361 -1.278779 -1.387680 -1.471619 -1.528563 -1.560242 -1.567731 -1.552436 -1.516035 -1.458225 -1.381972 -1.291345 -9.610223 4.5053028E-02 -0.1655257 -0.3793761 -0.5854989 -0.7838275 -0.9722599 -1.150874 -1.314034 -1.453804 -1.571217 -1.660228 -1.719891 -1.753291 -1.758892 -1.740513 -1.694824 -1.623669 -1.530813 -1.421096 -9.610223 -0.1252720 -0.3363360 -0.5476297 -0.7556720 -0.9590049 -1.152418 -1.331218 -1.494951 -1.642203 -1.765834 -1.861880 -1.928811 -1.965072 -1.972835 -1.952716 -1.899905 -1.817228 -1.709172 -1.581254 -9.610223 -0.3309880 -0.5367894 -0.7452965 -0.9521701 -1.154660 -1.346099 -1.521246 -1.687766 -1.838230 -1.967178 -2.072259 -2.148168 -2.190399 -2.204222 -2.183616 -2.126452 -2.034577 -1.913029 -1.768047 -9.610223 -0.5705206 -0.7681698 -0.9707251 -1.169677 -1.362368 -1.548651 -1.723930 -1.887357 -2.038618 -2.172810 -2.285684 -2.370111 -2.423868 -2.442345 -2.422852 -2.363401 -2.264530 -2.131194 -1.970336 -9.610223 -0.8430455 -1.027770 -1.217027 -1.401772 -1.587236 -1.766265 -1.935134 -2.096745 -2.248576 -2.386360 -2.504470 -2.599580 -2.664786 -2.689471 -2.673316 -2.613883 -2.511358 -2.368916 -2.193830 -9.610223 -1.141885 -1.308261 -1.484617 -1.657661 -1.829173 -1.996770 -2.159981 -2.320704 -2.471005 -2.609015 -2.732988 -2.837436 -2.910496 -2.944252 -2.933128 -2.877012 -2.774083 -2.627053 -2.438991 -9.610223 -1.470689 -1.618546 -1.777591 -1.935019 -2.092300 -2.250563 -2.406511 -2.560100 -2.707458 -2.845037 -2.970422 -3.076222 -3.154237 -3.195415 -3.189637 -3.137577 -3.036397 -2.888036 -2.688455 -9.610223 -1.833464 -1.960053 -2.103162 -2.248110 -2.390674 -2.535375 -2.679345 -2.823955 -2.966798 -3.099312 -3.218821 -3.323365 -3.403174 -3.449138 -3.451679 -3.404245 -3.308094 -3.161883 -2.952943 -9.610223 -2.248909 -2.354248 -2.477725 -2.604775 -2.730544 -2.858303 -2.988026 -3.119271 -3.248970 -3.372075 -3.483508 -3.581543 -3.658882 -3.707920 -3.717026 -3.675124 -3.590814 -3.443965 -3.227472 -9.610223 -2.734154 -2.812547 -2.911454 -3.016266 -3.122280 -3.227868 -3.336971 -3.450322 -3.563856 -3.674030 -3.773751 -3.862143 -3.933941 -3.982767 -3.997375 -3.970468 -3.893323 -3.746822 -3.525912 -9.610223 -3.305952 -3.355033 -3.423116 -3.500314 -3.580701 -3.662416 -3.748979 -3.838688 -3.931963 -4.024683 -4.108397 -4.183863 -4.244987 -4.293098 -4.322739 -4.303246 -4.222816 -4.082610 -3.853658 -9.610223 -4.024385 -4.040307 -4.075890 -4.119933 -4.170146 -4.221794 -4.279112 -4.340941 -4.405308 -4.472888 -4.541741 -4.607384 -4.663421 -4.705790 -4.724263 -4.697806 -4.621124 -4.477405 -4.233382 -9.610223 -5.134371 -5.110628 -5.100134 -5.102254 -5.112972 -5.125585 -5.141785 -5.168248 -5.198890 -5.231558 -5.266388 -5.300888 -5.331359 -5.349029 -5.350715 -5.316523 -5.215097 -5.033307 -4.749607 -9.610223 -15.81916 -15.63513 -15.42924 -15.20288 -14.95739 -14.69402 -14.41389 -14.11806 -13.80747 -13.48296 -13.14529 -12.79516 -12.43319 -12.05997 -11.67599 -11.28175 -10.87767 -10.46415 -10.04155 -9.610223 0.1759099 8.5173242E-02 -2.3070434E-02 -0.1381421 -0.2552357 -0.3665696 -0.4764296 -0.5850092 -0.6866689 -0.7799266 -0.8598400 -0.9284081 -0.9864442 -1.031938 -1.068433 -1.097057 -1.120384 -1.138817 -1.151059 -11.22807 0.4743548 0.3414044 0.1940443 4.5246169E-02 -9.9317111E-02 -0.2392722 -0.3759178 -0.5063795 -0.6247132 -0.7271101 -0.8098888 -0.8770329 -0.9264259 -0.9596232 -0.9788079 -0.9870783 -0.9873348 -0.9796991 -0.9642643 -11.22807 0.6469125 0.4687381 0.2857921 0.1086636 -6.4594343E-02 -0.2306324 -0.3890573 -0.5369587 -0.6688905 -0.7775734 -0.8647135 -0.9295123 -0.9701816 -0.9907685 -0.9934235 -0.9819157 -0.9599594 -0.9272311 -0.8850220 -11.22807 0.7143457 0.5020000 0.2930663 9.1593727E-02 -0.1078316 -0.2984526 -0.4779349 -0.6424955 -0.7841413 -0.9012511 -0.9938160 -1.057105 -1.092379 -1.102648 -1.090840 -1.061154 -1.018110 -0.9612134 -0.8929058 -11.22807 0.7001767 0.4680418 0.2369348 1.4064834E-02 -0.2031793 -0.4132867 -0.6124309 -0.7923093 -0.9448681 -1.071768 -1.169373 -1.232331 -1.264847 -1.267073 -1.243266 -1.197787 -1.134423 -1.054078 -0.9601986 -11.22807 0.6212649 0.3760597 0.1303071 -0.1079030 -0.3392625 -0.5629032 -0.7755036 -0.9654509 -1.133144 -1.271667 -1.372068 -1.437643 -1.468855 -1.465786 -1.432220 -1.373055 -1.290657 -1.187627 -1.068672 -11.22807 0.4849229 0.2337640 -1.8534482E-02 -0.2660862 -0.5094740 -0.7395027 -0.9558381 -1.158407 -1.337984 -1.484630 -1.592664 -1.661848 -1.692762 -1.687759 -1.646676 -1.576295 -1.476226 -1.351442 -1.207907 -11.22807 0.3002198 4.6821456E-02 -0.2071426 -0.4586502 -0.7039640 -0.9363287 -1.158979 -1.369016 -1.554817 -1.708052 -1.827046 -1.903240 -1.938072 -1.933859 -1.890745 -1.811075 -1.695596 -1.550507 -1.383257 -11.22807 7.0120178E-02 -0.1797040 -0.4322346 -0.6766751 -0.9187776 -1.154550 -1.380815 -1.590378 -1.776840 -1.939253 -2.066142 -2.152708 -2.197621 -2.197565 -2.157803 -2.071943 -1.943792 -1.780453 -1.590662 -11.22807 -0.2027748 -0.4404836 -0.6839177 -0.9219467 -1.158781 -1.390632 -1.611303 -1.818236 -2.007345 -2.172040 -2.306917 -2.406492 -2.463540 -2.475749 -2.441265 -2.353324 -2.215884 -2.036882 -1.826136 -11.22807 -0.5096212 -0.7325740 -0.9664792 -1.194999 -1.420424 -1.637914 -1.851583 -2.056364 -2.241132 -2.407223 -2.550452 -2.659965 -2.731988 -2.761594 -2.734535 -2.649160 -2.506361 -2.314824 -2.085148 -11.22807 -0.8548871 -1.060271 -1.276809 -1.488968 -1.698257 -1.903816 -2.104922 -2.300230 -2.482221 -2.649383 -2.795316 -2.914043 -3.003616 -3.046913 -3.030236 -2.950356 -2.806830 -2.606395 -2.360090 -11.22807 -1.236624 -1.417949 -1.613600 -1.808979 -1.999778 -2.187765 -2.374482 -2.561400 -2.739445 -2.901550 -3.051060 -3.181317 -3.279689 -3.336078 -3.333919 -3.264091 -3.125844 -2.923081 -2.662871 -11.22807 -1.660274 -1.813587 -1.983821 -2.155878 -2.327317 -2.499427 -2.673553 -2.845693 -3.014237 -3.174079 -3.323405 -3.453785 -3.555536 -3.621073 -3.631030 -3.573717 -3.444168 -3.244953 -2.972952 -11.22807 -2.129408 -2.252296 -2.397448 -2.548797 -2.700396 -2.851646 -3.007316 -3.166198 -3.323915 -3.474358 -3.613155 -3.738931 -3.840420 -3.907943 -3.930494 -3.886090 -3.769807 -3.579365 -3.298913 -11.22807 -2.670975 -2.762592 -2.877615 -3.001650 -3.130138 -3.259368 -3.393670 -3.532266 -3.671006 -3.805480 -3.931201 -4.045405 -4.140914 -4.208673 -4.237943 -4.208104 -4.115677 -3.929344 -3.644145 -11.22807 -3.311352 -3.369941 -3.449772 -3.540146 -3.638262 -3.739104 -3.845367 -3.959255 -4.075286 -4.188258 -4.295263 -4.392722 -4.478580 -4.542280 -4.576913 -4.574018 -4.490072 -4.312122 -4.023463 -11.22807 -4.106799 -4.128644 -4.171299 -4.223535 -4.284083 -4.350265 -4.422850 -4.502483 -4.586733 -4.673350 -4.755609 -4.834326 -4.912643 -4.979633 -5.017383 -5.009448 -4.931108 -4.762097 -4.463826 -11.22807 -5.316514 -5.287242 -5.277554 -5.282815 -5.294589 -5.313228 -5.341641 -5.378676 -5.421413 -5.472198 -5.524493 -5.571787 -5.616550 -5.663731 -5.687518 -5.673400 -5.586379 -5.390168 -5.048014 -11.22807 -18.85708 -18.64022 -18.39392 -18.12037 -17.82163 -17.49961 -17.15598 -16.79224 -16.40974 -16.00965 -15.59304 -15.16084 -14.71391 -14.25299 -13.77877 -13.29188 -12.79287 -12.28225 -11.76051 -11.22807 0.4781934 0.3769036 0.2618592 0.1342699 2.1246735E-03 -0.1300647 -0.2589999 -0.3819624 -0.4992003 -0.6067535 -0.7016067 -0.7817402 -0.8473819 -0.8998287 -0.9393128 -0.9689247 -0.9910951 -1.008551 -1.019804 -12.90406 0.8452014 0.6930813 0.5300026 0.3622660 0.1936243 2.9269621E-02 -0.1266701 -0.2755997 -0.4114172 -0.5292767 -0.6280549 -0.7031414 -0.7585780 -0.7932817 -0.8108321 -0.8144134 -0.8077317 -0.7934353 -0.7712410 -12.90406 1.060736 0.8541194 0.6467041 0.4392210 0.2361068 4.5791201E-02 -0.1358753 -0.3061751 -0.4572203 -0.5857357 -0.6858122 -0.7574165 -0.8025805 -0.8199940 -0.8160770 -0.7946225 -0.7601892 -0.7153209 -0.6607199 -12.90406 1.151979 0.9056703 0.6605734 0.4232593 0.1939106 -2.5351346E-02 -0.2338291 -0.4235252 -0.5895332 -0.7283612 -0.8320544 -0.9042596 -0.9412633 -0.9453261 -0.9221988 -0.8776881 -0.8167909 -0.7423209 -0.6560050 -12.90406 1.147595 0.8740490 0.6033508 0.3452258 9.5477186E-02 -0.1490375 -0.3801500 -0.5906793 -0.7743824 -0.9202200 -1.031270 -1.105893 -1.137224 -1.131031 -1.091294 -1.025479 -0.9395341 -0.8360979 -0.7185282 -12.90406 1.064656 0.7762224 0.4937117 0.2183686 -5.0574295E-02 -0.3101808 -0.5595516 -0.7889124 -0.9868923 -1.147630 -1.268302 -1.344640 -1.375692 -1.362151 -1.309352 -1.224506 -1.115213 -0.9837109 -0.8353565 -12.90406 0.9189528 0.6257477 0.3353353 4.9340148E-02 -0.2320192 -0.5036276 -0.7653551 -1.005212 -1.216045 -1.393246 -1.526805 -1.607735 -1.641672 -1.624814 -1.563314 -1.463195 -1.331847 -1.173418 -0.9948407 -12.90406 0.7203190 0.4246274 0.1324164 -0.1564079 -0.4436021 -0.7236912 -0.9893547 -1.234590 -1.457706 -1.647461 -1.789261 -1.883705 -1.922899 -1.907910 -1.841082 -1.729977 -1.578794 -1.394794 -1.186731 -12.90406 0.4687528 0.1797823 -0.1122229 -0.3986189 -0.6840592 -0.9608076 -1.229260 -1.480135 -1.708843 -1.902734 -2.056760 -2.163505 -2.214362 -2.207248 -2.141211 -2.023647 -1.855800 -1.648118 -1.411636 -12.90406 0.1699546 -0.1088280 -0.3946724 -0.6733897 -0.9475347 -1.219270 -1.486375 -1.737473 -1.961883 -2.161482 -2.324924 -2.443137 -2.512349 -2.517476 -2.462027 -2.342069 -2.162035 -1.933560 -1.670270 -12.90406 -0.1757417 -0.4379588 -0.7086716 -0.9753978 -1.239318 -1.500803 -1.756900 -1.998229 -2.221040 -2.421501 -2.589866 -2.722380 -2.809096 -2.835397 -2.795501 -2.679748 -2.492794 -2.247585 -1.959774 -12.90406 -0.5644591 -0.8039514 -1.056884 -1.308719 -1.555698 -1.798023 -2.038231 -2.270931 -2.486325 -2.682270 -2.856769 -2.999296 -3.102103 -3.156784 -3.133996 -3.029761 -2.842379 -2.585494 -2.276168 -12.90406 -0.9973816 -1.210329 -1.437809 -1.666515 -1.892304 -2.116132 -2.338432 -2.554909 -2.761052 -2.954593 -3.127452 -3.275399 -3.398363 -3.471650 -3.469065 -3.379517 -3.198831 -2.935807 -2.608511 -12.90406 -1.472245 -1.653203 -1.852371 -2.056292 -2.258600 -2.458517 -2.660773 -2.863170 -3.059242 -3.243223 -3.414719 -3.569911 -3.699293 -3.788084 -3.808829 -3.738847 -3.574144 -3.315578 -2.974555 -12.90406 -1.999554 -2.144257 -2.310774 -2.484144 -2.662781 -2.841409 -3.023802 -3.205744 -3.386621 -3.564028 -3.729386 -3.877196 -4.005218 -4.101739 -4.138229 -4.089661 -3.945032 -3.699161 -3.347841 -12.90406 -2.593622 -2.702415 -2.836234 -2.979389 -3.129037 -3.281385 -3.439657 -3.601949 -3.764113 -3.922985 -4.074200 -4.211568 -4.329915 -4.424209 -4.473550 -4.445553 -4.328992 -4.099236 -3.742396 -12.90406 -3.297933 -3.366657 -3.459580 -3.566354 -3.682993 -3.804784 -3.932604 -4.065930 -4.202744 -4.338480 -4.469001 -4.588686 -4.692870 -4.779386 -4.834649 -4.834883 -4.747151 -4.529446 -4.174112 -12.90406 -4.173164 -4.197088 -4.243920 -4.305928 -4.380383 -4.465218 -4.556108 -4.653387 -4.755514 -4.856377 -4.959946 -5.058570 -5.144750 -5.229649 -5.295526 -5.309086 -5.224300 -5.030945 -4.670004 -12.90406 -5.479477 -5.445231 -5.433290 -5.437521 -5.451488 -5.481154 -5.525025 -5.575798 -5.632559 -5.693959 -5.760342 -5.832668 -5.895239 -5.948500 -6.001844 -6.009985 -5.934669 -5.726358 -5.323087 -12.90406 -22.02910 -21.77880 -21.49070 -21.16732 -20.81237 -20.42829 -20.01740 -19.58176 -19.12314 -18.64313 -18.14308 -17.62421 -17.08760 -16.53421 -15.96488 -15.38040 -14.78147 -14.16872 -13.54274 -12.90406 0.7685279 0.6611078 0.5401030 0.4032696 0.2583306 0.1102204 -3.7593126E-02 -0.1822433 -0.3152640 -0.4371480 -0.5465763 -0.6394812 -0.7145270 -0.7733257 -0.8170306 -0.8483036 -0.8702788 -0.8863333 -0.8966640 -14.63411 1.207859 1.038847 0.8615013 0.6755608 0.4877371 0.3011762 0.1194137 -5.0175998E-02 -0.2011648 -0.3357785 -0.4478399 -0.5348145 -0.5943715 -0.6316506 -0.6471950 -0.6464592 -0.6334454 -0.6120270 -0.5829805 -14.63411 1.470503 1.235333 1.002644 0.7681405 0.5391602 0.3178016 0.1091489 -7.9774767E-02 -0.2498407 -0.3952524 -0.5096940 -0.5898675 -0.6359439 -0.6519408 -0.6405779 -0.6089486 -0.5622625 -0.5047708 -0.4375320 -14.63411 1.586930 1.303306 1.025144 0.7559285 0.4912890 0.2373435 3.6977029E-03 -0.2102257 -0.3975433 -0.5540356 -0.6758113 -0.7534398 -0.7909966 -0.7889824 -0.7543355 -0.6940345 -0.6150850 -0.5223917 -0.4176495 -14.63411 1.590738 1.275995 0.9694691 0.6702382 0.3821796 0.1059725 -0.1554508 -0.3952679 -0.6033224 -0.7731995 -0.9008272 -0.9828395 -1.015833 -0.9995404 -0.9442427 -0.8575280 -0.7478002 -0.6204932 -0.4786592 -14.63411 1.506446 1.175208 0.8504239 0.5330439 0.2292679 -6.6827603E-02 -0.3500768 -0.6107612 -0.8398030 -1.027877 -1.165943 -1.256022 -1.287782 -1.263430 -1.190640 -1.080417 -0.9417468 -0.7807185 -0.6021971 -14.63411 1.351151 1.011242 0.6795537 0.3573281 3.7919417E-02 -0.2744172 -0.5710436 -0.8466977 -1.093372 -1.294862 -1.452989 -1.554763 -1.589212 -1.561934 -1.477069 -1.346222 -1.180987 -0.9872926 -0.7725826 -14.63411 1.133387 0.7958320 0.4649584 0.1373273 -0.1877702 -0.5083886 -0.8148350 -1.099693 -1.354365 -1.574278 -1.749981 -1.865114 -1.911920 -1.887204 -1.796924 -1.650632 -1.461513 -1.236803 -0.9866268 -14.63411 0.8621621 0.5327933 0.2021951 -0.1229041 -0.4463531 -0.7668644 -1.076749 -1.361098 -1.625787 -1.859055 -2.045244 -2.178076 -2.242046 -2.227262 -2.138785 -1.984346 -1.774646 -1.521008 -1.236435 -14.63411 0.5359808 0.2194647 -0.1032756 -0.4211345 -0.7366132 -1.047966 -1.350311 -1.638135 -1.905473 -2.140762 -2.335950 -2.484909 -2.568131 -2.572074 -2.491987 -2.337437 -2.111874 -1.832027 -1.514462 -14.63411 0.1559930 -0.1410736 -0.4482234 -0.7535085 -1.052046 -1.351148 -1.646415 -1.929021 -2.188316 -2.422458 -2.624529 -2.784564 -2.891519 -2.919801 -2.861688 -2.713054 -2.478709 -2.177073 -1.828825 -14.63411 -0.2723573 -0.5449033 -0.8284025 -1.115029 -1.399051 -1.682433 -1.961187 -2.226322 -2.478749 -2.708449 -2.909041 -3.079858 -3.206821 -3.265317 -3.236507 -3.102947 -2.868061 -2.550928 -2.175317 -14.63411 -0.7463520 -0.9899188 -1.249186 -1.513339 -1.775048 -2.033684 -2.290854 -2.540701 -2.778918 -2.999358 -3.199893 -3.373980 -3.515651 -3.608531 -3.609043 -3.499428 -3.273419 -2.948686 -2.550204 -14.63411 -1.272292 -1.482115 -1.708815 -1.942910 -2.178331 -2.412595 -2.645373 -2.872965 -3.096704 -3.310172 -3.501901 -3.677106 -3.833709 -3.945418 -3.976068 -3.893369 -3.687862 -3.365055 -2.949786 -14.63411 -1.852525 -2.022781 -2.214205 -2.414077 -2.618975 -2.825154 -3.035211 -3.243336 -3.447117 -3.645832 -3.834634 -4.007418 -4.160573 -4.283779 -4.337945 -4.287203 -4.111728 -3.806035 -3.379385 -14.63411 -2.504937 -2.630568 -2.781674 -2.946454 -3.119912 -3.299044 -3.481270 -3.664142 -3.849310 -4.033286 -4.205894 -4.364868 -4.508577 -4.628280 -4.697818 -4.675917 -4.535178 -4.257922 -3.826558 -14.63411 -3.269132 -3.350997 -3.456407 -3.578542 -3.713756 -3.860509 -4.013349 -4.165367 -4.320739 -4.479921 -4.632262 -4.770386 -4.894536 -5.003983 -5.080321 -5.084356 -4.992229 -4.737351 -4.309333 -14.63411 -4.222694 -4.251319 -4.304173 -4.373316 -4.462897 -4.566242 -4.678854 -4.793507 -4.910927 -5.033379 -5.155233 -5.268792 -5.372259 -5.463952 -5.554113 -5.586878 -5.509726 -5.285512 -4.859444 -14.63411 -5.623437 -5.583680 -5.571875 -5.574253 -5.594656 -5.636599 -5.692008 -5.755048 -5.823587 -5.899329 -5.984698 -6.071281 -6.152523 -6.220531 -6.285349 -6.322624 -6.261512 -6.043123 -5.579068 -14.63411 -25.32410 -25.03976 -24.70781 -24.33279 -23.91882 -23.46950 -22.98789 -22.47667 -21.93813 -21.37423 -20.78668 -20.17700 -19.54648 -18.89631 -18.22752 -17.54105 -16.83774 -16.11835 -15.38360 -14.63411 1.052152 0.9385712 0.8107189 0.6654158 0.5116307 0.3511679 0.1859489 2.4979349E-02 -0.1284856 -0.2676898 -0.3905375 -0.4961173 -0.5817288 -0.6466362 -0.6947718 -0.7274969 -0.7495419 -0.7644780 -0.7739275 -16.41466 1.561661 1.373672 1.181527 0.9804541 0.7767797 0.5695539 0.3675428 0.1766484 2.9259985E-03 -0.1473391 -0.2735731 -0.3698220 -0.4370729 -0.4747874 -0.4892271 -0.4840374 -0.4649652 -0.4364208 -0.4004764 -16.41466 1.868891 1.605170 1.347988 1.089915 0.8345399 0.5871374 0.3534368 0.1376282 -5.2042849E-02 -0.2154678 -0.3439563 -0.4331035 -0.4819479 -0.4947996 -0.4767357 -0.4353096 -0.3767754 -0.3062873 -0.2262572 -16.41466 2.012640 1.692738 1.383762 1.081471 0.7848777 0.4994296 0.2326834 -6.4864866E-03 -0.2135054 -0.3910082 -0.5269326 -0.6146788 -0.6506903 -0.6428805 -0.5957808 -0.5199785 -0.4232691 -0.3117801 -0.1882719 -16.41466 2.028066 1.672922 1.328714 0.9924887 0.6676621 0.3527346 5.8964636E-02 -0.2057978 -0.4386630 -0.6315063 -0.7794189 -0.8698827 -0.9009977 -0.8763887 -0.8043848 -0.6966006 -0.5631263 -0.4113244 -0.2447109 -16.41466 1.944057 1.567132 1.204247 0.8472986 0.4996171 0.1653362 -0.1464177 -0.4373773 -0.6932731 -0.9087281 -1.073949 -1.172998 -1.206578 -1.170503 -1.078064 -0.9415451 -0.7732783 -0.5818461 -0.3724816 -16.41466 1.777547 1.394568 1.021901 0.6554509 0.2960752 -5.1435743E-02 -0.3814608 -0.6895749 -0.9653435 -1.202340 -1.386241 -1.504341 -1.545017 -1.506056 -1.398445 -1.237213 -1.036514 -0.8065516 -0.5548450 -16.41466 1.544096 1.162793 0.7877966 0.4218186 5.9765272E-02 -0.2980508 -0.6384974 -0.9571314 -1.249895 -1.500190 -1.706455 -1.849075 -1.901836 -1.869406 -1.754328 -1.573475 -1.343979 -1.077056 -0.7836451 -16.41466 1.248185 0.8768530 0.5095576 0.1465549 -0.2144261 -0.5711690 -0.9154160 -1.241123 -1.538218 -1.802541 -2.027495 -2.189912 -2.268316 -2.249191 -2.137177 -1.944178 -1.690521 -1.388950 -1.054838 -16.41466 0.8944241 0.5420402 0.1845548 -0.1702447 -0.5225590 -0.8730453 -1.213757 -1.535267 -1.836433 -2.108635 -2.341414 -2.522863 -2.628874 -2.633785 -2.536071 -2.342066 -2.069502 -1.736572 -1.363258 -16.41466 0.4855856 0.1557656 -0.1848187 -0.5269214 -0.8658758 -1.202178 -1.529191 -1.846071 -2.145746 -2.413867 -2.648137 -2.843855 -2.973540 -3.012228 -2.936468 -2.753763 -2.469837 -2.109831 -1.699368 -16.41466 2.3749985E-02 -0.2809311 -0.5990677 -0.9205675 -1.238825 -1.557822 -1.870827 -2.174664 -2.459791 -2.721861 -2.955259 -3.154779 -3.309117 -3.380548 -3.344487 -3.181842 -2.897651 -2.517544 -2.073327 -16.41466 -0.4922021 -0.7647426 -1.053657 -1.349375 -1.647513 -1.945702 -2.234330 -2.515018 -2.786530 -3.037537 -3.263436 -3.466120 -3.634287 -3.741193 -3.748937 -3.617715 -3.345681 -2.955484 -2.482659 -16.41466 -1.061164 -1.298710 -1.555135 -1.819958 -2.088390 -2.357891 -2.621774 -2.879118 -3.129649 -3.367476 -3.588035 -3.783325 -3.961271 -4.097722 -4.142873 -4.050936 -3.804777 -3.416592 -2.922057 -16.41466 -1.693112 -1.888302 -2.105318 -2.332997 -2.568073 -2.806964 -3.042074 -3.274114 -3.504992 -3.727435 -3.933767 -4.129068 -4.306560 -4.453465 -4.530860 -4.478921 -4.273389 -3.904276 -3.397406 -16.41466 -2.402646 -2.550323 -2.721598 -2.906130 -3.104733 -3.312028 -3.519437 -3.723096 -3.928854 -4.134869 -4.330685 -4.510708 -4.675396 -4.819881 -4.911397 -4.900106 -4.739849 -4.407478 -3.895339 -16.41466 -3.226880 -3.322790 -3.444319 -3.582752 -3.739506 -3.908704 -4.082293 -4.257554 -4.433655 -4.611887 -4.785775 -4.944844 -5.088074 -5.216861 -5.314116 -5.335309 -5.229045 -4.936591 -4.429382 -16.41466 -4.249995 -4.287694 -4.351986 -4.432940 -4.536608 -4.660583 -4.791370 -4.924164 -5.061134 -5.202541 -5.343085 -5.474096 -5.593384 -5.701218 -5.800347 -5.859647 -5.788698 -5.532481 -5.036613 -16.41466 -5.749648 -5.707895 -5.697727 -5.701779 -5.727817 -5.783908 -5.855142 -5.930917 -6.010152 -6.103068 -6.205529 -6.310134 -6.405853 -6.492530 -6.565686 -6.627952 -6.576324 -6.344591 -5.818865 -16.41466 -28.73271 -28.41375 -28.03665 -27.60756 -27.13190 -26.61435 -26.05883 -25.46867 -24.84669 -24.19529 -23.51656 -22.81227 -22.08401 -21.33316 -20.56096 -19.76850 -18.95678 -18.12670 -17.27908 -16.41466 1.330581 1.210109 1.078189 0.9261829 0.7615333 0.5891644 0.4122230 0.2353877 6.4967856E-02 -9.2929952E-02 -0.2312546 -0.3487611 -0.4439285 -0.5165802 -0.5678121 -0.6026072 -0.6248020 -0.6387106 -0.6472532 -18.24260 1.907397 1.702180 1.495822 1.277871 1.057542 0.8348016 0.6148824 0.4051497 0.2104953 3.9261252E-02 -9.8495647E-02 -0.2056139 -0.2780454 -0.3178278 -0.3302701 -0.3206240 -0.2954325 -0.2598105 -0.2168810 -18.24260 2.261712 1.967103 1.682802 1.400069 1.121865 0.8515807 0.5946457 0.3567294 0.1411000 -4.0093865E-02 -0.1816252 -0.2798901 -0.3320380 -0.3411826 -0.3164618 -0.2646276 -0.1940202 -0.1105023 -1.7453527E-02 -18.24260 2.431369 2.072076 1.730321 1.398254 1.071900 0.7561507 0.4620477 0.1958570 -3.6362309E-02 -0.2321075 -0.3833076 -0.4778414 -0.5149999 -0.4990047 -0.4401036 -0.3483912 -0.2335740 -0.1028875 3.9785843E-02 -18.24260 2.456739 2.059891 1.680190 1.308432 0.9456418 0.5985469 0.2724691 -2.2349602E-02 -0.2780928 -0.4967175 -0.6626221 -0.7642092 -0.7937857 -0.7598648 -0.6712661 -0.5425645 -0.3851333 -0.2080088 -1.6083198E-02 -18.24260 2.373867 1.954150 1.551915 1.155078 0.7681047 0.3971777 4.9661443E-02 -0.2660542 -0.5495354 -0.7958859 -0.9833947 -1.097677 -1.130816 -1.085713 -0.9724517 -0.8096332 -0.6113613 -0.3886392 -0.1477261 -18.24260 2.199682 1.771953 1.357718 0.9512447 0.5509263 0.1647299 -0.1937987 -0.5324902 -0.8388468 -1.107615 -1.324430 -1.458657 -1.505392 -1.457005 -1.327058 -1.134704 -0.8980521 -0.6307577 -0.3412138 -18.24260 1.947901 1.524637 1.108519 0.7007231 0.2982547 -8.9935169E-02 -0.4631803 -0.8151566 -1.137173 -1.425839 -1.664284 -1.830702 -1.899255 -1.858383 -1.720195 -1.504642 -1.233233 -0.9228219 -0.5851696 -18.24260 1.629116 1.218599 0.8107255 0.4098848 1.3670983E-02 -0.3775967 -0.7550585 -1.113869 -1.446518 -1.743395 -2.002399 -2.199640 -2.295477 -2.276469 -2.141580 -1.911724 -1.611193 -1.260033 -0.8751794 -18.24260 1.249031 0.8598409 0.4686340 7.6581307E-02 -0.3119473 -0.6967801 -1.069765 -1.429972 -1.761948 -2.065302 -2.336831 -2.553584 -2.684823 -2.697315 -2.580566 -2.347718 -2.025820 -1.637408 -1.206773 -18.24260 0.8140635 0.4503005 7.6011151E-02 -0.3006961 -0.6761689 -1.048175 -1.410748 -1.758911 -2.089778 -2.394540 -2.663689 -2.893785 -3.055475 -3.107710 -3.022717 -2.803063 -2.468342 -2.047702 -1.573422 -18.24260 0.3210235 -1.4979718E-02 -0.3653488 -0.7204381 -1.078777 -1.430692 -1.774446 -2.110677 -2.432965 -2.724693 -2.989765 -3.223319 -3.405607 -3.500434 -3.456274 -3.265726 -2.930451 -2.484599 -1.969800 -18.24260 -0.2308601 -0.5343783 -0.8548810 -1.180931 -1.514700 -1.846950 -2.170171 -2.483711 -2.783635 -3.065723 -3.321585 -3.550081 -3.748235 -3.874686 -3.889170 -3.738368 -3.419205 -2.959910 -2.410024 -18.24260 -0.8424186 -1.108026 -1.392951 -1.687579 -1.992975 -2.296152 -2.589660 -2.876849 -3.156171 -3.420762 -3.663759 -3.889097 -4.085389 -4.245132 -4.308572 -4.208948 -3.922764 -3.466255 -2.889299 -18.24260 -1.522735 -1.745317 -1.988379 -2.243078 -2.510578 -2.780847 -3.044441 -3.302649 -3.556309 -3.803522 -4.032130 -4.243651 -4.445117 -4.616036 -4.714210 -4.665254 -4.428895 -3.993423 -3.400460 -18.24260 -2.287340 -2.457594 -2.651170 -2.861246 -3.086614 -3.319123 -3.550867 -3.780960 -4.007051 -4.231433 -4.446314 -4.646783 -4.835514 -5.002866 -5.116357 -5.115024 -4.937945 -4.549661 -3.951721 -18.24260 -3.171960 -3.282690 -3.421181 -3.580975 -3.759274 -3.951597 -4.146343 -4.342501 -4.541331 -4.739674 -4.929405 -5.107213 -5.271779 -5.421688 -5.538744 -5.572946 -5.456418 -5.129682 -4.539780 -18.24260 -4.265478 -4.309772 -4.383442 -4.482663 -4.606328 -4.746325 -4.896324 -5.048441 -5.204905 -5.365390 -5.520424 -5.666660 -5.799603 -5.931149 -6.039086 -6.113458 -6.052029 -5.771406 -5.202695 -18.24260 -5.856492 -5.815707 -5.804096 -5.817434 -5.859792 -5.921310 -6.005270 -6.097104 -6.194233 -6.298054 -6.413811 -6.531426 -6.639523 -6.744885 -6.842011 -6.911301 -6.877958 -6.635211 -6.046076 -18.24260 -32.24688 -31.89273 -31.46899 -30.98369 -30.44385 -29.85529 -29.22288 -28.55065 -27.84200 -27.09978 -26.32645 -25.52410 -24.69457 -23.83948 -22.96025 -22.05816 -21.13436 -20.18989 -19.22568 -18.24260 1.599754 1.474657 1.334072 1.173473 1.001472 0.8140655 0.6222289 0.4287234 0.2379329 5.9542120E-02 -0.1010861 -0.2357735 -0.3448201 -0.4274078 -0.4851874 -0.5236321 -0.5468282 -0.5605127 -0.5685643 -20.11515 2.250562 2.025694 1.802902 1.573128 1.335363 1.096580 0.8620391 0.6350458 0.4214976 0.2342701 7.9896271E-02 -3.5228889E-02 -0.1128205 -0.1537163 -0.1628400 -0.1482896 -0.1166118 -7.3821180E-02 -2.3806192E-02 -20.11515 2.647602 2.321115 2.012446 1.703954 1.400519 1.109637 0.8340974 0.5739641 0.3371100 0.1355653 -1.9971656E-02 -0.1258215 -0.1796390 -0.1858121 -0.1526428 -9.0108588E-02 -7.1179871E-03 8.9597337E-02 0.1958858 -20.11515 2.843075 2.445444 2.068489 1.703197 1.348266 1.007839 0.6871674 0.3973959 0.1383984 -8.0515675E-02 -0.2456788 -0.3485714 -0.3858160 -0.3625261 -0.2912968 -0.1829228 -4.9630340E-02 0.1003880 0.2625298 -20.11515 2.880594 2.438849 2.020487 1.613710 1.218316 0.8394607 0.4860362 0.1649112 -0.1237769 -0.3650167 -0.5490132 -0.6598423 -0.6905183 -0.6451496 -0.5401270 -0.3890603 -0.2069793 -4.1900915E-03 0.2135507 -20.11515 2.795376 2.331576 1.890520 1.457197 1.030830 0.6281371 0.2493156 -9.8292492E-02 -0.4107847 -0.6860117 -0.8975940 -1.027339 -1.062091 -1.006055 -0.8731060 -0.6833203 -0.4543772 -0.1996009 7.3482737E-02 -20.11515 2.613530 2.142993 1.688234 1.240650 0.8040870 0.3841813 -1.0960222E-02 -0.3765793 -0.7133859 -1.015996 -1.260400 -1.419431 -1.470785 -1.415429 -1.262531 -1.038469 -0.7651721 -0.4595507 -0.1313996 -20.11515 2.346998 1.881082 1.424383 0.9783624 0.5379533 0.1128412 -0.2910834 -0.6735816 -1.026288 -1.347535 -1.623177 -1.814536 -1.898290 -1.853771 -1.693685 -1.442672 -1.128654 -0.7736921 -0.3909305 -20.11515 2.005110 1.557138 1.111200 0.6702050 0.2349034 -0.1863272 -0.5968043 -0.9874753 -1.349639 -1.683038 -1.974949 -2.203201 -2.327497 -2.308041 -2.153970 -1.886677 -1.537794 -1.135713 -0.6991242 -20.11515 1.602729 1.177147 0.7475414 0.3193166 -0.1051704 -0.5225035 -0.9285038 -1.319134 -1.685734 -2.019008 -2.322219 -2.579280 -2.738588 -2.762995 -2.630482 -2.360963 -1.986342 -1.540815 -1.051704 -20.11515 1.140910 0.7422640 0.3352219 -7.7501036E-02 -0.4891996 -0.8940548 -1.288547 -1.672207 -2.030845 -2.364342 -2.671288 -2.934728 -3.130233 -3.201191 -3.108996 -2.853626 -2.465166 -1.981576 -1.441987 -20.11515 0.6189693 0.2498906 -0.1308774 -0.5208603 -0.9148237 -1.303075 -1.678273 -2.043060 -2.394336 -2.721327 -3.015365 -3.282740 -3.499094 -3.616182 -3.575976 -3.357166 -2.968977 -2.455526 -1.868724 -20.11515 3.3293922E-02 -0.3014693 -0.6520028 -1.013363 -1.381115 -1.744619 -2.098750 -2.444450 -2.776864 -3.082809 -3.367592 -3.628450 -3.854487 -4.010405 -4.028664 -3.863990 -3.496074 -2.965267 -2.336588 -20.11515 -0.6194555 -0.9135320 -1.226142 -1.552431 -1.890604 -2.227760 -2.554198 -2.867912 -3.175519 -3.464096 -3.730743 -3.980189 -4.210636 -4.387916 -4.467802 -4.365454 -4.039473 -3.511058 -2.849237 -20.11515 -1.344930 -1.592339 -1.862688 -2.149588 -2.447647 -2.747902 -3.040797 -3.325407 -3.605005 -3.870457 -4.122043 -4.353634 -4.577968 -4.773813 -4.891278 -4.850692 -4.586632 -4.084450 -3.402066 -20.11515 -2.162398 -2.354029 -2.572134 -2.809951 -3.063124 -3.323406 -3.579120 -3.832289 -4.084178 -4.324956 -4.555183 -4.773689 -4.984500 -5.176000 -5.312781 -5.321815 -5.135322 -4.690005 -4.004091 -20.11515 -3.107507 -3.233830 -3.389828 -3.572526 -3.775906 -3.990912 -4.207843 -4.425282 -4.644460 -4.860151 -5.065431 -5.259382 -5.443967 -5.615101 -5.751012 -5.797579 -5.681190 -5.317002 -4.642381 -20.11515 -4.266100 -4.319115 -4.405574 -4.521149 -4.665137 -4.827678 -4.995713 -5.167533 -5.344735 -5.520145 -5.688825 -5.848881 -5.998735 -6.145250 -6.274085 -6.350874 -6.305504 -6.001847 -5.359739 -20.11515 -5.936038 -5.900761 -5.896950 -5.919541 -5.972466 -6.053068 -6.147521 -6.253559 -6.371365 -6.492537 -6.612842 -6.741539 -6.864705 -6.986889 -7.105361 -7.177577 -7.164345 -6.913656 -6.261316 -20.11515 -35.85967 -35.46975 -34.99789 -34.45440 -33.84797 -33.18580 -32.47370 -31.71650 -30.91818 -30.08206 -29.21098 -28.30736 -27.37331 -26.41068 -25.42111 -24.40604 -23.36679 -22.30453 -21.22033 -20.11515 1.861850 1.734659 1.589805 1.421376 1.237178 1.039957 0.8323050 0.6199618 0.4098391 0.2072591 2.5257656E-02 -0.1312429 -0.2553939 -0.3499184 -0.4155131 -0.4574793 -0.4822367 -0.4961161 -0.5037349 -22.02986 2.587461 2.345263 2.104900 1.857322 1.605471 1.351097 1.099030 0.8532341 0.6203215 0.4136420 0.2425119 0.1142942 3.0119248E-02 -1.2834544E-02 -2.0191437E-02 -1.0563348E-03 3.6894195E-02 8.6530477E-02 0.1435829 -22.02986 3.030701 2.671803 2.333415 2.000991 1.674767 1.361497 1.067757 0.7879177 0.5295346 0.3102955 0.1389928 2.7115474E-02 -2.8460426E-02 -3.0324185E-02 1.2065052E-02 8.5956894E-02 0.1817303 0.2917993 0.4115284 -22.02986 3.249110 2.810724 2.399504 2.002070 1.616539 1.251295 0.9103332 0.5938672 0.3102580 6.9657519E-02 -0.1107519 -0.2203392 -0.2571797 -0.2268485 -0.1409747 -1.5418652E-02 0.1367544 0.3063817 0.4883561 -22.02986 3.296829 2.811458 2.354008 1.908910 1.480826 1.075712 0.6942940 0.3458567 2.7892623E-02 -0.2412888 -0.4420035 -0.5638518 -0.5938834 -0.5393566 -0.4164160 -0.2424052 -3.5290819E-02 0.1934361 0.4374482 -22.02986 3.211468 2.702566 2.219248 1.748225 1.289656 0.8541128 0.4454972 6.9001853E-02 -0.2780065 -0.5792344 -0.8153393 -0.9605519 -0.9997103 -0.9324758 -0.7791912 -0.5608046 -0.3005825 -1.3394615E-02 0.2924878 -22.02986 3.019570 2.505162 2.010569 1.526466 1.051603 0.5994450 0.1711740 -0.2266039 -0.5918661 -0.9247397 -1.199344 -1.381987 -1.442011 -1.379157 -1.204640 -0.9478296 -0.6371102 -0.2924514 7.5073808E-02 -22.02986 2.737775 2.232714 1.737304 1.249390 0.7734192 0.3142253 -0.1258194 -0.5352431 -0.9170862 -1.270417 -1.577183 -1.802447 -1.900753 -1.856923 -1.674305 -1.386874 -1.029586 -0.6291031 -0.2003221 -22.02986 2.379305 1.891689 1.406977 0.9265693 0.4541849 -3.3985244E-03 -0.4426878 -0.8629558 -1.255138 -1.617337 -1.946872 -2.206271 -2.356910 -2.345577 -2.174357 -1.868492 -1.470833 -1.016886 -0.5275526 -22.02986 1.953135 1.491100 1.024460 0.5562468 9.4310291E-02 -0.3528933 -0.7902948 -1.211434 -1.604859 -1.971920 -2.305259 -2.596434 -2.792757 -2.830565 -2.689185 -2.382251 -1.953974 -1.450209 -0.9014932 -22.02986 1.466021 1.031308 0.5888068 0.1417133 -0.3066310 -0.7434779 -1.168886 -1.581553 -1.971706 -2.329648 -2.667575 -2.973343 -3.199037 -3.294334 -3.201350 -2.913567 -2.469323 -1.921566 -1.315410 -22.02986 0.9143508 0.5133719 9.9251181E-02 -0.3248895 -0.7538867 -1.173463 -1.581798 -1.976773 -2.351799 -2.704618 -3.034099 -3.333836 -3.584842 -3.729046 -3.700274 -3.456089 -3.014266 -2.431813 -1.771500 -22.02986 0.2961857 -6.7445278E-02 -0.4496408 -0.8442004 -1.247690 -1.643409 -2.025823 -2.400159 -2.760561 -3.094682 -3.402645 -3.696008 -3.953337 -4.137361 -4.171437 -3.995884 -3.579065 -2.975758 -2.266593 -22.02986 -0.3936228 -0.7151926 -1.058385 -1.416250 -1.786961 -2.154054 -2.511152 -2.858048 -3.187958 -3.500148 -3.791242 -4.065195 -4.322638 -4.526059 -4.626034 -4.526393 -4.162355 -3.560004 -2.810982 -22.02986 -1.162458 -1.434834 -1.731483 -2.049702 -2.383122 -2.712351 -3.031630 -3.345282 -3.648296 -3.934404 -4.204133 -4.461504 -4.703510 -4.921836 -5.063490 -5.038138 -4.749874 -4.179286 -3.404818 -22.02986 -2.031359 -2.243442 -2.486118 -2.752871 -3.036576 -3.323878 -3.605113 -3.882401 -4.155096 -4.416434 -4.661204 -4.898516 -5.130390 -5.340541 -5.498927 -5.527558 -5.329539 -4.822740 -4.043478 -22.02986 -3.031249 -3.173659 -3.352865 -3.558371 -3.786623 -4.026212 -4.263757 -4.503425 -4.744591 -4.977394 -5.198588 -5.411625 -5.617338 -5.804398 -5.955564 -6.024242 -5.909696 -5.502678 -4.737668 -22.02986 -4.254133 -4.315794 -4.420113 -4.554506 -4.719123 -4.899998 -5.086097 -5.282624 -5.480726 -5.676151 -5.858448 -6.033477 -6.205836 -6.363385 -6.502644 -6.589119 -6.557378 -6.236487 -5.510623 -22.02986 -6.015035 -5.973909 -5.981470 -6.018901 -6.089840 -6.182833 -6.288710 -6.414291 -6.548074 -6.690911 -6.827219 -6.958782 -7.104574 -7.241227 -7.366332 -7.456751 -7.447720 -7.193466 -6.474871 -22.02986 -39.56498 -39.13872 -38.61758 -38.01369 -37.33845 -36.60017 -35.80578 -34.96089 -34.07009 -33.13720 -32.16544 -31.15758 -30.11600 -29.04279 -27.94004 -26.80889 -25.65083 -24.46764 -23.26029 -22.02986 2.115571 1.987847 1.843482 1.672775 1.480992 1.271312 1.051848 0.8220372 0.5924093 0.3699854 0.1671525 -7.5937212E-03 -0.1481729 -0.2533277 -0.3253641 -0.3701630 -0.3960513 -0.4098597 -0.4169479 -23.98451 2.914817 2.657362 2.401902 2.140158 1.870310 1.601597 1.332158 1.065455 0.8137844 0.5860388 0.3975689 0.2543633 0.1617788 0.1157554 0.1098630 0.1340183 0.1779257 0.2343512 0.2984667 -23.98451 3.408250 3.016950 2.651257 2.290459 1.941582 1.608165 1.293149 0.9918782 0.7130423 0.4746058 0.2886932 0.1657144 0.1072692 0.1090274 0.1600520 0.2454059 0.3539609 0.4773619 0.6106914 -23.98451 3.651264 3.173142 2.723421 2.293236 1.880017 1.488690 1.126153 0.7852855 0.4773382 0.2173943 2.0150242E-02 -9.6770823E-02 -0.1343528 -9.5392041E-02 5.4406668E-03 0.1487245 0.3201426 0.5096889 0.7118130 -23.98451 3.708208 3.177172 2.680370 2.198253 1.737039 1.304415 0.8996815 0.5217308 0.1777634 -0.1155468 -0.3369496 -0.4677293 -0.4992895 -0.4349473 -0.2915221 -9.3911707E-02 0.1387517 0.3938951 0.6646631 -23.98451 3.620944 3.067381 2.542185 2.031014 1.540034 1.075463 0.6371095 0.2329729 -0.1432385 -0.4748418 -0.7348465 -0.8970140 -0.9406711 -0.8644057 -0.6884367 -0.4409992 -0.1489543 0.1711900 0.5104777 -23.98451 3.419678 2.861754 2.325022 1.802970 1.295321 0.8088629 0.3505695 -7.5707152E-02 -0.4720687 -0.8331488 -1.138401 -1.346271 -1.420249 -1.349589 -1.152570 -0.8618084 -0.5130101 -0.1287759 0.2788601 -23.98451 3.122651 2.576879 2.043000 1.517161 1.002995 0.5117528 4.0364433E-02 -0.4001772 -0.8079354 -1.190442 -1.531343 -1.788458 -1.906962 -1.864543 -1.661175 -1.336979 -0.9356009 -0.4887114 -1.3036638E-02 -23.98451 2.747721 2.221891 1.698850 1.177005 0.6697195 0.1790552 -0.2936226 -0.7395418 -1.158484 -1.551712 -1.913432 -2.210486 -2.385808 -2.389879 -2.201844 -1.857576 -1.410543 -0.9035912 -0.3605041 -23.98451 2.301095 1.799721 1.297598 0.7905701 0.2925035 -0.1891808 -0.6538697 -1.102756 -1.523376 -1.917506 -2.289390 -2.610582 -2.841363 -2.900997 -2.754406 -2.410411 -1.928256 -1.365029 -0.7556022 -23.98451 1.787946 1.317575 0.8401038 0.3549261 -0.1261331 -0.5957082 -1.050742 -1.491570 -1.906624 -2.294933 -2.659399 -2.999095 -3.262675 -3.387336 -3.299292 -2.981527 -2.480146 -1.866753 -1.192763 -23.98451 1.208752 0.7738514 0.3271005 -0.1317089 -0.5947166 -1.046217 -1.484067 -1.909890 -2.309638 -2.685049 -3.042412 -3.377989 -3.659840 -3.837797 -3.823784 -3.558365 -3.062012 -2.408375 -1.673018 -23.98451 0.5597184 0.1650790 -0.2473148 -0.6765687 -1.113180 -1.541475 -1.956083 -2.356532 -2.739434 -3.100497 -3.435534 -3.757950 -4.044610 -4.256125 -4.317436 -4.132410 -3.667591 -2.989570 -2.198291 -23.98451 -0.1664342 -0.5159342 -0.8875428 -1.281089 -1.683847 -2.081055 -2.466424 -2.842480 -3.199739 -3.531046 -3.848169 -4.152065 -4.428644 -4.659202 -4.779481 -4.688027 -4.287789 -3.609405 -2.771375 -23.98451 -0.9785699 -1.273656 -1.598324 -1.947362 -2.312191 -2.674442 -3.021752 -3.360411 -3.688987 -3.995694 -4.285602 -4.569124 -4.831393 -5.062839 -5.228173 -5.218880 -4.911315 -4.269757 -3.400635 -23.98451 -1.892832 -2.127100 -2.397030 -2.691489 -3.005591 -3.319918 -3.626876 -3.930324 -4.227233 -4.505556 -4.770622 -5.028047 -5.274351 -5.498830 -5.675000 -5.724585 -5.522409 -4.957733 -4.080688 -23.98451 -2.950851 -3.107982 -3.310210 -3.542012 -3.799246 -4.057164 -4.319866 -4.584529 -4.847297 -5.096425 -5.331939 -5.566092 -5.784509 -5.985356 -6.149486 -6.233765 -6.130006 -5.683606 -4.824862 -23.98451 -4.243847 -4.309640 -4.429299 -4.586144 -4.774588 -4.971890 -5.181601 -5.399073 -5.619002 -5.828319 -6.025651 -6.219707 -6.402536 -6.568493 -6.717108 -6.816682 -6.797927 -6.466963 -5.656082 -23.98451 -6.087661 -6.038241 -6.051839 -6.105204 -6.198888 -6.305831 -6.431985 -6.575347 -6.726607 -6.881876 -7.031577 -7.177075 -7.332106 -7.476602 -7.611005 -7.713097 -7.714580 -7.467400 -6.684389 -23.98451 -43.35743 -42.89427 -42.32198 -41.65633 -40.91009 -40.09339 -39.21426 -38.27913 -37.29322 -36.26086 -35.18568 -34.07080 -32.91887 -31.73224 -30.51297 -29.26287 -27.98358 -26.67656 -25.34313 -23.98451 2.362439 2.231797 2.089075 1.920098 1.723882 1.506762 1.272210 1.028589 0.7774542 0.5379626 0.3127191 0.1183458 -3.8406663E-02 -0.1532519 -0.2313011 -0.2790505 -0.3058785 -0.3195384 -0.3261561 -25.97711 3.233375 2.960251 2.692482 2.417059 2.135463 1.850216 1.563489 1.277671 1.006422 0.7605091 0.5515242 0.3936058 0.2921326 0.2443255 0.2407291 0.2697194 0.3198903 0.3831935 0.4544139 -25.97711 3.778041 3.355930 2.962124 2.577305 2.203590 1.849879 1.514563 1.189962 0.8941828 0.6342462 0.4321127 0.2968256 0.2356042 0.2417310 0.3018145 0.3991376 0.5205727 0.6574418 0.8045342 -25.97711 4.048354 3.528952 3.043906 2.577907 2.136438 1.721554 1.333044 0.9702337 0.6389690 0.3544749 0.1404746 1.0957664E-02 -2.7566213E-02 1.9836150E-02 0.1351808 0.2963278 0.4871650 0.6967245 0.9192840 -25.97711 4.113789 3.539408 2.999663 2.480958 1.988773 1.526111 1.098835 0.6956923 0.3217906 3.1876962E-03 -0.2390707 -0.3819652 -0.4158168 -0.3397350 -0.1765789 4.4951942E-02 0.3035935 0.5854864 0.8834171 -25.97711 4.025190 3.425236 2.858960 2.308799 1.783519 1.289951 0.8273361 0.3916181 -1.2223740E-02 -0.3722297 -0.6589304 -0.8374671 -0.8874074 -0.8010720 -0.6009871 -0.3239132 5.4499554E-04 0.3541777 0.7274165 -25.97711 3.813319 3.212832 2.634265 2.071658 1.532187 1.016402 0.5251862 7.0852853E-02 -0.3535115 -0.7463914 -1.079580 -1.312979 -1.401012 -1.325758 -1.105137 -0.7800400 -0.3925761 3.1908832E-02 0.4803240 -25.97711 3.503002 2.915552 2.340826 1.777848 1.230993 0.7029870 0.2017581 -0.2670788 -0.7046587 -1.113769 -1.486222 -1.773318 -1.918028 -1.877953 -1.655126 -1.292996 -0.8469048 -0.3529266 0.1704214 -25.97711 3.110205 2.545446 1.985576 1.425174 0.8793277 0.3564269 -0.1470877 -0.6224295 -1.063423 -1.485438 -1.879521 -2.210476 -2.416055 -2.436953 -2.236550 -1.854891 -1.357727 -0.7967532 -0.1990377 -25.97711 2.645177 2.106095 1.564779 1.020130 0.4861278 -2.8639145E-02 -0.5250098 -0.9971949 -1.442654 -1.862857 -2.265537 -2.619338 -2.882466 -2.972291 -2.821956 -2.442041 -1.904991 -1.281036 -0.6098567 -25.97711 2.106436 1.599970 1.086661 0.5650291 4.7216568E-02 -0.4515711 -0.9375455 -1.403833 -1.842497 -2.255975 -2.652110 -3.018039 -3.319478 -3.474263 -3.400049 -3.054328 -2.496360 -1.815899 -1.073049 -25.97711 1.499734 1.032082 0.5502648 5.6972794E-02 -0.4390940 -0.9222579 -1.391183 -1.841823 -2.267629 -2.665841 -3.052038 -3.416691 -3.725286 -3.937796 -3.947587 -3.669730 -3.118555 -2.392477 -1.581009 -25.97711 0.8200134 0.3960437 -4.8295423E-02 -0.5120520 -0.9817238 -1.440188 -1.885770 -2.314489 -2.718499 -3.101575 -3.471465 -3.813335 -4.124905 -4.366250 -4.457932 -4.272460 -3.762739 -3.008571 -2.133927 -25.97711 5.9089486E-02 -0.3161201 -0.7181742 -1.144312 -1.581234 -2.007109 -2.421201 -2.824730 -3.208319 -3.562148 -3.902622 -4.229081 -4.525108 -4.780247 -4.927599 -4.851633 -4.419141 -3.664436 -2.736098 -25.97711 -0.7912293 -1.111308 -1.464479 -1.844196 -2.240459 -2.629332 -3.010950 -3.376306 -3.727023 -4.053778 -4.367315 -4.668552 -4.947314 -5.195097 -5.384928 -5.399238 -5.076862 -4.363110 -3.397632 -25.97711 -1.752245 -2.006599 -2.303482 -2.630935 -2.974153 -3.313067 -3.650459 -3.977540 -4.296565 -4.591232 -4.875032 -5.152882 -5.407126 -5.647609 -5.843921 -5.919119 -5.717093 -5.094466 -4.118063 -25.97711 -2.866570 -3.038455 -3.262905 -3.522707 -3.804919 -4.090897 -4.378529 -4.664860 -4.945792 -5.209342 -5.460226 -5.714021 -5.942490 -6.155467 -6.334026 -6.438407 -6.348207 -5.863811 -4.910988 -25.97711 -4.223491 -4.294790 -4.430652 -4.610849 -4.820304 -5.043139 -5.276543 -5.513423 -5.749298 -5.974247 -6.186349 -6.399260 -6.588444 -6.766166 -6.920124 -7.036546 -7.030185 -6.688395 -5.792549 -25.97711 -6.143305 -6.096522 -6.112182 -6.184878 -6.290181 -6.420506 -6.569729 -6.731134 -6.899963 -7.064554 -7.229160 -7.393290 -7.547557 -7.700954 -7.840093 -7.954999 -7.969203 -7.730731 -6.884382 -25.97711 -47.23225 -46.73162 -46.10710 -45.37789 -44.55837 -43.66104 -42.69483 -41.66705 -40.58355 -39.44920 -38.26828 -37.04352 -35.77862 -34.47591 -33.13768 -31.76593 -30.36271 -28.92889 -27.46667 -25.97711 2.600549 2.469896 2.327184 2.160478 1.964707 1.741759 1.494471 1.232654 0.9655002 0.7025861 0.4560537 0.2403770 6.6741705E-02 -5.9500322E-02 -0.1440402 -0.1949225 -0.2227718 -0.2363856 -0.2426138 -28.00587 3.546126 3.254179 2.974338 2.689146 2.395655 2.097992 1.791130 1.488120 1.197067 0.9303520 0.7002905 0.5262023 0.4152967 0.3655139 0.3640039 0.3979395 0.4544165 0.5246471 0.6030120 -28.00587 4.139930 3.686370 3.266882 2.857112 2.463128 2.088115 1.730147 1.386931 1.069598 0.7900575 0.5689375 0.4205578 0.3554274 0.3667027 0.4360097 0.5452412 0.6797484 0.8302174 0.9912313 -28.00587 4.438665 3.879382 3.358026 2.859813 2.388820 1.949168 1.538390 1.150505 0.7969825 0.4902786 0.2581857 0.1156014 7.7195831E-02 0.1341084 0.2647715 0.4446509 0.6552077 0.8850774 1.128393 -28.00587 4.515302 3.895394 3.315367 2.758455 2.234602 1.745631 1.292138 0.8632101 0.4634046 0.1182444 -0.1460332 -0.3060162 -0.3405018 -0.2533061 -7.0314728E-02 0.1756659 0.4607031 0.7696245 1.095163 -28.00587 4.423521 3.779158 3.169269 2.580755 2.023549 1.499046 1.009692 0.5486711 0.1161787 -0.2731838 -0.5873150 -0.7853165 -0.8426479 -0.7458577 -0.5224751 -0.2154257 0.1420716 0.5296121 0.9373552 -28.00587 4.202324 3.557125 2.937269 2.336521 1.762561 1.215794 0.6970881 0.2139293 -0.2378052 -0.6599008 -1.022692 -1.279850 -1.384341 -1.305333 -1.059498 -0.6993791 -0.2723479 0.1929684 0.6828601 -28.00587 3.878354 3.248590 2.634169 2.030863 1.450841 0.8920890 0.3587784 -0.1361334 -0.6001169 -1.041358 -1.439953 -1.758019 -1.930065 -1.897131 -1.655667 -1.255724 -0.7640323 -0.2223474 0.3494533 -28.00587 3.469020 2.863633 2.264148 1.666929 1.086520 0.5289575 -4.6112598E-03 -0.5052595 -0.9735100 -1.420161 -1.842067 -2.203120 -2.444703 -2.483279 -2.274102 -1.854432 -1.305927 -0.6901404 -3.6867566E-02 -28.00587 2.983457 2.406317 1.827596 1.244656 0.6757956 0.1275347 -0.3995128 -0.8971483 -1.364381 -1.810808 -2.239534 -2.624935 -2.919042 -3.041564 -2.894344 -2.481541 -1.888939 -1.203099 -0.4692110 -28.00587 2.421383 1.879290 1.328362 0.7702549 0.2176357 -0.3153900 -0.8286219 -1.319659 -1.780462 -2.219495 -2.644930 -3.031785 -3.364248 -3.557912 -3.502908 -3.133624 -2.518212 -1.769675 -0.9568840 -28.00587 1.786618 1.286443 0.7700754 0.2395154 -0.2894275 -0.8026574 -1.300530 -1.777354 -2.224211 -2.649960 -3.059922 -3.443060 -3.784974 -4.031474 -4.071905 -3.785958 -3.178931 -2.379184 -1.490419 -28.00587 1.076927 0.6226339 0.1472819 -0.3508018 -0.8528762 -1.341377 -1.815697 -2.274347 -2.699977 -3.102596 -3.498878 -3.861827 -4.196741 -4.471119 -4.594505 -4.417096 -3.863040 -3.031399 -2.072134 -28.00587 0.2841335 -0.1182614 -0.5499715 -1.010022 -1.477683 -1.935157 -2.379210 -2.808893 -3.211544 -3.589923 -3.956373 -4.297432 -4.617540 -4.894432 -5.074857 -5.016776 -4.557652 -3.725260 -2.705339 -28.00587 -0.6049435 -0.9480019 -1.330509 -1.743891 -2.168699 -2.587837 -2.997455 -3.392828 -3.760332 -4.105630 -4.445640 -4.761506 -5.059268 -5.327795 -5.535522 -5.576931 -5.246766 -4.460066 -3.396495 -28.00587 -1.611531 -1.883369 -2.206700 -2.566171 -2.940102 -3.308955 -3.672437 -4.025041 -4.358337 -4.674397 -4.981244 -5.273851 -5.541083 -5.795937 -6.006407 -6.108997 -5.914403 -5.235332 -4.157731 -28.00587 -2.775840 -2.962060 -3.210570 -3.500176 -3.807360 -4.121611 -4.436997 -4.744961 -5.040652 -5.324096 -5.598128 -5.860988 -6.103473 -6.325369 -6.516966 -6.638935 -6.565534 -6.046245 -4.995723 -28.00587 -4.195918 -4.276843 -4.428568 -4.633450 -4.863465 -5.113316 -5.372332 -5.628745 -5.881228 -6.123638 -6.358735 -6.583264 -6.781593 -6.962048 -7.128863 -7.253374 -7.263167 -6.913763 -5.928031 -28.00587 -6.201581 -6.152493 -6.177245 -6.266062 -6.386839 -6.542024 -6.715682 -6.893439 -7.077747 -7.261946 -7.439969 -7.619992 -7.779153 -7.935657 -8.084100 -8.202068 -8.235806 -8.004570 -7.085849 -28.00587 -51.18514 -50.64650 -49.96841 -49.17344 -48.27919 -47.29912 -46.24364 -45.12093 -43.93751 -42.69878 -41.40921 -40.07262 -38.69226 -37.27098 -35.81128 -34.31536 -32.78518 -31.22251 -29.62893 -28.00587 2.834391 2.700508 2.560423 2.394575 2.199811 1.973389 1.719199 1.439160 1.155848 0.8696058 0.6004527 0.3629576 0.1724399 3.3738095E-02 -5.6802370E-02 -0.1108644 -0.1397077 -0.1533263 -0.1592208 -30.06916 3.852434 3.542866 3.248191 2.952045 2.649286 2.342534 2.018755 1.696618 1.387113 1.095332 0.8456838 0.6536362 0.5333936 0.4801793 0.4808500 0.5198181 0.5826299 0.6598924 0.7454556 -30.06916 4.496107 4.008375 3.561878 3.129492 2.717617 2.323388 1.942234 1.581669 1.239460 0.9411444 0.6989248 0.5363213 0.4668637 0.4823751 0.5609860 0.6822972 0.8299490 0.9942186 1.169321 -30.06916 4.821666 4.221091 3.665184 3.135955 2.638029 2.173087 1.740378 1.327147 0.9483145 0.6231871 0.3678121 0.2118194 0.1714933 0.2377727 0.3837768 0.5823805 0.8128294 1.063292 1.327631 -30.06916 4.909972 4.245470 3.625485 3.032587 2.475633 1.961698 1.481606 1.024083 0.6029364 0.2300375 -5.7761267E-02 -0.2354439 -0.2725782 -0.1747336 2.8432481E-02 0.2996596 0.6112620 0.9476163 1.301164 -30.06916 4.817172 4.127006 3.474948 2.847457 2.259770 1.704141 1.184227 0.7020252 0.2427248 -0.1767419 -0.5177993 -0.7415814 -0.8084275 -0.7035981 -0.4577385 -0.1202830 0.2705359 0.6923566 1.135121 -30.06916 4.586572 3.896866 3.234155 2.597144 1.987998 1.406808 0.8646385 0.3576251 -0.1244919 -0.5742301 -0.9664178 -1.250717 -1.373536 -1.291408 -1.022107 -0.6263714 -0.1591729 0.3475278 0.8795179 -30.06916 4.248151 3.576617 2.922271 2.278973 1.662133 1.075653 0.5161884 -7.2651324E-03 -0.4964467 -0.9667658 -1.391658 -1.740159 -1.939600 -1.918978 -1.659049 -1.220750 -0.6827718 -9.2693463E-02 0.5283394 -30.06916 3.824228 3.176679 2.536231 1.900912 1.289137 0.6996758 0.1351417 -0.3905814 -0.8838894 -1.358068 -1.802999 -2.193193 -2.468227 -2.531555 -2.316869 -1.858012 -1.257367 -0.5860981 0.1236122 -30.06916 3.316182 2.700197 2.084944 1.466377 0.8609929 0.2801058 -0.2768476 -0.7996845 -1.289194 -1.763955 -2.212510 -2.622581 -2.950896 -3.110084 -2.972687 -2.528371 -1.879497 -1.131117 -0.3335108 -30.06916 2.731980 2.155571 1.567585 0.9705228 0.3842624 -0.1814413 -0.7256283 -1.238139 -1.721454 -2.187929 -2.629411 -3.041596 -3.402092 -3.640029 -3.606670 -3.218791 -2.546127 -1.728465 -0.8445458 -30.06916 2.070067 1.536428 0.9865433 0.4192880 -0.1433928 -0.6871145 -1.213777 -1.715881 -2.183621 -2.633957 -3.062538 -3.465599 -3.837796 -4.116777 -4.193803 -3.904890 -3.244399 -2.370012 -1.402672 -30.06916 1.330608 0.8476633 0.3383852 -0.1935337 -0.7261245 -1.246776 -1.750359 -2.232616 -2.680845 -3.105307 -3.519952 -3.907090 -4.263146 -4.565887 -4.726439 -4.565104 -3.967228 -3.057665 -2.012321 -30.06916 0.5063881 7.8653745E-02 -0.3856488 -0.8784153 -1.376627 -1.865731 -2.339528 -2.790207 -3.213900 -3.615001 -4.006353 -4.361787 -4.703233 -5.003208 -5.216442 -5.181988 -4.698693 -3.789190 -2.676106 -30.06916 -0.4201355 -0.7846268 -1.195703 -1.642288 -2.097481 -2.547300 -2.984361 -3.402082 -3.794631 -4.161149 -4.523017 -4.853414 -5.165322 -5.454155 -5.680357 -5.753413 -5.417475 -4.560379 -3.397604 -30.06916 -1.466997 -1.757053 -2.107433 -2.498264 -2.901442 -3.304768 -3.694497 -4.068546 -4.423909 -4.761760 -5.088568 -5.389290 -5.673172 -5.935412 -6.164638 -6.292197 -6.107095 -5.372297 -4.191917 -30.06916 -2.681836 -2.883740 -3.155815 -3.474303 -3.810439 -4.154635 -4.495048 -4.824821 -5.140769 -5.442379 -5.732657 -6.000793 -6.257612 -6.489851 -6.693400 -6.831901 -6.775008 -6.219539 -5.070375 -30.06916 -4.167685 -4.258123 -4.428266 -4.654138 -4.911776 -5.187909 -5.467191 -5.746697 -6.015992 -6.276196 -6.526478 -6.752366 -6.966274 -7.152133 -7.325112 -7.459877 -7.483198 -7.132272 -6.060522 -30.06916 -6.261106 -6.207528 -6.241786 -6.340942 -6.483697 -6.660951 -6.851585 -7.053822 -7.256603 -7.452053 -7.646404 -7.825811 -7.997893 -8.149964 -8.311371 -8.438060 -8.488168 -8.267728 -7.284308 -30.06916 -55.21230 -54.63510 -53.90219 -53.04004 -52.06892 -51.00412 -49.85728 -48.63747 -47.35192 -46.00656 -44.60629 -43.15530 -41.65716 -40.11496 -38.53142 -36.90895 -35.24966 -33.55549 -31.82814 -30.06916 3.058789 2.925978 2.784490 2.624481 2.423283 2.198256 1.940701 1.648113 1.344056 1.034765 0.7402198 0.4801556 0.2713486 0.1209798 2.3050457E-02 -3.4544777E-02 -6.4489119E-02 -7.8329466E-02 -8.3990067E-02 -32.16550 4.154306 3.824188 3.517962 3.205213 2.893933 2.578174 2.246032 1.907025 1.575208 1.260875 0.9885055 0.7803029 0.6513711 0.5954838 0.5989751 0.6431007 0.7126205 0.7969517 0.8897907 -32.16550 4.845774 4.326716 3.848089 3.390875 2.962365 2.555102 2.154431 1.770906 1.407591 1.085244 0.8211295 0.6446854 0.5721792 0.5912258 0.6793954 0.8128885 0.9740093 1.152240 1.341608 -32.16550 5.200788 4.554634 3.961730 3.403579 2.883129 2.395494 1.937108 1.499745 1.096694 0.7483915 0.4702007 0.3016724 0.2598197 0.3349684 0.4967792 0.7144554 0.9651314 1.236461 1.522115 -32.16550 5.295939 4.586876 3.928238 3.301992 2.714592 2.172434 1.665666 1.183340 0.7341371 0.3355681 2.0137625E-02 -0.1751050 -0.2188515 -0.1119462 0.1110573 0.4073775 0.7457553 1.109853 1.491784 -32.16550 5.203328 4.469704 3.774620 3.111921 2.489888 1.903350 1.357346 0.8472863 0.3615840 -8.6505860E-02 -0.4541313 -0.7042470 -0.7848808 -0.6757997 -0.4080738 -3.9663315E-02 0.3845053 0.8410655 1.319333 -32.16550 4.966145 4.230904 3.528260 2.850986 2.207331 1.595631 1.024712 0.4937621 -1.6681939E-02 -0.4913311 -0.9092355 -1.224118 -1.370695 -1.290679 -0.9993844 -0.5679996 -6.0402546E-02 0.4881735 1.062850 -32.16550 4.614604 3.900034 3.203707 2.521167 1.870378 1.250286 0.6651613 0.1166094 -0.3993775 -0.8921474 -1.343079 -1.719256 -1.952650 -1.944588 -1.666818 -1.189335 -0.6042761 3.4980688E-02 0.7059408 -32.16550 4.173656 3.484027 2.802859 2.130167 1.482905 0.8620626 0.2691154 -0.2809426 -0.7987649 -1.297721 -1.761758 -2.179997 -2.492009 -2.580177 -2.362219 -1.865287 -1.212053 -0.4844401 0.2824985 -32.16550 3.643761 2.990495 2.335383 1.680141 1.041181 0.4248097 -0.1587332 -0.7047466 -1.218972 -1.715087 -2.182350 -2.618093 -2.984102 -3.173891 -3.055653 -2.580251 -1.875394 -1.063760 -0.2015946 -32.16550 3.036600 2.425133 1.800562 1.166702 0.5453934 -5.1823679E-02 -0.6248378 -1.161927 -1.664450 -2.155483 -2.613386 -3.052317 -3.438664 -3.712897 -3.714027 -3.311145 -2.582404 -1.694821 -0.7389319 -32.16550 2.348680 1.783206 1.196850 0.5948574 2.7867249E-04 -0.5774643 -1.131027 -1.655541 -2.143996 -2.619857 -3.065423 -3.489672 -3.883649 -4.195704 -4.315282 -4.031065 -3.319431 -2.370189 -1.323404 -32.16550 1.580758 1.068659 0.5263878 -4.1362952E-02 -0.6038359 -1.157183 -1.688190 -2.190767 -2.661689 -3.115360 -3.540044 -3.948756 -4.324998 -4.654234 -4.854657 -4.717938 -4.080427 -3.093456 -1.961172 -32.16550 0.7248994 0.2716004 -0.2217444 -0.7492309 -1.278175 -1.800076 -2.301102 -2.774388 -3.218890 -3.646308 -4.051148 -4.428224 -4.781173 -5.106116 -5.348840 -5.343863 -4.841970 -3.855817 -2.648308 -32.16550 -0.2350236 -0.6208491 -1.061721 -1.540087 -2.027637 -2.509520 -2.972630 -3.412319 -3.827891 -4.221424 -4.590307 -4.941032 -5.265000 -5.575558 -5.820820 -5.922154 -5.588390 -4.663970 -3.400412 -32.16550 -1.321663 -1.632313 -2.008808 -2.429576 -2.865083 -3.300011 -3.718214 -4.113541 -4.489715 -4.847918 -5.185393 -5.502039 -5.795757 -6.076462 -6.318326 -6.466237 -6.297227 -5.513700 -4.228727 -32.16550 -2.586484 -2.805722 -3.101966 -3.447135 -3.816713 -4.188153 -4.553610 -4.905568 -5.241105 -5.560296 -5.860853 -6.137210 -6.398549 -6.651320 -6.866199 -7.014400 -6.975816 -6.395741 -5.144241 -32.16550 -4.137720 -4.236260 -4.426873 -4.673368 -4.959669 -5.260892 -5.563958 -5.859302 -6.151396 -6.424145 -6.684121 -6.919525 -7.138463 -7.337491 -7.518706 -7.658461 -7.696762 -7.348269 -6.189385 -32.16550 -6.309872 -6.254450 -6.299840 -6.412411 -6.581831 -6.779938 -6.991058 -7.205614 -7.426872 -7.637509 -7.843902 -8.028676 -8.203563 -8.370451 -8.528829 -8.664023 -8.731483 -8.525223 -7.479285 -32.16550 -59.31027 -58.69398 -57.90500 -56.97406 -55.92430 -54.77286 -53.53266 -52.21370 -50.82391 -49.36977 -47.85664 -46.28907 -44.67093 -43.00558 -41.29597 -39.54470 -37.75406 -35.92612 -34.06271 -32.16550 3.275999 3.143751 3.004817 2.842903 2.633098 2.410612 2.152412 1.857367 1.528847 1.194490 0.8754162 0.5929295 0.3637322 0.2002480 9.3567140E-02 3.2226428E-02 8.8223629E-04 -1.3383863E-02 -1.8838003E-02 -34.29354 4.449733 4.099211 3.775975 3.447177 3.122258 2.803715 2.467273 2.113394 1.758019 1.418557 1.124573 0.9012856 0.7606721 0.7021577 0.7075374 0.7570496 0.8331606 0.9245396 1.024742 -34.29354 5.192395 4.636289 4.124908 3.638485 3.197842 2.776552 2.363304 1.955271 1.570456 1.225131 0.9408791 0.7512683 0.6749529 0.6978542 0.7962016 0.9423522 1.117179 1.309496 1.513344 -34.29354 5.572111 4.881670 4.246672 3.661748 3.118262 2.614450 2.128285 1.666042 1.239344 0.8668454 0.5694110 0.3849585 0.3409853 0.4243133 0.6024673 0.8394122 1.110641 1.403066 1.710341 -34.29354 5.674781 4.919405 4.221598 3.563515 2.950006 2.377226 1.843295 1.334653 0.8590385 0.4362907 9.0621561E-02 -0.1277272 -0.1831783 -7.0933990E-02 0.1710333 0.4919078 0.8572514 1.249334 1.660041 -34.29354 5.581090 4.804088 4.069344 3.372322 2.714171 2.096016 1.523429 0.9881381 0.4763680 4.6427785E-03 -0.3959046 -0.6749269 -0.7776756 -0.6698322 -0.3813559 1.6844418E-02 0.4745689 0.9661521 1.480417 -34.29354 5.338608 4.561087 3.817244 3.099501 2.420106 1.777131 1.180564 0.6244800 9.1252767E-02 -0.4104106 -0.8539621 -1.202993 -1.378520 -1.308133 -0.9964425 -0.5301044 1.7783130E-02 0.6086128 1.226581 -34.29354 4.977926 4.218277 3.478271 2.757644 2.070991 1.419827 0.8077269 0.2385828 -0.3082367 -0.8187318 -1.293361 -1.700486 -1.964823 -1.974378 -1.679598 -1.163665 -0.5309737 0.1580345 0.8796605 -34.29354 4.517237 3.785077 3.064003 2.352765 1.669842 1.018022 0.4009302 -0.1761231 -0.7192192 -1.235071 -1.722248 -2.168349 -2.510048 -2.635594 -2.413746 -1.880904 -1.174863 -0.3902273 0.4347346 -34.29354 3.966130 3.274521 2.579795 1.885893 1.215416 0.5689299 -4.6708878E-02 -0.6140162 -1.152710 -1.667002 -2.156446 -2.615504 -3.005187 -3.240736 -3.143089 -2.641072 -1.880619 -1.004921 -7.7336937E-02 -34.29354 3.334563 2.687236 2.027202 1.358604 0.7032762 7.3516741E-02 -0.5285500 -1.086822 -1.612677 -2.123774 -2.602211 -3.056189 -3.466897 -3.782641 -3.819591 -3.408862 -2.625557 -1.666995 -0.6381813 -34.29354 2.622268 2.025669 1.403641 0.7653317 0.1386232 -0.4710526 -1.053871 -1.597942 -2.111383 -2.607588 -3.068010 -3.505859 -3.922756 -4.273615 -4.429445 -4.158668 -3.400624 -2.374972 -1.247710 -34.29354 1.825935 1.285254 0.7106361 0.1097579 -0.4879791 -1.070768 -1.631426 -2.155175 -2.648363 -3.121434 -3.558700 -3.981539 -4.386064 -4.737069 -4.973229 -4.866848 -4.198087 -3.132408 -1.912264 -34.29354 0.9415764 0.4631032 -6.2063687E-02 -0.6204743 -1.184888 -1.737466 -2.265064 -2.761761 -3.226952 -3.671635 -4.087866 -4.484390 -4.857262 -5.204206 -5.471851 -5.502768 -4.989974 -3.927321 -2.624682 -34.29354 -5.1207166E-02 -0.4610703 -0.9307021 -1.439998 -1.960835 -2.473664 -2.962651 -3.425490 -3.860623 -4.275283 -4.653971 -5.018915 -5.362825 -5.687750 -5.955368 -6.083719 -5.761192 -4.770173 -3.405756 -34.29354 -1.177617 -1.507503 -1.912415 -2.361306 -2.831680 -3.294100 -3.741839 -4.161877 -4.551624 -4.928324 -5.276219 -5.605040 -5.919908 -6.206304 -6.456886 -6.632845 -6.487074 -5.655130 -4.266787 -34.29354 -2.492051 -2.725492 -3.048385 -3.420494 -3.820967 -4.222061 -4.610517 -4.982737 -5.333820 -5.671321 -5.982113 -6.269698 -6.544663 -6.803425 -7.016963 -7.185633 -7.170883 -6.568685 -5.218023 -34.29354 -4.103499 -4.210672 -4.419382 -4.693317 -5.008047 -5.337272 -5.658917 -5.973295 -6.272137 -6.566544 -6.834802 -7.081185 -7.306591 -7.519788 -7.687324 -7.836908 -7.899057 -7.552494 -6.313993 -34.29354 -6.351830 -6.296160 -6.348210 -6.482522 -6.673108 -6.898232 -7.127739 -7.363664 -7.585872 -7.817037 -8.029169 -8.220309 -8.401275 -8.574495 -8.721129 -8.858276 -8.948075 -8.763234 -7.668104 -34.29354 -63.47591 -62.82024 -61.97373 -60.97247 -59.84234 -58.60243 -57.26697 -55.84689 -54.35087 -52.78592 -51.15787 -49.47163 -47.73139 -45.94079 -44.10298 -42.22078 -40.29664 -38.33278 -36.33114 -34.29354 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.136669 -1.650536 -1.664181 -1.676861 -1.688805 -1.699733 -1.709422 -1.724779 -1.739485 -1.753474 -1.766815 -1.778955 -1.790707 -1.801581 -1.812994 -1.826596 -1.839316 -1.850631 -1.860330 -1.867694 -2.280320 -1.673270 -1.687495 -1.701390 -1.714003 -1.725161 -1.735528 -1.751474 -1.766641 -1.780978 -1.794050 -1.806371 -1.817932 -1.828332 -1.839225 -1.852284 -1.864132 -1.874197 -1.880068 -1.890392 -2.280320 -1.698240 -1.713418 -1.727791 -1.740524 -1.752172 -1.763227 -1.779600 -1.795019 -1.809560 -1.822476 -1.834691 -1.845815 -1.855662 -1.866091 -1.878543 -1.889480 -1.898304 -1.900850 -1.913641 -2.280320 -1.726625 -1.742004 -1.756233 -1.769288 -1.781432 -1.793033 -1.809627 -1.825180 -1.839200 -1.852276 -1.864282 -1.874982 -1.884071 -1.894287 -1.905975 -1.915975 -1.923577 -1.923201 -1.938066 -2.280320 -1.757471 -1.772283 -1.786667 -1.799981 -1.812593 -1.824399 -1.840970 -1.856023 -1.870157 -1.883095 -1.894640 -1.904748 -1.913345 -1.922956 -1.933861 -1.942856 -1.949299 -1.946504 -1.962960 -2.280320 -1.789440 -1.804282 -1.818767 -1.832331 -1.844904 -1.856660 -1.873102 -1.887725 -1.901613 -1.914103 -1.925059 -1.934277 -1.942717 -1.951424 -1.961324 -1.969198 -1.974662 -1.969947 -1.987468 -2.280320 -1.824507 -1.839163 -1.853725 -1.867186 -1.879522 -1.891020 -1.906369 -1.921046 -1.934486 -1.946446 -1.956359 -1.965336 -1.973129 -1.980994 -1.989759 -1.996045 -2.000838 -1.994736 -2.012787 -2.280320 -1.862874 -1.877243 -1.891486 -1.904617 -1.916095 -1.926888 -1.942062 -1.956155 -1.968961 -1.980162 -1.989410 -1.997946 -2.004576 -2.011383 -2.019120 -2.024006 -2.024351 -2.020905 -2.038915 -2.280320 -1.905041 -1.918813 -1.932570 -1.944562 -1.955654 -1.965831 -1.980237 -1.993530 -2.005416 -2.015311 -2.024419 -2.032075 -2.037750 -2.043158 -2.049374 -2.053271 -2.048699 -2.048774 -2.066127 -2.280320 -1.951126 -1.963439 -1.976142 -1.987627 -1.998093 -2.007433 -2.020889 -2.033068 -2.043409 -2.053053 -2.061224 -2.067456 -2.071819 -2.076078 -2.080482 -2.083596 -2.075224 -2.078038 -2.094046 -2.280320 -2.000285 -2.011764 -2.023352 -2.033820 -2.043046 -2.051283 -2.062808 -2.073892 -2.083915 -2.092474 -2.098869 -2.103790 -2.106843 -2.108932 -2.112286 -2.110570 -2.103347 -2.107897 -2.121761 -2.280320 -2.055090 -2.065292 -2.075409 -2.084580 -2.092232 -2.098193 -2.108891 -2.118874 -2.127522 -2.134146 -2.139119 -2.142461 -2.144567 -2.144967 -2.146016 -2.137885 -2.134377 -2.139692 -2.150496 -2.280320 -2.116336 -2.124731 -2.132717 -2.139115 -2.144889 -2.150083 -2.159242 -2.166718 -2.173688 -2.178558 -2.181808 -2.183722 -2.183932 -2.183277 -2.176236 -2.168926 -2.167926 -2.172804 -2.179584 -2.280320 -2.183302 -2.189389 -2.195198 -2.200396 -2.204008 -2.206202 -2.213098 -2.218511 -2.222972 -2.226041 -2.227024 -2.227012 -2.225883 -2.219620 -2.209177 -2.203684 -2.203639 -2.206834 -2.208366 -2.280320 -2.261570 -2.265063 -2.267732 -2.270031 -2.270771 -2.270751 -2.274981 -2.277809 -2.279295 -2.279527 -2.278687 -2.276768 -2.268432 -2.258352 -2.250925 -2.246502 -2.245011 -2.244894 -2.379169 -2.280320 -2.353468 -2.353580 -2.353198 -2.352081 -2.350410 -2.348394 -2.345394 -2.345395 -2.344195 -2.342378 -2.335380 -2.325871 -2.316761 -2.309033 -2.302667 -2.297822 -2.293279 -2.287630 -2.368176 -2.280320 -2.466286 -2.462690 -2.458928 -2.455121 -2.450162 -2.445393 -2.440147 -2.429761 -2.419186 -2.408552 -2.400144 -2.391898 -2.383859 -2.375866 -2.368230 -2.359744 -2.349916 -2.336164 -2.356756 -2.280320 -2.619095 -2.605853 -2.595667 -2.584958 -2.574193 -2.563531 -2.552689 -2.541675 -2.530633 -2.519357 -2.507875 -2.497043 -2.484565 -2.471915 -2.458031 -2.442223 -2.422479 -2.407267 -2.344910 -2.280320 -2.873862 -2.858953 -2.843711 -2.829197 -2.812897 -2.796191 -2.779030 -2.761788 -2.743264 -2.724030 -2.703668 -2.681791 -2.657763 -2.630748 -2.532291 -2.483841 -2.434405 -2.384001 -2.332638 -2.280320 -2.936228 -2.907130 -2.877394 -2.847027 -2.816034 -2.784422 -2.752441 -2.719365 -2.685927 -2.651893 -2.617273 -2.582075 -2.546303 -2.509964 -2.473063 -2.435606 -2.397590 -2.359033 -2.319941 -2.280320 -1.378366 -1.402642 -1.426475 -1.459619 -1.490343 -1.519979 -1.547383 -1.573096 -1.596362 -1.621420 -1.647869 -1.672460 -1.695538 -1.716783 -1.735937 -1.755909 -1.775954 -1.794937 -1.810123 -3.518405 -1.386200 -1.414722 -1.444457 -1.482190 -1.517885 -1.551172 -1.581493 -1.609435 -1.634155 -1.660848 -1.688342 -1.713229 -1.736160 -1.756440 -1.774122 -1.792286 -1.810154 -1.825344 -1.838550 -3.518405 -1.405259 -1.438870 -1.474204 -1.515047 -1.553850 -1.589201 -1.622161 -1.651534 -1.677786 -1.705772 -1.733655 -1.758864 -1.781161 -1.800335 -1.816555 -1.833075 -1.848765 -1.860223 -1.871351 -3.518405 -1.438082 -1.475702 -1.514635 -1.558544 -1.598534 -1.636157 -1.670384 -1.700821 -1.728600 -1.757296 -1.785465 -1.810782 -1.832369 -1.850487 -1.865269 -1.880193 -1.893989 -1.901832 -1.910842 -3.518405 -1.483327 -1.524378 -1.566020 -1.610135 -1.652023 -1.690629 -1.725497 -1.757260 -1.785917 -1.814937 -1.843317 -1.868319 -1.889031 -1.906098 -1.919499 -1.933166 -1.945177 -1.949604 -1.956505 -3.518405 -1.541195 -1.584056 -1.625781 -1.670924 -1.712990 -1.752085 -1.788065 -1.820567 -1.849592 -1.878682 -1.907115 -1.931305 -1.951514 -1.967553 -1.979754 -1.992274 -2.002547 -2.003914 -2.008744 -3.518405 -1.608134 -1.651177 -1.693171 -1.737783 -1.779520 -1.819074 -1.855286 -1.888081 -1.917128 -1.946329 -1.973868 -1.997330 -2.016850 -2.031930 -2.043315 -2.054419 -2.063046 -2.061630 -2.064293 -3.518405 -1.683995 -1.726141 -1.767425 -1.810877 -1.852222 -1.891253 -1.927191 -1.959471 -1.988860 -2.017542 -2.043932 -2.066589 -2.085166 -2.099244 -2.109946 -2.120089 -2.125186 -2.122847 -2.123169 -3.518405 -1.767381 -1.808066 -1.847932 -1.890008 -1.930110 -1.967926 -2.003012 -2.035062 -2.063671 -2.090801 -2.116373 -2.137970 -2.155565 -2.169342 -2.178943 -2.187896 -2.189061 -2.186458 -2.184144 -3.518405 -1.857998 -1.896546 -1.934456 -1.974409 -2.012263 -2.048589 -2.083021 -2.113848 -2.140275 -2.166161 -2.190686 -2.211133 -2.227595 -2.240705 -2.249486 -2.256681 -2.254316 -2.251176 -2.245891 -3.518405 -1.956901 -1.992893 -2.027936 -2.065319 -2.101525 -2.136067 -2.168094 -2.196831 -2.221594 -2.246020 -2.269233 -2.288217 -2.304450 -2.316549 -2.324180 -2.327430 -2.323750 -2.319767 -2.311220 -3.518405 -2.063354 -2.096226 -2.129248 -2.164755 -2.198264 -2.229427 -2.258338 -2.285157 -2.307944 -2.330629 -2.352128 -2.371203 -2.386312 -2.397161 -2.402563 -2.400938 -2.397423 -2.391985 -2.379685 -3.518405 -2.180438 -2.209651 -2.238863 -2.270644 -2.300505 -2.329094 -2.355444 -2.379165 -2.399603 -2.420181 -2.441152 -2.459113 -2.472915 -2.481644 -2.481202 -2.477938 -2.474465 -2.466587 -2.449630 -3.518405 -2.310443 -2.333767 -2.356691 -2.384454 -2.411445 -2.437494 -2.460780 -2.480968 -2.499645 -2.517998 -2.536928 -2.552734 -2.564360 -2.567949 -2.563485 -2.559318 -2.554220 -2.543021 -2.520385 -3.518405 -2.455016 -2.473042 -2.492451 -2.514779 -2.535424 -2.557903 -2.579965 -2.598403 -2.613720 -2.628274 -2.643265 -2.655081 -2.659791 -2.659241 -2.654981 -2.648391 -2.639543 -2.623685 -2.593992 -3.518405 -2.626323 -2.638147 -2.652161 -2.669924 -2.687443 -2.704730 -2.720100 -2.733607 -2.744780 -2.754853 -2.762468 -2.766152 -2.766949 -2.765005 -2.759452 -2.747646 -2.733667 -2.710571 -2.672389 -3.518405 -2.848075 -2.852227 -2.856661 -2.866181 -2.876921 -2.886520 -2.895531 -2.899883 -2.900654 -2.902578 -2.905200 -2.906507 -2.904464 -2.897919 -2.886122 -2.868358 -2.844334 -2.811557 -2.763077 -3.518405 -3.149817 -3.142236 -3.135416 -3.135240 -3.135126 -3.133902 -3.132327 -3.130295 -3.126103 -3.119928 -3.111152 -3.104462 -3.093974 -3.078427 -3.056818 -3.027365 -2.989291 -2.942575 -2.881521 -3.518405 -3.663606 -3.647238 -3.630886 -3.613950 -3.597036 -3.578545 -3.560864 -3.544137 -3.524601 -3.502059 -3.475883 -3.445557 -3.410784 -3.371974 -3.330845 -3.282786 -3.226143 -3.160686 -3.082421 -3.518405 -5.020588 -4.961755 -4.900394 -4.836557 -4.770288 -4.701634 -4.630663 -4.557668 -4.481950 -4.404301 -4.324536 -4.242698 -4.159056 -4.072945 -3.985142 -3.895442 -3.803865 -3.710479 -3.615316 -3.518405 -1.065995 -1.112734 -1.157691 -1.199013 -1.240240 -1.286402 -1.329924 -1.370172 -1.407043 -1.441230 -1.475038 -1.509725 -1.542531 -1.572825 -1.600136 -1.624590 -1.647997 -1.668891 -1.687764 -4.847148 -1.030958 -1.088531 -1.142792 -1.192833 -1.244377 -1.298694 -1.348887 -1.395139 -1.436985 -1.475019 -1.511891 -1.548953 -1.581780 -1.610614 -1.635220 -1.655776 -1.674427 -1.689297 -1.701758 -4.847148 -1.026901 -1.091874 -1.153546 -1.212514 -1.272232 -1.333056 -1.388737 -1.439483 -1.485949 -1.527407 -1.567585 -1.605825 -1.638659 -1.665969 -1.687910 -1.704805 -1.718870 -1.728257 -1.734383 -4.847148 -1.046688 -1.116727 -1.185737 -1.252453 -1.318222 -1.383640 -1.443614 -1.498429 -1.548227 -1.593393 -1.636288 -1.674985 -1.707500 -1.733417 -1.752660 -1.766244 -1.775894 -1.780251 -1.780159 -4.847148 -1.085799 -1.161021 -1.235295 -1.306693 -1.377070 -1.445831 -1.509349 -1.567451 -1.619995 -1.668121 -1.712361 -1.751466 -1.782959 -1.807370 -1.823930 -1.834419 -1.839912 -1.839370 -1.833222 -4.847148 -1.145905 -1.225093 -1.302103 -1.376776 -1.449617 -1.521103 -1.587808 -1.648733 -1.704332 -1.754063 -1.798835 -1.837743 -1.868830 -1.891409 -1.905839 -1.913513 -1.915249 -1.910250 -1.898324 -4.847148 -1.226581 -1.306743 -1.385283 -1.461618 -1.536608 -1.610065 -1.678480 -1.742066 -1.800017 -1.850850 -1.895738 -1.934599 -1.964759 -1.986057 -1.998825 -2.004020 -2.002710 -1.993944 -1.976600 -4.847148 -1.323765 -1.402911 -1.482157 -1.559793 -1.635396 -1.709378 -1.778852 -1.843490 -1.902129 -1.953758 -1.998704 -2.036902 -2.065998 -2.085961 -2.097438 -2.100500 -2.096409 -2.084505 -2.062023 -4.847148 -1.436966 -1.514868 -1.593745 -1.671005 -1.746058 -1.819453 -1.888730 -1.952637 -2.010911 -2.062512 -2.107411 -2.144681 -2.172409 -2.191720 -2.202296 -2.203544 -2.197577 -2.182382 -2.155133 -4.847148 -1.567930 -1.642989 -1.718532 -1.793375 -1.867530 -1.938938 -2.005921 -2.068028 -2.125069 -2.175926 -2.219361 -2.255161 -2.282110 -2.300770 -2.310189 -2.310090 -2.303019 -2.284588 -2.252730 -4.847148 -1.716725 -1.786367 -1.857098 -1.928047 -1.998574 -2.067165 -2.130618 -2.190126 -2.245014 -2.293300 -2.334188 -2.368140 -2.394815 -2.413206 -2.421325 -2.420058 -2.412082 -2.390461 -2.354283 -4.847148 -1.882245 -1.945578 -2.010195 -2.075328 -2.140629 -2.204718 -2.265341 -2.320423 -2.371085 -2.415916 -2.454311 -2.486909 -2.512982 -2.530229 -2.538230 -2.537383 -2.527280 -2.502848 -2.462266 -4.847148 -2.063826 -2.120374 -2.177108 -2.236628 -2.296137 -2.353827 -2.408471 -2.458514 -2.503561 -2.544799 -2.581302 -2.612597 -2.636159 -2.653507 -2.661671 -2.660974 -2.648203 -2.621596 -2.576019 -4.847148 -2.262910 -2.312263 -2.361663 -2.413357 -2.464655 -2.513601 -2.560460 -2.604831 -2.645739 -2.683215 -2.717244 -2.745188 -2.767479 -2.784219 -2.794001 -2.790643 -2.775067 -2.746006 -2.694887 -4.847148 -2.485999 -2.524445 -2.562312 -2.603704 -2.645282 -2.687588 -2.727429 -2.765921 -2.802640 -2.835427 -2.864970 -2.890312 -2.911034 -2.928140 -2.934823 -2.927423 -2.909899 -2.876508 -2.818523 -4.847148 -2.727674 -2.755830 -2.785280 -2.816134 -2.850807 -2.886782 -2.920450 -2.951732 -2.980605 -3.007435 -3.033544 -3.057122 -3.074252 -3.084070 -3.084927 -3.073784 -3.052236 -3.012185 -2.944412 -4.847148 -3.021894 -3.039147 -3.059041 -3.081245 -3.105488 -3.130380 -3.154953 -3.181413 -3.205637 -3.225564 -3.242628 -3.256509 -3.263286 -3.265724 -3.261964 -3.244867 -3.213341 -3.162446 -3.081823 -4.847148 -3.424904 -3.427387 -3.434366 -3.443866 -3.456912 -3.470363 -3.483056 -3.495569 -3.504741 -3.514534 -3.518982 -3.521852 -3.519437 -3.511516 -3.495173 -3.465311 -3.416753 -3.347734 -3.250416 -4.847148 -4.113415 -4.095203 -4.082393 -4.071475 -4.060999 -4.051155 -4.043872 -4.035843 -4.027365 -4.015850 -4.001142 -3.979009 -3.952814 -3.918823 -3.872353 -3.811084 -3.731503 -3.633815 -3.514845 -4.847148 -7.350590 -7.261634 -7.166559 -7.066256 -6.960665 -6.849969 -6.734303 -6.613875 -6.488813 -6.359285 -6.225443 -6.087398 -5.945318 -5.799304 -5.649489 -5.495990 -5.338894 -5.178333 -5.014627 -4.847148 -0.7365690 -0.8043374 -0.8712894 -0.9350384 -0.9937662 -1.053366 -1.114477 -1.170009 -1.219528 -1.265035 -1.305815 -1.345201 -1.381305 -1.414481 -1.446398 -1.474127 -1.498479 -1.519228 -1.537216 -6.258605 -0.6436549 -0.7299107 -0.8124266 -0.8910569 -0.9646383 -1.037870 -1.109860 -1.174220 -1.231662 -1.282112 -1.325524 -1.366089 -1.401817 -1.433252 -1.460339 -1.480978 -1.496720 -1.507249 -1.514002 -6.258605 -0.6077768 -0.7071109 -0.8031319 -0.8942705 -0.9809396 -1.066621 -1.146436 -1.217662 -1.281293 -1.335909 -1.382744 -1.424836 -1.459846 -1.489712 -1.512163 -1.526256 -1.533818 -1.534694 -1.530762 -6.258605 -0.6140140 -0.7228048 -0.8290063 -0.9319193 -1.030414 -1.123480 -1.210032 -1.288107 -1.355843 -1.413999 -1.464075 -1.507871 -1.543478 -1.571660 -1.589755 -1.597839 -1.597716 -1.589457 -1.575258 -6.258605 -0.6537709 -0.7696422 -0.8839200 -0.9960623 -1.100968 -1.199494 -1.293015 -1.375108 -1.446673 -1.508379 -1.561884 -1.606885 -1.643656 -1.670021 -1.684086 -1.686515 -1.679273 -1.662304 -1.638216 -6.258605 -0.7228523 -0.8443068 -0.9646713 -1.080423 -1.189131 -1.293202 -1.389374 -1.475647 -1.550744 -1.616362 -1.672150 -1.719752 -1.757310 -1.781572 -1.792064 -1.789554 -1.775809 -1.750645 -1.717094 -6.258605 -0.8208992 -0.9443023 -1.066530 -1.184377 -1.296207 -1.401585 -1.500601 -1.589683 -1.668833 -1.738534 -1.797137 -1.847787 -1.885826 -1.908495 -1.916453 -1.909898 -1.890445 -1.858236 -1.815644 -6.258605 -0.9442722 -1.064934 -1.186640 -1.306538 -1.418090 -1.523660 -1.623340 -1.715623 -1.799006 -1.871331 -1.934997 -1.987762 -2.025568 -2.047701 -2.053897 -2.044437 -2.020239 -1.982615 -1.931374 -6.258605 -1.087989 -1.205377 -1.323685 -1.440761 -1.552053 -1.656674 -1.756029 -1.850023 -1.935125 -2.012056 -2.078369 -2.132066 -2.169580 -2.191032 -2.196059 -2.184257 -2.156127 -2.114021 -2.054789 -6.258605 -1.254412 -1.364286 -1.476955 -1.589761 -1.698772 -1.803337 -1.901329 -1.993590 -2.081357 -2.160989 -2.228337 -2.281959 -2.319581 -2.340491 -2.345239 -2.332203 -2.301281 -2.255643 -2.189204 -6.258605 -1.439801 -1.542426 -1.647276 -1.754865 -1.860173 -1.961659 -2.058352 -2.148816 -2.235825 -2.314857 -2.381426 -2.434731 -2.472291 -2.492993 -2.497294 -2.483382 -2.451301 -2.402962 -2.329934 -6.258605 -1.646484 -1.740865 -1.837343 -1.937618 -2.036215 -2.133205 -2.228228 -2.316348 -2.397819 -2.472652 -2.537352 -2.589481 -2.626878 -2.647925 -2.651745 -2.637194 -2.606724 -2.554576 -2.475526 -6.258605 -1.877431 -1.961450 -2.048581 -2.139539 -2.232263 -2.322785 -2.412017 -2.494245 -2.568904 -2.637678 -2.698613 -2.749523 -2.787802 -2.808907 -2.812243 -2.798699 -2.770869 -2.715482 -2.631318 -6.258605 -2.133589 -2.207023 -2.286071 -2.367545 -2.449568 -2.529374 -2.608145 -2.682544 -2.749089 -2.810591 -2.867993 -2.917271 -2.954038 -2.975672 -2.979921 -2.970912 -2.942255 -2.884330 -2.795462 -6.258605 -2.427206 -2.486379 -2.551471 -2.618814 -2.686714 -2.753324 -2.819528 -2.882728 -2.942524 -2.998773 -3.049922 -3.094333 -3.128124 -3.150483 -3.159879 -3.151578 -3.120026 -3.061423 -2.966121 -6.258605 -2.755409 -2.797030 -2.844588 -2.895651 -2.946386 -3.001722 -3.057652 -3.112231 -3.160903 -3.207381 -3.251590 -3.290387 -3.320694 -3.347416 -3.357508 -3.344585 -3.308885 -3.247830 -3.145121 -6.258605 -3.122598 -3.150428 -3.187347 -3.224952 -3.261467 -3.301631 -3.342574 -3.384455 -3.420659 -3.457583 -3.493286 -3.530922 -3.559145 -3.574358 -3.576134 -3.558737 -3.519682 -3.449308 -3.333651 -6.258605 -3.618199 -3.622138 -3.636169 -3.658910 -3.681064 -3.702952 -3.730982 -3.760177 -3.786608 -3.807604 -3.829991 -3.848603 -3.860132 -3.863734 -3.856505 -3.829318 -3.776042 -3.687155 -3.549906 -6.258605 -4.441175 -4.418141 -4.403737 -4.395706 -4.390527 -4.389724 -4.391919 -4.395932 -4.398267 -4.397991 -4.397501 -4.391992 -4.381625 -4.359607 -4.322236 -4.262321 -4.169912 -4.041276 -3.872636 -6.258605 -9.892175 -9.771982 -9.641875 -9.502251 -9.353538 -9.196123 -9.030398 -8.856730 -8.675452 -8.486903 -8.291366 -8.089146 -7.880480 -7.665643 -7.444836 -7.218304 -6.986222 -6.748801 -6.506204 -6.258605 -0.4271421 -0.5023409 -0.5862681 -0.6688247 -0.7497376 -0.8269207 -0.9046739 -0.9767163 -1.043443 -1.104256 -1.156714 -1.203735 -1.244617 -1.279978 -1.311324 -1.340559 -1.365567 -1.385938 -1.402224 -7.745110 -0.2636038 -0.3666776 -0.4735690 -0.5783235 -0.6795895 -0.7743905 -0.8669878 -0.9526317 -1.029713 -1.096035 -1.151657 -1.198841 -1.236916 -1.266806 -1.289976 -1.308835 -1.320553 -1.325723 -1.325461 -7.745110 -0.1839353 -0.3101413 -0.4381390 -0.5624132 -0.6802970 -0.7905058 -0.8965940 -0.9931669 -1.078004 -1.148949 -1.208189 -1.254994 -1.290697 -1.315801 -1.332002 -1.340475 -1.339693 -1.330476 -1.314446 -7.745110 -0.1672332 -0.3118771 -0.4564125 -0.5956383 -0.7271889 -0.8524775 -0.9704004 -1.075230 -1.165011 -1.241247 -1.303219 -1.351012 -1.384876 -1.405929 -1.416713 -1.415503 -1.402974 -1.380053 -1.348835 -7.745110 -0.2015593 -0.3593730 -0.5161545 -0.6658024 -0.8088163 -0.9459319 -1.073315 -1.183983 -1.279238 -1.360559 -1.425159 -1.474144 -1.507694 -1.525961 -1.531967 -1.522271 -1.498734 -1.462752 -1.416948 -7.745110 -0.2791338 -0.4433888 -0.6076456 -0.7669966 -0.9187394 -1.062677 -1.193962 -1.309829 -1.412017 -1.496876 -1.564434 -1.615454 -1.649394 -1.667323 -1.668365 -1.651181 -1.617577 -1.569268 -1.509455 -7.745110 -0.3939515 -0.5602815 -0.7293404 -0.8946778 -1.051391 -1.196212 -1.330160 -1.451533 -1.557458 -1.647499 -1.719340 -1.773204 -1.808522 -1.827194 -1.824543 -1.801252 -1.758823 -1.699220 -1.626171 -7.745110 -0.5416909 -0.7079369 -0.8774613 -1.042910 -1.197944 -1.343249 -1.479386 -1.602509 -1.712261 -1.806807 -1.883771 -1.941295 -1.980823 -1.999655 -1.994488 -1.966277 -1.916378 -1.846720 -1.761201 -7.745110 -0.7215744 -0.8833002 -1.046247 -1.205592 -1.358889 -1.505638 -1.638740 -1.762815 -1.876395 -1.975101 -2.057551 -2.121532 -2.165315 -2.184586 -2.178890 -2.147578 -2.092048 -2.013935 -1.917171 -7.745110 -0.9266678 -1.077936 -1.230910 -1.385885 -1.535376 -1.677391 -1.809501 -1.932394 -2.047856 -2.151717 -2.239187 -2.310665 -2.358195 -2.378816 -2.373979 -2.341512 -2.282501 -2.198555 -2.091393 -7.745110 -1.150545 -1.293165 -1.437823 -1.581274 -1.723484 -1.861392 -1.991115 -2.111174 -2.226763 -2.333630 -2.427168 -2.501487 -2.551930 -2.575343 -2.571471 -2.539611 -2.478832 -2.391567 -2.274976 -7.745110 -1.401581 -1.529251 -1.662982 -1.794959 -1.928867 -2.059422 -2.185492 -2.303241 -2.416512 -2.524115 -2.618377 -2.693321 -2.746517 -2.772725 -2.770259 -2.739961 -2.679509 -2.590970 -2.466346 -7.745110 -1.676288 -1.789835 -1.912357 -2.032343 -2.153974 -2.276562 -2.397486 -2.512066 -2.620044 -2.721640 -2.812734 -2.888086 -2.942263 -2.971078 -2.970990 -2.942780 -2.885312 -2.797204 -2.665823 -7.745110 -1.983123 -2.079712 -2.188366 -2.298513 -2.407355 -2.518574 -2.629915 -2.736040 -2.835108 -2.928084 -3.013539 -3.086203 -3.140895 -3.171480 -3.174108 -3.148506 -3.099220 -3.009161 -2.872352 -7.745110 -2.329947 -2.409772 -2.503222 -2.598801 -2.692095 -2.786559 -2.881505 -2.975615 -3.065951 -3.148995 -3.226361 -3.294014 -3.347547 -3.379807 -3.384825 -3.367011 -3.323350 -3.232547 -3.092148 -7.745110 -2.729187 -2.787176 -2.858553 -2.934087 -3.008427 -3.085772 -3.162505 -3.240310 -3.319188 -3.392769 -3.458847 -3.518700 -3.567649 -3.600303 -3.613424 -3.602024 -3.556118 -3.467645 -3.320487 -7.745110 -3.183856 -3.220262 -3.269944 -3.323189 -3.379530 -3.436751 -3.495444 -3.553775 -3.615761 -3.677226 -3.731077 -3.778872 -3.824185 -3.863877 -3.878022 -3.859920 -3.811419 -3.721662 -3.564905 -7.745110 -3.764889 -3.772696 -3.797831 -3.830465 -3.862414 -3.896817 -3.930650 -3.967718 -4.009386 -4.057266 -4.102787 -4.139948 -4.172332 -4.193326 -4.195734 -4.175947 -4.117058 -4.013908 -3.834447 -7.745110 -4.704326 -4.675936 -4.662893 -4.656490 -4.659286 -4.667860 -4.674139 -4.679415 -4.690290 -4.706605 -4.725550 -4.740512 -4.746809 -4.744364 -4.726753 -4.677831 -4.583457 -4.429767 -4.208955 -7.745110 -12.61859 -12.46679 -12.29964 -12.11797 -11.92254 -11.71413 -11.49345 -11.26112 -11.01778 -10.76399 -10.50023 -10.22700 -9.944720 -9.653778 -9.354553 -9.047384 -8.732572 -8.410414 -8.081179 -7.745110 -0.1274644 -0.2091123 -0.3078048 -0.4043831 -0.5025983 -0.5992411 -0.6936026 -0.7852870 -0.8698623 -0.9447669 -1.011973 -1.069613 -1.117507 -1.157369 -1.190565 -1.218238 -1.243398 -1.263269 -1.278112 -9.300068 0.1038075 -1.3776952E-02 -0.1394597 -0.2648631 -0.3893910 -0.5087174 -0.6243402 -0.7337167 -0.8298183 -0.9140154 -0.9851108 -1.040781 -1.083699 -1.114259 -1.135213 -1.148075 -1.155109 -1.154517 -1.147275 -9.300068 0.2291831 8.0339037E-02 -7.4173860E-02 -0.2254778 -0.3728656 -0.5138636 -0.6474304 -0.7687038 -0.8760306 -0.9687366 -1.042636 -1.096787 -1.134820 -1.156874 -1.166227 -1.165244 -1.154978 -1.134917 -1.106587 -9.300068 0.2745380 9.8557599E-02 -7.8610174E-02 -0.2505828 -0.4182986 -0.5787915 -0.7262642 -0.8586544 -0.9763811 -1.075569 -1.151115 -1.205788 -1.239350 -1.254645 -1.253568 -1.239927 -1.213195 -1.174378 -1.125601 -9.300068 0.2529181 5.8227241E-02 -0.1377775 -0.3258650 -0.5081601 -0.6819606 -0.8412979 -0.9869475 -1.114285 -1.216823 -1.295627 -1.350755 -1.381895 -1.392078 -1.382447 -1.357490 -1.315332 -1.258472 -1.189850 -9.300068 0.1734887 -3.1746544E-02 -0.2395692 -0.4407867 -0.6317688 -0.8129063 -0.9836345 -1.139978 -1.274418 -1.382229 -1.464994 -1.520770 -1.551415 -1.558197 -1.542811 -1.507163 -1.450877 -1.376817 -1.288962 -9.300068 4.5617074E-02 -0.1647400 -0.3782916 -0.5840095 -0.7817954 -0.9695182 -1.147215 -1.309246 -1.447707 -1.563653 -1.651129 -1.709320 -1.741488 -1.746348 -1.728183 -1.683673 -1.614619 -1.524589 -1.418266 -9.300068 -0.1243900 -0.3351273 -0.5459884 -0.7534489 -0.9560107 -1.148428 -1.325971 -1.488185 -1.633663 -1.755326 -1.849341 -1.914402 -1.949167 -1.956231 -1.936663 -1.885600 -1.805807 -1.701458 -1.577778 -9.300068 -0.3295869 -0.5349031 -0.7427791 -0.9488189 -1.150222 -1.340281 -1.513741 -1.678212 -1.826302 -1.952624 -2.055046 -2.128530 -2.168942 -2.182169 -2.162468 -2.107817 -2.019888 -1.903247 -1.763644 -9.300068 -0.5682566 -0.7651860 -0.9668213 -1.164592 -1.355787 -1.540204 -1.713200 -1.873926 -2.022067 -2.152862 -2.262269 -2.343605 -2.395238 -2.413137 -2.394974 -2.339016 -2.245482 -2.118629 -1.964632 -9.300068 -0.8393323 -1.022998 -1.210935 -1.394050 -1.577471 -1.753986 -1.919844 -2.077930 -2.225780 -2.359200 -2.472894 -2.564144 -2.626771 -2.650789 -2.636492 -2.581714 -2.486353 -2.352507 -2.186210 -9.300068 -1.135739 -1.300602 -1.475103 -1.645891 -1.814660 -1.978946 -2.138270 -2.294491 -2.439748 -2.572326 -2.690841 -2.790507 -2.860285 -2.893208 -2.884497 -2.834407 -2.740904 -2.605466 -2.428483 -9.300068 -1.460484 -1.606188 -1.762673 -1.917057 -2.070738 -2.224751 -2.375781 -2.523745 -2.664925 -2.795988 -2.914833 -3.014825 -3.088823 -3.128997 -3.126247 -3.081734 -2.992612 -2.859562 -2.673802 -9.300068 -1.816438 -1.940053 -2.079721 -2.220680 -2.358618 -2.497963 -2.635883 -2.773735 -2.909210 -3.034071 -3.145938 -3.243689 -3.318785 -3.363523 -3.369742 -3.331460 -3.250278 -3.123661 -2.931753 -9.300068 -2.220457 -2.321818 -2.440790 -2.562752 -2.682797 -2.804082 -2.926603 -3.049968 -3.171229 -3.285652 -3.388596 -3.479159 -3.551281 -3.598968 -3.612409 -3.581209 -3.515603 -3.391905 -3.195824 -9.300068 -2.686463 -2.759826 -2.853128 -2.951770 -3.051017 -3.149160 -3.250131 -3.354745 -3.459135 -3.560098 -3.650953 -3.731600 -3.797955 -3.845560 -3.864961 -3.850779 -3.794807 -3.674262 -3.477085 -9.300068 -3.226083 -3.269284 -3.331048 -3.401414 -3.474478 -3.548367 -3.626597 -3.707500 -3.791734 -3.875433 -3.950658 -4.018914 -4.075103 -4.122367 -4.157843 -4.151903 -4.092654 -3.980442 -3.776019 -9.300068 -3.892545 -3.902646 -3.932217 -3.969908 -4.013417 -4.058054 -4.108097 -4.162350 -4.219108 -4.279226 -4.341278 -4.401288 -4.453880 -4.496315 -4.520320 -4.505981 -4.449034 -4.330538 -4.107437 -9.300068 -4.924196 -4.896327 -4.881946 -4.880052 -4.886611 -4.894939 -4.906760 -4.928757 -4.955004 -4.983452 -5.014525 -5.046154 -5.075299 -5.093964 -5.100264 -5.075270 -4.986819 -4.819531 -4.546465 -9.300068 -15.50901 -15.32498 -15.11908 -14.89272 -14.64723 -14.38386 -14.10374 -13.80791 -13.49731 -13.17280 -12.83514 -12.48500 -12.12304 -11.74981 -11.36584 -10.97160 -10.56752 -10.15399 -9.731397 -9.300068 0.1759246 8.5197762E-02 -2.3033593E-02 -0.1380872 -0.2551511 -0.3664396 -0.4762323 -0.5847133 -0.6862327 -0.7792953 -0.8589440 -0.9271659 -0.9847748 -1.029769 -1.065723 -1.093871 -1.117070 -1.136070 -1.149573 -10.91791 0.4743778 0.3414377 0.1940946 4.5321707E-02 -9.9201396E-02 -0.2390976 -0.3756570 -0.5059962 -0.6241593 -0.7263265 -0.8088041 -0.8755767 -0.9245369 -0.9572588 -0.9759688 -0.9838824 -0.9841872 -0.9771916 -0.9629529 -10.91791 0.6469468 0.4687874 0.2858669 0.1087760 -6.4425357E-02 -0.2303805 -0.3886863 -0.5364224 -0.6681297 -0.7765185 -0.8632914 -0.9276567 -0.9678516 -0.9879497 -0.9901660 -0.9783950 -0.9566592 -0.9246901 -0.8837302 -10.91791 0.7143911 0.5020697 0.2931732 9.1755353E-02 -0.1075875 -0.2980888 -0.4774024 -0.6417314 -0.7830688 -0.8997844 -0.9918749 -1.054630 -1.089346 -1.099083 -1.086861 -1.057021 -1.014406 -0.9584584 -0.8915570 -10.91791 0.7002484 0.4681499 0.2370989 1.4311647E-02 -0.2028100 -0.4127420 -0.6116387 -0.7911819 -0.9433027 -1.069658 -1.166626 -1.228897 -1.260726 -1.262354 -1.238166 -1.192722 -1.130037 -1.050911 -0.9586952 -10.91791 0.6213786 0.3762313 0.1305641 -0.1075202 -0.3386979 -0.5620778 -0.7743143 -0.9637740 -1.130838 -1.268594 -1.368133 -1.432799 -1.463143 -1.459396 -1.425507 -1.366659 -1.285291 -1.183865 -1.066950 -10.91791 0.4851100 0.2340419 -1.8124828E-02 -0.2654852 -0.5085989 -0.7382419 -0.9540450 -1.155904 -1.334579 -1.480149 -1.586995 -1.654960 -1.684762 -1.679000 -1.637697 -1.568053 -1.469507 -1.346864 -1.205881 -10.91791 0.3005364 4.7281951E-02 -0.2064794 -0.4576949 -0.7025955 -0.9343882 -1.156261 -1.365274 -1.549792 -1.701520 -1.818846 -1.893374 -1.926778 -1.921678 -1.878607 -1.800190 -1.686946 -1.544763 -1.380785 -10.91791 7.0664376E-02 -0.1789299 -0.4311427 -0.6751391 -0.9166222 -1.151547 -1.376682 -1.584795 -1.769473 -1.929762 -2.054328 -2.138607 -2.181638 -2.180528 -2.141213 -2.057295 -1.932379 -1.773051 -1.587543 -10.91791 -0.2018220 -0.4391622 -0.6820974 -0.9194500 -1.155362 -1.385973 -1.605041 -1.809961 -1.996589 -2.158366 -2.290054 -2.386522 -2.441018 -2.452066 -2.418427 -2.333375 -2.200549 -2.027124 -1.822078 -10.91791 -0.5079232 -0.7302871 -0.9634105 -1.190905 -1.414974 -1.630714 -1.842147 -2.044132 -2.225550 -2.387730 -2.526706 -2.632024 -2.700687 -2.728916 -2.703071 -2.621842 -2.485523 -2.301729 -2.079710 -10.91791 -0.8518154 -1.056264 -1.271595 -1.482235 -1.689592 -1.892684 -2.090723 -2.282279 -2.459847 -2.621927 -2.762315 -2.875642 -2.960930 -3.002337 -2.987287 -2.913002 -2.778425 -2.588645 -2.352595 -10.91791 -1.231012 -1.410892 -1.604742 -1.797886 -1.985949 -2.170554 -2.353174 -2.535203 -2.707536 -2.863189 -3.005762 -3.129268 -3.222110 -3.275818 -3.275595 -3.212953 -3.086751 -2.898744 -2.652117 -10.91791 -1.649982 -1.801102 -1.968702 -2.137592 -2.305265 -2.472873 -2.641676 -2.807604 -2.969038 -3.121030 -3.261995 -3.384191 -3.479173 -3.541265 -3.553314 -3.504923 -3.390920 -3.211722 -2.957263 -10.91791 -2.110466 -2.230171 -2.371626 -2.518649 -2.665238 -2.810686 -2.959663 -3.110958 -3.260180 -3.401381 -3.530480 -3.646839 -3.740575 -3.803942 -3.828711 -3.794841 -3.697790 -3.533295 -3.275009 -10.91791 -2.636159 -2.723411 -2.833483 -2.951888 -3.074031 -3.196151 -3.322473 -3.452230 -3.581320 -3.705514 -3.820728 -3.924858 -4.012077 -4.075376 -4.106996 -4.088995 -4.020215 -3.864238 -3.606035 -10.91791 -3.247478 -3.300561 -3.374354 -3.458045 -3.548792 -3.641635 -3.739183 -3.843678 -3.949731 -4.052320 -4.148904 -4.236522 -4.314462 -4.374049 -4.411266 -4.421901 -4.362943 -4.218384 -3.959971 -10.91791 -3.991362 -4.007397 -4.043924 -4.089559 -4.143003 -4.201595 -4.266126 -4.337282 -4.412723 -4.490369 -4.563871 -4.634508 -4.706569 -4.770783 -4.811759 -4.816121 -4.760972 -4.624128 -4.353988 -10.91791 -5.117208 -5.083704 -5.069890 -5.070812 -5.078019 -5.091851 -5.115233 -5.147054 -5.184471 -5.229928 -5.277162 -5.319934 -5.361428 -5.407829 -5.434817 -5.430089 -5.359546 -5.183896 -4.857010 -10.91791 -18.54692 -18.33006 -18.08376 -17.81021 -17.51148 -17.18945 -16.84582 -16.48209 -16.09958 -15.69950 -15.28289 -14.85069 -14.40375 -13.94284 -13.46862 -12.98172 -12.48271 -11.97210 -11.45035 -10.91791 0.4782272 0.3769394 0.2619018 0.1343249 2.1958067E-03 -0.1299702 -0.2588699 -0.3817800 -0.4989400 -0.6063796 -0.7010705 -0.7809805 -0.8463250 -0.8984042 -0.9374601 -0.9666343 -0.9885135 -1.006265 -1.018472 -12.59390 0.8452054 0.6930951 0.5300179 0.3622921 0.1936643 2.9332945E-02 -0.1265685 -0.2754400 -0.4111697 -0.5289026 -0.6275049 -0.7023565 -0.7575005 -0.7918640 -0.8090490 -0.8122984 -0.8054779 -0.7915551 -0.7702320 -12.59390 1.060745 0.8541316 0.6467261 0.4392556 0.2361631 4.5881614E-02 -0.1357322 -0.3059514 -0.4568785 -0.5852284 -0.6850837 -0.7564073 -0.8012459 -0.8183084 -0.8140454 -0.7923256 -0.7578819 -0.7134864 -0.6597791 -12.59390 1.151990 0.9056893 0.6606050 0.4233115 0.1939952 -2.5214842E-02 -0.2336132 -0.4231915 -0.5890306 -0.7276281 -0.8310211 -0.9028657 -0.9394773 -0.9431478 -0.9196727 -0.8749629 -0.8142039 -0.7403552 -0.6550435 -12.59390 1.147615 0.8740821 0.6034048 0.3453125 9.5616415E-02 -0.1488161 -0.3798051 -0.5901541 -0.7736039 -0.9191045 -1.029731 -1.103866 -1.134697 -1.128046 -1.087959 -1.022030 -0.9364363 -0.8338296 -0.7174550 -12.59390 1.064690 0.7762778 0.4938018 0.2185126 -5.0346419E-02 -0.3098252 -0.5590048 -0.7880878 -0.9856834 -1.145918 -1.265979 -1.341640 -1.372028 -1.357931 -1.304800 -1.219977 -1.111347 -0.9809848 -0.8341126 -12.59390 0.9190149 0.6258459 0.3354892 4.9581356E-02 -0.2316439 -0.5030518 -0.7644821 -1.003915 -1.214163 -1.390608 -1.523270 -1.603241 -1.636267 -1.618719 -1.556937 -1.457125 -1.326855 -1.170023 -0.9933423 -12.59390 0.7204319 0.4248024 0.1326840 -0.1559988 -0.4429803 -0.7227533 -0.9879600 -1.232550 -1.454785 -1.643417 -1.783912 -1.876962 -1.914891 -1.899048 -1.832011 -1.721692 -1.572205 -1.390467 -1.184902 -12.59390 0.4689637 0.1800995 -0.1117507 -0.3979175 -0.6830186 -0.9592737 -1.227023 -1.476927 -1.704331 -1.896596 -2.048710 -2.153429 -2.202498 -2.194290 -2.128213 -2.012138 -1.846903 -1.642452 -1.409330 -12.59390 0.1703556 -0.1082441 -0.3938272 -0.6721696 -0.9457765 -1.216746 -1.482784 -1.732439 -1.954988 -2.152240 -2.312929 -2.428221 -2.494891 -2.498515 -2.443388 -2.325814 -2.149738 -1.925936 -1.667262 -12.59390 -0.1749660 -0.4368654 -0.7071366 -0.9732502 -1.236320 -1.496632 -1.751149 -1.990411 -2.210567 -2.407728 -2.572238 -2.700667 -2.783733 -2.807989 -2.768774 -2.656596 -2.475492 -2.237087 -1.955721 -12.59390 -0.5629272 -0.8018698 -1.054062 -1.304905 -1.550560 -1.791146 -2.029074 -2.258822 -2.470535 -2.661992 -2.831290 -2.968231 -3.065971 -3.117887 -3.095925 -2.996763 -2.817823 -2.570789 -2.270530 -12.59390 -0.9943093 -1.206317 -1.432584 -1.659733 -1.883526 -2.104790 -2.323844 -2.536262 -2.737450 -2.925095 -3.091157 -3.231842 -3.348232 -3.417615 -3.415856 -3.332957 -3.164112 -2.915073 -2.600437 -12.59390 -1.466046 -1.645458 -1.842700 -2.044210 -2.243549 -2.439825 -2.637604 -2.834578 -3.024170 -3.200593 -3.363616 -3.509823 -3.630848 -3.714231 -3.735439 -3.673581 -3.524761 -3.286067 -2.962402 -12.59390 -1.987004 -2.129243 -2.292807 -2.462617 -2.637013 -2.810648 -2.987083 -3.162011 -3.334772 -3.502962 -3.658236 -3.795458 -3.913565 -4.003356 -4.039801 -4.000775 -3.876259 -3.657523 -3.329182 -12.59390 -2.568222 -2.673343 -2.802879 -2.941060 -3.084945 -3.230773 -3.381523 -3.535258 -3.687804 -3.836021 -3.975843 -4.101563 -4.209023 -4.295758 -4.344683 -4.327270 -4.235143 -4.039577 -3.711973 -12.59390 -3.246817 -3.310545 -3.397815 -3.498239 -3.607758 -3.721768 -3.840878 -3.964592 -4.090964 -4.215420 -4.334227 -4.442231 -4.535696 -4.614791 -4.669584 -4.681351 -4.620988 -4.441617 -4.121486 -12.59390 -4.072163 -4.090378 -4.131147 -4.186440 -4.253524 -4.330533 -4.412938 -4.501091 -4.593532 -4.684321 -4.777644 -4.866317 -4.943636 -5.022683 -5.088993 -5.113830 -5.054112 -4.899889 -4.573838 -12.59390 -5.290649 -5.252069 -5.235819 -5.235446 -5.244504 -5.269012 -5.307322 -5.352251 -5.402939 -5.458083 -5.518264 -5.584764 -5.642363 -5.692657 -5.747373 -5.764150 -5.707618 -5.526186 -5.143504 -12.59390 -21.71894 -21.46864 -21.18055 -20.85716 -20.50222 -20.11813 -19.70725 -19.27160 -18.81299 -18.33297 -17.83292 -17.31405 -16.77745 -16.22405 -15.65473 -15.07025 -14.47132 -13.85857 -13.23258 -12.59390 0.7685952 0.6611645 0.5401643 0.4033479 0.2584224 0.1103320 -3.7453949E-02 -0.1820663 -0.3150353 -0.4368446 -0.5461658 -0.6389210 -0.7137623 -0.7722909 -0.8156649 -0.8465649 -0.8682306 -0.8843648 -0.8954098 -14.32395 1.207856 1.038855 0.8615138 0.6755762 0.4877560 0.3012064 0.1194615 -5.0100233E-02 -0.2010435 -0.3355875 -0.4475457 -0.5343766 -0.5937414 -0.6307820 -0.6460539 -0.6450399 -0.6318448 -0.6106022 -0.5821838 -14.32395 1.470507 1.235341 1.002657 0.7681584 0.5391858 0.3178440 0.1092165 -7.9667099E-02 -0.2496686 -0.3949857 -0.5092931 -0.5892900 -0.6351476 -0.6508965 -0.6392730 -0.6074095 -0.5606238 -0.5034032 -0.4367991 -14.32395 1.586934 1.303311 1.025155 0.7559465 0.4913201 0.2373957 3.7867760E-03 -0.2100776 -0.3973050 -0.5536631 -0.6752556 -0.7526503 -0.7899373 -0.7876428 -0.7527304 -0.6922316 -0.6132758 -0.5209733 -0.4169458 -14.32395 1.590744 1.276005 0.9694864 0.6702701 0.3822321 0.1060625 -0.1552998 -0.3950220 -0.6029326 -0.7726051 -0.8999593 -0.9816377 -1.014273 -0.9976401 -0.9420605 -0.8551999 -0.7456051 -0.6188523 -0.4778766 -14.32395 1.506456 1.175226 0.8504554 0.5330973 0.2293583 -6.6675887E-02 -0.3498275 -0.6103583 -0.8391719 -1.026928 -1.164576 -1.254165 -1.285430 -1.260649 -1.187560 -1.077286 -0.9389694 -0.7787432 -0.6013026 -14.32395 1.351171 1.011277 0.6796117 0.3574243 3.8079053E-02 -0.2741562 -0.5706220 -0.8460292 -1.092340 -1.293327 -1.450804 -1.551840 -1.585578 -1.557735 -1.472579 -1.341833 -1.177315 -0.9847929 -0.7714940 -14.32395 1.133427 0.7958979 0.4650654 0.1375020 -0.1874890 -0.5079381 -0.8141240 -1.098588 -1.352687 -1.571811 -1.746503 -1.860511 -1.906257 -1.880768 -1.790236 -1.644354 -1.456496 -1.233534 -0.9852592 -14.32395 0.8622440 0.5329229 0.2023996 -0.1225840 -0.4458520 -0.7660844 -1.075547 -1.359276 -1.623071 -1.855119 -2.039780 -2.170881 -2.233234 -2.217366 -2.128699 -1.975244 -1.767624 -1.516609 -1.234676 -14.32395 0.5361498 0.2197228 -0.1028829 -0.4205387 -0.7357118 -1.046608 -1.348280 -1.635130 -1.901102 -2.134581 -2.327492 -2.473835 -2.554600 -2.556987 -2.476773 -2.324140 -2.101906 -1.825994 -1.512160 -14.32395 0.1563490 -0.1405501 -0.4474565 -0.7523859 -1.050408 -1.348766 -1.642965 -1.924075 -2.181359 -2.412861 -2.611607 -2.767815 -2.871109 -2.897001 -2.838968 -2.693386 -2.464253 -2.168569 -1.825704 -14.32395 -0.2715927 -0.5438242 -0.8268831 -1.112887 -1.396043 -1.678223 -1.955333 -2.218259 -2.467747 -2.693683 -2.889621 -3.055070 -3.176717 -3.231625 -3.202932 -3.073817 -2.846800 -2.538686 -2.170943 -14.32395 -0.7446774 -0.9876566 -1.246133 -1.509213 -1.769503 -2.026270 -2.280967 -2.527569 -2.761633 -2.976892 -3.171157 -3.338029 -3.472383 -3.560163 -3.560298 -3.456697 -3.242085 -2.930821 -2.543867 -14.32395 -1.268570 -1.477323 -1.702657 -1.934976 -2.168127 -2.399524 -2.628664 -2.851680 -3.069745 -3.276317 -3.459898 -3.625914 -3.773148 -3.877762 -3.907126 -3.831699 -3.642001 -3.338730 -2.940229 -14.32395 -1.844251 -2.012645 -2.201765 -2.398787 -2.600195 -2.802153 -3.007063 -3.208952 -3.405262 -3.595187 -3.773939 -3.935598 -4.077343 -4.191435 -4.242975 -4.200354 -4.045351 -3.767519 -3.364279 -14.32395 -2.486511 -2.609107 -2.756580 -2.917047 -3.085433 -3.258669 -3.433955 -3.608790 -3.784646 -3.958076 -4.118954 -4.265223 -4.396174 -4.505365 -4.571227 -4.557894 -4.441724 -4.201625 -3.801646 -14.32395 -3.228368 -3.305724 -3.405981 -3.522182 -3.650670 -3.789890 -3.934192 -4.076690 -4.221410 -4.368936 -4.508732 -4.633762 -4.745030 -4.843914 -4.916340 -4.928984 -4.865182 -4.653583 -4.264999 -14.32395 -4.134373 -4.157519 -4.204378 -4.266784 -4.348974 -4.444250 -4.547984 -4.653132 -4.760270 -4.871797 -4.982282 -5.084405 -5.176965 -5.259962 -5.347267 -5.388855 -5.338322 -5.158942 -4.774742 -14.32395 -5.444084 -5.400166 -5.383935 -5.381465 -5.396706 -5.433122 -5.482553 -5.539259 -5.601091 -5.669859 -5.748115 -5.827708 -5.902544 -5.965719 -6.029565 -6.073922 -6.032728 -5.847230 -5.409895 -14.32395 -25.01394 -24.72961 -24.39765 -24.02264 -23.60867 -23.15934 -22.67773 -22.16652 -21.62797 -21.06407 -20.47653 -19.86684 -19.23633 -18.58616 -17.91737 -17.23090 -16.52758 -15.80820 -15.07344 -14.32395 1.051869 0.9382229 0.8103262 0.6649708 0.5111125 0.3505592 0.1852355 2.4147684E-02 -0.1294416 -0.2687660 -0.3917142 -0.4973593 -0.5829789 -0.6478153 -0.6957951 -0.7282855 -0.7500867 -0.7650135 -0.7750129 -16.10451 1.561700 1.373749 1.181592 0.9805312 0.7768764 0.5696768 0.3676976 0.1768468 3.1811607E-03 -0.1470105 -0.2731481 -0.3692743 -0.4363724 -0.4738989 -0.4881228 -0.4827024 -0.4634478 -0.4349537 -0.3994559 -16.10451 1.868889 1.605165 1.347985 1.089908 0.8345341 0.5871337 0.3534381 0.1376415 -5.2005742E-02 -0.2153878 -0.3438084 -0.4328559 -0.4815664 -0.4942517 -0.4760021 -0.4343922 -0.3757491 -0.3053932 -0.2258156 -16.10451 2.012646 1.692741 1.383770 1.081483 0.7848966 0.4994606 0.2327351 -6.4010010E-03 -0.2133659 -0.3907848 -0.5265900 -0.6141806 -0.6500028 -0.6419876 -0.5946853 -0.5187126 -0.4219494 -0.3106854 -0.1876856 -16.10451 2.028068 1.672923 1.328719 0.9924979 0.6676788 0.3527692 5.9026107E-02 -0.2056884 -0.4384760 -0.6311992 -0.7789406 -0.8691856 -0.9000499 -0.8751929 -0.8029727 -0.6950461 -0.5616020 -0.4101620 -0.2441661 -16.10451 1.944060 1.567138 1.204258 0.8473184 0.4996542 0.1654010 -0.1463032 -0.4371799 -0.6929431 -0.9081967 -1.073140 -1.171844 -1.205056 -1.168651 -1.075971 -0.9393629 -0.7712767 -0.5804005 -0.3718264 -16.10451 1.777554 1.394580 1.021922 0.6554890 0.2961430 -5.1317148E-02 -0.3812568 -0.6892306 -0.9647776 -1.201443 -1.384886 -1.502433 -1.542553 -1.503135 -1.395260 -1.234054 -1.033795 -0.8046932 -0.5540382 -16.10451 1.544110 1.162818 0.7878396 0.4218929 5.9892382E-02 -0.2978352 -0.6381361 -0.9565360 -1.248936 -1.498691 -1.704211 -1.845938 -1.897829 -1.864737 -1.749389 -1.568775 -1.340178 -1.074595 -0.7826327 -16.10451 1.248217 0.8769063 0.5096459 0.1467009 -0.2141850 -0.5707738 -0.9147735 -1.240092 -1.536597 -1.800053 -2.023815 -2.184804 -2.261796 -2.241659 -2.129389 -1.937025 -1.685024 -1.385559 -1.053509 -16.10451 0.8944953 0.5421545 0.1847377 -0.1699536 -0.5220972 -0.8723158 -1.212611 -1.533484 -1.833704 -2.104549 -2.335493 -2.514685 -2.618412 -2.621717 -2.523737 -2.331113 -2.061369 -1.731768 -1.361471 -16.10451 0.4857493 0.1560166 -0.1844347 -0.5263339 -0.8649818 -1.200820 -1.527138 -1.842985 -2.141175 -2.407248 -2.638773 -2.831057 -2.957176 -2.993297 -2.917130 -2.736982 -2.457688 -2.102912 -1.696931 -16.10451 2.4133138E-02 -0.2803709 -0.5982477 -0.9193656 -1.237072 -1.555271 -1.867124 -2.169331 -2.452208 -2.711241 -2.940641 -3.135194 -3.284202 -3.351515 -3.314808 -3.156025 -2.879200 -2.507324 -2.069882 -16.10451 -0.4912877 -0.7634686 -1.051878 -1.346885 -1.644040 -1.940879 -2.227671 -2.505858 -2.774003 -3.020635 -3.240946 -3.436778 -3.597398 -3.698148 -3.704426 -3.578398 -3.317431 -2.940084 -2.477612 -16.10451 -1.058942 -1.295768 -1.551231 -1.814770 -2.081515 -2.348807 -2.609798 -2.863383 -3.109076 -3.340817 -3.553851 -3.740149 -3.908174 -4.036060 -4.078091 -3.992408 -3.761914 -3.393198 -2.914385 -16.10451 -1.687674 -1.881486 -2.096754 -2.322195 -2.554457 -2.789842 -3.020590 -3.247207 -3.471383 -3.685703 -3.882402 -4.066515 -4.231781 -4.367505 -4.439739 -4.394182 -4.209211 -3.868526 -3.385052 -16.10451 -2.389320 -2.534508 -2.702781 -2.883652 -3.077848 -3.279879 -3.481020 -3.677266 -3.874273 -4.070069 -4.254251 -4.421144 -4.571820 -4.703339 -4.787873 -4.782732 -4.647185 -4.354084 -3.874676 -16.10451 -3.194420 -3.286313 -3.403181 -3.536167 -3.686656 -3.848688 -4.014080 -4.180061 -4.345649 -4.512094 -4.673035 -4.818124 -4.946896 -5.062461 -5.152194 -5.179163 -5.100632 -4.856112 -4.391738 -16.10451 -4.172847 -4.205261 -4.263724 -4.338034 -4.434326 -4.550127 -4.671931 -4.794909 -4.921186 -5.051081 -5.179446 -5.297847 -5.404621 -5.501348 -5.594272 -5.659455 -5.615296 -5.408982 -4.961668 -16.10451 -5.579414 -5.533422 -5.518764 -5.517901 -5.538549 -5.588777 -5.653654 -5.722644 -5.794634 -5.879901 -5.974558 -6.071271 -6.159406 -6.239669 -6.309671 -6.376999 -6.345298 -6.151781 -5.659558 -16.10451 -28.42255 -28.10360 -27.72650 -27.29741 -26.82174 -26.30420 -25.74868 -25.15851 -24.53653 -23.88514 -23.20640 -22.50212 -21.77386 -21.02301 -20.25080 -19.45835 -18.64663 -17.81655 -16.96892 -16.10451 1.329675 1.209075 1.077055 0.9248430 0.7599551 0.5872912 0.4099896 0.2327241 6.1814997E-02 -9.6612006E-02 -0.2354627 -0.3534564 -0.4490282 -0.5219615 -0.5733201 -0.6081010 -0.6301903 -0.6440856 -0.6530673 -17.93244 1.907403 1.702187 1.495817 1.277913 1.057597 0.8348691 0.6149668 0.4052596 0.2106377 3.9447606E-02 -9.8251395E-02 -0.2052940 -0.2776272 -0.3172849 -0.3295737 -0.3197553 -0.2944086 -0.2587737 -0.2161586 -17.93244 2.261726 1.967104 1.682826 1.400098 1.121902 0.8516299 0.5947137 0.3568239 0.1412315 -3.9909549E-02 -0.1813701 -0.2795431 -0.3315775 -0.3405871 -0.3157169 -0.2637328 -0.1930176 -0.1095485 -1.6815891E-02 -17.93244 2.431372 2.072080 1.730327 1.398262 1.071913 0.7561706 0.4620803 0.1959077 -3.6279116E-02 -0.2319725 -0.3830956 -0.4775247 -0.5145541 -0.4984112 -0.4393591 -0.3475134 -0.2326328 -0.1020646 4.0252108E-02 -17.93244 2.456739 2.059894 1.680193 1.308437 0.9456503 0.5985640 0.2724983 -2.2295114E-02 -0.2779938 -0.4965450 -0.6623399 -0.7637793 -0.7931790 -0.7590737 -0.6703079 -0.5414879 -0.3840519 -0.2071436 -1.5658807E-02 -17.93244 2.373869 1.954154 1.551918 1.155086 0.7681203 0.3972056 4.9712826E-02 -0.2659585 -0.5493643 -0.7955912 -0.9829167 -1.096961 -1.129830 -1.084477 -0.9710223 -0.8081151 -0.6099346 -0.3875866 -0.1472481 -17.93244 2.199684 1.771957 1.357726 0.9512612 0.5509548 0.1647830 -0.1937014 -0.5323140 -0.8385392 -1.107093 -1.323595 -1.457416 -1.503717 -1.454967 -1.324797 -1.132429 -0.8960526 -0.6293814 -0.3406187 -17.93244 1.947906 1.524648 1.108536 0.7007543 0.2983116 -8.9832395E-02 -0.4629976 -0.8148379 -1.136628 -1.424933 -1.662843 -1.828570 -1.896407 -1.854978 -1.716535 -1.501136 -1.230353 -0.9209664 -0.5844148 -17.93244 1.629128 1.218620 0.8107632 0.4099511 1.3786803E-02 -0.3773969 -0.7547164 -1.113290 -1.445556 -1.741835 -1.999946 -2.196021 -2.290645 -2.270725 -2.135536 -1.906152 -1.606892 -1.257417 -0.8741713 -17.93244 1.249061 0.8598914 0.4687193 7.6723404E-02 -0.3117108 -0.6963893 -1.069121 -1.428921 -1.760260 -2.062636 -2.332729 -2.547589 -2.676767 -2.687701 -2.570560 -2.338735 -2.019233 -1.633603 -1.205386 -17.93244 0.8141388 0.4504211 7.6203816E-02 -0.3003887 -0.6756814 -1.047404 -1.409529 -1.756999 -2.086815 -2.390022 -2.656961 -2.884088 -3.042420 -3.091980 -3.006316 -2.788647 -2.458091 -2.042038 -1.571479 -17.93244 0.3212155 -1.4688554E-02 -0.3649057 -0.7197645 -1.077757 -1.429151 -1.772122 -2.107188 -2.427780 -2.717127 -2.978878 -3.208002 -3.385138 -3.475560 -3.430025 -3.242782 -2.914405 -2.476039 -1.967034 -17.93244 -0.2303611 -0.5336612 -0.8538456 -1.179433 -1.512538 -1.843837 -2.165711 -2.477351 -2.774638 -3.053119 -3.304148 -3.526354 -3.717057 -3.836649 -3.848517 -3.702125 -3.393743 -2.946627 -2.405924 -17.93244 -0.8410960 -1.106226 -1.390489 -1.684206 -1.988361 -2.289865 -2.581125 -2.865287 -3.140580 -3.399922 -3.636164 -3.852938 -4.039188 -4.189267 -4.247837 -4.153202 -3.882527 -3.445351 -2.882980 -17.93244 -1.519176 -1.740747 -1.982495 -2.235476 -2.500749 -2.768155 -3.028104 -3.281680 -3.529455 -3.769318 -3.988906 -4.189452 -4.378290 -4.536689 -4.627219 -4.582722 -4.366928 -3.960462 -3.390255 -17.93244 -2.277753 -2.445996 -2.637094 -2.844098 -3.065705 -3.293596 -3.519758 -3.743097 -3.961065 -4.175781 -4.379312 -4.566578 -4.740423 -4.893101 -4.996463 -4.998291 -4.845627 -4.498643 -3.934208 -17.93244 -3.146220 -3.253404 -3.387699 -3.542526 -3.715034 -3.900596 -4.087598 -4.274788 -4.463358 -4.650041 -4.826694 -4.989962 -5.138780 -5.273493 -5.379675 -5.415937 -5.325716 -5.051420 -4.507463 -17.93244 -4.198093 -4.237391 -4.305416 -4.398128 -4.514480 -4.646258 -4.787214 -4.929344 -5.074809 -5.223379 -5.365703 -5.498413 -5.617476 -5.735968 -5.834697 -5.911179 -5.875421 -5.649639 -5.135982 -17.93244 -5.694696 -5.649794 -5.633610 -5.641881 -5.678638 -5.734009 -5.811284 -5.895861 -5.985201 -6.080904 -6.188279 -6.297261 -6.396790 -6.494477 -6.586602 -6.658341 -6.644196 -6.444369 -5.895909 -17.93244 -31.93673 -31.58257 -31.15884 -30.67353 -30.13370 -29.54513 -28.91272 -28.24049 -27.53184 -26.78963 -26.01629 -25.21395 -24.38442 -23.52932 -22.65009 -21.74800 -20.82421 -19.87973 -18.91552 -17.93244 1.604092 1.479422 1.339491 1.179833 1.009007 0.8231441 0.6332186 0.4420466 0.2540357 7.8766026E-02 -7.8539059E-02 -0.2099946 -0.3160721 -0.3961529 -0.4519926 -0.4889993 -0.5112047 -0.5242874 -0.5323258 -19.80499 2.250045 2.024981 1.802065 1.572115 1.334105 1.094983 0.8600064 0.6324624 0.4182371 0.2302414 7.5062640E-02 -4.0820651E-02 -0.1190622 -0.1604372 -0.1698479 -0.1554254 -0.1237695 -8.1016853E-02 -3.1262565E-02 -19.80499 2.647602 2.321118 2.012462 1.703965 1.400536 1.109658 0.8341290 0.5740095 0.3371740 0.1356578 -1.9838801E-02 -0.1256341 -0.1793803 -0.1854653 -0.1521924 -8.9548789E-02 -6.4683687E-03 9.0241060E-02 0.1963097 -19.80499 2.843079 2.445442 2.068490 1.703202 1.348271 1.007847 0.6871824 0.3974225 0.1384424 -8.0440998E-02 -0.2455575 -0.3483833 -0.3855413 -0.3621486 -0.2908103 -0.1823352 -4.8981562E-02 0.1009803 0.2628716 -19.80499 2.880597 2.438851 2.020489 1.613712 1.218319 0.8394699 0.4860527 0.1649406 -0.1237211 -0.3649151 -0.5488397 -0.6595678 -0.6901194 -0.6446143 -0.5394664 -0.3883055 -0.2062020 -3.5380053E-03 0.2138901 -19.80499 2.795375 2.331576 1.890520 1.457199 1.030836 0.6281496 0.2493399 -9.8245539E-02 -0.4106947 -0.6858464 -0.8973091 -1.026888 -1.061445 -1.005217 -0.8721178 -0.6822578 -0.4533629 -0.1988246 7.3841549E-02 -19.80499 2.613530 2.142993 1.688237 1.240655 0.8040996 0.3842056 -1.0913882E-02 -0.3764898 -0.7132201 -1.015695 -1.259885 -1.418622 -1.469645 -1.413998 -1.260917 -1.036831 -0.7637150 -0.4585298 -0.1309608 -19.80499 2.347001 1.881086 1.424390 0.9783761 0.5379782 0.1128902 -0.2909909 -0.6734120 -1.025980 -1.346990 -1.622253 -1.813088 -1.896259 -1.851268 -1.690954 -1.440044 -1.126472 -0.7722814 -0.3903613 -19.80499 2.005115 1.557148 1.111216 0.6702347 0.2349581 -0.1862261 -0.5966228 -0.9871512 -1.349072 -1.682062 -1.973322 -2.200652 -2.323908 -2.303633 -2.149257 -1.882337 -1.534424 -1.133681 -0.6983523 -19.80499 1.602742 1.177169 0.7475806 0.3193860 -0.1050498 -0.5222943 -0.9281430 -1.318516 -1.684692 -2.017279 -2.319403 -2.574903 -2.732400 -2.755318 -2.622327 -2.353657 -1.981006 -1.537791 -1.050629 -19.80499 1.140944 0.7423214 0.3353183 -7.7340610E-02 -0.4889339 -0.8936163 -1.287825 -1.671025 -2.028934 -2.361289 -2.666484 -2.927433 -3.119881 -3.188170 -3.095074 -2.841300 -2.456556 -1.976943 -1.440439 -19.80499 0.6190653 0.2500418 -0.1306386 -0.5204831 -0.9142305 -1.302143 -1.676816 -2.040788 -2.390825 -2.715965 -3.007301 -3.270833 -3.482376 -3.594920 -3.552803 -3.336678 -2.954941 -2.448290 -1.866467 -19.80499 3.3565775E-02 -0.3010652 -0.6513999 -1.012462 -1.379772 -1.742618 -2.095780 -2.440060 -2.770425 -3.073481 -3.354162 -3.609374 -3.828331 -3.977067 -3.991557 -3.830510 -3.473063 -2.953729 -2.333207 -19.80499 -0.6186686 -0.9124309 -1.224592 -1.550246 -1.887521 -2.223425 -2.548129 -2.859452 -3.163768 -3.447911 -3.708616 -3.950152 -4.170755 -4.337666 -4.411088 -4.312335 -4.001732 -3.492308 -2.843957 -19.80499 -1.342610 -1.589287 -1.858658 -2.144248 -2.440566 -2.738528 -3.028425 -3.309118 -3.583643 -3.842597 -4.085855 -4.306960 -4.518531 -4.700888 -4.808540 -4.770162 -4.526435 -4.053912 -3.393442 -19.80499 -2.155512 -2.345551 -2.561645 -2.796907 -3.046884 -3.303196 -3.554020 -3.801111 -4.045552 -4.277333 -4.496633 -4.702086 -4.897671 -5.073107 -5.197046 -5.205781 -5.042982 -4.640598 -3.988925 -19.80499 -3.087114 -3.210378 -3.362663 -3.540862 -3.738908 -3.947655 -4.157268 -4.366162 -4.575431 -4.779759 -4.972009 -5.151150 -5.319285 -5.473464 -5.595518 -5.640150 -5.548200 -5.239871 -4.614219 -19.80499 -4.207253 -4.255605 -4.336656 -4.445916 -4.582650 -4.737065 -4.896070 -5.057810 -5.223866 -5.387144 -5.542644 -5.688480 -5.823457 -5.955291 -6.072225 -6.147144 -6.125224 -5.880377 -5.300019 -19.80499 -5.782398 -5.743022 -5.734672 -5.752112 -5.799184 -5.873342 -5.960765 -6.059096 -6.168685 -6.281280 -6.392675 -6.512043 -6.625859 -6.739264 -6.850989 -6.923031 -6.927441 -6.723705 -6.119724 -19.80499 -35.54951 -35.15959 -34.68774 -34.14424 -33.53782 -32.87564 -32.16354 -31.40634 -30.60802 -29.77190 -28.90082 -27.99721 -27.06316 -26.10053 -25.11096 -24.09589 -23.05664 -21.99438 -20.91017 -19.80499 1.870529 1.744022 1.600493 1.433933 1.252285 1.058327 0.8548675 0.6477894 0.4440645 0.2490151 7.5150885E-02 -7.3126063E-02 -0.1898161 -0.2780211 -0.3388453 -0.3775325 -0.4002078 -0.4128669 -0.4200584 -21.71970 2.588126 2.345681 2.105590 1.858172 1.606553 1.352491 1.100838 0.8555819 0.6233546 0.4174803 0.2472283 0.1198774 3.6480155E-02 -5.8396761E-03 -1.2723763E-02 6.7520556E-03 4.4939633E-02 9.4699226E-02 0.1516415 -21.71970 3.030629 2.671751 2.333341 2.000899 1.674641 1.361325 1.067520 0.7875941 0.5290970 0.3097227 0.1382733 2.6262129E-02 -2.9416027E-02 -3.1334214E-02 1.1051516E-02 8.4977917E-02 0.1807997 0.2908703 0.4104432 -21.71970 3.249102 2.810717 2.399496 2.002059 1.616520 1.251269 0.9102962 0.5938147 0.3101882 6.9567233E-02 -0.1108583 -0.2204490 -0.2572731 -0.2269037 -0.1409732 -1.5354068E-02 0.1368665 0.3064678 0.4882661 -21.71970 3.296828 2.811457 2.354008 1.908908 1.480824 1.075711 0.6942920 0.3458569 2.7900739E-02 -0.2412662 -0.4419492 -0.5637461 -0.5937054 -0.5390932 -0.4160683 -0.2419891 -3.4848385E-02 0.1938051 0.4375940 -21.71970 3.211467 2.702565 2.219249 1.748225 1.289657 0.8541154 0.4455038 6.9016762E-02 -0.2779714 -0.5791610 -0.8151985 -0.9603097 -0.9993399 -0.9319718 -0.7785816 -0.5601370 -0.2999375 -1.2905789E-02 0.2926729 -21.71970 3.019570 2.505161 2.010570 1.526468 1.051608 0.5994561 0.1711969 -0.2265576 -0.5917728 -0.9245612 -1.199018 -1.381445 -1.441213 -1.378122 -1.203456 -0.9466183 -0.6360205 -0.2916634 7.5428508E-02 -21.71970 2.737776 2.232714 1.737307 1.249395 0.7734305 0.3142477 -0.1257737 -0.5351533 -0.9169128 -1.270091 -1.576594 -1.801467 -1.899308 -1.855078 -1.672267 -1.384908 -1.027951 -0.6280429 -0.1999069 -21.71970 2.379306 1.891693 1.406984 0.9265838 0.4542122 -3.3476893E-03 -0.4425907 -0.8627745 -1.254804 -1.616728 -1.945794 -2.204481 -2.354246 -2.342175 -2.170664 -1.865088 -1.468187 -1.015304 -0.5269636 -21.71970 1.953141 1.491110 1.024478 0.5562810 9.4371259E-02 -0.3527812 -0.7900926 -1.211071 -1.604217 -1.970798 -2.303334 -2.593266 -2.788009 -2.824412 -2.682509 -2.376289 -1.949633 -1.447799 -0.9006616 -21.71970 1.466037 1.031336 0.5888551 0.1417972 -0.3064863 -0.7432278 -1.168458 -1.580822 -1.970474 -2.327593 -2.664174 -2.967879 -3.190876 -3.283547 -3.189472 -2.903044 -2.462057 -1.917774 -1.314192 -21.71970 0.9143988 0.5134505 9.9380381E-02 -0.3246778 -0.7535406 -1.172899 -1.580883 -1.975294 -2.349431 -2.700852 -3.028156 -3.324652 -3.571288 -3.710921 -3.679794 -3.437761 -3.001935 -2.425689 -1.769666 -21.71970 0.2963339 -6.7217290E-02 -0.4492887 -0.8436576 -1.246852 -1.642122 -2.023849 -2.397143 -2.755984 -3.087805 -3.392381 -3.680805 -3.931570 -4.108265 -4.137649 -3.964885 -3.558117 -2.965713 -2.263810 -21.71970 -0.3931541 -0.7145182 -1.057409 -1.414835 -1.784904 -2.151077 -2.506853 -2.851870 -3.179147 -3.487646 -3.773575 -4.040428 -4.288526 -4.481260 -4.573216 -4.475783 -4.126881 -3.543197 -2.806576 -21.71970 -1.160947 -1.432800 -1.728731 -2.045962 -2.378029 -2.705444 -3.022282 -3.332664 -3.631356 -3.911798 -4.173990 -4.421553 -4.651195 -4.855347 -4.985131 -4.959676 -4.691247 -4.150922 -3.397506 -21.71970 -2.026420 -2.237258 -2.478321 -2.742979 -3.023996 -3.307895 -3.584856 -3.856783 -4.122771 -4.375830 -4.610272 -4.834901 -5.051643 -5.244776 -5.387909 -5.413066 -5.237772 -4.775350 -4.030568 -21.71970 -3.015153 -3.154905 -3.330872 -3.532403 -3.755804 -3.989580 -4.220322 -4.451935 -4.683637 -4.905471 -5.113797 -5.311946 -5.500854 -5.669634 -5.804282 -5.867273 -5.775125 -5.426773 -4.713080 -21.71970 -4.203062 -4.260252 -4.359384 -4.487689 -4.645260 -4.818091 -4.995202 -5.181621 -5.368511 -5.551677 -5.720383 -5.880689 -6.037405 -6.178921 -6.303919 -6.384890 -6.373755 -6.115906 -5.457075 -21.71970 -5.869330 -5.824023 -5.827067 -5.859164 -5.924024 -6.010290 -6.108767 -6.226277 -6.351480 -6.485276 -6.612090 -6.733895 -6.869698 -6.996579 -7.113461 -7.201450 -7.207699 -7.003835 -6.341340 -21.71970 -39.25483 -38.82856 -38.30743 -37.70354 -37.02829 -36.29001 -35.49563 -34.65074 -33.75994 -32.82704 -31.85529 -30.84742 -29.80584 -28.73263 -27.62988 -26.49874 -25.34067 -24.15749 -22.95014 -21.71970 2.124056 1.996685 1.853360 1.684422 1.495065 1.288644 1.073388 0.8490689 0.6263021 0.4121465 0.2185571 5.3340472E-02 -7.8339398E-02 -0.1760120 -0.2424504 -0.2835181 -0.3071024 -0.3196110 -0.3262057 -23.67435 2.916329 2.658820 2.403530 2.142226 1.872984 1.605080 1.336752 1.071551 0.8218170 0.5964370 0.4105907 0.2700319 0.1797956 0.1356290 0.1310240 0.1559842 0.2003691 0.2570417 0.3211528 -23.67435 3.408471 3.017132 2.651515 2.290799 1.942060 1.608831 1.294084 0.9931922 0.7148748 0.4770950 0.2919371 0.1697276 0.1119723 0.1142674 0.1656616 0.2512583 0.3599647 0.4834302 0.6166785 -23.67435 3.651250 3.173130 2.723403 2.293210 1.879980 1.488635 1.126071 0.7851650 0.4771588 0.2171399 1.9809270E-02 -9.7194038E-02 -0.1348378 -9.5904939E-02 4.9342765E-03 0.1482468 0.3196956 0.5092312 0.7112322 -23.67435 3.708207 3.177171 2.680369 2.198249 1.737036 1.304409 0.8996721 0.5217137 0.1777419 -0.1155722 -0.3369745 -0.4677408 -0.4992715 -0.4348849 -0.2914072 -9.3749739E-02 0.1389372 0.3940392 0.6646498 -23.67435 3.620944 3.067381 2.542185 2.031014 1.540036 1.075466 0.6371136 0.2329824 -0.1432175 -0.4747964 -0.7347550 -0.8968490 -0.9404089 -0.8640415 -0.6879889 -0.4405031 -0.1484653 0.1715785 0.5106471 -23.67435 3.419678 2.861754 2.325023 1.802971 1.295324 0.8088679 0.3505807 -7.5683169E-02 -0.4720186 -0.8330466 -1.138201 -1.345918 -1.419701 -1.348855 -1.151719 -0.8609305 -0.5122136 -0.1281924 0.2791217 -23.67435 3.122652 2.576878 2.043001 1.517165 1.002999 0.5117642 4.0387902E-02 -0.4001296 -0.8078376 -1.190246 -1.530966 -1.787790 -1.905922 -1.863163 -1.659630 -1.335484 -0.9343582 -0.4878947 -1.2711992E-02 -23.67435 2.747722 2.221893 1.698853 1.177011 0.6697319 0.1790808 -0.2935711 -0.7394406 -1.158287 -1.551332 -1.912719 -2.209231 -2.383827 -2.387231 -2.198920 -1.854878 -1.408456 -0.9023443 -0.3600391 -23.67435 2.301097 1.799725 1.297607 0.7905865 0.2925352 -0.1891209 -0.6537567 -1.102543 -1.522982 -1.916780 -2.288075 -2.608301 -2.837728 -2.896045 -2.748900 -2.405491 -1.924706 -1.363090 -0.7549440 -23.67435 1.787953 1.317589 0.8401279 0.3549698 -0.1260545 -0.5955659 -1.050488 -1.491119 -1.905832 -2.293550 -2.657003 -2.995050 -3.256269 -3.378386 -3.289107 -2.972501 -2.473984 -1.863633 -1.191788 -23.67435 1.208776 0.7738923 0.3271705 -0.1315900 -0.5945147 -1.045876 -1.483492 -1.908927 -2.308042 -2.682410 -3.038068 -3.370968 -3.648942 -3.822372 -3.805629 -3.541917 -3.051167 -2.403191 -1.671523 -23.67435 0.5597996 0.1652076 -0.2471093 -0.6762412 -1.112658 -1.540645 -1.954768 -2.354460 -2.736194 -3.095444 -3.427709 -3.745935 -4.026605 -4.230824 -4.286700 -4.103511 -3.648422 -2.980768 -2.195953 -23.67435 -0.1661548 -0.5155205 -0.8869278 -1.280171 -1.682475 -2.079009 -2.463385 -2.837984 -3.193144 -3.521421 -3.834107 -4.131698 -4.399613 -4.619435 -4.730375 -4.639577 -4.254277 -3.594235 -2.767630 -23.67435 -0.9775850 -1.272300 -1.596446 -1.944746 -2.308542 -2.669353 -3.014699 -3.350671 -3.675604 -3.977365 -4.260539 -4.534999 -4.785446 -5.002413 -5.154154 -5.142239 -4.854079 -4.243306 -3.394331 -23.67435 -1.889303 -2.122597 -2.391243 -2.684002 -2.995875 -3.307309 -3.610571 -3.909304 -4.200236 -4.470929 -4.726305 -4.971525 -5.202831 -5.409753 -5.568670 -5.611397 -5.430576 -4.912234 -4.069458 -23.67435 -2.938189 -3.093026 -3.292404 -3.520676 -3.773572 -4.026205 -4.282575 -4.539694 -4.793445 -5.031924 -5.254796 -5.474166 -5.675494 -5.857164 -6.002565 -6.077297 -5.993388 -5.608464 -4.803071 -23.67435 -4.199424 -4.261025 -4.375734 -4.526654 -4.708240 -4.897666 -5.098476 -5.305915 -5.514608 -5.711527 -5.895006 -6.073860 -6.240391 -6.389163 -6.521588 -6.612249 -6.610501 -6.346260 -5.607636 -23.67435 -5.948972 -5.895497 -5.904561 -5.952455 -6.039931 -6.139836 -6.258241 -6.393191 -6.535486 -6.681321 -6.821037 -6.956296 -7.100832 -7.234769 -7.359736 -7.457173 -7.471040 -7.276858 -6.558053 -23.67435 -43.04728 -42.58411 -42.01183 -41.34618 -40.59994 -39.78324 -38.90411 -37.96897 -36.98306 -35.95070 -34.87553 -33.76064 -32.60872 -31.42209 -30.20281 -28.95271 -27.67342 -26.36640 -25.03298 -23.67435 2.369241 2.238895 2.097131 1.929418 1.735085 1.520690 1.289789 1.050963 0.8061252 0.5742521 0.3579735 0.1730532 2.5305079E-02 -8.2035691E-02 -0.1544805 -0.1985502 -0.2231717 -0.2356292 -0.2417887 -25.66696 3.234505 2.961396 2.693817 2.418585 2.137444 1.852846 1.567023 1.282458 1.012871 0.7690396 0.5624687 0.4070278 0.3077753 0.2616961 0.2592782 0.2889850 0.3395659 0.4030803 0.4743080 -25.66696 3.778283 3.356190 2.962392 2.577672 2.204107 1.850617 1.515623 1.191496 0.8963668 0.6372962 0.4361793 0.3019563 0.2416787 0.2485219 0.3090749 0.4066816 0.5282803 0.6652249 0.8122714 -25.66696 4.048409 3.528996 3.043970 2.578000 2.136582 1.721776 1.333387 0.9707640 0.6397844 0.3556928 0.1422020 1.3247097E-02 -2.4752464E-02 2.3055583E-02 0.1386689 0.2999802 0.4909104 0.7004986 0.9229851 -25.66696 4.113782 3.539402 2.999655 2.480946 1.988752 1.526080 1.098781 0.6956021 0.3216442 2.9546437E-03 -0.2394203 -0.3824440 -0.4164117 -0.3404033 -0.1772740 4.4258770E-02 0.3029062 0.5847718 0.8825886 -25.66696 4.025189 3.425235 2.858958 2.308798 1.783520 1.289950 0.8273350 0.3916185 -1.2223318E-02 -0.3722211 -0.6589054 -0.8374074 -0.8872952 -0.8008996 -0.6007606 -0.3236539 8.0207596E-04 0.3543710 0.7274504 -25.66696 3.813319 3.212833 2.634265 2.071658 1.532188 1.016404 0.5251920 7.0865072E-02 -0.3534845 -0.7463319 -1.079455 -1.312745 -1.400629 -1.325229 -1.104512 -0.7793925 -0.3919849 3.2352235E-02 0.4805271 -25.66696 3.503003 2.915551 2.340827 1.777848 1.230995 0.7029933 0.2017695 -0.2670545 -0.7046049 -1.113654 -1.485988 -1.772876 -1.917300 -1.876951 -1.653990 -1.291902 -0.8460059 -0.3523460 0.1706235 -25.66696 3.110206 2.545447 1.985577 1.425177 0.8793346 0.3564391 -0.1470607 -0.6223729 -1.063307 -1.485203 -1.879054 -2.209598 -2.414582 -2.434884 -2.234220 -1.852745 -1.356088 -0.7957698 -0.1986750 -25.66696 2.645178 2.106097 1.564783 1.020138 0.4861445 -2.8606759E-02 -0.5249466 -0.9970698 -1.442411 -1.862389 -2.264645 -2.617705 -2.879695 -2.968299 -2.817400 -2.437977 -1.902099 -1.279478 -0.6093405 -25.66696 2.106438 1.599975 1.086673 0.5650520 4.7259890E-02 -0.4514903 -0.9373944 -1.403554 -1.841987 -2.255045 -2.650428 -3.015060 -3.314458 -3.466854 -3.391274 -3.046518 -2.491122 -1.813305 -1.072261 -25.66696 1.499746 1.032103 0.5503027 5.7039794E-02 -0.4389758 -0.9220505 -1.390821 -1.841195 -2.266552 -2.663992 -3.048869 -3.411340 -3.716561 -3.924734 -3.931456 -3.654934 -3.108963 -2.388047 -1.579781 -25.66696 0.8200579 0.3961164 -4.8175577E-02 -0.5118539 -0.9813973 -1.439652 -1.884895 -2.313066 -2.716205 -3.097871 -3.465496 -3.803876 -4.110085 -4.344387 -4.429986 -4.245448 -3.745129 -3.000806 -2.131949 -25.66696 5.9256341E-02 -0.3158662 -0.7177861 -1.143716 -1.580318 -2.005704 -2.419057 -2.821467 -3.203387 -3.554728 -3.891463 -4.212427 -4.500497 -4.745122 -4.882159 -4.805175 -4.387253 -3.650630 -2.732875 -25.66696 -0.7905877 -1.110405 -1.463198 -1.842369 -2.237846 -2.625600 -3.005640 -3.368798 -3.716453 -4.038929 -4.346466 -4.639533 -4.907069 -5.140506 -5.315343 -5.324508 -5.020882 -4.338294 -3.392125 -25.66696 -1.749727 -2.003325 -2.299189 -2.625266 -2.966643 -3.303137 -3.637363 -3.960323 -4.273985 -4.561749 -4.836488 -5.102849 -5.342415 -5.565091 -5.742465 -5.807591 -5.625094 -5.050417 -4.108132 -25.66696 -2.856602 -3.026538 -3.248505 -3.505182 -3.783499 -4.064723 -4.346536 -4.625828 -4.898259 -5.151567 -5.390162 -5.629357 -5.840571 -6.033825 -6.191802 -6.283024 -6.209473 -5.788608 -4.891328 -25.66696 -4.184867 -4.252334 -4.383451 -4.557998 -4.760723 -4.975852 -5.200507 -5.427506 -5.652186 -5.864541 -6.062714 -6.260191 -6.432410 -6.592098 -6.728274 -6.832655 -6.839325 -6.566684 -5.748420 -25.66696 -6.011332 -5.960833 -5.971835 -6.038962 -6.137723 -6.260737 -6.401898 -6.554676 -6.714130 -6.868774 -7.023024 -7.176640 -7.319798 -7.462007 -7.590684 -7.698977 -7.722482 -7.538504 -6.764635 -25.66696 -46.92209 -46.42147 -45.79694 -45.06773 -44.24822 -43.35088 -42.38468 -41.35689 -40.27340 -39.13905 -37.95813 -36.73337 -35.46846 -34.16576 -32.82753 -31.45578 -30.05256 -28.61874 -27.15651 -25.66696 2.606015 2.475552 2.333580 2.167923 1.973659 1.752905 1.508721 1.251134 0.9895720 0.7337825 0.4958031 0.2894658 0.1248789 6.2214513E-03 -7.2694130E-02 -0.1199357 -0.1456609 -0.1581568 -0.1639582 -27.69572 3.546932 3.254984 2.975282 2.690264 2.397079 2.099897 1.793744 1.491731 1.202043 0.9370949 0.7091616 0.5373074 0.4284255 0.3801971 0.3797356 0.4142909 0.4711115 0.5415173 0.6198949 -27.69572 4.140084 3.686538 3.267074 2.857356 2.463469 2.088615 1.730885 1.388018 1.071191 0.7923415 0.5720675 0.4245938 0.3602712 0.3721458 0.4418388 0.5512960 0.6859306 0.8364602 0.9974441 -27.69572 4.438705 3.879424 3.358075 2.859882 2.388930 1.949341 1.538665 1.150944 0.7976790 0.4913524 0.2597548 0.1177360 7.9854116E-02 0.1371644 0.2680811 0.4481069 0.6587440 0.8886425 1.131909 -27.69572 4.515312 3.895401 3.315378 2.758474 2.234633 1.745684 1.292228 0.8633710 0.4636837 0.1187174 -0.1452764 -0.3048994 -0.3390160 -0.2515222 -6.8334982E-02 0.1777581 0.4628508 0.7717763 1.097242 -27.69572 4.423520 3.779157 3.169267 2.580754 2.023546 1.499040 1.009685 0.5486570 0.1161552 -0.2732230 -0.5873756 -0.7854010 -0.8427483 -0.7459583 -0.5225636 -0.2155034 0.1419901 0.5294877 0.9371148 -27.69572 4.202323 3.557125 2.937271 2.336520 1.762559 1.215794 0.6970895 0.2139324 -0.2377968 -0.6598802 -1.022644 -1.279746 -1.384156 -1.305064 -1.059176 -0.6990504 -0.2720619 0.1931494 0.6828622 -27.69572 3.878354 3.248590 2.634169 2.030863 1.450842 0.8920901 0.3587840 -0.1361220 -0.6000884 -1.041292 -1.439811 -1.757733 -1.929564 -1.896415 -1.654847 -1.254945 -0.7634049 -0.2219593 0.3495490 -27.69572 3.469020 2.863633 2.264148 1.666931 1.086523 0.5289635 -4.5964094E-03 -0.5052284 -0.9734424 -1.420015 -1.841761 -2.202510 -2.443611 -2.481668 -2.272250 -1.852737 -1.304645 -0.6893743 -3.6594316E-02 -27.69572 2.983457 2.406318 1.827597 1.244660 0.6758041 0.1275515 -0.3994771 -0.8970746 -1.364232 -1.810506 -2.238931 -2.623765 -2.916938 -3.038347 -2.890554 -2.478169 -1.886581 -1.201836 -0.4688023 -27.69572 2.421384 1.879293 1.328369 0.7702662 0.2176597 -0.3153436 -0.8285320 -1.319486 -1.780133 -2.218870 -2.643750 -3.029596 -3.360356 -3.551805 -3.495343 -3.126852 -2.513743 -1.767509 -0.9562476 -27.69572 1.786624 1.286454 0.7700959 0.2395532 -0.2893580 -0.8025314 -1.300302 -1.776945 -2.223482 -2.648661 -3.057620 -3.439010 -3.778034 -4.020498 -4.057593 -3.772622 -3.170416 -2.375381 -1.489410 -27.69572 1.076952 0.6226754 0.1473520 -0.3506818 -0.8526717 -1.341031 -1.815113 -2.273368 -2.698346 -3.099882 -3.494366 -3.854403 -4.184658 -4.452364 -4.569180 -4.391815 -3.846804 -3.024524 -2.070481 -27.69572 0.2842333 -0.1181056 -0.5497262 -1.009634 -1.477070 -1.934192 -2.377695 -2.806526 -3.207861 -3.584216 -3.947560 -4.283886 -4.596811 -4.863672 -5.033020 -4.972150 -4.527175 -3.712617 -2.702571 -27.69572 -0.6045249 -0.9473993 -1.329634 -1.742612 -2.166823 -2.585098 -2.993469 -3.387048 -3.752000 -4.093667 -4.428435 -4.736938 -5.024230 -5.278753 -5.470434 -5.504175 -5.191870 -4.436739 -3.391718 -27.69572 -1.609729 -1.880991 -2.203518 -2.561887 -2.934303 -3.301141 -3.661939 -4.010983 -4.339540 -4.649368 -4.947948 -5.229699 -5.482727 -5.719663 -5.910052 -5.999403 -5.822024 -5.192548 -4.148991 -27.69572 -2.768011 -2.952603 -3.198960 -3.485827 -3.789529 -4.099509 -4.409623 -4.711091 -4.998799 -5.272453 -5.534612 -5.783106 -6.008338 -6.210013 -6.379702 -6.485168 -6.424821 -5.971165 -4.978134 -27.69572 -4.162488 -4.239893 -4.387116 -4.586547 -4.810070 -5.052460 -5.302839 -5.549536 -5.790882 -6.020702 -6.241702 -6.450541 -6.631420 -6.793152 -6.940763 -7.050477 -7.069416 -6.791399 -5.888176 -27.69572 -6.076180 -6.023578 -6.043727 -6.126572 -6.240577 -6.388184 -6.553415 -6.722203 -6.896791 -7.070714 -7.238039 -7.406962 -7.554653 -7.699526 -7.836652 -7.946419 -7.986722 -7.811159 -6.972429 -27.69572 -50.87498 -50.33635 -49.65826 -48.86329 -47.96903 -46.98896 -45.93349 -44.81077 -43.62736 -42.38863 -41.09906 -39.76246 -38.38210 -36.96083 -35.50113 -34.00520 -32.47503 -30.91235 -29.31877 -27.69572 2.838805 2.705044 2.565522 2.400527 2.206973 1.982346 1.730729 1.454387 1.176011 0.8963655 0.6353339 0.4069876 0.2254733 9.4436124E-02 9.4815185E-03 -4.0984452E-02 -6.7785069E-02 -8.0362774E-02 -8.5860260E-02 -29.75901 3.853011 3.543430 3.248853 2.952844 2.650313 2.343916 2.020682 1.699338 1.390940 1.100669 0.8528751 0.6628423 0.5444344 0.4926353 0.4942409 0.5337477 0.5968499 0.6742569 0.7598365 -29.75901 4.496203 4.008480 3.562001 3.129653 2.717841 2.323722 1.942737 1.582428 1.240608 0.9428315 0.7013053 0.5394639 0.4706893 0.4867013 0.5656280 0.6871179 0.8348687 0.9991866 1.174269 -29.75901 4.821689 4.221116 3.665215 3.135997 2.638095 2.173194 1.740553 1.327437 0.9487889 0.6239433 0.3689552 0.2134168 0.1735170 0.2401151 0.3863180 0.5850327 0.8155422 1.066028 1.330334 -29.75901 4.909977 4.245476 3.625492 3.032598 2.475653 1.961733 1.481668 1.024192 0.6031336 0.2303849 -5.7182930E-02 -0.2345590 -0.2713746 -0.1732734 3.0055974E-02 0.3013735 0.6130207 0.9493814 1.302878 -29.75901 4.817173 4.127008 3.474950 2.847460 2.259776 1.704151 1.184247 0.7020664 0.2428038 -0.1765863 -0.5175048 -0.7410725 -0.8076534 -0.7025849 -0.4565657 -0.1190273 0.2718211 0.6936241 1.136308 -29.75901 4.586572 3.896865 3.234156 2.597143 1.987997 1.406805 0.8646352 0.3576208 -0.1245005 -0.5742453 -0.9664422 -1.250755 -1.373587 -1.291470 -1.022178 -0.6264630 -0.1593039 0.3473188 0.8791751 -29.75901 4.248151 3.576617 2.922271 2.278973 1.662133 1.075656 0.5161913 -7.2585884E-03 -0.4964291 -0.9667262 -1.391565 -1.739959 -1.939227 -1.918420 -1.658397 -1.220127 -0.6822644 -9.2367135E-02 0.5284423 -29.75901 3.824228 3.176679 2.536232 1.900912 1.289139 0.6996798 0.1351490 -0.3905630 -0.8838494 -1.357977 -1.802798 -2.192768 -2.467415 -2.530288 -2.315372 -1.856646 -1.256336 -0.5854788 0.1238427 -29.75901 3.316183 2.700197 2.084945 1.466380 0.8609974 0.2801154 -0.2768276 -0.7996422 -1.289102 -1.763760 -2.212103 -2.621748 -2.949308 -3.107495 -2.969525 -2.525563 -1.877565 -1.130099 -0.3331890 -29.75901 2.731981 2.155574 1.567589 0.9705290 0.3842753 -0.1814143 -0.7255741 -1.238032 -1.721241 -2.187508 -2.628587 -3.039994 -3.399093 -3.634999 -3.600140 -3.212890 -2.542301 -1.726658 -0.8440264 -29.75901 2.070070 1.536434 0.9865547 0.4193089 -0.1433526 -0.6870382 -1.213633 -1.715614 -2.183127 -2.633045 -3.060870 -3.462542 -3.832303 -4.107605 -4.181138 -3.892794 -3.236795 -2.366733 -1.401827 -29.75901 1.330621 0.8476869 0.3384267 -0.1934611 -0.7259967 -1.246552 -1.749969 -2.231942 -2.679688 -3.103322 -3.516555 -3.901267 -4.253333 -4.549908 -4.703622 -4.541461 -3.952139 -3.051556 -2.010909 -29.75901 0.5064481 7.8749940E-02 -0.3854935 -0.8781628 -1.376216 -1.865067 -2.338458 -2.788492 -3.211159 -3.610635 -3.999405 -4.350786 -4.685843 -4.976372 -5.178141 -5.139163 -4.669322 -3.777546 -2.673673 -29.75901 -0.4198618 -0.7842244 -1.195105 -1.641394 -2.096137 -2.545293 -2.981372 -3.397651 -3.788077 -4.151529 -4.508838 -4.832585 -5.134912 -5.410186 -5.619832 -5.682618 -5.363200 -4.538191 -3.393350 -29.75901 -1.465712 -1.755330 -2.105083 -2.495032 -2.896982 -3.298635 -3.686099 -4.057097 -4.408302 -4.740542 -5.059778 -5.350256 -5.620594 -5.865133 -6.073395 -6.184651 -6.014200 -5.330440 -4.184058 -29.75901 -2.675707 -2.876253 -3.146490 -3.462573 -3.795659 -4.136012 -4.471620 -4.795479 -5.103913 -5.396277 -5.675049 -5.929061 -6.168766 -6.380455 -6.561112 -6.680050 -6.632492 -6.144142 -5.054521 -29.75901 -4.138781 -4.226016 -4.391912 -4.612490 -4.863922 -5.132789 -5.403657 -5.673567 -5.931885 -6.179440 -6.415477 -6.625446 -6.821587 -6.988043 -7.140819 -7.258203 -7.286400 -7.007816 -6.024007 -29.75901 -6.141525 -6.084760 -6.114407 -6.207321 -6.343069 -6.512386 -6.694417 -6.887327 -7.080121 -7.264982 -7.448262 -7.616168 -7.776437 -7.916458 -8.065982 -8.182984 -8.236732 -8.071782 -7.176529 -29.75901 -54.90214 -54.32495 -53.59203 -52.72989 -51.75877 -50.69397 -49.54713 -48.32732 -47.04177 -45.69640 -44.29614 -42.84515 -41.34700 -39.80480 -38.22127 -36.59879 -34.93951 -33.24534 -31.51799 -29.75901 3.062389 2.929636 2.788598 2.629259 2.429080 2.205498 1.950058 1.660629 1.360985 1.057759 0.7709690 0.5198594 0.3200534 0.1773747 8.5085325E-02 3.1079909E-02 3.1207928E-03 -9.7294161E-03 -1.5018321E-02 -31.85535 4.154720 3.824586 3.518427 3.205786 2.894677 2.579184 2.247456 1.909070 1.578161 1.265101 0.9943551 0.7879502 0.6606691 0.6060591 0.6103771 0.6549714 0.7247334 0.8091843 0.9020397 -31.85535 4.845835 4.326781 3.848166 3.390979 2.962513 2.555324 2.154773 1.771437 1.408416 1.086496 0.8229520 0.6471491 0.5752187 0.5946882 0.6831177 0.8167540 0.9779519 1.156222 1.345577 -31.85535 5.200801 4.554648 3.961747 3.403603 2.883168 2.395561 1.937219 1.499933 1.097016 0.7489198 0.4710286 0.3028603 0.2613497 0.3367522 0.4987181 0.7164780 0.9671993 1.238549 1.524179 -31.85535 5.295942 4.586879 3.928242 3.301997 2.714602 2.172454 1.665701 1.183408 0.7342635 0.3357992 2.0541783E-02 -0.1744626 -0.2179543 -0.1108430 0.1122889 0.4086782 0.7470902 1.111195 1.493089 -31.85535 5.203329 4.469704 3.774621 3.111923 2.489892 1.903356 1.357356 0.8473092 0.3616320 -8.6406432E-02 -0.4539347 -0.7038878 -0.7843128 -0.6750379 -0.4071842 -3.8708411E-02 0.3854836 0.8420330 1.320240 -31.85535 4.966145 4.230905 3.528260 2.850986 2.207330 1.595631 1.024713 0.4937648 -1.6671941E-02 -0.4913080 -0.9091813 -1.224001 -1.370475 -1.290346 -0.9989763 -0.5675654 -5.9981331E-02 0.4885439 1.063121 -31.85535 4.614603 3.900033 3.203706 2.521167 1.870378 1.250287 0.6651618 0.1166144 -0.3993676 -0.8921211 -1.343016 -1.719112 -1.952363 -1.944136 -1.666276 -1.188811 -0.6038387 3.5281889E-02 0.7060678 -31.85535 4.173656 3.484027 2.802858 2.130168 1.482906 0.8620644 0.2691202 -0.2809328 -0.7987410 -1.297665 -1.761627 -2.179702 -2.491408 -2.579187 -2.361018 -1.864193 -1.211235 -0.4839517 0.2826756 -31.85535 3.643762 2.990495 2.335383 1.680143 1.041182 0.4248151 -0.1587212 -0.7047201 -1.218915 -1.714961 -2.182074 -2.617502 -2.982900 -3.171810 -3.052997 -2.577883 -1.873786 -1.062925 -0.2013375 -31.85535 3.036601 2.425134 1.800563 1.166706 0.5454004 -5.1808234E-02 -0.6248050 -1.161859 -1.664313 -2.155200 -2.612808 -3.051144 -3.436353 -3.708776 -3.708367 -3.305943 -2.579093 -1.693291 -0.7385063 -31.85535 2.348681 1.783209 1.196856 0.5948700 3.0322245E-04 -0.5774171 -1.130936 -1.655366 -2.143661 -2.619218 -3.064209 -3.487366 -3.879314 -4.188078 -4.304062 -4.019987 -3.312549 -2.367331 -1.322700 -31.85535 1.580766 1.068672 0.5264121 -4.1318409E-02 -0.6037554 -1.157038 -1.687929 -2.190303 -2.660867 -3.113905 -3.537476 -3.944208 -4.317019 -4.640694 -4.834114 -4.695642 -4.066223 -3.087971 -1.959967 -31.85535 0.7249355 0.2716599 -0.2216458 -0.7490661 -1.277899 -1.799617 -2.300344 -2.773142 -3.216847 -3.642961 -4.045660 -4.419274 -4.766596 -5.082798 -5.313872 -5.302715 -4.813504 -3.845079 -2.646198 -31.85535 -0.2348448 -0.6205808 -1.061313 -1.539461 -2.026675 -2.508047 -2.970391 -3.408919 -3.822743 -4.213664 -4.578621 -4.923404 -5.238559 -5.536221 -5.764696 -5.853380 -5.534371 -4.642841 -3.396635 -31.85535 -1.320748 -1.631064 -2.007073 -2.427139 -2.861657 -3.295199 -3.711498 -4.104201 -4.476751 -4.829930 -5.160484 -5.467562 -5.748329 -6.011699 -6.232159 -6.360978 -6.203451 -5.472680 -4.221639 -31.85535 -2.581693 -2.799793 -3.094470 -3.437551 -3.804436 -4.172455 -4.533576 -4.880029 -5.208651 -5.519011 -5.808558 -6.071177 -6.315629 -6.547663 -6.738779 -6.864937 -6.831334 -6.320158 -5.129883 -31.85535 -4.112660 -4.208273 -4.394909 -4.636405 -4.916675 -5.210890 -5.505858 -5.791722 -6.072900 -6.333168 -6.578868 -6.798174 -6.999106 -7.178273 -7.338080 -7.458423 -7.497246 -7.221357 -6.155752 -31.85535 -6.195715 -6.137445 -6.178192 -6.284526 -6.446611 -6.636549 -6.838790 -7.043734 -7.254626 -7.454404 -7.649374 -7.822272 -7.985004 -8.139526 -8.285254 -8.409548 -8.477814 -8.326085 -7.376624 -31.85535 -59.00012 -58.38383 -57.59484 -56.66391 -55.61415 -54.46270 -53.22251 -51.90355 -50.51376 -49.05962 -47.54649 -45.97892 -44.36077 -42.69543 -40.98582 -39.23454 -37.44390 -35.61596 -33.75255 -31.85535 3.278955 3.146724 3.008142 2.846785 2.637854 2.416543 2.160081 1.867654 1.543107 1.214356 0.9026458 0.6288911 0.4087530 0.2530610 0.1521650 9.4441116E-02 6.5061353E-02 5.1757317E-02 4.6655811E-02 -33.98338 4.450034 4.099494 3.776307 3.447591 3.122806 2.804461 2.468329 2.114940 1.760308 1.421932 1.129367 0.9076785 0.7685781 0.7112237 0.7173512 0.7672741 0.8435917 0.9350708 1.035291 -33.98338 5.192434 4.636330 4.124957 3.638553 3.197941 2.776701 2.363539 1.955646 1.571055 1.226067 0.9422821 0.7532075 0.6773800 0.7006390 0.7992004 0.9454653 1.120352 1.312700 1.516540 -33.98338 5.572118 4.881678 4.246683 3.661763 3.118287 2.614491 2.128355 1.666166 1.239560 0.8672156 0.5700110 0.3858469 0.3421504 0.4256835 0.6039591 0.8409678 1.112231 1.404671 1.711930 -33.98338 5.674782 4.919407 4.221600 3.563519 2.950012 2.377237 1.843317 1.334695 0.8591176 0.4364448 9.0902217E-02 -0.1272621 -0.1825065 -7.0093431E-02 0.1719771 0.4929058 0.8582762 1.250365 1.661045 -33.98338 5.581090 4.804088 4.069344 3.372323 2.714173 2.096020 1.523436 0.9881517 0.4763989 4.7089872E-03 -0.3957641 -0.6746569 -0.7772275 -0.6692126 -0.3806253 1.7630877E-02 0.4753758 0.9669525 1.481172 -33.98338 5.338608 4.561087 3.817244 3.099500 2.420108 1.777132 1.180566 0.6244863 9.1266260E-02 -0.4103808 -0.8538907 -1.202833 -1.378204 -1.307642 -0.9958291 -0.5294408 1.8446678E-02 0.6092416 1.227133 -33.98338 4.977926 4.218277 3.478271 2.757644 2.070991 1.419827 0.8077284 0.2385834 -0.3082326 -0.8187216 -1.293334 -1.700422 -1.964689 -1.974169 -1.679365 -1.163471 -0.5308609 0.1580407 0.8795313 -33.98338 4.517237 3.785077 3.064003 2.352764 1.669841 1.018023 0.4009335 -0.1761173 -0.7192050 -1.235037 -1.722163 -2.168147 -2.509612 -2.634833 -2.412797 -1.880048 -1.174244 -0.3898728 0.4348384 -33.98338 3.966131 3.274521 2.579795 1.885894 1.215417 0.5689320 -4.6701882E-02 -0.6140009 -1.152675 -1.666921 -2.156259 -2.615082 -3.004284 -3.239062 -3.140832 -2.639046 -1.879269 -1.004223 -7.7122070E-02 -33.98338 3.334563 2.687237 2.027203 1.358606 0.7032803 7.3525712E-02 -0.5285304 -1.086781 -1.612587 -2.123583 -2.601805 -3.055331 -3.465131 -3.779281 -3.814666 -3.404243 -2.622685 -1.665695 -0.6378343 -33.98338 2.622269 2.025670 1.403644 0.7653388 0.1386373 -0.4710239 -1.053814 -1.597828 -2.111155 -2.607139 -3.067124 -3.504122 -3.919358 -4.267278 -4.419514 -4.148467 -3.394394 -2.372458 -1.247119 -33.98338 1.825939 1.285262 0.7106505 0.1097849 -0.4879288 -1.070674 -1.631251 -2.154853 -2.647777 -3.120367 -3.556756 -3.977991 -4.379591 -4.725625 -4.954807 -4.845740 -4.184682 -3.127413 -1.911225 -33.98338 0.9415982 0.4631397 -6.2001344E-02 -0.6203668 -1.184703 -1.737149 -2.264526 -2.760853 -3.225425 -3.669070 -4.083544 -4.477119 -4.845078 -5.183982 -5.440053 -5.463233 -4.962252 -3.917274 -2.622833 -33.98338 -5.1090419E-02 -0.4608909 -0.9304225 -1.439559 -1.960145 -2.472583 -2.960969 -3.422877 -3.856572 -4.269025 -4.644338 -5.004041 -5.339931 -5.652683 -5.903344 -6.017001 -5.707264 -4.749733 -3.402362 -33.98338 -1.176964 -1.506598 -1.911131 -2.359469 -2.829044 -3.290333 -3.736461 -4.154239 -4.540839 -4.913100 -5.254711 -5.574723 -5.877177 -6.146826 -6.375506 -6.529921 -6.392376 -5.614310 -4.260308 -33.98338 -2.488299 -2.720797 -3.042347 -3.412664 -3.810777 -4.208850 -4.593410 -4.960588 -5.305222 -5.634488 -5.934714 -6.208959 -6.467226 -6.705392 -6.894258 -7.038605 -7.024495 -6.491919 -5.204810 -33.98338 -4.081805 -4.186309 -4.391299 -4.660542 -4.969498 -5.291975 -5.605814 -5.910979 -6.199045 -6.481083 -6.735032 -6.965060 -7.172300 -7.365085 -7.510456 -7.638811 -7.697294 -7.421738 -6.282589 -33.98338 -6.242844 -6.184537 -6.232008 -6.359912 -6.542903 -6.759607 -6.980059 -7.206039 -7.417765 -7.637827 -7.838215 -8.017225 -8.185686 -8.346145 -8.479679 -8.604855 -8.692584 -8.559515 -7.569653 -33.98338 -63.16576 -62.51009 -61.66357 -60.66232 -59.53218 -58.29227 -56.95681 -55.53674 -54.04072 -52.47577 -50.84771 -49.16147 -47.42124 -45.63063 -43.79283 -41.91063 -39.98649 -38.02262 -36.02099 -33.98338 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -0.8153529 -0.7445452 -0.6720721 -0.5979484 -0.5221909 -0.4448147 -0.3658357 -0.2852715 -0.2031424 -0.1194566 -3.4229293E-02 5.2523363E-02 0.1407856 0.2305420 0.3217811 0.4144916 0.5086436 0.6042217 0.7012113 0.7995963 -2.0370385E-02 -4.7534849E-03 5.4688840E-03 1.2192443E-03 -9.0369591E-03 -2.3349468E-02 -3.8520698E-02 -5.1016025E-02 -5.7264473E-02 -6.6758275E-02 -9.1719046E-02 -0.1546259 -0.2113690 -0.2645181 -0.3120461 -0.3672530 -0.4289234 -0.4887904 -0.5391763 -1.149407 -7.5880565E-02 -5.7718646E-02 -4.5082878E-02 -4.6088707E-02 -5.3536516E-02 -6.5134361E-02 -7.8147836E-02 -8.9091077E-02 -9.4634995E-02 -0.1028509 -0.1251707 -0.1893559 -0.2493551 -0.3025840 -0.3491656 -0.4030569 -0.4624089 -0.5180364 -0.5613601 -1.149407 -0.1340190 -0.1131049 -9.7856663E-02 -9.5541753E-02 -0.1000319 -0.1088413 -0.1197055 -0.1290368 -0.1338030 -0.1410066 -0.1611597 -0.2268922 -0.2864617 -0.3398274 -0.3850785 -0.4381619 -0.4950135 -0.5459681 -0.5819687 -1.149407 -0.1955046 -0.1715580 -0.1534380 -0.1476400 -0.1488615 -0.1547590 -0.1632837 -0.1706800 -0.1744043 -0.1805586 -0.1989264 -0.2666210 -0.3258640 -0.3783321 -0.4226613 -0.4747952 -0.5291011 -0.5751301 -0.6037474 -1.149407 -0.2615420 -0.2343978 -0.2132842 -0.2038411 -0.2015863 -0.2045303 -0.2106951 -0.2161606 -0.2188314 -0.2239604 -0.2406886 -0.3061531 -0.3652844 -0.4171952 -0.4606435 -0.5117007 -0.5633353 -0.6037591 -0.6246229 -1.149407 -0.3305700 -0.3000495 -0.2757461 -0.2625103 -0.2565377 -0.2563291 -0.2597168 -0.2630083 -0.2641485 -0.2678285 -0.2828422 -0.3465787 -0.4042364 -0.4546346 -0.4978084 -0.5467178 -0.5951840 -0.6291956 -0.6418880 -1.149407 -0.4030237 -0.3688569 -0.3411413 -0.3241311 -0.3143126 -0.3107904 -0.3111277 -0.3119159 -0.3109634 -0.3127211 -0.3258729 -0.3886412 -0.4455704 -0.4945905 -0.5372400 -0.5838014 -0.6285903 -0.6558704 -0.6600335 -1.149407 -0.4827067 -0.4444370 -0.4127660 -0.3916967 -0.3777874 -0.3706514 -0.3676976 -0.3657553 -0.3623138 -0.3619235 -0.3728577 -0.4336108 -0.4890509 -0.5373394 -0.5789006 -0.6225427 -0.6627574 -0.6828084 -0.6779071 -1.149407 -0.5697752 -0.5269325 -0.4908231 -0.4654195 -0.4470003 -0.4356914 -0.4290509 -0.4238660 -0.4173835 -0.4143128 -0.4226003 -0.4824003 -0.5362349 -0.5845116 -0.6239517 -0.6651134 -0.6993061 -0.7118663 -0.6973932 -1.149407 -0.6670749 -0.6191049 -0.5780886 -0.5477400 -0.5245725 -0.5085708 -0.4978352 -0.4889078 -0.4790094 -0.4726509 -0.4778612 -0.5351107 -0.5886682 -0.6360603 -0.6728333 -0.7103642 -0.7376989 -0.7421296 -0.7174888 -1.149407 -0.7764260 -0.7224990 -0.6758839 -0.6397626 -0.6112632 -0.5899410 -0.5745457 -0.5611533 -0.5472160 -0.5366132 -0.5381544 -0.5934272 -0.6461144 -0.6913468 -0.7259226 -0.7573351 -0.7763035 -0.7720301 -0.7364872 -1.149407 -0.9025422 -0.8420743 -0.7889009 -0.7461216 -0.7114170 -0.6839852 -0.6631356 -0.6446286 -0.6260819 -0.6105049 -0.6075022 -0.6614164 -0.7118315 -0.7543973 -0.7854006 -0.8089435 -0.8193106 -0.8049729 -0.7579139 -1.149407 -1.052584 -0.9844278 -0.9234755 -0.8732101 -0.8311057 -0.7964027 -0.7687842 -0.7440616 -0.7198585 -0.6982541 -0.6897737 -0.7405657 -0.7873891 -0.8277748 -0.8513138 -0.8654138 -0.8663313 -0.8404864 -0.7812200 -1.149407 -1.227895 -1.151832 -1.082185 -1.023632 -0.9730995 -0.9299766 -0.8943321 -0.8622191 -0.8311424 -0.8024771 -0.7871758 -0.8337814 -0.8778647 -0.9102206 -0.9242682 -0.9276288 -0.9170230 -0.8779511 -0.8058268 -1.149407 -1.441090 -1.356014 -1.276583 -1.208773 -1.149331 -1.096338 -1.051234 -1.010008 -0.9704019 -0.9334198 -0.9101810 -0.9519700 -0.9871536 -1.009100 -1.014614 -1.003594 -0.9789546 -0.9249883 -0.8404363 -1.149407 -1.707775 -1.612061 -1.521214 -1.442673 -1.372574 -1.308210 -1.251375 -1.198594 -1.147834 -1.100315 -1.066416 -1.097091 -1.121138 -1.132513 -1.126323 -1.096280 -1.053699 -0.9831613 -0.8868597 -1.149407 -2.055536 -1.948545 -1.845375 -1.750350 -1.667029 -1.587834 -1.515920 -1.447937 -1.382213 -1.317916 -1.270306 -1.288909 -1.298502 -1.293521 -1.268216 -1.218749 -1.148284 -1.061782 -0.9551988 -1.149407 -2.549890 -2.434658 -2.321612 -2.210098 -2.100343 -2.001614 -1.909327 -1.822017 -1.735742 -1.650282 -1.571047 -1.566293 -1.550194 -1.517029 -1.462866 -1.386545 -1.291134 -1.188289 -1.375348 -1.149407 -3.396715 -3.262141 -3.124674 -2.982331 -2.850942 -2.718032 -2.584619 -2.448906 -2.329314 -2.211556 -2.097512 -2.033264 -1.957498 -1.877036 -1.793764 -1.699052 -1.593600 -1.555045 -1.387826 -1.149407 -4.688386 -4.551151 -4.407844 -4.258576 -4.103468 -3.942626 -3.776151 -3.604156 -3.426728 -3.244014 -3.056127 -2.863155 -2.665200 -2.462411 -2.255127 -2.042676 -1.825931 -1.604756 -1.379472 -1.149407 0.4572510 0.4310585 0.3931572 0.3486149 0.2996190 0.2348071 0.1706829 0.1071457 3.9414257E-02 -2.1020457E-02 -8.2816482E-02 -0.1568391 -0.2286636 -0.2983592 -0.3645672 -0.4287387 -0.4937851 -0.5553259 -0.6078431 -3.430635 0.3902195 0.3721123 0.3415696 0.3023361 0.2575997 0.1998500 0.1413675 7.8576714E-02 1.8660290E-03 -6.6400170E-02 -0.1378934 -0.2184760 -0.2950265 -0.3665583 -0.4324406 -0.4933350 -0.5530188 -0.6059224 -0.6449679 -3.430635 0.3164462 0.3064553 0.2833651 0.2501886 0.2100910 0.1589697 0.1058428 4.4288080E-02 -3.8764730E-02 -0.1138725 -0.1947410 -0.2806996 -0.3606973 -0.4334416 -0.4993527 -0.5573780 -0.6118376 -0.6566385 -0.6818726 -3.430635 0.2340805 0.2315370 0.2161366 0.1898009 0.1551546 0.1103487 6.2483344E-02 1.6744415E-03 -8.5034519E-02 -0.1694968 -0.2572065 -0.3472583 -0.4300275 -0.5044721 -0.5710455 -0.6275267 -0.6774186 -0.7153153 -0.7267675 -3.430635 0.1437714 0.1482481 0.1403902 0.1214801 9.2914261E-02 5.4392785E-02 1.2183649E-02 -4.6539266E-02 -0.1393701 -0.2309437 -0.3241201 -0.4173822 -0.5024019 -0.5793163 -0.6466392 -0.7029804 -0.7496461 -0.7811680 -0.7790028 -3.430635 4.2954691E-02 5.4765392E-02 5.4352254E-02 4.2960629E-02 2.1262441E-02 -1.0432170E-02 -4.6793569E-02 -0.1036017 -0.2013417 -0.2981515 -0.3953348 -0.4906390 -0.5779791 -0.6584838 -0.7272781 -0.7846741 -0.8297727 -0.8556200 -0.8404199 -3.430635 -6.8404295E-02 -4.9276564E-02 -4.2368215E-02 -4.6280216E-02 -6.0651153E-02 -8.5255772E-02 -0.1153466 -0.1689129 -0.2693047 -0.3687958 -0.4674523 -0.5639709 -0.6539367 -0.7369827 -0.8079539 -0.8665560 -0.9104907 -0.9307289 -0.9022778 -3.430635 -0.1899387 -0.1634901 -0.1493687 -0.1463281 -0.1533721 -0.1704214 -0.1938530 -0.2434739 -0.3440900 -0.4438353 -0.5422145 -0.6387247 -0.7319664 -0.8167918 -0.8911982 -0.9503140 -0.9947538 -1.008638 -0.9668919 -3.430635 -0.3224413 -0.2886768 -0.2671048 -0.2571540 -0.2568100 -0.2661072 -0.2825477 -0.3268763 -0.4262101 -0.5237866 -0.6199564 -0.7174497 -0.8121102 -0.8988669 -0.9766852 -1.038214 -1.082546 -1.088581 -1.033369 -3.430635 -0.4685304 -0.4271593 -0.3980363 -0.3808074 -0.3729575 -0.3742350 -0.3829109 -0.4206079 -0.5152982 -0.6092578 -0.7039763 -0.8011038 -0.8947337 -0.9848344 -1.063991 -1.128161 -1.172841 -1.168771 -1.099065 -3.430635 -0.6273335 -0.5781170 -0.5413166 -0.5165424 -0.5011308 -0.4939914 -0.4947118 -0.5250986 -0.6133103 -0.7045063 -0.7979233 -0.8909933 -0.9847555 -1.076833 -1.158286 -1.225148 -1.267746 -1.252673 -1.167840 -3.430635 -0.8018485 -0.7442523 -0.6992576 -0.6662530 -0.6427104 -0.6268287 -0.6191134 -0.6418287 -0.7255045 -0.8137876 -0.9018134 -0.9917020 -1.085122 -1.176358 -1.262615 -1.331718 -1.367775 -1.341161 -1.239346 -3.430635 -1.003790 -0.9357457 -0.8816492 -0.8392678 -0.8066972 -0.7812712 -0.7640355 -0.7793702 -0.8571622 -0.9374067 -1.021262 -1.108690 -1.197909 -1.292429 -1.379547 -1.448268 -1.472352 -1.433527 -1.311590 -3.430635 -1.243320 -1.162734 -1.097434 -1.044614 -1.001441 -0.9652451 -0.9368319 -0.9414203 -1.009816 -1.085238 -1.164504 -1.245136 -1.334696 -1.427296 -1.515008 -1.573768 -1.583703 -1.528720 -1.383488 -3.430635 -1.531487 -1.436923 -1.357164 -1.292013 -1.236288 -1.187573 -1.146217 -1.139854 -1.201633 -1.267844 -1.340835 -1.420679 -1.504839 -1.594881 -1.673587 -1.716472 -1.712297 -1.634574 -1.462619 -3.430635 -1.898617 -1.786608 -1.690128 -1.607671 -1.537176 -1.472699 -1.415775 -1.394761 -1.449575 -1.510194 -1.576981 -1.648914 -1.726467 -1.802856 -1.863530 -1.890886 -1.866858 -1.759771 -1.556066 -3.430635 -2.398732 -2.265728 -2.148298 -2.045407 -1.953899 -1.870961 -1.793495 -1.756689 -1.796989 -1.844922 -1.900554 -1.959196 -2.017354 -2.074916 -2.120852 -2.126572 -2.067165 -1.921004 -1.682631 -3.430635 -3.115329 -2.959032 -2.817046 -2.685843 -2.566968 -2.456708 -2.354337 -2.293406 -2.314428 -2.343272 -2.377023 -2.417201 -2.459225 -2.494851 -2.507034 -2.469725 -2.354262 -2.154776 -1.882760 -3.430635 -4.441608 -4.255115 -4.076660 -3.904534 -3.739388 -3.578779 -3.426088 -3.321073 -3.312890 -3.310077 -3.307716 -3.302032 -3.288641 -3.252759 -3.173115 -3.034998 -2.830664 -2.572663 -2.273740 -3.430635 -9.239897 -9.034843 -8.816635 -8.585644 -8.342215 -8.086689 -7.819417 -7.540804 -7.251147 -6.950861 -6.640254 -6.319651 -5.989412 -5.649759 -5.301068 -4.943557 -4.577514 -4.203206 -3.820812 -3.430635 0.9277982 0.8548252 0.7564384 0.6484517 0.5439526 0.4363423 0.3414181 0.2552804 0.1742793 9.6837513E-02 2.2250647E-02 -5.6099057E-02 -0.1347525 -0.2125561 -0.2901133 -0.3623603 -0.4285264 -0.4874920 -0.5358786 -5.999882 0.8749620 0.8181109 0.7364355 0.6414965 0.5457253 0.4472636 0.3378266 0.2362128 0.1407390 4.9119763E-02 -3.7140515E-02 -0.1265785 -0.2133873 -0.2962647 -0.3732192 -0.4391238 -0.4937166 -0.5359997 -0.5619063 -5.999882 0.8030559 0.7599639 0.6936718 0.6118146 0.5248576 0.4324951 0.3151006 0.2023106 9.4329171E-02 -9.0340115E-03 -0.1078392 -0.2088055 -0.3043235 -0.3937110 -0.4711766 -0.5327774 -0.5776352 -0.6045987 -0.6089085 -5.999882 0.7154949 0.6847053 0.6325399 0.5640588 0.4873688 0.4032875 0.2797267 0.1581310 3.9983556E-02 -7.3312685E-02 -0.1849883 -0.2966645 -0.4015828 -0.4972332 -0.5764657 -0.6354680 -0.6722691 -0.6854506 -0.6686058 -5.999882 0.6102957 0.5915247 0.5524739 0.4977347 0.4329543 0.3599041 0.2325310 0.1046901 -2.0388879E-02 -0.1436072 -0.2662378 -0.3865284 -0.5004127 -0.6012364 -0.6824032 -0.7394332 -0.7694396 -0.7694892 -0.7317044 -5.999882 0.4885866 0.4813416 0.4542449 0.4123153 0.3600339 0.2988575 0.1698120 3.8071021E-02 -9.2056468E-02 -0.2239454 -0.3550099 -0.4836176 -0.6047985 -0.7108427 -0.7953304 -0.8522260 -0.8782166 -0.8669729 -0.8090080 -5.999882 0.3511910 0.3552483 0.3395903 0.3089963 0.2687269 0.2193307 9.0705507E-02 -4.2910919E-02 -0.1782821 -0.3156411 -0.4521029 -0.5875933 -0.7147086 -0.8264035 -0.9158628 -0.9748808 -0.9997154 -0.9800069 -0.9027820 -5.999882 0.1972442 0.2124711 0.2079001 0.1877907 0.1590992 0.1215110 -5.0047496E-03 -0.1406450 -0.2788930 -0.4171116 -0.5566192 -0.6947889 -0.8255749 -0.9422412 -1.036720 -1.099805 -1.124466 -1.098877 -1.001709 -5.999882 2.4960978E-02 5.1240668E-02 5.7401173E-02 4.7740299E-02 2.9802604E-02 3.6703856E-03 -0.1215395 -0.2568394 -0.3934113 -0.5311511 -0.6696593 -0.8077904 -0.9408480 -1.061509 -1.160379 -1.230246 -1.257046 -1.227055 -1.110784 -5.999882 -0.1704065 -0.1328007 -0.1157059 -0.1148594 -0.1224121 -0.1376414 -0.2594886 -0.3898524 -0.5226482 -0.6569118 -0.7916757 -0.9273860 -1.060055 -1.182925 -1.287509 -1.364953 -1.394621 -1.360311 -1.225159 -5.999882 -0.3899897 -0.3405686 -0.3118895 -0.3005443 -0.2977379 -0.3024861 -0.4169422 -0.5400919 -0.6665795 -0.7948484 -0.9247342 -1.056088 -1.186054 -1.308279 -1.419701 -1.503915 -1.538641 -1.498933 -1.344657 -5.999882 -0.6327001 -0.5716084 -0.5307320 -0.5083855 -0.4950810 -0.4891818 -0.5949137 -0.7087522 -0.8266237 -0.9485572 -1.072029 -1.196530 -1.320810 -1.444767 -1.562021 -1.652398 -1.694721 -1.644273 -1.470748 -5.999882 -0.9045176 -0.8309270 -0.7770036 -0.7422926 -0.7177408 -0.7007518 -0.7958281 -0.8999778 -1.009167 -1.121395 -1.235835 -1.351306 -1.472558 -1.597177 -1.716062 -1.813694 -1.861884 -1.798085 -1.603954 -5.999882 -1.216145 -1.128164 -1.059468 -1.010765 -0.9732547 -0.9439185 -1.029019 -1.122182 -1.217888 -1.317655 -1.420895 -1.531804 -1.650010 -1.771864 -1.892503 -1.998685 -2.040680 -1.961367 -1.743831 -5.999882 -1.587426 -1.482451 -1.396657 -1.331695 -1.278250 -1.234311 -1.303474 -1.380881 -1.460963 -1.550648 -1.647195 -1.753641 -1.863886 -1.982100 -2.104928 -2.209728 -2.235871 -2.141424 -1.892353 -5.999882 -2.035636 -1.909399 -1.802380 -1.718030 -1.645796 -1.583852 -1.637475 -1.701077 -1.770678 -1.851883 -1.938925 -2.033755 -2.137117 -2.253336 -2.367751 -2.450725 -2.457408 -2.336690 -2.048750 -5.999882 -2.637608 -2.483140 -2.347553 -2.238028 -2.140911 -2.054641 -2.095423 -2.143713 -2.196979 -2.259292 -2.334109 -2.420441 -2.514264 -2.610702 -2.698872 -2.758961 -2.743977 -2.577062 -2.237361 -5.999882 -3.516914 -3.327820 -3.154038 -3.008727 -2.877895 -2.759048 -2.774247 -2.803194 -2.836901 -2.877067 -2.931938 -2.987177 -3.055384 -3.125002 -3.194857 -3.222489 -3.152810 -2.914369 -2.511430 -5.999882 -5.117259 -4.883185 -4.651088 -4.444357 -4.250652 -4.071840 -4.041112 -4.031923 -4.031566 -4.032235 -4.050157 -4.074409 -4.107977 -4.136665 -4.138043 -4.063012 -3.851071 -3.491158 -3.022426 -5.999882 -14.36805 -14.09381 -13.79672 -13.47763 -13.13733 -12.77667 -12.39647 -11.99759 -11.58075 -11.14680 -10.69634 -10.23014 -9.748737 -9.252799 -8.742830 -8.219374 -7.683158 -7.133892 -6.572757 -5.999882 1.362288 1.232475 1.069994 0.8904560 0.7134897 0.6368203 0.5384132 0.4387833 0.3391232 0.2403843 0.1472623 5.7094742E-02 -2.9639428E-02 -0.1107747 -0.1883330 -0.2620264 -0.3269512 -0.3810189 -0.4217842 -8.816086 1.341198 1.236229 1.098454 0.9435765 0.7847767 0.6806988 0.5584071 0.4358285 0.3141629 0.1968346 8.8144824E-02 -1.5395106E-02 -0.1092829 -0.1933827 -0.2666306 -0.3287229 -0.3728609 -0.3988531 -0.4049776 -8.816086 1.283858 1.201617 1.087291 0.9547426 0.8148419 0.6838344 0.5420090 0.3998378 0.2592981 0.1261978 -4.9055827E-05 -0.1173416 -0.2211023 -0.3115017 -0.3846811 -0.4378969 -0.4644631 -0.4647270 -0.4377606 -8.816086 1.195434 1.132969 1.040099 0.9283706 0.8070259 0.6583804 0.5013905 0.3434100 0.1896575 4.1585900E-02 -0.1004167 -0.2309345 -0.3468993 -0.4455576 -0.5225833 -0.5694578 -0.5813791 -0.5582533 -0.4992714 -8.816086 1.079691 1.034048 0.9597982 0.8679103 0.7651593 0.6054330 0.4373800 0.2706575 0.1076929 -5.4000195E-02 -0.2081486 -0.3506804 -0.4803113 -0.5886224 -0.6716781 -0.7154076 -0.7154582 -0.6712335 -0.5813526 -8.816086 0.9408870 0.9097596 0.8513947 0.7768129 0.6915019 0.5252680 0.3514933 0.1810054 1.0562114E-02 -0.1580647 -0.3207914 -0.4752201 -0.6165503 -0.7374009 -0.8271440 -0.8704683 -0.8619730 -0.7990900 -0.6793703 -8.816086 0.7786314 0.7611341 0.7168266 0.6570704 0.5875191 0.4196778 0.2453976 7.1560472E-02 -0.1014246 -0.2734361 -0.4424940 -0.6068783 -0.7584887 -0.8925411 -0.9905334 -1.038554 -1.026175 -0.9482086 -0.8004772 -8.816086 0.5913350 0.5883042 0.5576012 0.5117363 0.4568213 0.2916858 0.1180663 -5.5300482E-02 -0.2282864 -0.4011628 -0.5745109 -0.7437127 -0.9054779 -1.049980 -1.158152 -1.214209 -1.203253 -1.114353 -0.9401847 -8.816086 0.3785984 0.3906413 0.3742204 0.3420830 0.3013329 0.1396543 -2.8889244E-02 -0.1990017 -0.3698579 -0.5426670 -0.7160985 -0.8879145 -1.055845 -1.206322 -1.324301 -1.390829 -1.385466 -1.288243 -1.088912 -8.816086 0.1403031 0.1673057 0.1657110 0.1467193 0.1191608 -3.4457847E-02 -0.1969799 -0.3614624 -0.5289201 -0.6984228 -0.8697977 -1.042934 -1.211225 -1.365396 -1.492916 -1.571758 -1.575727 -1.474979 -1.250622 -8.816086 -0.1248226 -8.2480088E-02 -6.8560228E-02 -7.3767535E-02 -8.8481963E-02 -0.2332168 -0.3879814 -0.5454220 -0.7057703 -0.8698152 -1.038412 -1.208530 -1.372963 -1.528259 -1.663411 -1.756960 -1.772513 -1.672103 -1.422810 -8.816086 -0.4210152 -0.3635004 -0.3339341 -0.3243612 -0.3257285 -0.4597267 -0.6039166 -0.7512912 -0.9033897 -1.061271 -1.223289 -1.385587 -1.545470 -1.699711 -1.841066 -1.948512 -1.977100 -1.876602 -1.602998 -8.816086 -0.7518641 -0.6786559 -0.6331999 -0.6084618 -0.5956513 -0.7164149 -0.8477001 -0.9844256 -1.128510 -1.275688 -1.426104 -1.580051 -1.734239 -1.886349 -2.033151 -2.151682 -2.194667 -2.093231 -1.795030 -8.816086 -1.128378 -1.037873 -0.9751027 -0.9340937 -0.9052182 -1.011114 -1.130244 -1.254891 -1.383403 -1.518222 -1.654743 -1.798640 -1.947998 -2.099257 -2.247696 -2.374822 -2.433984 -2.320060 -1.996081 -8.816086 -1.573521 -1.463147 -1.380561 -1.320846 -1.273471 -1.361058 -1.461279 -1.568551 -1.679587 -1.798402 -1.922767 -2.060244 -2.203497 -2.351251 -2.497612 -2.632714 -2.693227 -2.562057 -2.209279 -8.816086 -2.113222 -1.978086 -1.872087 -1.789601 -1.720054 -1.782965 -1.860393 -1.944647 -2.042752 -2.150639 -2.264825 -2.388724 -2.523692 -2.665221 -2.811038 -2.943155 -2.983628 -2.834887 -2.439676 -8.816086 -2.807457 -2.638108 -2.499454 -2.388222 -2.290925 -2.333530 -2.393207 -2.457607 -2.536718 -2.624003 -2.722761 -2.830949 -2.955032 -3.091824 -3.220824 -3.321197 -3.337125 -3.148491 -2.698075 -8.816086 -3.841900 -3.626136 -3.440871 -3.286543 -3.150063 -3.158374 -3.183210 -3.218611 -3.270328 -3.335759 -3.412366 -3.493903 -3.591851 -3.692708 -3.789551 -3.868695 -3.835788 -3.575342 -3.041705 -8.816086 -5.696661 -5.417294 -5.158589 -4.928186 -4.718937 -4.666652 -4.637652 -4.618178 -4.619756 -4.631009 -4.666397 -4.709569 -4.766504 -4.833497 -4.898517 -4.901451 -4.736256 -4.304910 -3.671332 -8.816086 -19.98897 -19.64416 -19.26430 -18.85097 -18.40573 -17.93021 -17.42603 -16.89462 -16.33740 -15.75572 -15.15073 -14.52355 -13.87524 -13.20674 -12.51890 -11.81255 -11.08844 -10.34723 -9.589584 -8.816086 1.761398 1.571464 1.339023 1.086285 0.9339871 0.8440617 0.7415990 0.6243199 0.5032640 0.3833348 0.2650510 0.1541054 5.3636760E-02 -3.7942853E-02 -0.1194695 -0.1921851 -0.2567304 -0.3080669 -0.3437622 -11.84672 1.786511 1.628984 1.433010 1.216870 1.057540 0.9359983 0.7976320 0.6498809 0.5018312 0.3549525 0.2157058 9.1887817E-02 -1.6120087E-02 -0.1059287 -0.1768352 -0.2286266 -0.2616620 -0.2721259 -0.2598568 -11.84672 1.757272 1.630067 1.466229 1.282800 1.117218 0.9603881 0.7909620 0.6170600 0.4421741 0.2703615 0.1113739 -2.8170707E-02 -0.1481082 -0.2415716 -0.3081729 -0.3445415 -0.3502697 -0.3232588 -0.2653779 -11.84672 1.679464 1.579359 1.443900 1.291154 1.120812 0.9364634 0.7449790 0.5500423 0.3524456 0.1615993 -1.3261665E-02 -0.1711171 -0.3048626 -0.4071310 -0.4737729 -0.5006332 -0.4829771 -0.4212997 -0.3192708 -11.84672 1.561476 1.483919 1.371557 1.244905 1.072651 0.8704681 0.6647466 0.4538838 0.2426322 4.0494945E-02 -0.1488140 -0.3232997 -0.4721316 -0.5881802 -0.6604776 -0.6835358 -0.6473492 -0.5542289 -0.4094722 -11.84672 1.407133 1.349234 1.256669 1.151026 0.9808549 0.7689565 0.5517575 0.3329568 0.1172744 -9.0341337E-02 -0.2916618 -0.4784372 -0.6429338 -0.7749202 -0.8581157 -0.8819510 -0.8328255 -0.7115710 -0.5255153 -11.84672 1.219181 1.180133 1.105999 1.018530 0.8518661 0.6338597 0.4127932 0.1934863 -2.1129057E-02 -0.2341348 -0.4408398 -0.6365235 -0.8158595 -0.9633048 -1.063640 -1.093787 -1.038395 -0.8940955 -0.6685980 -11.84672 1.000098 0.9785336 0.9217534 0.8503021 0.6886550 0.4710790 0.2543038 3.9860189E-02 -0.1751645 -0.3892666 -0.5979384 -0.8005319 -0.9910111 -1.153052 -1.271381 -1.313835 -1.259133 -1.097501 -0.8349065 -11.84672 0.7519557 0.7467714 0.7063847 0.6496547 0.4970389 0.2873237 7.8499682E-02 -0.1323550 -0.3440625 -0.5558223 -0.7657058 -0.9716943 -1.167981 -1.345276 -1.479355 -1.539961 -1.494094 -1.321898 -1.024992 -11.84672 0.4759044 0.4875000 0.4636343 0.4222688 0.2822669 8.2417540E-02 -0.1197147 -0.3234527 -0.5285120 -0.7365126 -0.9451289 -1.151211 -1.351533 -1.538170 -1.686966 -1.768364 -1.739133 -1.562943 -1.234415 -11.84672 0.1684782 0.1982286 0.1918666 0.1671778 3.9696828E-02 -0.1493691 -0.3405463 -0.5349691 -0.7333995 -0.9344500 -1.138383 -1.341917 -1.543468 -1.732826 -1.894404 -1.995568 -1.988914 -1.814090 -1.456046 -11.84672 -0.1759802 -0.1272740 -0.1152422 -0.1230802 -0.2342927 -0.4092698 -0.5881346 -0.7728175 -0.9611191 -1.153268 -1.349501 -1.548025 -1.745916 -1.935970 -2.107052 -2.227133 -2.245358 -2.078680 -1.690812 -11.84672 -0.5626264 -0.4936654 -0.4618503 -0.4519404 -0.5459952 -0.7056330 -0.8686375 -1.040230 -1.217051 -1.398868 -1.584410 -1.772610 -1.964803 -2.154646 -2.330065 -2.470188 -2.511904 -2.356791 -1.940307 -11.84672 -1.002460 -0.9119884 -0.8590664 -0.8300201 -0.9040784 -1.044433 -1.191242 -1.347605 -1.508733 -1.677675 -1.848239 -2.025693 -2.209895 -2.396374 -2.577300 -2.732110 -2.794149 -2.646727 -2.200880 -11.84672 -1.514494 -1.399468 -1.322286 -1.271488 -1.325417 -1.443874 -1.569840 -1.705220 -1.847260 -2.000010 -2.157277 -2.322415 -2.495745 -2.680910 -2.864047 -3.027237 -3.111876 -2.957082 -2.480096 -11.84672 -2.133676 -1.988659 -1.882315 -1.806046 -1.833236 -1.923793 -2.025431 -2.137528 -2.260828 -2.396215 -2.539840 -2.691290 -2.853860 -3.032494 -3.212608 -3.384712 -3.466898 -3.290850 -2.777787 -11.84672 -2.928944 -2.742762 -2.597249 -2.488559 -2.485017 -2.547270 -2.623385 -2.709865 -2.809137 -2.925428 -3.052005 -3.186414 -3.331420 -3.497476 -3.678944 -3.834056 -3.886565 -3.685973 -3.112544 -11.84672 -4.095607 -3.852094 -3.647890 -3.490250 -3.446594 -3.470192 -3.510382 -3.564908 -3.627728 -3.709400 -3.810082 -3.921239 -4.042749 -4.180099 -4.326903 -4.441895 -4.470286 -4.198295 -3.532936 -11.84672 -6.199049 -5.873566 -5.570725 -5.321367 -5.196845 -5.148962 -5.113989 -5.101074 -5.109139 -5.129347 -5.170916 -5.230715 -5.314954 -5.407938 -5.523733 -5.616580 -5.542503 -5.081850 -4.280053 -11.84672 -26.03819 -25.62146 -25.15502 -24.64151 -24.08373 -23.48440 -22.84608 -22.17150 -21.46182 -20.72008 -19.94773 -19.14643 -18.31763 -17.46273 -16.58294 -15.67939 -14.75309 -13.80498 -12.83592 -11.84672 2.139493 1.880584 1.572494 1.259585 1.165934 1.065705 0.9504511 0.8169121 0.6761112 0.5320446 0.3915523 0.2585725 0.1374049 3.3530846E-02 -5.6508232E-02 -0.1319151 -0.1945513 -0.2437274 -0.2757308 -15.06665 2.211866 1.995866 1.736960 1.467774 1.340415 1.200272 1.042649 0.8711571 0.6945710 0.5184745 0.3526343 0.2011379 7.4162707E-02 -2.5787150E-02 -9.7974263E-02 -0.1434498 -0.1633479 -0.1587289 -0.1294785 -15.06665 2.213466 2.037087 1.821759 1.591256 1.425543 1.243559 1.046624 0.8405221 0.6309158 0.4276270 0.2352742 6.3848898E-02 -7.3653899E-02 -0.1756241 -0.2370595 -0.2579724 -0.2400761 -0.1851315 -9.7075865E-02 -15.06665 2.152834 2.010978 1.832178 1.637120 1.435261 1.219702 0.9938747 0.7601300 0.5269263 0.2992740 8.3417997E-02 -0.1063059 -0.2599732 -0.3712474 -0.4301237 -0.4335890 -0.3832004 -0.2812426 -0.1360319 -15.06665 2.038261 1.925414 1.775460 1.608939 1.379552 1.140528 0.8945513 0.6445274 0.3956131 0.1503808 -8.2336396E-02 -0.2884603 -0.4623958 -0.5879732 -0.6541804 -0.6494893 -0.5726389 -0.4274462 -0.2267042 -15.06665 1.873144 1.786143 1.660560 1.516429 1.270357 1.017477 0.7604166 0.5018373 0.2419149 -1.2000576E-02 -0.2523414 -0.4745382 -0.6672528 -0.8126553 -0.8935421 -0.8907447 -0.7950082 -0.6111174 -0.3565486 -15.06665 1.666154 1.601717 1.497694 1.372262 1.117483 0.8603448 0.5995750 0.3353247 7.1871050E-02 -0.1833791 -0.4287620 -0.6627299 -0.8708516 -1.038309 -1.139037 -1.148910 -1.043966 -0.8274481 -0.5211345 -15.06665 1.423016 1.378861 1.294764 1.185209 0.9307271 0.6740071 0.4124756 0.1505500 -0.1091410 -0.3628134 -0.6122509 -0.8522114 -1.073817 -1.261785 -1.386772 -1.417300 -1.314784 -1.073122 -0.7178084 -15.06665 1.145367 1.121169 1.056211 0.9627519 0.7116790 0.4596302 0.2043580 -4.9695235E-02 -0.3018231 -0.5533715 -0.8022516 -1.044932 -1.276886 -1.480367 -1.632150 -1.688506 -1.599345 -1.341948 -0.9407690 -15.06665 0.8310561 0.8264694 0.7799807 0.7031133 0.4620813 0.2211515 -2.2149213E-02 -0.2668850 -0.5124083 -0.7577011 -1.001397 -1.246746 -1.482427 -1.698233 -1.873115 -1.957896 -1.891263 -1.628040 -1.184547 -15.06665 0.4812445 0.4968520 0.4692703 0.4093161 0.1837602 -4.0954582E-02 -0.2728381 -0.5062708 -0.7431482 -0.9792944 -1.218421 -1.458779 -1.694766 -1.920157 -2.111553 -2.227825 -2.192923 -1.933923 -1.452183 -15.06665 9.0214700E-02 0.1283869 0.1220405 8.0775775E-02 -0.1270747 -0.3360474 -0.5516471 -0.7714769 -0.9974936 -1.226206 -1.455661 -1.686463 -1.921412 -2.149329 -2.354167 -2.498390 -2.503323 -2.258077 -1.742280 -15.06665 -0.3506316 -0.2878521 -0.2706821 -0.2917186 -0.4779543 -0.6682341 -0.8652136 -1.070876 -1.284919 -1.500925 -1.717945 -1.939366 -2.166442 -2.393598 -2.607064 -2.773536 -2.817849 -2.592635 -2.043136 -15.06665 -0.8496915 -0.7601817 -0.7172030 -0.7159760 -0.8791034 -1.048181 -1.228930 -1.415055 -1.610597 -1.811149 -2.015378 -2.224615 -2.440381 -2.663904 -2.879772 -3.071027 -3.149454 -2.949009 -2.366482 -15.06665 -1.429985 -1.311567 -1.239783 -1.213595 -1.352674 -1.496164 -1.652991 -1.815576 -1.989633 -2.172641 -2.359988 -2.557458 -2.760740 -2.974591 -3.197775 -3.401456 -3.508134 -3.324348 -2.706515 -15.06665 -2.129839 -1.977885 -1.872333 -1.814919 -1.922538 -2.034588 -2.163084 -2.301328 -2.449405 -2.612192 -2.781528 -2.964509 -3.153933 -3.360801 -3.582317 -3.793169 -3.925136 -3.730330 -3.072874 -15.06665 -3.024083 -2.826798 -2.678014 -2.579266 -2.650114 -2.728149 -2.821573 -2.931980 -3.053730 -3.189474 -3.338162 -3.502856 -3.678892 -3.868565 -4.084970 -4.301683 -4.418187 -4.193567 -3.477420 -15.06665 -4.316754 -4.054693 -3.842595 -3.683417 -3.704513 -3.737725 -3.787651 -3.857560 -3.942825 -4.043798 -4.158092 -4.294741 -4.452170 -4.620636 -4.813890 -4.992922 -5.076206 -4.790117 -3.979989 -15.06665 -6.608639 -6.251148 -5.931998 -5.667080 -5.609636 -5.568758 -5.537502 -5.527736 -5.540298 -5.584647 -5.643356 -5.716068 -5.818110 -5.948453 -6.094120 -6.256584 -6.281157 -5.819784 -4.844457 -15.06665 -32.46606 -31.97608 -31.41931 -30.79999 -30.12247 -29.39095 -28.60925 -27.78087 -26.90893 -25.99622 -25.04524 -24.05822 -23.03716 -21.98383 -20.89985 -19.78667 -18.64561 -17.47787 -16.28454 -15.06665 2.506360 2.173895 1.789646 1.523173 1.422223 1.304502 1.172051 1.024770 0.8657808 0.7009291 0.5390448 0.3859733 0.2475984 0.1275515 2.9695798E-02 -4.8487548E-02 -0.1090334 -0.1544324 -0.1826412 -18.45619 2.630767 2.357121 2.033498 1.782638 1.635765 1.473021 1.295629 1.102881 0.9018065 0.7001511 0.5069506 0.3345654 0.1878277 7.6754101E-02 2.9168462E-03 -3.4076154E-02 -3.8971640E-02 -1.7420167E-02 2.8995439E-02 -18.45619 2.662853 2.437642 2.169550 1.928399 1.734166 1.526589 1.304406 1.070460 0.8322835 0.5974405 0.3771806 0.1820710 2.3015859E-02 -8.5213259E-02 -0.1414462 -0.1430141 -9.6458852E-02 -1.0905326E-02 0.1079073 -18.45619 2.617613 2.432092 2.208297 1.976270 1.742619 1.498279 1.240371 0.9750834 0.7081481 0.4447778 0.1985880 -2.2563932E-02 -0.2007752 -0.3207711 -0.3717947 -0.3496674 -0.2594369 -0.1143382 7.4738450E-02 -18.45619 2.505097 2.354052 2.165389 1.941916 1.680129 1.406542 1.125924 0.8394681 0.5526463 0.2722743 2.9690254E-03 -0.2415991 -0.4415841 -0.5834848 -0.6425840 -0.6085371 -0.4837469 -0.2834033 -2.5719753E-02 -18.45619 2.334117 2.214283 2.055213 1.839906 1.558160 1.269459 0.9740114 0.6739502 0.3769384 8.4820010E-02 -0.1988001 -0.4596864 -0.6828908 -0.8504140 -0.9297763 -0.8961381 -0.7474288 -0.4969522 -0.1723752 -18.45619 2.113894 2.020733 1.886932 1.680799 1.390607 1.093387 0.7911185 0.4872867 0.1856863 -0.1131749 -0.4032831 -0.6744487 -0.9194895 -1.110748 -1.220187 -1.201214 -1.040404 -0.7464831 -0.3571197 -18.45619 1.850893 1.782217 1.671139 1.474619 1.182850 0.8841310 0.5828999 0.2806859 -2.1137398E-02 -0.3187034 -0.6089473 -0.8893634 -1.148449 -1.365158 -1.505322 -1.516832 -1.358526 -1.030553 -0.5792223 -18.45619 1.545198 1.499896 1.409503 1.226094 0.9384540 0.6467981 0.3510779 5.2354135E-02 -0.2429645 -0.5326080 -0.8218694 -1.105402 -1.371794 -1.610970 -1.781097 -1.834039 -1.694640 -1.344276 -0.8345084 -18.45619 1.198011 1.175648 1.105601 0.9375198 0.6617116 0.3801297 9.4023541E-02 -0.1948868 -0.4793868 -0.7631443 -1.046123 -1.325622 -1.598660 -1.847847 -2.049365 -2.144865 -2.039814 -1.680271 -1.116267 -18.45619 0.8078337 0.8094617 0.7615338 0.6105478 0.3493768 8.3320498E-02 -0.1878618 -0.4628624 -0.7383497 -1.012170 -1.285437 -1.559628 -1.830172 -2.085259 -2.312866 -2.450073 -2.389925 -2.037447 -1.424721 -18.45619 0.3708384 0.3977993 0.3735187 0.2426566 1.1282752E-03 -0.2464933 -0.5009658 -0.7601866 -1.021358 -1.281906 -1.547490 -1.811126 -2.072829 -2.334551 -2.576526 -2.751788 -2.743888 -2.412046 -1.755723 -18.45619 -0.1205041 -6.6051878E-02 -6.3953266E-02 -0.1725366 -0.3920243 -0.6182287 -0.8521124 -1.091657 -1.335539 -1.583322 -1.834904 -2.085891 -2.340839 -2.601006 -2.851930 -3.056827 -3.107935 -2.808786 -2.114964 -18.45619 -0.6811947 -0.5974782 -0.5665642 -0.6472337 -0.8396081 -1.038743 -1.249668 -1.468918 -1.694164 -1.921481 -2.156591 -2.397702 -2.642516 -2.895627 -3.151083 -3.377414 -3.480701 -3.221882 -2.491098 -18.45619 -1.324730 -1.208960 -1.146468 -1.195309 -1.357988 -1.528232 -1.712006 -1.907483 -2.107350 -2.314901 -2.533328 -2.760287 -2.993255 -3.236647 -3.489866 -3.739295 -3.883400 -3.664735 -2.897527 -18.45619 -2.092251 -1.938884 -1.840474 -1.852238 -1.980052 -2.115991 -2.266481 -2.434697 -2.609740 -2.793384 -2.991010 -3.200919 -3.420018 -3.651842 -3.907323 -4.163572 -4.340940 -4.141515 -3.331446 -18.45619 -3.069332 -2.864748 -2.720414 -2.686597 -2.771475 -2.867698 -2.981263 -3.114691 -3.258867 -3.415612 -3.588482 -3.777523 -3.982715 -4.202155 -4.446551 -4.710702 -4.895462 -4.669791 -3.807009 -18.45619 -4.466771 -4.186489 -3.974996 -3.878412 -3.906407 -3.953043 -4.015287 -4.102711 -4.210913 -4.326323 -4.465810 -4.624037 -4.804602 -5.008202 -5.233847 -5.479496 -5.616079 -5.349825 -4.386580 -18.45619 -6.944137 -6.543995 -6.215542 -6.009711 -5.941367 -5.898209 -5.885478 -5.889447 -5.919079 -5.970230 -6.045381 -6.150007 -6.269456 -6.416214 -6.604997 -6.811372 -6.933177 -6.497992 -5.342360 -18.45619 -39.23353 -38.66897 -38.01822 -37.28762 -36.48361 -35.61214 -34.67860 -33.68773 -32.64372 -31.55028 -30.41063 -29.22787 -28.00404 -26.74137 -25.44238 -24.10885 -22.74168 -21.34308 -19.91417 -18.45619 2.858812 2.446578 1.986925 1.794955 1.690483 1.558867 1.407378 1.239896 1.062398 0.8794761 0.6956768 0.5222510 0.3658276 0.2316645 0.1244243 4.2769447E-02 -1.6745459E-02 -5.8121283E-02 -8.3045788E-02 -21.99948 3.041428 2.706006 2.318562 2.106975 1.943510 1.758315 1.554595 1.338959 1.116812 0.8916429 0.6754574 0.4797293 0.3175733 0.1955328 0.1231007 9.5094189E-02 0.1051805 0.1449728 0.2085251 -21.99948 3.106331 2.831808 2.511416 2.270712 2.048903 1.809247 1.558166 1.300179 1.035231 0.7728693 0.5262917 0.3067223 0.1308759 1.3414956E-02 -3.3267114E-02 -1.4121532E-02 6.0878605E-02 0.1781941 0.3276576 -21.99948 3.076168 2.848476 2.580567 2.317863 2.048207 1.769557 1.483052 1.188883 0.8906026 0.5969999 0.3179016 7.0305094E-02 -0.1331426 -0.2628401 -0.3037153 -0.2525211 -0.1216624 6.8271600E-02 0.3013796 -21.99948 2.966408 2.777889 2.550893 2.273480 1.974496 1.669022 1.354280 1.034894 0.7143676 0.3977008 9.5258072E-02 -0.1811513 -0.4148020 -0.5695328 -0.6216040 -0.5545767 -0.3777914 -0.1195367 0.1958065 -21.99948 2.790658 2.636158 2.442231 2.160212 1.844247 1.519346 1.187339 0.8521907 0.5178527 0.1868850 -0.1314685 -0.4317494 -0.6905652 -0.8807889 -0.9591954 -0.8959507 -0.6869726 -0.3664444 2.9464444E-02 -21.99948 2.559418 2.435675 2.270819 1.990139 1.663319 1.328590 0.9878714 0.6460583 0.3061733 -3.0309010E-02 -0.3606049 -0.6740324 -0.9541415 -1.179022 -1.297236 -1.255399 -1.032570 -0.6575249 -0.1833007 -21.99948 2.277114 2.182464 2.043837 1.766967 1.439214 1.101510 0.7588894 0.4168870 7.8852184E-02 -0.2585627 -0.5913985 -0.9083365 -1.205984 -1.459319 -1.622464 -1.618523 -1.401565 -0.9824988 -0.4327306 -21.99948 1.946904 1.879696 1.764222 1.497293 1.172953 0.8405410 0.5034355 0.1664231 -0.1682807 -0.5007445 -0.8256926 -1.144039 -1.450299 -1.725447 -1.928709 -1.977784 -1.787539 -1.338119 -0.7163655 -21.99948 1.568926 1.528301 1.435864 1.181750 0.8684043 0.5473201 0.2204150 -0.1082433 -0.4333341 -0.7551082 -1.072500 -1.386887 -1.693895 -1.984836 -2.217135 -2.327020 -2.185011 -1.723333 -1.034292 -21.99948 1.142596 1.128169 1.059897 0.8231484 0.5261216 0.2186132 -9.3333222E-02 -0.4072390 -0.7163870 -1.027869 -1.336845 -1.641664 -1.946560 -2.240069 -2.498981 -2.663488 -2.586509 -2.132929 -1.382552 -21.99948 0.6617482 0.6751963 0.6333899 0.4172870 0.1406544 -0.1459711 -0.4386990 -0.7327521 -1.027098 -1.323874 -1.620795 -1.917027 -2.212964 -2.503520 -2.782231 -2.991972 -2.985285 -2.562931 -1.758975 -21.99948 0.1219192 0.1644879 0.1503989 -3.8570877E-02 -0.2897421 -0.5504898 -0.8225907 -1.095293 -1.370639 -1.649722 -1.934778 -2.216982 -2.499781 -2.790056 -3.076962 -3.322620 -3.386710 -3.012048 -2.161239 -21.99948 -0.4878465 -0.4131066 -0.3969932 -0.5549818 -0.7773167 -1.008711 -1.253719 -1.504009 -1.756812 -2.019633 -2.284094 -2.550156 -2.825818 -3.109276 -3.399412 -3.665200 -3.803596 -3.488816 -2.599493 -21.99948 -1.189178 -1.078167 -1.028752 -1.149598 -1.337261 -1.536587 -1.752190 -1.977596 -2.204148 -2.440984 -2.689082 -2.942053 -3.204153 -3.479408 -3.765093 -4.050717 -4.239935 -3.990534 -3.060781 -21.99948 -2.020520 -1.866578 -1.778608 -1.858153 -2.005203 -2.167906 -2.349247 -2.541690 -2.742755 -2.954400 -3.182357 -3.415992 -3.662942 -3.925095 -4.210907 -4.505599 -4.733605 -4.533450 -3.559240 -21.99948 -3.072374 -2.861580 -2.723909 -2.753811 -2.852423 -2.971814 -3.113721 -3.268951 -3.437786 -3.618960 -3.820806 -4.031168 -4.260364 -4.515230 -4.790152 -5.088467 -5.344377 -5.139325 -4.107586 -21.99948 -4.569466 -4.276255 -4.064801 -4.028310 -4.062393 -4.122061 -4.210602 -4.319889 -4.444060 -4.589023 -4.751015 -4.932456 -5.135575 -5.367609 -5.634962 -5.925729 -6.145123 -5.891353 -4.759110 -21.99948 -7.228554 -6.797430 -6.455938 -6.301453 -6.224960 -6.186401 -6.185810 -6.213297 -6.265310 -6.337545 -6.429111 -6.553495 -6.706411 -6.877580 -7.088809 -7.345488 -7.535416 -7.142732 -5.807606 -21.99948 -46.30904 -45.66858 -44.92028 -44.07322 -43.13633 -42.11770 -41.02447 -39.86285 -38.63845 -37.35518 -36.01778 -34.62977 -33.19375 -31.71242 -30.18870 -28.62450 -27.02179 -25.38233 -23.70773 -21.99948 3.197783 2.703344 2.167130 2.067125 1.959920 1.818951 1.649428 1.463093 1.265071 1.061130 0.8578641 0.6621546 0.4876544 0.3408566 0.2233594 0.1386293 7.9758689E-02 4.1282818E-02 1.9249886E-02 -25.68348 3.442641 3.040387 2.587844 2.428200 2.252512 2.045432 1.818470 1.578665 1.331375 1.084996 0.8453958 0.6279153 0.4481983 0.3201547 0.2473328 0.2292797 0.2546177 0.3118890 0.3923190 -25.68348 3.543115 3.215010 2.841960 2.609961 2.361223 2.092106 1.812086 1.524816 1.234720 0.9473775 0.6726457 0.4283124 0.2355857 0.1119795 7.2365835E-02 0.1118719 0.2155570 0.3643101 0.5441767 -25.68348 3.529590 3.257884 2.945571 2.655964 2.352607 2.039726 1.719886 1.396022 1.069730 0.7461833 0.4385340 0.1591750 -6.3885719E-02 -0.2055988 -0.2353103 -0.1550090 1.7170699E-02 0.2525364 0.5298088 -25.68348 3.423056 3.196202 2.930715 2.604522 2.268881 1.925554 1.576722 1.227203 0.8732573 0.5238228 0.1890381 -0.1197393 -0.3820571 -0.5569605 -0.6022004 -0.5010707 -0.2716662 4.5585297E-02 0.4189814 -25.68348 3.243191 3.054413 2.826086 2.481826 2.125819 1.763466 1.398495 1.029424 0.6586525 0.2939219 -5.9650823E-02 -0.3930455 -0.6915480 -0.9074325 -0.9921049 -0.8963342 -0.6262942 -0.2336191 0.2342386 -25.68348 3.000635 2.846009 2.649873 2.297492 1.932111 1.561266 1.182679 0.8050449 0.4294358 5.6902863E-02 -0.3053709 -0.6566827 -0.9803167 -1.237156 -1.373952 -1.310138 -1.020501 -0.5609082 -4.5071266E-04 -25.68348 2.700281 2.578161 2.410831 2.058961 1.693134 1.316815 0.9351951 0.5571772 0.1803209 -0.1897837 -0.5561319 -0.9155025 -1.250604 -1.543995 -1.734103 -1.725041 -1.444201 -0.9304017 -0.2801951 -25.68348 2.346335 2.255912 2.115290 1.769231 1.406600 1.034399 0.6585355 0.2852088 -8.5512005E-02 -0.4540865 -0.8165748 -1.170474 -1.514614 -1.830858 -2.069023 -2.127120 -1.885399 -1.334404 -0.5984696 -25.68348 1.940010 1.879133 1.764156 1.429095 1.076782 0.7157779 0.3515701 -1.0979205E-02 -0.3739222 -0.7350229 -1.086664 -1.434194 -1.779442 -2.104328 -2.379752 -2.509888 -2.332312 -1.765293 -0.9487560 -25.68348 1.479074 1.446431 1.358128 1.040037 0.7068523 0.3618079 1.1925473E-02 -0.3374243 -0.6861101 -1.032210 -1.372858 -1.713136 -2.050265 -2.380902 -2.674273 -2.873621 -2.781081 -2.225556 -1.335222 -25.68348 0.9621510 0.9590092 0.8984054 0.6040804 0.2924202 -3.2290962E-02 -0.3640231 -0.6931661 -1.022594 -1.354368 -1.682241 -2.009392 -2.339422 -2.663481 -2.972276 -3.222671 -3.224494 -2.708689 -1.753005 -25.68348 0.3801084 0.4094606 0.3779333 0.1123273 -0.1726376 -0.4713304 -0.7772636 -1.084715 -1.393523 -1.709398 -2.018982 -2.332980 -2.649804 -2.968422 -3.285977 -3.570777 -3.660494 -3.212805 -2.202596 -25.68348 -0.2759196 -0.2112163 -0.2116931 -0.4427089 -0.6950422 -0.9635291 -1.242300 -1.524856 -1.810774 -2.104522 -2.397509 -2.691139 -2.995973 -3.312271 -3.628191 -3.935864 -4.106170 -3.741861 -2.685435 -25.68348 -1.031804 -0.9267993 -0.8913458 -1.081997 -1.295822 -1.528751 -1.775664 -2.028850 -2.289906 -2.558754 -2.829591 -3.106775 -3.401458 -3.706330 -4.021603 -4.336163 -4.576826 -4.303019 -3.207476 -25.68348 -1.925224 -1.773043 -1.694816 -1.838040 -2.008624 -2.200882 -2.410436 -2.630949 -2.861009 -3.104817 -3.355898 -3.611119 -3.889928 -4.182791 -4.490603 -4.822354 -5.107678 -4.911639 -3.771024 -25.68348 -3.047404 -2.834202 -2.700490 -2.789357 -2.908634 -3.052308 -3.218684 -3.402257 -3.595915 -3.807617 -4.031996 -4.264191 -4.520760 -4.801905 -5.108545 -5.442469 -5.760189 -5.591464 -4.388990 -25.68348 -4.637577 -4.337485 -4.121086 -4.134499 -4.184840 -4.266163 -4.374847 -4.505220 -4.653868 -4.820395 -5.013576 -5.212762 -5.441055 -5.705272 -6.004847 -6.337761 -6.638632 -6.417502 -5.112147 -25.68348 -7.461791 -7.007595 -6.649010 -6.532014 -6.463065 -6.433727 -6.450269 -6.495368 -6.563480 -6.662324 -6.787404 -6.933704 -7.104236 -7.318030 -7.552709 -7.852676 -8.101268 -7.767520 -6.245213 -25.68348 -53.66652 -52.94886 -52.09954 -51.13102 -50.05518 -48.88266 -47.62253 -46.28258 -44.86944 -43.38875 -41.84535 -40.24343 -38.58664 -36.87818 -35.12093 -33.31741 -31.46993 -29.58055 -27.65116 -25.68348 3.526449 2.948219 2.412894 2.341309 2.228516 2.077493 1.895567 1.690761 1.473194 1.247789 1.022329 0.8076506 0.6147257 0.4536994 0.3290630 0.2403726 0.1816271 0.1457258 0.1262690 -29.49723 3.834843 3.365027 2.898815 2.745275 2.553862 2.329742 2.081869 1.818614 1.548887 1.277545 1.016086 0.7772519 0.5832907 0.4482254 0.3777966 0.3704683 0.4109507 0.4853659 0.5824806 -29.49723 3.972102 3.587219 3.187587 2.939091 2.665680 2.370898 2.061690 1.747039 1.430482 1.117968 0.8169839 0.5478987 0.3370446 0.2092265 0.1770117 0.2391721 0.3715521 0.5512697 0.7615467 -29.49723 3.976291 3.656818 3.305680 2.987214 2.653095 2.304747 1.953635 1.598648 1.242320 0.8931836 0.5548297 0.2481713 6.3280109E-04 -0.1503474 -0.1712414 -5.9947912E-02 0.1540466 0.4346992 0.7564459 -29.49723 3.875131 3.607665 3.295692 2.932708 2.558459 2.179548 1.797310 1.412686 1.029542 0.6505087 0.2834516 -5.9522968E-02 -0.3499524 -0.5482525 -0.5891622 -0.4549281 -0.1722007 0.2044804 0.6364262 -29.49723 3.691190 3.467275 3.188279 2.799388 2.405588 2.004875 1.603223 1.202650 0.7994859 0.4028212 1.7185817E-02 -0.3530293 -0.6844969 -0.9367786 -1.027624 -0.9006351 -0.5690659 -0.1032434 0.4375530 -29.49723 3.436104 3.250281 3.000613 2.603136 2.198203 1.786878 1.375140 0.9621601 0.5523565 0.1494733 -0.2485808 -0.6331865 -0.9960335 -1.292516 -1.453530 -1.368697 -1.014286 -0.4691282 0.1786127 -29.49723 3.119057 2.969803 2.747244 2.347930 1.941177 1.528192 1.111601 0.6979235 0.2861061 -0.1188895 -0.5161331 -0.9106929 -1.287567 -1.618598 -1.847554 -1.833982 -1.490269 -0.8798366 -0.1277796 -29.49723 2.742565 2.627982 2.431697 2.038023 1.636986 1.226892 0.8158774 0.4074916 -1.5839359E-03 -0.4009629 -0.7970449 -1.190591 -1.567831 -1.923005 -2.202953 -2.277957 -1.984738 -1.329841 -0.4774552 -29.49723 2.308734 2.226131 2.057086 1.675712 1.287225 0.8867652 0.4870129 8.7561131E-02 -0.3106512 -0.7036580 -1.091944 -1.474867 -1.853241 -2.216218 -2.531468 -2.691703 -2.484214 -1.812408 -0.8656619 -29.49723 1.818639 1.766387 1.625614 1.263229 0.8920192 0.5089762 0.1230812 -0.2604488 -0.6484177 -1.027927 -1.399976 -1.774823 -2.149018 -2.507191 -2.842970 -3.077711 -2.975950 -2.320034 -1.286633 -29.49723 1.268251 1.248153 1.135520 0.7985606 0.4502828 8.8626064E-02 -0.2788801 -0.6451962 -1.013884 -1.374303 -1.732537 -2.096825 -2.456812 -2.812361 -3.153026 -3.443895 -3.457620 -2.854883 -1.744524 -29.49723 0.6495928 0.6645875 0.5823937 0.2759161 -4.4903256E-02 -0.3810156 -0.7231073 -1.065801 -1.411348 -1.756127 -2.096768 -2.443464 -2.791107 -3.135998 -3.483130 -3.805012 -3.927530 -3.412082 -2.237254 -29.49723 -5.2853655E-02 7.4096880E-04 -4.6782266E-02 -0.3167031 -0.6024262 -0.9052801 -1.218718 -1.535629 -1.856737 -2.181297 -2.499233 -2.830171 -3.160118 -3.499713 -3.843508 -4.185471 -4.395047 -3.992471 -2.766304 -29.49723 -0.8575236 -0.7604008 -0.7677420 -0.9953693 -1.241984 -1.507741 -1.786973 -2.072531 -2.362621 -2.664760 -2.960554 -3.270622 -3.590848 -3.916800 -4.256416 -4.607220 -4.895264 -4.609053 -3.342704 -29.49723 -1.810691 -1.662837 -1.621172 -1.798225 -1.997823 -2.219942 -2.459743 -2.708959 -2.966153 -3.240631 -3.514583 -3.803902 -4.108835 -4.420861 -4.754017 -5.115193 -5.450998 -5.273669 -3.963217 -29.49723 -3.001660 -2.789395 -2.685374 -2.801523 -2.945618 -3.117286 -3.311139 -3.517802 -3.737058 -3.976011 -4.224804 -4.486676 -4.775546 -5.071956 -5.406063 -5.769434 -6.140600 -6.021895 -4.650972 -29.49723 -4.676197 -4.368487 -4.175695 -4.212803 -4.283335 -4.387752 -4.521255 -4.671746 -4.838456 -5.032331 -5.248028 -5.478771 -5.740979 -6.027266 -6.345207 -6.718228 -7.087653 -6.922061 -5.450957 -29.49723 -7.650622 -7.172519 -6.824137 -6.723843 -6.668763 -6.657470 -6.691745 -6.756098 -6.842407 -6.954216 -7.107563 -7.282848 -7.488304 -7.733185 -7.999753 -8.315151 -8.637652 -8.364233 -6.662821 -29.49723 -61.28404 -60.48789 -59.53418 -58.43935 -57.21892 -55.88616 -54.45243 -52.92714 -51.31828 -49.63248 -47.87548 -46.05214 -44.16673 -42.22294 -40.22411 -38.17315 -36.07271 -33.92517 -31.73269 -29.49723 3.849692 3.190643 2.690634 2.615185 2.497833 2.336905 2.143012 1.923481 1.686172 1.439759 1.193324 0.9600207 0.7500980 0.5776119 0.4462459 0.3538789 0.2962000 0.2629372 0.2458115 -33.43137 4.219854 3.680971 3.226433 3.058636 2.850152 2.607975 2.342131 2.058716 1.766017 1.471403 1.186343 0.9304347 0.7212939 0.5818291 0.5173739 0.5211969 0.5776341 0.6694087 0.7830169 -33.43137 4.394758 3.951448 3.536885 3.261513 2.960634 2.641729 2.307917 1.964880 1.623102 1.283469 0.9581063 0.6654047 0.4362708 0.3033839 0.2827798 0.3670854 0.5284397 0.7393014 0.9800330 -33.43137 4.416765 4.047716 3.661938 3.310138 2.944923 2.566968 2.182317 1.796534 1.412572 1.035011 0.6701624 0.3333088 6.1587818E-02 -9.9033959E-02 -0.1096527 3.3879962E-02 0.2901075 0.6162648 0.9827613 -33.43137 4.321341 4.010833 3.651469 3.253772 2.845465 2.429051 2.013175 1.595414 1.181649 0.7762720 0.3767295 2.8771455E-03 -0.3221010 -0.5403748 -0.5798222 -0.4105515 -7.4498095E-02 0.3620949 0.8532597 -33.43137 4.134144 3.873228 3.539122 3.114251 2.680246 2.241868 1.804628 1.369127 0.9391731 0.5117813 9.2041671E-02 -0.3099621 -0.6768033 -0.9634371 -1.064987 -0.9106333 -0.5165765 2.3689682E-02 0.6383316 -33.43137 3.867411 3.650137 3.340795 2.903462 2.459537 2.009361 1.562577 1.116874 0.6749590 0.2393535 -0.1891885 -0.6082107 -1.004506 -1.347455 -1.530297 -1.431975 -1.013027 -0.3801648 0.3561763 -33.43137 3.531840 3.354774 3.069632 2.632654 2.185436 1.734792 1.286125 0.8356351 0.3909072 -4.4939663E-02 -0.4775796 -0.9022026 -1.314337 -1.687886 -1.953642 -1.945671 -1.543471 -0.8343936 2.1001812E-02 -33.43137 3.134306 2.994364 2.734499 2.304227 1.863992 1.418307 0.9721102 0.5257071 8.5364692E-02 -0.3467708 -0.7758578 -1.203093 -1.616554 -2.005686 -2.331270 -2.429661 -2.091962 -1.330352 -0.3598496 -33.43137 2.676705 2.570596 2.338325 1.922406 1.495969 1.058801 0.6228180 0.1868067 -0.2461479 -0.6678550 -1.092316 -1.512880 -1.917231 -2.315639 -2.670924 -2.870018 -2.641891 -1.861612 -0.7819839 -33.43137 2.159056 2.086511 1.882837 1.487376 1.079166 0.6584350 0.2368449 -0.1850998 -0.6051652 -1.015877 -1.428616 -1.831551 -2.233280 -2.626190 -2.997141 -3.271005 -3.178236 -2.421386 -1.241499 -33.43137 1.578321 1.540738 1.366432 0.9970086 0.6123723 0.2137377 -0.1888437 -0.5931556 -0.9974433 -1.391119 -1.782719 -2.177355 -2.566680 -2.948242 -3.322264 -3.649103 -3.692239 -3.004226 -1.735280 -33.43137 0.9228759 0.9232967 0.7821089 0.4451083 8.9621529E-02 -0.2833951 -0.6629258 -1.041934 -1.422575 -1.795690 -2.171758 -2.553466 -2.922306 -3.295773 -3.666825 -4.023324 -4.190581 -3.614534 -2.270616 -33.43137 0.1805317 0.2222229 0.1193698 -0.1813153 -0.5024235 -0.8417427 -1.189593 -1.538758 -1.893624 -2.248510 -2.601388 -2.963955 -3.319679 -3.678224 -4.048390 -4.416831 -4.678782 -4.246000 -2.844601 -33.43137 -0.6731624 -0.5854989 -0.6426880 -0.8981398 -1.177309 -1.478415 -1.791058 -2.107009 -2.429468 -2.759776 -3.090511 -3.432078 -3.773521 -4.121280 -4.483934 -4.861635 -5.193719 -4.911695 -3.465960 -33.43137 -1.683723 -1.540853 -1.544669 -1.744901 -1.974636 -2.229812 -2.499984 -2.778350 -3.064792 -3.363932 -3.672656 -3.992723 -4.319841 -4.652980 -5.011457 -5.389792 -5.774203 -5.630148 -4.146746 -33.43137 -2.941247 -2.726323 -2.663697 -2.798971 -2.968964 -3.169244 -3.390704 -3.625257 -3.869507 -4.133699 -4.414775 -4.710938 -5.021115 -5.341621 -5.693225 -6.080096 -6.494544 -6.440499 -4.900999 -33.43137 -4.697867 -4.377987 -4.220897 -4.271097 -4.362299 -4.494961 -4.651053 -4.825873 -5.016937 -5.233150 -5.479620 -5.744692 -6.036211 -6.338293 -6.683475 -7.076410 -7.495955 -7.410575 -5.775281 -33.43137 -7.829484 -7.319134 -6.994311 -6.893561 -6.846334 -6.859326 -6.910247 -6.990587 -7.096739 -7.235548 -7.410221 -7.622947 -7.864919 -8.126947 -8.427581 -8.756978 -9.130290 -8.948174 -7.069458 -33.43137 -69.07755 -68.26695 -67.20552 -65.97987 -64.60936 -63.11050 -61.49688 -59.78009 -57.96843 -56.07066 -54.09301 -52.04111 -49.91980 -47.73336 -45.48553 -43.17965 -40.81873 -38.40545 -35.94226 -33.43137 4.163123 3.423150 2.963828 2.885388 2.757443 2.586229 2.377599 2.140368 1.880435 1.605952 1.332458 1.068912 0.8321152 0.6347259 0.4858083 0.3835066 0.3213308 0.2867720 0.2701640 -37.47786 4.599864 3.993579 3.554923 3.367991 3.141442 2.882034 2.597358 2.295721 1.981253 1.664196 1.359412 1.084257 0.8631887 0.7205772 0.6624692 0.6790904 0.7525141 0.8612209 0.9913021 -37.47786 4.810901 4.309042 3.881323 3.577182 3.249778 2.904334 2.546447 2.179785 1.811320 1.447999 1.098322 0.7831795 0.5358680 0.4018259 0.3947393 0.5032808 0.6951436 0.9373565 1.208844 -37.47786 4.851343 4.431200 4.012507 3.627464 3.228596 2.821395 2.407161 1.989626 1.580253 1.176064 0.7841143 0.4184104 0.1195760 -5.1535960E-02 -4.9791832E-02 0.1254017 0.4249074 0.7966126 1.208338 -37.47786 4.761878 4.407310 4.002446 3.567717 3.124024 2.674644 2.223286 1.774952 1.333962 0.8981170 0.4716116 6.2902428E-02 -0.2937765 -0.5337421 -0.5740448 -0.3704182 2.0518076E-02 0.5171759 1.068295 -37.47786 4.569959 4.271373 3.883712 3.421669 2.950529 2.474575 2.002299 1.534628 1.074745 0.6192915 0.1686573 -0.2655943 -0.6708066 -0.9868414 -1.107983 -0.9260616 -0.4687828 0.1459749 0.8354453 -37.47786 4.293156 4.043202 3.675609 3.200322 2.715059 2.229230 1.747277 1.267831 0.7973444 0.3296286 -0.1327038 -0.5805411 -1.011031 -1.390845 -1.606874 -1.502016 -1.016855 -0.2952325 0.5309767 -37.47786 3.940876 3.735008 3.389053 2.912222 2.426826 1.939913 1.455555 0.9723626 0.4969065 2.5818802E-02 -0.4387758 -0.8927923 -1.334762 -1.750260 -2.052995 -2.062332 -1.603293 -0.7938194 0.1664688 -37.47786 3.522059 3.355135 3.034619 2.568273 2.089666 1.607019 1.127241 0.6434112 0.1722063 -0.2944729 -0.7572396 -1.209366 -1.655056 -2.078243 -2.444812 -2.579982 -2.205691 -1.336707 -0.2464535 -37.47786 3.042468 2.912567 2.619082 2.168127 1.702846 1.231396 0.7574738 0.2837804 -0.1794222 -0.6373397 -1.092979 -1.539724 -1.977347 -2.402952 -2.798130 -3.043754 -2.803892 -1.915601 -0.7014603 -37.47786 2.499650 2.406078 2.141332 1.712654 1.266430 0.8098848 0.3501100 -0.1087455 -0.5613481 -1.005087 -1.452726 -1.886365 -2.310363 -2.733991 -3.135957 -3.456029 -3.378695 -2.523005 -1.194065 -37.47786 1.887586 1.832072 1.599578 1.197926 0.7758930 0.3397994 -9.9716708E-02 -0.5378023 -0.9760252 -1.403510 -1.834724 -2.252362 -2.666602 -3.076864 -3.481648 -3.842734 -3.922325 -3.156702 -1.726585 -37.47786 1.199266 1.184170 0.9872538 0.6173404 0.2252985 -0.1837914 -0.5989177 -1.012741 -1.428565 -1.835282 -2.245391 -2.652311 -3.048336 -3.447633 -3.843854 -4.228839 -4.438580 -3.814973 -2.300172 -37.47786 0.4179505 0.4462229 0.2915626 -3.9098941E-02 -0.3973180 -0.7735218 -1.156515 -1.538750 -1.924290 -2.312549 -2.702316 -3.089901 -3.471258 -3.854048 -4.245213 -4.638899 -4.946574 -4.499453 -2.920239 -37.47786 -0.4824135 -0.4043617 -0.5107893 -0.7928412 -1.107455 -1.442661 -1.788485 -2.137127 -2.490717 -2.851680 -3.218080 -3.588053 -3.949740 -4.321412 -4.703479 -5.103685 -5.474004 -5.210812 -3.587833 -37.47786 -1.544043 -1.406090 -1.455688 -1.682465 -1.943796 -2.230548 -2.531636 -2.840175 -3.158634 -3.487800 -3.828180 -4.174924 -4.522121 -4.882241 -5.256154 -5.658330 -6.084157 -5.980512 -4.327967 -37.47786 -2.867433 -2.653195 -2.629805 -2.788038 -2.983966 -3.213438 -3.460498 -3.721924 -3.999634 -4.290395 -4.603717 -4.923726 -5.254536 -5.603202 -5.969950 -6.387134 -6.836267 -6.844203 -5.141088 -37.47786 -4.706643 -4.380498 -4.255748 -4.322470 -4.433750 -4.588210 -4.769634 -4.968292 -5.191393 -5.433950 -5.710212 -6.002102 -6.311744 -6.647365 -7.012738 -7.423568 -7.886062 -7.890646 -6.091112 -37.47786 -7.981918 -7.447363 -7.151784 -7.057386 -7.018755 -7.041557 -7.111987 -7.212041 -7.349585 -7.518704 -7.724620 -7.958960 -8.220335 -8.509326 -8.837932 -9.194094 -9.603951 -9.509123 -7.465463 -37.47786 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.74101 -66.82596 -64.80591 -62.68973 -60.48490 -58.19778 -55.83386 -53.39794 -50.89425 -48.32655 -45.69817 -43.01216 -40.27123 -37.47786 4.467785 3.645239 3.236019 3.157793 3.021437 2.837817 2.616797 2.361813 2.079626 1.781172 1.479451 1.186469 0.9216323 0.6994871 0.5334277 0.4216487 0.3544668 0.3185741 0.3024557 -41.62963 4.973404 4.298838 3.879560 3.675729 3.427519 3.149698 2.846923 2.525602 2.188977 1.849821 1.521860 1.223802 0.9886223 0.8381183 0.7842735 0.8134141 0.9017154 1.026558 1.172785 -41.62963 5.222248 4.662944 4.223611 3.887535 3.531943 3.160984 2.776625 2.387785 1.996154 1.608563 1.233820 0.8943027 0.6337822 0.4961294 0.5032200 0.6376091 0.8602082 1.133603 1.436079 -41.62963 5.279849 4.808797 4.358449 3.938525 3.506469 3.068046 2.624160 2.181442 1.743486 1.313443 0.8924268 0.4990709 0.1756916 -6.4230766E-03 7.5196312E-03 0.2161772 0.5597356 0.9773927 1.434928 -41.62963 5.196540 4.797364 4.348361 3.875896 3.395145 2.912314 2.429343 1.950964 1.481661 1.016917 0.5622867 0.1225861 -0.2657628 -0.5316626 -0.5716262 -0.3332822 0.1132326 0.6703879 1.282316 -41.62963 5.000386 4.663498 4.223238 3.721948 3.212757 2.704028 2.195974 1.697271 1.206488 0.7189250 0.2430736 -0.2241725 -0.6597462 -1.009854 -1.154041 -0.9465499 -0.4258929 0.2636315 1.029085 -41.62963 4.711779 4.428757 4.003877 3.489770 2.967352 2.445546 1.927524 1.415699 0.9128861 0.4144364 -7.6343976E-02 -0.5530517 -1.015217 -1.427587 -1.686062 -1.575659 -1.026885 -0.2169340 0.7005602 -41.62963 4.344545 4.108307 3.703920 3.190003 2.664745 2.142636 1.620367 1.103934 0.5984631 9.2818119E-02 -0.4006184 -0.8813065 -1.350382 -1.798933 -2.146226 -2.179433 -1.668492 -0.7588879 0.3081010 -41.62963 3.907284 3.713352 3.333566 2.828521 2.312874 1.793396 1.274682 0.7598758 0.2546644 -0.2490030 -0.7372491 -1.215770 -1.687033 -2.145878 -2.548239 -2.724120 -2.324157 -1.349286 -0.1370010 -41.62963 3.404931 3.250823 2.898739 2.411652 1.908999 1.399283 0.8900882 0.3797936 -0.1165792 -0.6104484 -1.095106 -1.564036 -2.032184 -2.483853 -2.912608 -3.203378 -2.967591 -1.976059 -0.6251103 -41.62963 2.836861 2.722399 2.400357 1.935752 1.452529 0.9574152 0.4620532 -3.2976370E-02 -0.5181240 -0.9990476 -1.473473 -1.934036 -2.385952 -2.834177 -3.264043 -3.629277 -3.576804 -2.630229 -1.150221 -41.62963 2.196927 2.122826 1.834721 1.397418 0.9379711 0.4643984 -1.0148347E-02 -0.4838221 -0.9536504 -1.418503 -1.880882 -2.323576 -2.763031 -3.198211 -3.626092 -4.023817 -4.146313 -3.315319 -1.722024 -41.62963 1.475585 1.443743 1.194666 0.7909119 0.3613607 -8.4115259E-02 -0.5334790 -0.9822491 -1.430148 -1.876916 -2.315730 -2.744580 -3.169292 -3.587903 -4.009284 -4.422593 -4.677637 -4.019720 -2.334178 -41.62963 0.6571236 0.6719882 0.4668695 0.1050602 -0.2882392 -0.7012699 -1.118784 -1.536886 -1.955060 -2.376265 -2.796022 -3.207611 -3.614134 -4.021982 -4.427536 -4.848276 -5.199000 -4.750937 -2.997591 -41.62963 -0.2840728 -0.2159221 -0.3709990 -0.6844705 -1.032121 -1.402641 -1.779552 -2.162488 -2.549828 -2.944896 -3.339713 -3.732046 -4.119520 -4.511098 -4.908960 -5.330323 -5.739615 -5.505834 -3.711380 -41.62963 -1.396667 -1.265456 -1.358423 -1.613597 -1.905659 -2.225264 -2.555692 -2.898781 -3.251254 -3.615834 -3.985225 -4.351507 -4.718784 -5.097761 -5.485930 -5.912302 -6.366117 -6.316834 -4.496472 -41.62963 -2.782600 -2.569255 -2.585851 -2.767930 -2.991384 -3.247494 -3.523730 -3.817020 -4.128547 -4.456707 -4.795338 -5.138673 -5.485257 -5.850737 -6.232951 -6.667458 -7.149119 -7.233317 -5.373526 -41.62963 -4.702786 -4.367597 -4.278697 -4.361125 -4.495763 -4.670100 -4.873028 -5.106353 -5.364326 -5.645907 -5.946029 -6.261019 -6.585449 -6.938799 -7.315253 -7.752085 -8.251301 -8.349183 -6.397082 -41.62963 -8.113318 -7.559575 -7.278184 -7.184599 -7.170869 -7.207775 -7.285580 -7.418742 -7.595654 -7.799328 -8.035727 -8.293675 -8.575849 -8.888051 -9.227648 -9.611687 -10.03898 -10.04253 -7.854222 -41.62963 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -67.03982 -64.51127 -61.89845 -59.20672 -56.44078 -53.60480 -50.70252 -47.73726 -44.71205 -41.62963 4.764458 3.859515 3.506012 3.432525 3.288634 3.096037 2.862395 2.592793 2.290806 1.970594 1.647650 1.332685 1.045920 0.8093907 0.6331443 0.5167234 0.4480866 0.4132482 0.3984606 -45.88049 5.339883 4.595065 4.199557 3.977855 3.710874 3.412803 3.092250 2.750873 2.392813 2.030765 1.679253 1.361053 1.108823 0.9527429 0.9036309 0.9445307 1.047792 1.188861 1.351257 -45.88049 5.628624 5.011577 4.560466 4.195307 3.808430 3.410925 3.001636 2.588730 2.173231 1.762594 1.361764 0.9993193 0.7224606 0.5788453 0.5996992 0.7600902 1.012360 1.317039 1.650739 -45.88049 5.703692 5.182206 4.701834 4.243775 3.778588 3.308459 2.834493 2.365708 1.901868 1.445583 0.9967310 0.5755668 0.2301058 3.2074858E-02 5.8811896E-02 0.3018374 0.6894044 1.153455 1.657407 -45.88049 5.625168 5.181664 4.688889 4.178110 3.660049 3.143471 2.628452 2.122297 1.622011 1.130526 0.6476426 0.1812538 -0.2380755 -0.5321779 -0.5731865 -0.3010370 0.2012236 0.8199880 1.493634 -45.88049 5.424838 5.049337 4.557338 4.015721 3.469228 2.925740 2.384744 1.854176 1.331207 0.8157277 0.3132411 -0.1792374 -0.6463597 -1.034798 -1.198677 -0.9710528 -0.3882421 0.3775372 1.220147 -45.88049 5.124784 4.807820 4.326771 3.773247 3.213181 2.657548 2.101603 1.559331 1.022074 0.4933565 -2.0098872E-02 -0.5255632 -1.014057 -1.461002 -1.758615 -1.652168 -1.043653 -0.1441143 0.8661574 -45.88049 4.742126 4.475044 4.013750 3.461418 2.900126 2.338782 1.779952 1.231148 0.6890181 0.1565588 -0.3624109 -0.8700088 -1.367396 -1.841486 -2.234122 -2.295805 -1.740247 -0.7303702 0.4450800 -45.88049 4.288310 4.066470 3.629177 3.086600 2.530834 1.974648 1.418414 0.8693175 0.3314661 -0.2044562 -0.7187888 -1.223941 -1.718164 -2.203359 -2.642266 -2.865504 -2.448928 -1.367876 -3.1517934E-02 -45.88049 3.764204 3.585929 3.175776 2.651097 2.110093 1.562737 1.016871 0.4740102 -5.8201388E-02 -0.5863428 -1.094996 -1.590299 -2.080437 -2.559993 -3.019511 -3.354137 -3.137199 -2.044018 -0.5536424 -45.88049 3.170795 3.035171 2.656685 2.155049 1.633391 1.102283 0.5711946 4.1760504E-02 -0.4800029 -0.9953828 -1.493035 -1.979302 -2.459351 -2.923528 -3.385345 -3.787171 -3.778815 -2.746781 -1.113196 -45.88049 2.503906 2.410671 2.067680 1.594860 1.098295 0.5878943 7.7269435E-02 -0.4315799 -0.9370709 -1.434206 -1.920608 -2.393436 -2.854536 -3.307628 -3.760062 -4.192119 -4.366943 -3.479656 -1.719840 -45.88049 1.751426 1.703065 1.401156 0.9642720 0.4978412 1.5687041E-02 -0.4688498 -0.9534788 -1.436014 -1.915992 -2.383866 -2.833885 -3.283377 -3.718397 -4.164341 -4.601363 -4.909370 -4.233416 -2.372853 -45.88049 0.8992225 0.9003291 0.6443273 0.2493549 -0.1791268 -0.6261715 -1.079530 -1.535845 -1.991502 -2.446187 -2.890600 -3.323882 -3.752704 -4.174027 -4.603352 -5.042247 -5.435644 -5.005661 -3.073936 -45.88049 -8.2971565E-02 -2.5695473E-02 -0.2267971 -0.5725857 -0.9551624 -1.359150 -1.772458 -2.191766 -2.616090 -3.044692 -3.465430 -3.876864 -4.289076 -4.688225 -5.106355 -5.542854 -5.990956 -5.803349 -3.832840 -45.88049 -1.245102 -1.119738 -1.256309 -1.540881 -1.864233 -2.215423 -2.579896 -2.959103 -3.349565 -3.746625 -4.140305 -4.527909 -4.918732 -5.300865 -5.708380 -6.147629 -6.629416 -6.653343 -4.664836 -45.88049 -2.692186 -2.478694 -2.533975 -2.740025 -2.993609 -3.279136 -3.583243 -3.914918 -4.262786 -4.623531 -4.982497 -5.344157 -5.714940 -6.083836 -6.484711 -6.931618 -7.441745 -7.613049 -5.600106 -45.88049 -4.688354 -4.348085 -4.290030 -4.391306 -4.550995 -4.750502 -4.978202 -5.247736 -5.541251 -5.852698 -6.171829 -6.501290 -6.853001 -7.212190 -7.611476 -8.071037 -8.590821 -8.792352 -6.696017 -45.88049 -8.229730 -7.656847 -7.403150 -7.306396 -7.299710 -7.360500 -7.468750 -7.636373 -7.842316 -8.078564 -8.331814 -8.608828 -8.914471 -9.243764 -9.603897 -10.01406 -10.44911 -10.55736 -8.240475 -45.88049 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.10439 -65.15091 -62.11699 -59.00648 -55.82423 -52.57365 -49.25806 -45.88049 5.054334 4.067225 3.772972 3.699630 3.555205 3.353133 3.108484 2.821997 2.501221 2.162196 1.816347 1.480076 1.173213 0.9214978 0.7349190 0.6135713 0.5443090 0.5107046 0.4970567 -50.22493 5.700005 4.884030 4.510414 4.275478 3.989886 3.673520 3.333710 2.971869 2.594119 2.209975 1.838557 1.502122 1.235266 1.077715 1.035084 1.089346 1.208869 1.366702 1.545412 -50.22493 6.029203 5.353187 4.891759 4.497602 4.082087 3.654853 3.221100 2.784256 2.346349 1.912151 1.487331 1.104577 0.8074419 0.6622602 0.6972968 0.8834483 1.166592 1.502960 1.868181 -50.22493 6.123293 5.551549 5.039916 4.546309 4.044859 3.542533 3.039792 2.543594 2.055059 1.574010 1.098748 0.6518779 0.2784850 6.5295897E-02 0.1032355 0.3804491 0.8125654 1.323500 1.874385 -50.22493 6.048202 5.560602 5.026121 4.474055 3.920158 3.368054 2.821853 2.286904 1.759290 1.241437 0.7329960 0.2395926 -0.2099852 -0.5325627 -0.5792237 -0.2752108 0.2839035 0.9649265 1.701058 -50.22493 5.843026 5.429240 4.885665 4.303869 3.719598 3.140762 2.567392 2.007755 1.450985 0.9112472 0.3818839 -0.1337843 -0.6317728 -1.053511 -1.243207 -1.001452 -0.3555664 0.4877863 1.408550 -50.22493 5.532092 5.180623 4.644815 4.050935 3.453595 2.861780 2.273536 1.696253 1.126415 0.5723159 3.3209860E-02 -0.4968322 -1.011839 -1.492966 -1.825077 -1.733048 -1.066852 -7.5976379E-02 1.028195 -50.22493 5.135047 4.836573 4.319204 3.726780 3.129094 2.532150 1.934890 1.354114 0.7767548 0.2168465 -0.3258432 -0.8603135 -1.380436 -1.880656 -2.313083 -2.413254 -1.820042 -0.7081454 0.5770254 -50.22493 4.663471 4.413548 3.919441 3.339495 2.747047 2.150430 1.559337 0.9764250 0.4012787 -0.1600203 -0.7016796 -1.231066 -1.747290 -2.253548 -2.727083 -3.000998 -2.581320 -1.393811 6.8005346E-02 -50.22493 4.119217 3.916598 3.450062 2.886426 2.306972 1.722449 1.141193 0.5640162 -5.0769360E-03 -0.5618191 -1.095456 -1.619401 -2.122875 -2.628171 -3.110511 -3.495525 -3.309540 -2.116671 -0.4855448 -50.22493 3.500606 3.343445 2.909180 2.371209 1.811451 1.243504 0.6775068 0.1120713 -0.4459008 -0.9902080 -1.514739 -2.023592 -2.519794 -3.007318 -3.490983 -3.930688 -3.976596 -2.867782 -1.079287 -50.22493 2.806594 2.694414 2.298203 1.790409 1.256148 0.7104485 0.1623577 -0.3833019 -0.9253781 -1.454340 -1.961731 -2.458774 -2.936684 -3.410772 -3.882667 -4.345401 -4.577634 -3.647487 -1.720959 -50.22493 2.025918 1.961260 1.607510 1.135695 0.6326208 0.1147766 -0.4081377 -0.9312356 -1.450786 -1.959836 -2.450999 -2.926666 -3.385549 -3.842404 -4.304452 -4.764112 -5.126510 -4.448380 -2.412613 -50.22493 1.139735 1.126932 0.8228756 0.3931043 -7.1097419E-02 -0.5539987 -1.043876 -1.538620 -2.033080 -2.517865 -2.981576 -3.439291 -3.879117 -4.316673 -4.766278 -5.219836 -5.656895 -5.260156 -3.153189 -50.22493 0.1192320 0.1657864 -8.2028054E-02 -0.4595517 -0.8767282 -1.316226 -1.765206 -2.225046 -2.686354 -3.140762 -3.580394 -4.014372 -4.436665 -4.856239 -5.290510 -5.739377 -6.221769 -6.097119 -3.956655 -50.22493 -1.090540 -0.9710265 -1.151674 -1.464687 -1.822996 -2.205510 -2.606042 -3.023884 -3.450372 -3.872043 -4.283016 -4.693629 -5.092167 -5.493249 -5.916642 -6.365487 -6.874616 -6.981635 -4.835891 -50.22493 -2.593505 -2.381235 -2.477130 -2.709764 -2.991919 -3.306847 -3.649866 -4.018378 -4.399888 -4.781988 -5.158861 -5.536126 -5.919435 -6.304127 -6.723162 -7.178417 -7.721987 -7.984468 -5.826521 -50.22493 -4.660738 -4.316571 -4.297639 -4.417810 -4.598359 -4.821881 -5.088802 -5.390213 -5.714668 -6.051813 -6.384783 -6.727068 -7.096583 -7.471847 -7.897394 -8.369608 -8.928062 -9.216813 -6.986292 -50.22493 -8.325732 -7.738526 -7.506868 -7.423425 -7.422470 -7.492886 -7.639935 -7.836022 -8.071240 -8.347118 -8.619612 -8.915763 -9.244701 -9.594244 -9.981698 -10.39911 -10.84975 -11.05200 -8.612291 -50.22493 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -67.91479 -64.52459 -61.05669 -57.51510 -53.90343 -50.22493 5.338786 4.267663 4.038286 3.964633 3.816146 3.610678 3.353271 3.050856 2.711743 2.353946 1.984147 1.624736 1.300586 1.032776 0.8361145 0.7101814 0.6406487 0.6077378 0.5951265 -54.65804 6.054962 5.167035 4.817845 4.565615 4.265253 3.928436 3.571211 3.188937 2.790205 2.387582 1.991538 1.635397 1.358947 1.198571 1.162100 1.230329 1.366442 1.540984 1.736092 -54.65804 6.423987 5.688262 5.216122 4.795412 4.350381 3.894535 3.435640 2.973888 2.517070 2.055359 1.608376 1.202058 0.8890136 0.7423541 0.7902364 1.003258 1.317824 1.686064 2.083172 -54.65804 6.537405 5.914340 5.373172 4.843501 4.307759 3.770736 3.239914 2.717463 2.204047 1.694337 1.195087 0.7241702 0.3247813 9.7871542E-02 0.1445033 0.4559847 0.9336506 1.491791 2.090221 -54.65804 6.466626 5.935184 5.357622 4.766304 4.174319 3.587498 3.010956 2.446330 1.888069 1.345636 0.8149168 0.2970031 -0.1800477 -0.5328642 -0.5896164 -0.2543313 0.3622873 1.105993 1.905493 -54.65804 6.255277 5.802989 5.209922 4.586232 3.965339 3.349867 2.746415 2.150501 1.566467 1.000603 0.4486737 -9.1341250E-02 -0.6142907 -1.068341 -1.289757 -1.039171 -0.3288524 0.5922543 1.592297 -54.65804 5.933330 5.547387 4.957627 4.323256 3.689137 3.060431 2.437483 1.826234 1.223561 0.6466217 8.2150303E-02 -0.4689256 -1.008384 -1.516372 -1.887169 -1.819400 -1.095777 -1.3010310E-02 1.186446 -54.65804 5.522786 5.192857 4.619543 3.988274 3.352419 2.717755 2.086617 1.467624 0.8592046 0.2754740 -0.2922883 -0.8478429 -1.388179 -1.913207 -2.379662 -2.529025 -1.905510 -0.6919246 0.7045729 -54.65804 5.033678 4.755770 4.206028 3.585685 2.955304 2.323301 1.693598 1.075628 0.4680624 -0.1169582 -0.6860421 -1.235608 -1.770601 -2.295263 -2.802688 -3.130510 -2.717524 -1.426296 0.1626990 -54.65804 4.467972 4.240963 3.718791 3.116927 2.498955 1.877906 1.259492 0.6477655 4.5882411E-02 -0.5378584 -1.097811 -1.639618 -2.160988 -2.685096 -3.191753 -3.628047 -3.480942 -2.191890 -0.4178591 -54.65804 3.826526 3.647462 3.158580 2.582521 1.985875 1.381975 0.7774141 0.1775784 -0.4173449 -0.9885507 -1.536043 -2.063002 -2.572814 -3.087529 -3.586330 -4.065591 -4.173028 -2.999226 -1.054210 -54.65804 3.106322 2.974549 2.525871 1.982192 1.411087 0.8292634 0.2417637 -0.3422311 -0.9202009 -1.474325 -2.003550 -2.516789 -3.012615 -3.505391 -3.996471 -4.490354 -4.779639 -3.825369 -1.731717 -54.65804 2.297478 2.216081 1.811488 1.304491 0.7650186 0.2101852 -0.3523797 -0.9139035 -1.468868 -1.998690 -2.510412 -3.008439 -3.478788 -3.959153 -4.435276 -4.927318 -5.327691 -4.666315 -2.457021 -54.65804 1.378674 1.351875 0.9985139 0.5358204 3.4938324E-02 -0.4831514 -1.012698 -1.545179 -2.073773 -2.580497 -3.066243 -3.540144 -3.995010 -4.456071 -4.921469 -5.401911 -5.862992 -5.514388 -3.236069 -54.65804 0.3214790 0.3573683 6.3076034E-02 -0.3466544 -0.7992192 -1.273246 -1.764795 -2.262652 -2.756799 -3.231279 -3.688017 -4.141994 -4.576442 -5.023420 -5.467769 -5.939783 -6.436530 -6.382649 -4.082818 -54.65804 -0.9309344 -0.8185420 -1.043873 -1.388603 -1.778773 -2.197586 -2.638702 -3.093807 -3.549769 -3.992961 -4.418155 -4.846385 -5.262520 -5.688677 -6.120660 -6.584792 -7.109301 -7.291646 -5.008211 -54.65804 -2.486055 -2.277494 -2.415966 -2.675780 -2.987103 -3.332970 -3.713088 -4.117392 -4.530948 -4.937511 -5.327886 -5.725540 -6.121300 -6.533825 -6.957775 -7.425908 -7.983902 -8.322543 -6.053846 -54.65804 -4.624808 -4.278243 -4.289527 -4.435093 -4.641325 -4.892332 -5.190614 -5.525012 -5.879224 -6.240964 -6.594371 -6.966686 -7.341050 -7.746319 -8.175577 -8.651384 -9.220691 -9.605870 -7.273471 -54.65804 -8.406195 -7.807371 -7.594672 -7.531719 -7.549508 -7.633288 -7.797360 -8.030044 -8.300274 -8.590773 -8.896658 -9.218960 -9.562787 -9.934137 -10.33199 -10.76199 -11.24126 -11.52175 -8.980336 -54.65804 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -66.39403 -62.55606 -58.64290 -54.65804 5.618081 4.462346 4.298345 4.226252 4.075942 3.864405 3.595729 3.277518 2.920510 2.540406 2.150664 1.769714 1.425483 1.141695 0.9340003 0.8041693 0.7334558 0.7010266 0.6892689 -59.17545 6.406045 5.444760 5.122109 4.851442 4.533817 4.180886 3.802446 3.401416 2.981266 2.557711 2.142366 1.767494 1.481073 1.317060 1.288255 1.371570 1.524283 1.715533 1.927172 -59.17545 6.814238 6.017438 5.536119 5.086143 4.615258 4.128241 3.645069 3.159588 2.677230 2.194998 1.726343 1.294310 0.9673849 0.8159840 0.8763368 1.117305 1.463225 1.863661 2.293033 -59.17545 6.946084 6.271287 5.700234 5.136692 4.564857 3.994882 3.434520 2.883105 2.346473 1.812572 1.290767 0.7949979 0.3719105 0.1299701 0.1818936 0.5297356 1.053244 1.659224 2.305853 -59.17545 6.879936 6.304326 5.684419 5.052954 4.424763 3.801373 3.194169 2.597489 2.014089 1.448897 0.8936094 0.3543457 -0.1500286 -0.5306169 -0.6014947 -0.2334721 0.4412033 1.248416 2.112165 -59.17545 6.662465 6.171896 5.528409 4.865007 4.205535 3.553633 2.917275 2.286523 1.678180 1.085608 0.5119988 -4.9080409E-02 -0.5949860 -1.080014 -1.339105 -1.079388 -0.3069259 0.6928295 1.773277 -59.17545 6.329417 5.908685 5.266285 4.590467 3.919048 3.252404 2.594765 1.949804 1.319203 0.7171760 0.1306119 -0.4393324 -1.000869 -1.531580 -1.947081 -1.909747 -1.132538 4.2164590E-02 1.338249 -59.17545 5.904553 5.543148 4.915307 4.243925 3.569264 2.896628 2.232196 1.576845 0.9392980 0.3306102 -0.2620859 -0.8321713 -1.394041 -1.938110 -2.441161 -2.642296 -1.996565 -0.6816473 0.8277624 -59.17545 5.397841 5.092459 4.486663 3.826488 3.156833 2.490526 1.824453 1.169721 0.5322598 -7.8904368E-02 -0.6696603 -1.235086 -1.790538 -2.331276 -2.870224 -3.247041 -2.855555 -1.464624 0.2534768 -59.17545 4.811605 4.559757 3.981274 3.342072 2.687388 2.028211 1.373739 0.7239478 8.9369409E-02 -0.5161469 -1.101212 -1.653070 -2.199399 -2.735393 -3.275806 -3.745316 -3.651164 -2.279742 -0.3612640 -59.17545 4.148182 3.946420 3.403724 2.790889 2.156036 1.515774 0.8719735 0.2320921 -0.3917374 -0.9864680 -1.556692 -2.095336 -2.626286 -3.157481 -3.683620 -4.187775 -4.356950 -3.135199 -1.031950 -59.17545 3.402092 3.250575 2.749418 2.170328 1.562024 0.9422027 0.3165705 -0.3085134 -0.9138995 -1.488757 -2.042655 -2.563928 -3.085890 -3.596918 -4.110498 -4.619640 -4.963933 -4.007712 -1.745185 -59.17545 2.564833 2.466496 2.012318 1.469252 0.8941523 0.3025097 -0.2999793 -0.9016989 -1.483742 -2.035227 -2.567336 -3.076478 -3.577307 -4.073843 -4.566017 -5.070902 -5.510882 -4.889040 -2.506226 -59.17545 1.615926 1.575005 1.173619 0.6751156 0.1393993 -0.4168129 -0.9879846 -1.559382 -2.113707 -2.639641 -3.147228 -3.633707 -4.119740 -4.595591 -5.070872 -5.558951 -6.048480 -5.771749 -3.324074 -59.17545 0.5254347 0.5495324 0.2079039 -0.2344818 -0.7223795 -1.234845 -1.767871 -2.301782 -2.825978 -3.318081 -3.797268 -4.263864 -4.729973 -5.188334 -5.640427 -6.115935 -6.631196 -6.664931 -4.212128 -59.17545 -0.7668932 -0.6635314 -0.9334092 -1.309614 -1.734696 -2.188962 -2.669498 -3.158972 -3.646713 -4.107707 -4.561387 -5.004699 -5.448954 -5.881610 -6.316063 -6.783883 -7.321786 -7.595341 -5.179372 -59.17545 -2.373838 -2.169703 -2.345295 -2.636594 -2.981733 -3.361156 -3.777171 -4.214706 -4.659221 -5.084948 -5.507461 -5.922710 -6.339754 -6.753971 -7.179117 -7.652664 -8.222603 -8.651662 -6.271832 -59.17545 -4.581993 -4.235109 -4.280215 -4.453506 -4.691309 -4.970597 -5.298398 -5.666398 -6.050839 -6.426020 -6.816666 -7.199259 -7.600684 -8.005965 -8.432630 -8.919034 -9.499416 -9.981761 -7.560327 -59.17545 -8.469831 -7.861843 -7.676507 -7.636863 -7.683499 -7.782133 -7.959922 -8.229285 -8.525211 -8.836070 -9.176540 -9.526731 -9.895108 -10.27328 -10.66738 -11.10995 -11.59849 -11.96165 -9.345853 -59.17545 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -67.69160 -63.47182 -59.17545 5.891464 4.648604 4.556667 4.486593 4.338388 4.116878 3.835006 3.500127 3.127236 2.726187 2.315129 1.914043 1.548842 1.247603 1.030182 0.8953321 0.8237030 0.7916381 0.7805808 -63.77322 6.751878 5.714651 5.419357 5.135182 4.799150 4.428002 4.028392 3.607891 3.165698 2.723040 2.288849 1.896416 1.595932 1.426738 1.406844 1.504004 1.673283 1.881199 2.109457 -63.77322 7.201555 6.341354 5.852851 5.373393 4.872638 4.359468 3.847430 3.339063 2.832999 2.331175 1.838815 1.385817 1.044272 0.8839969 0.9613062 1.229726 1.607718 2.040573 2.502590 -63.77322 7.351357 6.624592 6.022620 5.422806 4.818336 4.212523 3.622945 3.043402 2.481477 1.929344 1.384902 0.8646488 0.4197225 0.1569352 0.2174442 0.6015583 1.171722 1.826183 2.521621 -63.77322 7.286484 6.666537 6.005052 5.335659 4.668452 4.010523 3.369274 2.741772 2.137530 1.548160 0.9704266 0.4094653 -0.1187898 -0.5298191 -0.6163861 -0.2180856 0.5147605 1.386325 2.315155 -63.77322 7.063862 6.534703 5.842720 5.137713 4.440770 3.750525 3.079681 2.419595 1.785400 1.169444 0.5736288 -7.0865317E-03 -0.5715711 -1.089100 -1.385747 -1.124197 -0.2913558 0.7878230 1.949703 -63.77322 6.719999 6.264632 5.569281 4.853778 4.141836 3.437818 2.747809 2.067634 1.413356 0.7825506 0.1791005 -0.4111003 -0.9874480 -1.545925 -2.002325 -1.996315 -1.175227 9.2352040E-02 1.486316 -63.77322 6.280672 5.888293 5.205739 4.493289 3.778852 3.072359 2.371505 1.682040 1.015689 0.3824259 -0.2273738 -0.8162676 -1.395207 -1.962899 -2.493634 -2.748357 -2.095079 -0.6792356 0.9444957 -63.77322 5.756001 5.422753 4.760873 4.061415 3.355455 2.651661 1.950805 1.256551 0.5919262 -4.3221310E-02 -0.6502376 -1.234440 -1.806824 -2.373538 -2.927282 -3.349169 -2.999378 -1.511367 0.3372976 -63.77322 5.149408 4.872482 4.239483 3.562427 2.871621 2.175564 1.479482 0.7926646 0.1320827 -0.4966578 -1.097715 -1.669150 -2.234657 -2.788248 -3.346526 -3.845751 -3.822468 -2.377615 -0.3130303 -63.77322 4.463888 4.239510 3.644231 2.995054 2.322804 1.642849 0.9599678 0.2832356 -0.3648037 -0.9824442 -1.569401 -2.129020 -2.680609 -3.225028 -3.764978 -4.290808 -4.533116 -3.273680 -1.010071 -63.77322 3.694230 3.522743 2.969866 2.352727 1.708979 1.050735 0.3840930 -0.2753918 -0.9077102 -1.502141 -2.074573 -2.618885 -3.160011 -3.687332 -4.208904 -4.729405 -5.136917 -4.194653 -1.762571 -63.77322 2.828710 2.713193 2.209791 1.631010 1.018934 0.3894378 -0.2565946 -0.8915742 -1.499607 -2.070956 -2.619730 -3.153643 -3.679071 -4.180924 -4.682798 -5.193407 -5.682072 -5.113865 -2.560807 -63.77322 1.851370 1.795383 1.346104 0.8143854 0.2407064 -0.3548887 -0.9675931 -1.572185 -2.153348 -2.698116 -3.228418 -3.741367 -4.242081 -4.722247 -5.202297 -5.697010 -6.220635 -6.025095 -3.416009 -63.77322 0.7285076 0.7397940 0.3532283 -0.1224177 -0.6464676 -1.199129 -1.769417 -2.338725 -2.887062 -3.407782 -3.908199 -4.399306 -4.876546 -5.332160 -5.792278 -6.271657 -6.809062 -6.932116 -4.343717 -63.77322 -0.6008730 -0.5078367 -0.8195183 -1.228402 -1.691538 -2.184481 -2.702954 -3.228084 -3.737136 -4.227225 -4.702601 -5.166665 -5.620363 -6.051137 -6.489962 -6.961859 -7.515121 -7.874118 -5.352734 -63.77322 -2.257190 -2.059136 -2.274990 -2.598603 -2.980590 -3.395949 -3.846508 -4.320859 -4.783738 -5.235555 -5.681767 -6.116219 -6.543157 -6.955864 -7.377417 -7.857155 -8.433249 -8.942870 -6.489331 -63.77322 -4.528955 -4.182261 -4.262186 -4.465337 -4.734711 -5.047658 -5.409977 -5.813283 -6.212761 -6.616043 -7.023762 -7.428435 -7.832274 -8.240229 -8.664115 -9.158146 -9.746075 -10.31228 -7.843861 -63.77322 -8.514934 -7.893441 -7.736816 -7.723019 -7.785703 -7.913194 -8.126917 -8.408919 -8.729430 -9.071666 -9.425764 -9.797028 -10.16866 -10.55993 -10.96622 -11.42066 -11.92954 -12.36027 -9.706691 -63.77322 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.38597 -63.77322 6.161083 4.829077 4.811022 4.744805 4.600989 4.366590 4.069898 3.720419 3.328605 2.911606 2.476643 2.051462 1.667882 1.348895 1.119466 0.9794475 0.9065614 0.8746313 0.8640950 -68.44775 7.095589 5.979224 5.714911 5.416131 5.061373 4.665762 4.248769 3.805617 3.351317 2.885595 2.427144 2.020127 1.704781 1.533089 1.520721 1.632246 1.818132 2.042798 2.287800 -68.44775 7.588823 6.661802 6.167806 5.658859 5.122918 4.583798 4.044216 3.515067 2.986238 2.460535 1.942976 1.476894 1.115601 0.9500673 1.043290 1.339827 1.750101 2.215683 2.710720 -68.44775 7.752322 6.972997 6.342164 5.702705 5.063970 4.427100 3.805110 3.202072 2.614544 2.037572 1.474649 0.9343066 0.4663327 0.1834202 0.2549078 0.6769264 1.295024 1.998495 2.743376 -68.44775 7.688604 7.024803 6.318546 5.611372 4.908039 4.214345 3.540721 2.884398 2.252255 1.638880 1.046828 0.4646368 -8.6402141E-02 -0.5266011 -0.6288811 -0.1981267 0.5941209 1.530990 2.525754 -68.44775 7.458693 6.890838 6.150707 5.406547 4.669941 3.945247 3.237709 2.544781 1.883369 1.249882 0.6353846 3.6449119E-02 -0.5488198 -1.096684 -1.428533 -1.172940 -0.2829733 0.8765509 2.120857 -68.44775 7.104767 6.614688 5.867039 5.111594 4.361062 3.619745 2.891111 2.177183 1.501786 0.8482067 0.2276178 -0.3821990 -0.9742339 -1.560350 -2.045680 -2.083920 -1.226511 0.1345388 1.627546 -68.44775 6.650668 6.226992 5.490629 4.737555 3.985411 3.239704 2.501540 1.780904 1.090863 0.4312067 -0.1917588 -0.8027751 -1.397489 -1.986859 -2.533930 -2.849515 -2.202370 -0.6862525 1.053061 -68.44775 6.107592 5.747067 5.029377 4.291742 3.547391 2.804529 2.067946 1.339928 0.6485377 -1.0433495E-02 -0.6304200 -1.235480 -1.825969 -2.407419 -2.969060 -3.444522 -3.142534 -1.558620 0.4220887 -68.44775 5.481355 5.179306 4.492054 3.777048 3.048355 2.315159 1.580353 0.8585811 0.1746252 -0.4787001 -1.089895 -1.689499 -2.269701 -2.833678 -3.397724 -3.934784 -3.986611 -2.476852 -0.2648256 -68.44775 4.774077 4.527076 3.879082 3.193122 2.484836 1.764313 1.042074 0.3315742 -0.3406041 -0.9781639 -1.581826 -2.169507 -2.735809 -3.283229 -3.832616 -4.384322 -4.697587 -3.425370 -1.001996 -68.44775 3.981359 3.789796 3.185954 2.531886 1.850979 1.152441 0.4448612 -0.2470693 -0.9014301 -1.519453 -2.107960 -2.682559 -3.228078 -3.763087 -4.288628 -4.833137 -5.292544 -4.387462 -1.788315 -68.44775 3.088828 2.955624 2.403375 1.789717 1.140833 0.4680996 -0.2145467 -0.8844907 -1.514794 -2.111879 -2.681074 -3.235009 -3.764297 -4.269862 -4.782103 -5.310373 -5.834166 -5.338807 -2.620503 -68.44775 2.084674 2.012483 1.516148 0.9508138 0.3409219 -0.2973683 -0.9479094 -1.587000 -2.189874 -2.763126 -3.311028 -3.846246 -4.346704 -4.833125 -5.321780 -5.835111 -6.378693 -6.272364 -3.513135 -68.44775 0.9315450 0.9286456 0.4971187 -1.1256090E-02 -0.5750886 -1.166996 -1.775900 -2.379370 -2.949558 -3.499004 -4.018676 -4.524299 -5.005906 -5.467226 -5.933978 -6.434478 -6.980729 -7.190153 -4.477830 -68.44775 -0.4348784 -0.3527961 -0.7060264 -1.149949 -1.651812 -2.185205 -2.743084 -3.300606 -3.830309 -4.344713 -4.837542 -5.311604 -5.769096 -6.212734 -6.656959 -7.144869 -7.702670 -8.145893 -5.528932 -68.44775 -2.137670 -1.946258 -2.199339 -2.556853 -2.974912 -3.430369 -3.922488 -4.421324 -4.908385 -5.384191 -5.843368 -6.285402 -6.719383 -7.144851 -7.573311 -8.064279 -8.648438 -9.232147 -6.708944 -68.44775 -4.466181 -4.119216 -4.234315 -4.467348 -4.769688 -5.123275 -5.529611 -5.948300 -6.381000 -6.811115 -7.227404 -7.638996 -8.048055 -8.465892 -8.903068 -9.408868 -10.00970 -10.63166 -8.122411 -68.44775 -8.563845 -7.924911 -7.799837 -7.816600 -7.905214 -8.065875 -8.319293 -8.612459 -8.961446 -9.339030 -9.707056 -10.08825 -10.47368 -10.86843 -11.28508 -11.74270 -12.25798 -12.73278 -10.06497 -68.44775 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.44775 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.8499198 -0.8181729 -0.7856686 -0.7524146 -0.7184198 -0.6836920 -0.6482393 -0.6120683 -0.5751804 -0.5375954 -0.4993210 -0.4603648 -0.4207348 -0.3804383 -0.3394793 -0.2978619 -0.2556050 -0.2127157 -0.1692010 -0.1250684 -0.7371622 -0.7422071 -0.7478510 -0.7644770 -0.7827361 -0.8009180 -0.8173620 -0.8308002 -0.8401289 -0.8524731 -0.8740193 -0.9152600 -0.9511558 -0.9825381 -1.009120 -1.037488 -1.066013 -1.090998 -1.110085 -2.074072 -0.7861697 -0.7895452 -0.7934959 -0.8078036 -0.8239688 -0.8400865 -0.8546522 -0.8663796 -0.8742227 -0.8846434 -0.9038540 -0.9467830 -0.9842085 -1.015719 -1.041678 -1.069069 -1.095990 -1.118448 -1.133897 -2.074072 -0.8365742 -0.8382372 -0.8404637 -0.8524880 -0.8665677 -0.8806477 -0.8934379 -0.9035122 -0.9099212 -0.9185848 -0.9356444 -0.9797976 -1.017366 -1.048678 -1.073657 -1.100159 -1.125318 -1.145042 -1.156751 -2.074072 -0.8895613 -0.8894409 -0.8899217 -0.8997388 -0.9117213 -0.9238761 -0.9350156 -0.9434897 -0.9485757 -0.9556974 -0.9709054 -1.015857 -1.053271 -1.083931 -1.108022 -1.133497 -1.156821 -1.173691 -1.181643 -2.074072 -0.9453825 -0.9433697 -0.9420868 -0.9496720 -0.9594820 -0.9697620 -0.9792988 -0.9862399 -0.9900294 -0.9956557 -1.009037 -1.053235 -1.090181 -1.120076 -1.143179 -1.167486 -1.188866 -1.202607 -1.206683 -2.074072 -1.002284 -0.9982960 -0.9951793 -1.000467 -1.008019 -1.016414 -1.024156 -1.029557 -1.031924 -1.035968 -1.047550 -1.090643 -1.126504 -1.155126 -1.177398 -1.200004 -1.219197 -1.229504 -1.229573 -2.074072 -1.061608 -1.055594 -1.050622 -1.053809 -1.059126 -1.065681 -1.071634 -1.075519 -1.076422 -1.078913 -1.088817 -1.130788 -1.165551 -1.192896 -1.214152 -1.234927 -1.251704 -1.258461 -1.254421 -2.074072 -1.124942 -1.116744 -1.109609 -1.110611 -1.113635 -1.118249 -1.122360 -1.124690 -1.124014 -1.124915 -1.133072 -1.173403 -1.206709 -1.232977 -1.252895 -1.271556 -1.285543 -1.288576 -1.280273 -2.074072 -1.192700 -1.182175 -1.172673 -1.171520 -1.172115 -1.174601 -1.176840 -1.177531 -1.175203 -1.174485 -1.180892 -1.219779 -1.251543 -1.276943 -1.295031 -1.311725 -1.322343 -1.321579 -1.308870 -2.074072 -1.266450 -1.253276 -1.241232 -1.237544 -1.235721 -1.235805 -1.236008 -1.234835 -1.230764 -1.228232 -1.232765 -1.269588 -1.300363 -1.324403 -1.340373 -1.354606 -1.361522 -1.356767 -1.339485 -2.074072 -1.346488 -1.330086 -1.315226 -1.308527 -1.304046 -1.301435 -1.299349 -1.295956 -1.289913 -1.285180 -1.287659 -1.322637 -1.352015 -1.374016 -1.387961 -1.398645 -1.401282 -1.392360 -1.370288 -2.074072 -1.436816 -1.416899 -1.398621 -1.388437 -1.380880 -1.375283 -1.370544 -1.364697 -1.356530 -1.349381 -1.349518 -1.382899 -1.410224 -1.429951 -1.441225 -1.447626 -1.445966 -1.432464 -1.405449 -2.074072 -1.541584 -1.517234 -1.494725 -1.480735 -1.469314 -1.460128 -1.451981 -1.443116 -1.432314 -1.422316 -1.419751 -1.450618 -1.475232 -1.492806 -1.499606 -1.501068 -1.494900 -1.476372 -1.444222 -2.074072 -1.661245 -1.632659 -1.605419 -1.587060 -1.571051 -1.557530 -1.545180 -1.532577 -1.518427 -1.505048 -1.499109 -1.526822 -1.548918 -1.561502 -1.562888 -1.558868 -1.547514 -1.523414 -1.485953 -2.074072 -1.805131 -1.771942 -1.739584 -1.716464 -1.695956 -1.677115 -1.659801 -1.642380 -1.623939 -1.606555 -1.596723 -1.620833 -1.637207 -1.643687 -1.640519 -1.629324 -1.611991 -1.581832 -1.539303 -2.074072 -1.981462 -1.942594 -1.904517 -1.875813 -1.849941 -1.825126 -1.801760 -1.778245 -1.754058 -1.731550 -1.716477 -1.733386 -1.742883 -1.743570 -1.734542 -1.714421 -1.689673 -1.652958 -1.605728 -2.074072 -2.206858 -2.161899 -2.117505 -2.078396 -2.045901 -2.013585 -1.982766 -1.951777 -1.920258 -1.888625 -1.867346 -1.876689 -1.878484 -1.871154 -1.853480 -1.825027 -1.788563 -1.745760 -1.694474 -2.074072 -2.524087 -2.475258 -2.425992 -2.375999 -2.325618 -2.283715 -2.243594 -2.204114 -2.163416 -2.121427 -2.081694 -2.079368 -2.068998 -2.049332 -2.019803 -1.980831 -1.934285 -1.885333 -2.203226 -2.074072 -3.049540 -2.989454 -2.927854 -2.863620 -2.806124 -2.746592 -2.685532 -2.622358 -2.569526 -2.516181 -2.463059 -2.430874 -2.393445 -2.355023 -2.316121 -2.272053 -2.223004 -2.283617 -2.195237 -2.074072 -3.660454 -3.598914 -3.534617 -3.467620 -3.397972 -3.325736 -3.250981 -3.173763 -3.094117 -3.012123 -2.927838 -2.841303 -2.752564 -2.661692 -2.568975 -2.473710 -2.376691 -2.277722 -2.177083 -2.074072 -0.2880650 -0.3360792 -0.3873388 -0.4398474 -0.4940057 -0.5592795 -0.6215668 -0.6797544 -0.7326912 -0.7790968 -0.8246596 -0.8741538 -0.9199107 -0.9613332 -0.9976576 -1.029767 -1.058911 -1.083243 -1.101541 -4.355299 -0.3493894 -0.3906232 -0.4359137 -0.4837180 -0.5333409 -0.5916150 -0.6475949 -0.7034772 -0.7636778 -0.8161914 -0.8681239 -0.9221133 -0.9704854 -1.012339 -1.047644 -1.077054 -1.102352 -1.121397 -1.132698 -4.355299 -0.4163496 -0.4508671 -0.4903321 -0.5331197 -0.5784439 -0.6306490 -0.6811726 -0.7349714 -0.8006219 -0.8583142 -0.9161378 -0.9736656 -1.023624 -1.065358 -1.099488 -1.126114 -1.147429 -1.161267 -1.165430 -4.355299 -0.4911265 -0.5197298 -0.5532312 -0.5907996 -0.6317559 -0.6789072 -0.7246652 -0.7772281 -0.8464990 -0.9105884 -0.9731154 -1.033225 -1.084161 -1.125781 -1.158785 -1.182954 -1.200366 -1.209297 -1.206280 -4.355299 -0.5728613 -0.5961094 -0.6238776 -0.6559008 -0.6924029 -0.7348810 -0.7761396 -0.8272274 -0.9014195 -0.9706759 -1.036988 -1.098838 -1.150371 -1.192052 -1.223758 -1.245808 -1.259595 -1.263638 -1.253415 -4.355299 -0.6635591 -0.6813864 -0.7038111 -0.7305122 -0.7622598 -0.7998937 -0.8373774 -0.8873772 -0.9661389 -1.039682 -1.108904 -1.171811 -1.223967 -1.266162 -1.296812 -1.317093 -1.327717 -1.327007 -1.309704 -4.355299 -0.7625470 -0.7751058 -0.7924013 -0.8138497 -0.8405207 -0.8732885 -0.9067751 -0.9548943 -1.036863 -1.113004 -1.183434 -1.246830 -1.299667 -1.341801 -1.371612 -1.390029 -1.397501 -1.391957 -1.367484 -4.355299 -0.8695201 -0.8772392 -0.8896054 -0.9063889 -0.9280980 -0.9556755 -0.9848947 -1.031246 -1.114411 -1.191542 -1.262109 -1.325498 -1.379277 -1.421026 -1.450499 -1.466709 -1.471552 -1.460844 -1.429176 -4.355299 -0.9843870 -0.9876836 -0.9950334 -1.007573 -1.024428 -1.046725 -1.071714 -1.115327 -1.198423 -1.274887 -1.344643 -1.408430 -1.462249 -1.503787 -1.532887 -1.547553 -1.549495 -1.533051 -1.494137 -4.355299 -1.108517 -1.107342 -1.109876 -1.117993 -1.130128 -1.147128 -1.167154 -1.206961 -1.287882 -1.362557 -1.431727 -1.495037 -1.547820 -1.589752 -1.617549 -1.630783 -1.630022 -1.607019 -1.560588 -4.355299 -1.240945 -1.235601 -1.233671 -1.237381 -1.245080 -1.256731 -1.271778 -1.307466 -1.384755 -1.458054 -1.526404 -1.587432 -1.639962 -1.681728 -1.708672 -1.720566 -1.716247 -1.686427 -1.632351 -4.355299 -1.382391 -1.373422 -1.367217 -1.366335 -1.369519 -1.376204 -1.386218 -1.417553 -1.491930 -1.563353 -1.628607 -1.688103 -1.740113 -1.780478 -1.807812 -1.818429 -1.808789 -1.772102 -1.709927 -4.355299 -1.540732 -1.526174 -1.516015 -1.510003 -1.508409 -1.509978 -1.514589 -1.541597 -1.611522 -1.678025 -1.741001 -1.799028 -1.848388 -1.889363 -1.915506 -1.923780 -1.906754 -1.863182 -1.792058 -4.355299 -1.722045 -1.699769 -1.684618 -1.673502 -1.665907 -1.661838 -1.660491 -1.680826 -1.744631 -1.807994 -1.867864 -1.921735 -1.970815 -2.009965 -2.035184 -2.036405 -2.011384 -1.959962 -1.879132 -4.355299 -1.932159 -1.903230 -1.879506 -1.863590 -1.849116 -1.838908 -1.830803 -1.845050 -1.904059 -1.961289 -2.017037 -2.070232 -2.116538 -2.154362 -2.172722 -2.164523 -2.131908 -2.070819 -1.979455 -4.355299 -2.193137 -2.154776 -2.122774 -2.096923 -2.076130 -2.056789 -2.040888 -2.047396 -2.101538 -2.155180 -2.207773 -2.257789 -2.300416 -2.328245 -2.335359 -2.318163 -2.276550 -2.203985 -2.100699 -4.355299 -2.545936 -2.495889 -2.452907 -2.416509 -2.384196 -2.355793 -2.327970 -2.326590 -2.374053 -2.421799 -2.467515 -2.506605 -2.535272 -2.550608 -2.548627 -2.520824 -2.464593 -2.377985 -2.261978 -4.355299 -3.051254 -2.989600 -2.933903 -2.881613 -2.835934 -2.793832 -2.754655 -2.739534 -2.773629 -2.805703 -2.834271 -2.860224 -2.878500 -2.880571 -2.860844 -2.814409 -2.737405 -2.632635 -2.504362 -4.355299 -3.967068 -3.886878 -3.810555 -3.735983 -3.663501 -3.591552 -3.526305 -3.486520 -3.499808 -3.510500 -3.515206 -3.509289 -3.493339 -3.459188 -3.400232 -3.316442 -3.209163 -3.085007 -2.947433 -4.355299 -6.955474 -6.863511 -6.765580 -6.661852 -6.552536 -6.437818 -6.317863 -6.192885 -6.063019 -5.928461 -5.789355 -5.645848 -5.498102 -5.346220 -5.190364 -5.030634 -4.867157 -4.700045 -4.529385 -4.355299 0.1692834 6.7415349E-02 -4.1801192E-02 -0.1514396 -0.2581308 -0.3682652 -0.4510088 -0.5223778 -0.5861246 -0.6439949 -0.6972311 -0.7494318 -0.7986748 -0.8443668 -0.8871115 -0.9236851 -0.9538407 -0.9774453 -0.9941823 -6.924547 0.1227321 3.4670644E-02 -6.1526336E-02 -0.1604056 -0.2566986 -0.3551693 -0.4508680 -0.5349960 -0.6097481 -0.6773297 -0.7379570 -0.7962747 -0.8493131 -0.8965905 -0.9374482 -0.9690822 -0.9919654 -1.006323 -1.011905 -6.924547 5.7953350E-02 -1.8001322E-02 -0.1026523 -0.1917937 -0.2798124 -0.3701962 -0.4740384 -0.5678752 -0.6521291 -0.7279475 -0.7959152 -0.8604506 -0.9171336 -0.9663295 -1.005181 -1.032242 -1.048189 -1.053537 -1.048133 -6.924547 -2.0991119E-02 -8.6108916E-02 -0.1598301 -0.2394217 -0.3200208 -0.4027449 -0.5130285 -0.6145999 -0.7069132 -0.7897206 -0.8655601 -0.9358758 -0.9965287 -1.047207 -1.084152 -1.106934 -1.116207 -1.112829 -1.096478 -6.924547 -0.1147203 -0.1692454 -0.2324887 -0.3020431 -0.3742870 -0.4490898 -0.5635823 -0.6710470 -0.7693074 -0.8592687 -0.9422766 -1.017357 -1.082164 -1.133334 -1.168176 -1.186584 -1.189336 -1.177252 -1.149959 -6.924547 -0.2228173 -0.2673660 -0.3211780 -0.3810244 -0.4443898 -0.5114538 -0.6285388 -0.7403762 -0.8437055 -0.9409176 -1.030172 -1.110525 -1.178868 -1.230513 -1.263744 -1.278254 -1.275168 -1.254728 -1.216608 -6.924547 -0.3447230 -0.3798883 -0.4244783 -0.4756854 -0.5304011 -0.5895613 -0.7079201 -0.8229711 -0.9323611 -1.035669 -1.130256 -1.216349 -1.287554 -1.340140 -1.372628 -1.384015 -1.375860 -1.347741 -1.298950 -6.924547 -0.4801954 -0.5063854 -0.5419513 -0.5850142 -0.6308323 -0.6815020 -0.7992897 -0.9183901 -1.032381 -1.139001 -1.238748 -1.328020 -1.401141 -1.454701 -1.486606 -1.495529 -1.482470 -1.447322 -1.387544 -6.924547 -0.6306449 -0.6480997 -0.6752805 -0.7098505 -0.7474697 -0.7893226 -0.9079481 -1.029068 -1.144761 -1.254781 -1.357029 -1.447929 -1.522485 -1.577196 -1.608617 -1.616189 -1.598902 -1.557023 -1.486404 -6.924547 -0.8004458 -0.8087479 -0.8280786 -0.8541307 -0.8837004 -0.9168946 -1.034427 -1.154217 -1.270605 -1.381354 -1.483406 -1.574281 -1.649534 -1.705009 -1.736756 -1.743442 -1.722131 -1.673459 -1.592014 -6.924547 -0.9898072 -0.9887004 -0.9999143 -1.018557 -1.040027 -1.065305 -1.178507 -1.295750 -1.409961 -1.518296 -1.618605 -1.708477 -1.783669 -1.838854 -1.871951 -1.877734 -1.853228 -1.797402 -1.705067 -6.924547 -1.196689 -1.187486 -1.190450 -1.202327 -1.216152 -1.233654 -1.342417 -1.453761 -1.562890 -1.667410 -1.764773 -1.852539 -1.925942 -1.982299 -2.016760 -2.021768 -1.995164 -1.930376 -1.827152 -6.924547 -1.423621 -1.406963 -1.402098 -1.406554 -1.413592 -1.423400 -1.524865 -1.629753 -1.731792 -1.830421 -1.923813 -2.007576 -2.080392 -2.137796 -2.172145 -2.177236 -2.148247 -2.073606 -1.959229 -6.924547 -1.675928 -1.651093 -1.638558 -1.634930 -1.634994 -1.636866 -1.729760 -1.827132 -1.920232 -2.010629 -2.097730 -2.179909 -2.252197 -2.308647 -2.343419 -2.349651 -2.313608 -2.228687 -2.102616 -6.924547 -1.966447 -1.931756 -1.909787 -1.897786 -1.888852 -1.882665 -1.963508 -2.050022 -2.132782 -2.216246 -2.299458 -2.380046 -2.448555 -2.504102 -2.539779 -2.543081 -2.496182 -2.401621 -2.261851 -6.924547 -2.299108 -2.256001 -2.223417 -2.201558 -2.183587 -2.168754 -2.236482 -2.313804 -2.389857 -2.467899 -2.544042 -2.618763 -2.684610 -2.740180 -2.770678 -2.759674 -2.700921 -2.594213 -2.439221 -6.924547 -2.730662 -2.673460 -2.629698 -2.593572 -2.563509 -2.536825 -2.595029 -2.661825 -2.729003 -2.796364 -2.866733 -2.938951 -3.001326 -3.042454 -3.054940 -3.029510 -2.959753 -2.835292 -2.661921 -6.924547 -3.353464 -3.280521 -3.219937 -3.166794 -3.117453 -3.075004 -3.122141 -3.179788 -3.237436 -3.293893 -3.350451 -3.399305 -3.440759 -3.462470 -3.463230 -3.420141 -3.327466 -3.179173 -2.984313 -6.924547 -4.476850 -4.378680 -4.287772 -4.204194 -4.124179 -4.050230 -4.071685 -4.105823 -4.141835 -4.172721 -4.205601 -4.229681 -4.244489 -4.237453 -4.195322 -4.106005 -3.963989 -3.778207 -3.561043 -6.924547 -10.66543 -10.54241 -10.40905 -10.26575 -10.11297 -9.951145 -9.780665 -9.601936 -9.415300 -9.221128 -9.019703 -8.811358 -8.596339 -8.374931 -8.147358 -7.913856 -7.674877 -7.429883 -7.179800 -6.924547 0.6000366 0.4387435 0.2659164 9.0240516E-02 -8.0838479E-02 -0.1610755 -0.2482261 -0.3304509 -0.4077474 -0.4796871 -0.5440469 -0.6025519 -0.6554051 -0.7019387 -0.7437565 -0.7809322 -0.8108475 -0.8328362 -0.8470266 -9.740750 0.5838436 0.4444231 0.2933477 0.1397351 -1.1621390E-02 -0.1131241 -0.2199985 -0.3200926 -0.4128571 -0.4966750 -0.5694942 -0.6339988 -0.6886493 -0.7342873 -0.7713081 -0.8003477 -0.8183308 -0.8259256 -0.8237796 -9.740750 0.5341333 0.4141816 0.2824936 0.1467736 1.1405386E-02 -0.1113926 -0.2350227 -0.3505452 -0.4568885 -0.5507925 -0.6329688 -0.7033143 -0.7604119 -0.8059222 -0.8392964 -0.8605255 -0.8673199 -0.8610623 -0.8429399 -9.740750 0.4558918 0.3531206 0.2388335 0.1189737 -1.8603214E-03 -0.1409614 -0.2783572 -0.4069876 -0.5237078 -0.6276702 -0.7188017 -0.7949146 -0.8555904 -0.9013960 -0.9322780 -0.9460120 -0.9421917 -0.9225699 -0.8886836 -9.740750 0.3523372 0.2646988 0.1657948 6.1470341E-02 -4.5919389E-02 -0.1959418 -0.3445123 -0.4821767 -0.6072066 -0.7210672 -0.8199696 -0.9016984 -0.9671197 -1.013758 -1.042621 -1.049471 -1.035464 -1.002866 -0.9534101 -9.740750 0.2265992 0.1522295 6.6856220E-02 -2.3783728E-02 -0.1181660 -0.2755603 -0.4307646 -0.5738372 -0.7068800 -0.8279120 -0.9333436 -1.021935 -1.092043 -1.141502 -1.168301 -1.168935 -1.145467 -1.100362 -1.035545 -9.740750 7.8732416E-02 1.6657438E-02 -5.6603536E-02 -0.1354585 -0.2176391 -0.3779758 -0.5358805 -0.6840449 -0.8225868 -0.9492498 -1.061333 -1.157496 -1.232737 -1.286543 -1.312055 -1.308189 -1.276381 -1.219499 -1.139683 -9.740750 -9.0475284E-02 -0.1395509 -0.2018470 -0.2694415 -0.3401691 -0.4996560 -0.6592670 -0.8103430 -0.9521084 -1.083093 -1.202198 -1.304433 -1.387045 -1.444697 -1.470302 -1.463212 -1.424468 -1.356688 -1.262146 -9.740750 -0.2797678 -0.3154981 -0.3667976 -0.4230022 -0.4827185 -0.6409587 -0.7985978 -0.9495155 -1.092602 -1.228002 -1.351820 -1.459600 -1.548430 -1.608434 -1.634840 -1.625504 -1.580868 -1.502582 -1.393480 -9.740750 -0.4905041 -0.5133888 -0.5531672 -0.5992920 -0.6482273 -0.8009565 -0.9554939 -1.103782 -1.248296 -1.386274 -1.513213 -1.627179 -1.719069 -1.781421 -1.809785 -1.799421 -1.750092 -1.662386 -1.538585 -9.740750 -0.7218210 -0.7324651 -0.7601303 -0.7965415 -0.8348264 -0.9805386 -1.131105 -1.277480 -1.419941 -1.557909 -1.688949 -1.804989 -1.897637 -1.962488 -1.993055 -1.983610 -1.930475 -1.834309 -1.695663 -9.740750 -0.9772092 -0.9767282 -0.9917253 -1.017295 -1.046116 -1.183465 -1.328946 -1.470391 -1.610105 -1.747501 -1.877458 -1.992092 -2.085297 -2.152008 -2.184783 -2.177027 -2.120802 -2.015956 -1.862556 -9.740750 -1.259295 -1.248863 -1.252466 -1.267039 -1.287258 -1.414150 -1.550893 -1.687751 -1.824224 -1.955733 -2.079766 -2.192803 -2.286738 -2.354060 -2.390541 -2.384369 -2.325998 -2.212286 -2.044050 -9.740750 -1.572992 -1.552687 -1.546276 -1.549336 -1.559716 -1.678108 -1.805268 -1.933772 -2.060691 -2.184611 -2.301422 -2.410924 -2.504277 -2.574060 -2.612685 -2.607759 -2.548645 -2.422331 -2.239072 -9.740750 -1.935369 -1.903170 -1.886630 -1.877264 -1.876318 -1.983110 -2.095446 -2.210530 -2.326512 -2.441876 -2.551251 -2.656215 -2.749923 -2.820679 -2.859264 -2.855556 -2.790842 -2.650743 -2.452055 -9.740750 -2.356226 -2.312005 -2.283553 -2.260858 -2.247252 -2.336668 -2.434262 -2.532994 -2.638636 -2.746568 -2.851022 -2.950161 -3.040390 -3.110709 -3.149111 -3.142480 -3.062808 -2.909537 -2.692403 -9.740750 -2.864979 -2.808068 -2.766664 -2.729919 -2.701453 -2.776874 -2.862146 -2.948358 -3.042127 -3.139406 -3.235036 -3.326653 -3.410864 -3.482821 -3.510249 -3.481912 -3.385756 -3.214630 -2.976679 -9.740750 -3.604357 -3.523602 -3.462230 -3.405286 -3.354452 -3.410894 -3.477360 -3.549269 -3.626580 -3.714969 -3.802805 -3.882069 -3.948909 -3.992184 -3.994294 -3.949947 -3.830227 -3.633577 -3.368328 -9.740750 -4.914937 -4.800427 -4.700128 -4.609704 -4.528809 -4.554367 -4.592576 -4.633892 -4.684382 -4.735022 -4.795641 -4.849738 -4.887117 -4.899531 -4.875949 -4.784856 -4.614371 -4.367720 -4.070813 -9.740750 -14.73066 -14.57598 -14.40542 -14.21983 -14.02003 -13.80683 -13.58098 -13.34313 -13.09395 -12.83400 -12.56382 -12.28390 -11.99468 -11.69658 -11.38997 -11.07521 -10.75263 -10.42250 -10.08513 -9.740750 0.9940199 0.7692385 0.5270803 0.2819830 0.1310835 4.1411038E-02 -5.1946409E-02 -0.1487076 -0.2420965 -0.3285979 -0.4081887 -0.4784301 -0.5383039 -0.5897113 -0.6328918 -0.6691256 -0.6988795 -0.7199135 -0.7323856 -12.77138 1.023379 0.8283121 0.6194966 0.4082354 0.2532492 0.1371447 1.6551798E-02 -0.1028814 -0.2142828 -0.3164219 -0.4061544 -0.4803418 -0.5402591 -0.5867039 -0.6207933 -0.6437419 -0.6563236 -0.6572916 -0.6478133 -12.77138 1.002069 0.8334775 0.6519787 0.4670093 0.3053421 0.1604932 1.5224207E-02 -0.1242751 -0.2539203 -0.3708914 -0.4701267 -0.5491598 -0.6103397 -0.6531290 -0.6797133 -0.6907378 -0.6871482 -0.6689546 -0.6381313 -12.77138 0.9361035 0.7912254 0.6343960 0.4732774 0.3059426 0.1359651 -2.9363791E-02 -0.1863211 -0.3329020 -0.4625314 -0.5699776 -0.6555558 -0.7188532 -0.7594650 -0.7793605 -0.7797588 -0.7607474 -0.7239773 -0.6721376 -12.77138 0.8318909 0.7072261 0.5708797 0.4314944 0.2604917 7.2559647E-02 -0.1073537 -0.2799349 -0.4397631 -0.5791994 -0.6952037 -0.7879133 -0.8543150 -0.8949332 -0.9096016 -0.9006022 -0.8670623 -0.8123046 -0.7397185 -12.77138 0.6923151 0.5856404 0.4674465 0.3465425 0.1754374 -2.3556933E-02 -0.2162174 -0.3990365 -0.5668449 -0.7134971 -0.8387167 -0.9380898 -1.009176 -1.051358 -1.062721 -1.045043 -0.9980384 -0.9258316 -0.8327525 -12.77138 0.5209144 0.4317472 0.3292717 0.2245202 5.5420760E-02 -0.1518612 -0.3512521 -0.5393896 -0.7109008 -0.8655707 -0.9982016 -1.104488 -1.182486 -1.227538 -1.238798 -1.213909 -1.154878 -1.066217 -0.9529792 -12.77138 0.3197863 0.2471416 0.1590564 6.8591103E-02 -9.7413592E-02 -0.3075963 -0.5065359 -0.6941456 -0.8708351 -1.031566 -1.170226 -1.284078 -1.369670 -1.419425 -1.432043 -1.401909 -1.332316 -1.228210 -1.095210 -12.77138 9.1057099E-02 3.3934813E-02 -4.0493872E-02 -0.1189840 -0.2779425 -0.4839251 -0.6786543 -0.8663323 -1.045123 -1.210059 -1.355019 -1.476749 -1.569135 -1.627570 -1.642255 -1.609676 -1.531601 -1.413334 -1.261049 -12.77138 -0.1602018 -0.2034011 -0.2639910 -0.3311369 -0.4791605 -0.6773821 -0.8696106 -1.055722 -1.233096 -1.399816 -1.551470 -1.679795 -1.780700 -1.847313 -1.865943 -1.833410 -1.749221 -1.618047 -1.446907 -12.77138 -0.4332728 -0.4630300 -0.5088647 -0.5639185 -0.7032222 -0.8930265 -1.078554 -1.260591 -1.436417 -1.603500 -1.757912 -1.892046 -2.001363 -2.073694 -2.097984 -2.066818 -1.978787 -1.835691 -1.645966 -12.77138 -0.7353361 -0.7513214 -0.7830459 -0.8251515 -0.9530033 -1.131401 -1.308420 -1.485926 -1.658858 -1.823740 -1.977927 -2.117463 -2.231499 -2.309086 -2.340210 -2.311979 -2.221723 -2.068208 -1.859534 -12.77138 -1.067697 -1.069672 -1.088348 -1.115919 -1.231591 -1.399517 -1.565897 -1.736011 -1.903064 -2.065257 -2.218732 -2.356746 -2.473285 -2.557514 -2.594254 -2.572138 -2.480403 -2.317348 -2.089824 -12.77138 -1.439479 -1.427747 -1.433965 -1.446280 -1.547322 -1.702868 -1.857892 -2.016402 -2.176954 -2.333330 -2.480954 -2.615002 -2.732658 -2.820777 -2.864779 -2.848137 -2.754734 -2.581312 -2.334709 -12.77138 -1.862013 -1.835215 -1.828365 -1.826758 -1.911385 -2.051917 -2.194496 -2.339550 -2.487016 -2.633660 -2.775026 -2.905508 -3.019655 -3.113586 -3.164122 -3.151648 -3.058307 -2.870201 -2.604250 -12.77138 -2.356452 -2.313655 -2.291549 -2.275526 -2.340603 -2.461326 -2.586877 -2.717217 -2.850441 -2.986286 -3.119308 -3.245138 -3.357497 -3.452229 -3.505388 -3.495687 -3.393254 -3.186993 -2.901162 -12.77138 -2.956229 -2.897461 -2.856871 -2.824973 -2.868681 -2.969482 -3.077031 -3.191540 -3.309503 -3.433686 -3.558656 -3.679260 -3.785158 -3.875015 -3.932324 -3.910162 -3.786345 -3.562476 -3.251919 -12.77138 -3.797553 -3.710238 -3.645280 -3.589102 -3.610281 -3.686857 -3.774024 -3.870267 -3.970963 -4.077124 -4.188450 -4.303687 -4.403703 -4.475594 -4.503310 -4.450222 -4.308642 -4.056201 -3.715105 -12.77138 -5.282886 -5.153327 -5.040223 -4.943913 -4.931821 -4.972910 -5.020325 -5.084117 -5.156797 -5.230184 -5.305345 -5.382728 -5.461121 -5.503009 -5.500069 -5.420224 -5.227138 -4.919978 -4.538532 -12.77138 -19.10478 -18.91782 -18.70835 -18.47785 -18.22769 -17.95919 -17.67352 -17.37210 -17.05487 -16.72375 -16.37918 -16.02186 -15.65246 -15.27155 -14.87967 -14.47731 -14.06491 -13.64288 -13.21158 -12.77138 1.361936 1.065281 0.7519294 0.4494404 0.3500738 0.2502167 0.1449999 3.3761490E-02 -7.5029671E-02 -0.1783571 -0.2724736 -0.3557872 -0.4269573 -0.4844017 -0.5311527 -0.5680686 -0.5966720 -0.6168776 -0.6280762 -15.99132 1.439131 1.182306 0.9135270 0.6529774 0.5226703 0.3903347 0.2526551 0.1140059 -1.7594254E-02 -0.1386840 -0.2435888 -0.3318148 -0.3999971 -0.4492641 -0.4819073 -0.5003947 -0.5063435 -0.5006860 -0.4842301 -15.99132 1.450027 1.228312 0.9963465 0.7665052 0.6023209 0.4355623 0.2671863 0.1033076 -5.0472606E-02 -0.1869102 -0.3036695 -0.3968519 -0.4629889 -0.5052090 -0.5253323 -0.5264851 -0.5111285 -0.4806310 -0.4372061 -15.99132 1.403419 1.212864 1.012716 0.8098133 0.6132742 0.4161984 0.2223296 3.5223775E-02 -0.1370864 -0.2889667 -0.4170487 -0.5151361 -0.5814367 -0.6186030 -0.6278268 -0.6129194 -0.5772606 -0.5226341 -0.4526210 -15.99132 1.304697 1.140646 0.9666847 0.7877287 0.5652110 0.3451359 0.1309040 -7.3842481E-02 -0.2611385 -0.4276443 -0.5661926 -0.6695126 -0.7388209 -0.7724931 -0.7734514 -0.7443481 -0.6892543 -0.6111656 -0.5148783 -15.99132 1.156628 1.016976 0.8661495 0.7073481 0.4671208 0.2312750 2.4373606E-03 -0.2142541 -0.4153562 -0.5928336 -0.7388167 -0.8504074 -0.9243057 -0.9577510 -0.9527839 -0.9117067 -0.8384199 -0.7376099 -0.6153569 -15.99132 0.9669168 0.8491699 0.7177575 0.5769582 0.3255916 8.1377842E-02 -0.1546058 -0.3820024 -0.5928639 -0.7774450 -0.9308764 -1.051832 -1.132120 -1.168824 -1.160469 -1.110412 -1.020712 -0.8981797 -0.7503126 -15.99132 0.7415634 0.6427942 0.5290639 0.4031823 0.1492373 -9.8285720E-02 -0.3400452 -0.5710746 -0.7856661 -0.9753104 -1.137957 -1.267837 -1.357241 -1.400396 -1.392418 -1.335835 -1.232042 -1.088943 -0.9158906 -15.99132 0.4846781 0.4031667 0.3063279 0.1931959 -5.8373749E-02 -0.3058343 -0.5473915 -0.7770858 -0.9898923 -1.184754 -1.355021 -1.493648 -1.594954 -1.646361 -1.643463 -1.583027 -1.467605 -1.305519 -1.107745 -15.99132 0.1950250 0.1300577 4.9200457E-02 -5.0654989E-02 -0.2966771 -0.5366457 -0.7707791 -0.9956645 -1.208909 -1.405395 -1.579467 -1.728556 -1.840850 -1.903537 -1.907993 -1.846649 -1.722035 -1.542613 -1.320619 -15.99132 -0.1242703 -0.1736430 -0.2395471 -0.3258004 -0.5602770 -0.7867667 -1.011763 -1.232113 -1.442722 -1.638933 -1.816986 -1.972955 -2.095776 -2.173383 -2.186657 -2.129216 -1.998717 -1.803745 -1.558100 -15.99132 -0.4721710 -0.5053672 -0.5566064 -0.6277736 -0.8464023 -1.062076 -1.276386 -1.488151 -1.693174 -1.890139 -2.069842 -2.227697 -2.363895 -2.454284 -2.479512 -2.429012 -2.296987 -2.088355 -1.819644 -15.99132 -0.8559243 -0.8714629 -0.9073905 -0.9624078 -1.163935 -1.365359 -1.567441 -1.769325 -1.968275 -2.160046 -2.338471 -2.500384 -2.641644 -2.742881 -2.780818 -2.738003 -2.606460 -2.385397 -2.093318 -15.99132 -1.282088 -1.279082 -1.298904 -1.337568 -1.519173 -1.705391 -1.896410 -2.085864 -2.273091 -2.457634 -2.635202 -2.796248 -2.938703 -3.050841 -3.099481 -3.070183 -2.940074 -2.708018 -2.392438 -15.99132 -1.768592 -1.745608 -1.747583 -1.769926 -1.930581 -2.097622 -2.270344 -2.446318 -2.621729 -2.796655 -2.965329 -3.124898 -3.267387 -3.382931 -3.446829 -3.426545 -3.297188 -3.052576 -2.712969 -15.99132 -2.338761 -2.293277 -2.274834 -2.278956 -2.414235 -2.557964 -2.711393 -2.871281 -3.031204 -3.193136 -3.353458 -3.506997 -3.646219 -3.768665 -3.841148 -3.826786 -3.697681 -3.432985 -3.068750 -15.99132 -3.029192 -2.961535 -2.919968 -2.902389 -3.010835 -3.128992 -3.258982 -3.400458 -3.544670 -3.690093 -3.839434 -3.987734 -4.127061 -4.245078 -4.319856 -4.307988 -4.159900 -3.871031 -3.479241 -15.99132 -3.970383 -3.871095 -3.801317 -3.755142 -3.834894 -3.923341 -4.027695 -4.145339 -4.271417 -4.401444 -4.535428 -4.673106 -4.809293 -4.920996 -4.981943 -4.937649 -4.761003 -4.442621 -4.017612 -15.99132 -5.593268 -5.451510 -5.330817 -5.239824 -5.285213 -5.337405 -5.400565 -5.479764 -5.570260 -5.674862 -5.779908 -5.882706 -5.983377 -6.072134 -6.096746 -6.023691 -5.805295 -5.433018 -4.961391 -15.99132 -23.75194 -23.53209 -23.28208 -23.00416 -22.70049 -22.37302 -22.02349 -21.65344 -21.26425 -20.85715 -20.43320 -19.99339 -19.53857 -19.06952 -18.58693 -18.09145 -17.58364 -17.06404 -16.53311 -15.99132 1.716472 1.344335 0.9634937 0.6997358 0.5917392 0.4766446 0.3564514 0.2331174 0.1102312 -8.4367646E-03 -0.1169303 -0.2126520 -0.2931913 -0.3583136 -0.4081846 -0.4456997 -0.4730029 -0.4916537 -0.5015616 -19.38085 1.848221 1.528888 1.202040 0.9544731 0.8067309 0.6554943 0.5009574 0.3459275 0.1966056 5.9037458E-02 -6.1896775E-02 -0.1603894 -0.2363302 -0.2882889 -0.3192095 -0.3321750 -0.3307255 -0.3176812 -0.2941367 -19.38085 1.891396 1.617183 1.334982 1.093405 0.9052737 0.7172022 0.5286304 0.3439718 0.1706644 1.5507355E-02 -0.1156481 -0.2177337 -0.2891195 -0.3286612 -0.3416404 -0.3313065 -0.3023162 -0.2585480 -0.2022360 -19.38085 1.860171 1.622768 1.378619 1.142398 0.9180462 0.6968004 0.4765351 0.2645686 6.9285527E-02 -0.1046078 -0.2472721 -0.3562224 -0.4260693 -0.4575146 -0.4551130 -0.4239504 -0.3690366 -0.2955714 -0.2070112 -19.38085 1.764335 1.559152 1.347136 1.117353 0.8650334 0.6145730 0.3695898 0.1361584 -7.9050086E-02 -0.2677942 -0.4250209 -0.5424017 -0.6130868 -0.6401349 -0.6254467 -0.5753359 -0.4960315 -0.3935851 -0.2731021 -19.38085 1.612281 1.437494 1.253285 1.029431 0.7545022 0.4857473 0.2224183 -2.9245147E-02 -0.2589891 -0.4613138 -0.6317283 -0.7579363 -0.8334064 -0.8589588 -0.8354807 -0.7685216 -0.6664354 -0.5357251 -0.3836004 -19.38085 1.410542 1.261912 1.101069 0.8854715 0.5981796 0.3159886 4.1141424E-02 -0.2206457 -0.4613916 -0.6764556 -0.8577150 -0.9933393 -1.077685 -1.104121 -1.076167 -0.9954380 -0.8721730 -0.7140685 -0.5305995 -19.38085 1.167068 1.040580 0.9013541 0.6927630 0.4012257 0.1123949 -0.1683738 -0.4348227 -0.6835175 -0.9067599 -1.096096 -1.245298 -1.340737 -1.374026 -1.344876 -1.255123 -1.113055 -0.9288640 -0.7144541 -19.38085 0.8828340 0.7761410 0.6566894 0.4577259 0.1666249 -0.1193393 -0.4004847 -0.6702131 -0.9221762 -1.146741 -1.344657 -1.507797 -1.615825 -1.661878 -1.636286 -1.542871 -1.385195 -1.176562 -0.9316922 -19.38085 0.5603673 0.4727408 0.3704929 0.1846541 -9.8746218E-02 -0.3792637 -0.6559182 -0.9220391 -1.170751 -1.398396 -1.601964 -1.774697 -1.899915 -1.958936 -1.944272 -1.850828 -1.681313 -1.450094 -1.175287 -19.38085 0.2027008 0.1343807 4.8231382E-02 -0.1226017 -0.3957157 -0.6665425 -0.9323254 -1.188274 -1.433607 -1.662630 -1.867828 -2.049386 -2.190433 -2.265212 -2.266806 -2.178737 -2.001294 -1.750118 -1.446090 -19.38085 -0.1927727 -0.2418855 -0.3120399 -0.4657767 -0.7221142 -0.9767371 -1.229966 -1.476470 -1.714451 -1.938332 -2.146742 -2.333216 -2.484626 -2.581888 -2.600198 -2.522936 -2.341942 -2.073091 -1.740409 -19.38085 -0.6288022 -0.6568150 -0.7091501 -0.8447132 -1.079903 -1.317354 -1.556797 -1.790372 -2.017380 -2.236948 -2.442819 -2.629368 -2.795090 -2.911965 -2.950327 -2.887781 -2.709957 -2.425977 -2.065403 -19.38085 -1.117464 -1.121387 -1.153419 -1.269082 -1.480109 -1.695876 -1.916740 -2.137646 -2.354014 -2.562065 -2.760441 -2.951798 -3.123880 -3.256160 -3.314486 -3.267227 -3.095317 -2.798081 -2.409233 -19.38085 -1.665618 -1.644572 -1.654966 -1.748479 -1.933775 -2.126916 -2.327837 -2.530535 -2.730593 -2.929707 -3.123407 -3.311515 -3.486395 -3.630974 -3.705404 -3.680111 -3.514205 -3.204420 -2.787106 -19.38085 -2.300933 -2.253684 -2.240130 -2.308629 -2.465963 -2.630545 -2.806881 -2.991879 -3.179017 -3.364727 -3.547992 -3.730688 -3.903947 -4.053280 -4.149043 -4.135933 -3.973775 -3.646821 -3.199850 -19.38085 -3.067891 -2.992979 -2.951331 -2.991290 -3.119980 -3.256296 -3.407099 -3.569573 -3.738332 -3.909115 -4.077941 -4.252018 -4.425828 -4.578770 -4.681613 -4.675560 -4.503360 -4.147955 -3.670426 -19.38085 -4.096394 -3.987083 -3.912091 -3.917717 -4.013929 -4.119452 -4.238975 -4.374536 -4.523572 -4.676355 -4.833756 -4.996826 -5.160857 -5.313589 -5.413379 -5.388183 -5.176736 -4.791986 -4.276747 -19.38085 -5.851785 -5.694636 -5.564009 -5.517854 -5.568260 -5.635046 -5.716429 -5.812841 -5.923631 -6.045907 -6.179628 -6.319404 -6.449514 -6.559657 -6.633257 -6.570763 -6.321470 -5.878551 -5.310985 -19.38085 -28.64397 -28.39063 -28.09843 -27.77072 -27.41057 -27.02075 -26.60363 -26.16134 -25.69568 -25.20827 -24.70051 -24.17388 -23.62899 -23.06681 -22.48871 -21.89547 -21.28708 -20.66491 -20.02932 -19.38085 2.058047 1.607181 1.155420 0.9566166 0.8439376 0.7158597 0.5796564 0.4400147 0.3018557 0.1690482 4.4796135E-02 -6.3496888E-02 -0.1539819 -0.2259967 -0.2797734 -0.3181796 -0.3446294 -0.3615887 -0.3703668 -22.92415 2.249279 1.865419 1.479820 1.264984 1.103158 0.9328490 0.7578869 0.5849602 0.4202093 0.2664361 0.1315893 2.1890564E-02 -5.9330359E-02 -0.1137566 -0.1417077 -0.1490674 -0.1403893 -0.1195008 -8.8850476E-02 -22.92415 2.327019 1.998602 1.668341 1.426648 1.215384 1.001245 0.7898885 0.5872127 0.3959195 0.2232260 7.8842372E-02 -3.1701569E-02 -0.1051152 -0.1426345 -0.1465439 -0.1243223 -8.1967436E-02 -2.4530578E-02 4.4741649E-02 -22.92415 2.311774 2.027850 1.741740 1.478465 1.223214 0.9727817 0.7288596 0.4955879 0.2782359 8.5515626E-02 -7.3479265E-02 -0.1890343 -0.2607870 -0.2860795 -0.2704220 -0.2216016 -0.1474138 -5.4568324E-02 5.2756794E-02 -22.92415 2.218752 1.973309 1.723752 1.444726 1.159269 0.8799274 0.6065030 0.3471635 0.1078186 -0.1043588 -0.2781633 -0.4036277 -0.4770762 -0.4942254 -0.4623940 -0.3894192 -0.2848277 -0.1572072 -1.2085455E-02 -22.92415 2.061122 1.849330 1.630573 1.344886 1.037881 0.7352585 0.4401653 0.1594946 -9.7902544E-02 -0.3279709 -0.5174530 -0.6564918 -0.7345864 -0.7498615 -0.7056631 -0.6118041 -0.4786255 -0.3170184 -0.1343458 -22.92415 1.849565 1.667297 1.475826 1.189866 0.8670006 0.5477101 0.2376120 -5.5847481E-02 -0.3275252 -0.5704241 -0.7784775 -0.9323105 -1.019217 -1.038067 -0.9870069 -0.8753988 -0.7162133 -0.5214927 -0.3015819 -22.92415 1.589171 1.433286 1.267668 0.9805106 0.6521878 0.3246439 7.0582097E-03 -0.2960767 -0.5744079 -0.8282304 -1.051012 -1.218798 -1.320871 -1.347910 -1.296194 -1.171126 -0.9886716 -0.7620236 -0.5052105 -22.92415 1.281829 1.149600 1.006158 0.7257732 0.3956951 6.9032446E-02 -0.2499649 -0.5535394 -0.8388859 -1.098945 -1.328666 -1.512981 -1.633137 -1.673598 -1.627611 -1.495335 -1.292869 -1.035834 -0.7425191 -22.92415 0.9304033 0.8207596 0.6963688 0.4270847 0.1034744 -0.2180286 -0.5304278 -0.8321609 -1.117172 -1.378163 -1.612367 -1.812984 -1.951977 -2.013396 -1.977952 -1.847073 -1.629361 -1.344226 -1.014952 -22.92415 0.5355893 0.4481722 0.3416526 8.7574452E-02 -0.2221681 -0.5330818 -0.8375989 -1.131079 -1.407500 -1.665578 -1.905630 -2.115311 -2.275745 -2.358982 -2.343247 -2.220458 -1.993142 -1.682575 -1.317988 -22.92415 9.5185243E-02 3.1313777E-02 -5.5928916E-02 -0.2922536 -0.5844676 -0.8786617 -1.168977 -1.447248 -1.715401 -1.969026 -2.208025 -2.425447 -2.603633 -2.708134 -2.720969 -2.612929 -2.381493 -2.049203 -1.650183 -22.92415 -0.3934353 -0.4328853 -0.4999154 -0.7147531 -0.9826630 -1.253356 -1.525356 -1.790918 -2.048023 -2.291542 -2.528574 -2.749553 -2.935018 -3.068215 -3.109624 -3.023000 -2.793532 -2.442518 -2.009670 -22.92415 -0.9329501 -0.9459293 -0.9907534 -1.180769 -1.421769 -1.668896 -1.919775 -2.168231 -2.412340 -2.647971 -2.874620 -3.091508 -3.291857 -3.447182 -3.518886 -3.457438 -3.240352 -2.873818 -2.408058 -22.92415 -1.539029 -1.523281 -1.543015 -1.704205 -1.917103 -2.137328 -2.365255 -2.596156 -2.823816 -3.042932 -3.260314 -3.478116 -3.683815 -3.854401 -3.950103 -3.917852 -3.711468 -3.331677 -2.832066 -22.92415 -2.235352 -2.189245 -2.180809 -2.310671 -2.493878 -2.685268 -2.885468 -3.090781 -3.303389 -3.512763 -3.718803 -3.929996 -4.136681 -4.313681 -4.434082 -4.426991 -4.229602 -3.834192 -3.299861 -22.92415 -3.074936 -2.997139 -2.955587 -3.048181 -3.197283 -3.358286 -3.532699 -3.713738 -3.906485 -4.101552 -4.294976 -4.492514 -4.694510 -4.886174 -5.017354 -5.023672 -4.827100 -4.402721 -3.831983 -22.92415 -4.191669 -4.075999 -3.996083 -4.048057 -4.159918 -4.285395 -4.426368 -4.578346 -4.744774 -4.924647 -5.105730 -5.292717 -5.487919 -5.674173 -5.813383 -5.811975 -5.575523 -5.112433 -4.500074 -22.92415 -6.075792 -5.908913 -5.769502 -5.763844 -5.822474 -5.902689 -5.998781 -6.111318 -6.240607 -6.389612 -6.549738 -6.715074 -6.886915 -7.038885 -7.137556 -7.098682 -6.811852 -6.291535 -5.623805 -22.92415 -33.75812 -33.47069 -33.13474 -32.75494 -32.33553 -31.88018 -31.39206 -30.87387 -30.32820 -29.75633 -29.16072 -28.54292 -27.90376 -27.24445 -26.56651 -25.87066 -25.15775 -24.42857 -23.68381 -22.92415 2.380315 1.850278 1.329445 1.213855 1.098226 0.9610781 0.8095903 0.6541182 0.4988379 0.3489285 0.2107072 8.7938175E-02 -1.2812387E-02 -9.0924688E-02 -0.1489211 -0.1881768 -0.2139672 -0.2296406 -0.2374232 -26.60814 2.637877 2.187751 1.740849 1.572816 1.401378 1.212937 1.019471 0.8279208 0.6436264 0.4742152 0.3254190 0.2049645 0.1171684 6.2773466E-02 3.7109360E-02 3.5528239E-02 5.1411781E-02 7.9845756E-02 0.1175579 -26.60814 2.754551 2.370382 1.989102 1.757013 1.523638 1.285188 1.051178 0.8265737 0.6160936 0.4270032 0.2682799 0.1492041 7.3661938E-02 4.0192332E-02 4.4549208E-02 7.8376904E-02 0.1340177 0.2050368 0.2872978 -26.60814 2.757842 2.426473 2.098041 1.811339 1.526785 1.246919 0.9767028 0.7204580 0.4829552 0.2707684 9.8689489E-02 -2.6257288E-02 -9.6736223E-02 -0.1151520 -8.5222214E-02 -1.8923102E-02 7.4542180E-02 0.1870095 0.3133019 -26.60814 2.668564 2.381666 2.094873 1.770517 1.451028 1.138274 0.8364981 0.5538810 0.2898068 5.4563358E-02 -0.1343815 -0.2688622 -0.3418692 -0.3498665 -0.2994128 -0.2032543 -7.3424228E-02 7.9770692E-02 0.2498709 -26.60814 2.506722 2.257697 2.004650 1.659333 1.314252 0.9767139 0.6535073 0.3461588 5.9664764E-02 -0.1962214 -0.4059294 -0.5553526 -0.6373028 -0.6412247 -0.5760024 -0.4537182 -0.2894282 -9.6240819E-02 0.1174424 -26.60814 2.284032 2.067925 1.845401 1.488429 1.128380 0.7754989 0.4322977 0.1075297 -0.1917467 -0.4663747 -0.6954768 -0.8657684 -0.9606918 -0.9679803 -0.8938223 -0.7497814 -0.5533242 -0.3209601 -6.3884832E-02 -26.60814 2.006083 1.819698 1.625456 1.264424 0.8978396 0.5339512 0.1815544 -0.1524493 -0.4633576 -0.7471945 -0.9975381 -1.190087 -1.301112 -1.321273 -1.245095 -1.084899 -0.8598358 -0.5895448 -0.2893878 -26.60814 1.677331 1.519520 1.350098 0.9914851 0.6220340 0.2566085 -9.5780753E-02 -0.4330803 -0.7472159 -1.040605 -1.305536 -1.516262 -1.651371 -1.691063 -1.621901 -1.452179 -1.202994 -0.8964558 -0.5536538 -26.60814 1.297832 1.166750 1.018718 0.6691042 0.3066884 -5.2492708E-02 -0.4002061 -0.7325495 -1.047416 -1.345057 -1.615429 -1.842175 -2.003162 -2.066839 -2.014465 -1.844047 -1.575514 -1.234824 -0.8498746 -26.60814 0.8670219 0.7620370 0.6350105 0.3005347 -4.5940604E-02 -0.3928319 -0.7302487 -1.056601 -1.366306 -1.658414 -1.930375 -2.171758 -2.354656 -2.449681 -2.420775 -2.262106 -1.981233 -1.609574 -1.183138 -26.60814 0.3878814 0.3089337 0.2035034 -0.1110158 -0.4369662 -0.7665051 -1.090606 -1.405189 -1.701484 -1.985140 -2.257738 -2.505260 -2.708366 -2.832253 -2.838023 -2.699868 -2.414905 -2.015986 -1.548842 -26.60814 -0.1428923 -0.1947891 -0.2772900 -0.5681968 -0.8712349 -1.178320 -1.480204 -1.776786 -2.062402 -2.336213 -2.601073 -2.851036 -3.068129 -3.219332 -3.265617 -3.156725 -2.875747 -2.454545 -1.947740 -26.60814 -0.7316322 -0.7553478 -0.8134850 -1.074720 -1.348500 -1.628433 -1.907564 -2.186186 -2.458183 -2.717263 -2.974935 -3.217668 -3.444036 -3.624314 -3.707536 -3.635477 -3.367363 -2.927779 -2.381880 -26.60814 -1.391843 -1.384149 -1.414209 -1.640650 -1.884265 -2.135678 -2.388994 -2.644194 -2.900266 -3.145465 -3.387077 -3.627406 -3.862261 -4.060371 -4.179573 -4.142912 -3.897813 -3.443588 -2.859021 -26.60814 -2.149748 -2.108471 -2.107377 -2.293843 -2.503530 -2.722790 -2.948356 -3.177189 -3.411620 -3.643999 -3.877147 -4.110014 -4.342609 -4.556137 -4.697027 -4.703482 -4.476640 -4.007235 -3.382544 -26.60814 -3.057011 -2.980464 -2.942995 -3.086278 -3.257552 -3.441466 -3.635466 -3.841435 -4.054838 -4.271463 -4.489740 -4.714372 -4.938191 -5.161753 -5.325480 -5.355142 -5.136723 -4.640612 -3.973484 -26.60814 -4.259578 -4.142016 -4.058466 -4.152590 -4.280780 -4.427505 -4.586123 -4.758991 -4.945995 -5.142746 -5.346728 -5.561586 -5.781370 -6.007394 -6.179748 -6.211358 -5.958851 -5.415488 -4.701708 -26.60814 -6.269176 -6.091549 -5.941512 -5.971650 -6.038630 -6.133412 -6.247932 -6.376579 -6.523503 -6.695920 -6.880110 -7.074904 -7.280636 -7.479950 -7.615129 -7.601718 -7.281510 -6.678651 -5.905231 -26.60814 -39.07559 -38.75349 -38.37226 -37.93819 -37.45686 -36.93303 -36.37072 -35.77329 -35.14364 -34.48421 -33.79709 -33.08413 -32.34689 -31.58681 -30.80512 -30.00294 -29.18128 -28.34105 -27.48309 -26.60814 2.691398 2.081477 1.563271 1.474386 1.353541 1.207556 1.044914 0.8731220 0.7005329 0.5332577 0.3785491 0.2429901 0.1315830 4.6458393E-02 -1.4470040E-02 -5.5017114E-02 -8.0342747E-02 -9.4873257E-02 -0.1017776 -30.42189 3.016632 2.497698 2.039847 1.878864 1.695351 1.493552 1.283400 1.072838 0.8702415 0.6830963 0.5208530 0.3898325 0.2976122 0.2429094 0.2205813 0.2250009 0.2480067 0.2838663 0.3286199 -30.42189 3.171824 2.730133 2.323500 2.078977 1.825981 1.566938 1.310237 1.064372 0.8333392 0.6275557 0.4557590 0.3276436 0.2507668 0.2227105 0.2356185 0.2817903 0.3506946 0.4351482 0.5304964 -30.42189 3.194843 2.814371 2.449251 2.137280 1.825836 1.515960 1.221273 0.9412256 0.6799133 0.4520782 0.2645308 0.1322581 6.2242649E-02 5.3103559E-02 9.6833616E-02 0.1811851 0.2940698 0.4261261 0.5716370 -30.42189 3.112612 2.783132 2.452509 2.092621 1.736308 1.392616 1.063672 0.7533361 0.4647067 0.2097423 2.8248427E-03 -0.1420991 -0.2132140 -0.2113081 -0.1422161 -2.2863925E-02 0.1324909 0.3114690 0.5069236 -30.42189 2.947856 2.660975 2.359082 1.969142 1.586893 1.215249 0.8601223 0.5278260 0.2136369 -6.8101175E-02 -0.2970200 -0.4610020 -0.5426665 -0.5372332 -0.4494116 -0.2984221 -0.1026157 0.1225520 0.3678132 -30.42189 2.712806 2.462526 2.188121 1.784185 1.385362 0.9963675 0.6238612 0.2707725 -5.9541252E-02 -0.3619026 -0.6174721 -0.8040460 -0.9055628 -0.9037728 -0.8064899 -0.6289117 -0.3950230 -0.1245133 0.1703790 -30.42189 2.418643 2.202429 1.953852 1.544086 1.136424 0.7401850 0.3561473 -7.1846233E-03 -0.3486866 -0.6666270 -0.9429795 -1.158254 -1.284786 -1.297108 -1.198966 -1.001354 -0.7327339 -0.4179932 -7.3691301E-02 -30.42189 2.067453 1.883610 1.658811 1.251776 0.8456239 0.4450677 5.9896871E-02 -0.3062468 -0.6534511 -0.9792221 -1.273219 -1.515014 -1.667564 -1.707551 -1.617987 -1.409745 -1.111425 -0.7542095 -0.3608558 -30.42189 1.660628 1.508045 1.305932 0.9087096 0.5105899 0.1158974 -0.2642452 -0.6290957 -0.9730933 -1.302835 -1.608398 -1.866287 -2.051425 -2.124254 -2.056080 -1.847453 -1.525996 -1.128680 -0.6868340 -30.42189 1.200134 1.076510 0.8973926 0.5164334 0.1333201 -0.2471336 -0.6188787 -0.9748621 -1.313902 -1.641218 -1.944680 -2.217354 -2.431072 -2.537110 -2.503047 -2.307196 -1.969861 -1.535501 -1.045801 -30.42189 0.6866762 0.5913301 0.4364290 7.6711372E-02 -0.2867372 -0.6481063 -1.003627 -1.350205 -1.679437 -1.993113 -2.292882 -2.575627 -2.807173 -2.951085 -2.956809 -2.789770 -2.447241 -1.980199 -1.443421 -30.42189 0.1170929 5.0520562E-02 -7.8350291E-02 -0.4115180 -0.7508038 -1.091036 -1.425887 -1.753679 -2.065847 -2.369430 -2.663976 -2.941564 -3.191245 -3.362983 -3.418685 -3.290312 -2.954511 -2.460129 -1.877265 -30.42189 -0.5173917 -0.5534310 -0.6542391 -0.9563716 -1.266318 -1.577096 -1.885183 -2.191702 -2.491625 -2.780484 -3.060179 -3.334388 -3.590172 -3.791108 -3.890139 -3.811282 -3.492702 -2.977262 -2.349285 -30.42189 -1.228539 -1.231851 -1.301284 -1.564335 -1.840029 -2.120016 -2.402119 -2.685001 -2.964055 -3.234977 -3.502044 -3.765521 -4.030608 -4.251540 -4.389290 -4.363957 -4.077086 -3.545014 -2.872622 -30.42189 -2.045368 -2.011832 -2.044214 -2.264908 -2.501986 -2.746492 -2.996933 -3.252946 -3.511035 -3.764394 -4.018464 -4.275044 -4.537267 -4.774544 -4.940531 -4.965337 -4.708803 -4.162077 -3.443933 -30.42189 -3.021202 -2.948514 -2.936339 -3.108629 -3.301749 -3.509922 -3.726667 -3.952650 -4.190549 -4.426896 -4.663421 -4.909398 -5.167370 -5.413242 -5.609576 -5.667189 -5.432238 -4.860915 -4.094762 -30.42189 -4.299795 -4.182386 -4.117959 -4.237026 -4.382377 -4.546494 -4.725595 -4.917622 -5.126630 -5.343651 -5.563031 -5.800575 -6.051867 -6.312516 -6.519257 -6.588016 -6.329755 -5.705648 -4.887840 -30.42189 -6.420309 -6.239532 -6.102122 -6.150072 -6.233874 -6.338524 -6.465551 -6.612877 -6.782452 -6.970986 -7.176626 -7.397555 -7.633285 -7.885759 -8.069429 -8.069953 -7.738160 -7.045942 -6.163769 -30.42189 -44.58060 -44.22326 -43.79525 -43.30479 -42.75906 -42.16398 -41.52451 -40.84475 -40.12815 -39.37761 -38.59560 -37.78427 -36.94547 -36.08083 -35.19180 -34.27968 -33.34563 -32.39069 -31.41582 -30.42189 2.994369 2.310157 1.825973 1.735935 1.611987 1.457210 1.283618 1.097404 0.9069206 0.7222551 0.5510218 0.4026287 0.2811320 0.1899585 0.1260283 8.4243789E-02 5.9540436E-02 4.6095427E-02 3.9996613E-02 -34.35604 3.385968 2.799814 2.354136 2.184521 1.987990 1.772742 1.548238 1.320291 1.099392 0.8957112 0.7188521 0.5804765 0.4837417 0.4300926 0.4126759 0.4233021 0.4535987 0.4969484 0.5487558 -34.35604 3.582682 3.081506 2.662303 2.396011 2.120842 1.843134 1.567348 1.298513 1.048200 0.8242389 0.6391255 0.5039545 0.4261752 0.4033582 0.4265578 0.4849448 0.5670713 0.6650358 0.7736019 -34.35604 3.624967 3.193910 2.796414 2.454152 2.115927 1.782086 1.461249 1.156692 0.8741472 0.6271475 0.4262845 0.2858959 0.2178617 0.2184061 0.2770036 0.3800502 0.5123608 0.6641424 0.8291346 -34.35604 3.549192 3.175812 2.799608 2.406128 2.018152 1.641971 1.286205 0.9487446 0.6343207 0.3603750 0.1351129 -1.8851003E-02 -8.9778863E-02 -7.5791508E-02 1.2258192E-02 0.1560693 0.3369606 0.5419389 0.7631952 -34.35604 3.382802 3.056969 2.701837 2.275450 1.854233 1.449253 1.064459 0.7034479 0.3635781 5.8028720E-02 -0.1944624 -0.3709529 -0.4538133 -0.4376108 -0.3271663 -0.1468304 8.0896288E-02 0.3385034 0.6159306 -34.35604 3.137880 2.853731 2.520886 2.074785 1.637528 1.214496 0.8117475 0.4322821 7.1734913E-02 -0.2598934 -0.5389422 -0.7466265 -0.8533564 -0.8459081 -0.7228524 -0.5110909 -0.2392007 7.0146404E-02 0.4036192 -34.35604 2.825167 2.579079 2.268275 1.818942 1.372716 0.9419718 0.5298320 0.1378299 -0.2365607 -0.5829755 -0.8889653 -1.128255 -1.268758 -1.280216 -1.158441 -0.9229063 -0.6103053 -0.2503848 0.1389461 -34.35604 2.452120 2.242138 1.953605 1.508399 1.064623 0.6334271 0.2159356 -0.1801043 -0.5578864 -0.9144406 -1.238496 -1.509836 -1.686127 -1.728902 -1.621775 -1.372856 -1.024679 -0.6157877 -0.1708812 -34.35604 2.021146 1.844800 1.579463 1.145948 0.7126824 0.2853699 -0.1291399 -0.5218762 -0.8982323 -1.255326 -1.592440 -1.887843 -2.093980 -2.181076 -2.101632 -1.853533 -1.477386 -1.022030 -0.5219995 -34.35604 1.533913 1.389582 1.149736 0.7318768 0.3127472 -0.1008906 -0.5036984 -0.8912954 -1.258952 -1.614659 -1.953226 -2.258793 -2.497720 -2.626550 -2.590630 -2.358470 -1.964102 -1.465718 -0.9112493 -34.35604 0.9891850 0.8751938 0.6622245 0.2661831 -0.1321289 -0.5270246 -0.9134784 -1.289030 -1.648014 -1.994323 -2.321114 -2.635995 -2.898541 -3.062878 -3.079372 -2.882265 -2.480844 -1.943977 -1.335840 -34.35604 0.3824731 0.2996717 0.1150367 -0.2521170 -0.6256129 -0.9971971 -1.363622 -1.722532 -2.064925 -2.391638 -2.712775 -3.027066 -3.300204 -3.501093 -3.570713 -3.426631 -3.034106 -2.464840 -1.803976 -34.35604 -0.2931185 -0.3434658 -0.4968110 -0.8310735 -1.175302 -1.518495 -1.857236 -2.190311 -2.515889 -2.829365 -3.135131 -3.436533 -3.721835 -3.946170 -4.070305 -3.987669 -3.619130 -3.025041 -2.312643 -34.35604 -1.054844 -1.070189 -1.187254 -1.480794 -1.786338 -2.095825 -2.405110 -2.715170 -3.021159 -3.312628 -3.603186 -3.890718 -4.178323 -4.427763 -4.593747 -4.578652 -4.247775 -3.635270 -2.871938 -34.35604 -1.928377 -1.903855 -1.977580 -2.223773 -2.488476 -2.762098 -3.036748 -3.317027 -3.600009 -3.872878 -4.145841 -4.423493 -4.710256 -4.972888 -5.177152 -5.218830 -4.937421 -4.310133 -3.495775 -34.35604 -2.968108 -2.899737 -2.924293 -3.117179 -3.335139 -3.566639 -3.805060 -4.053420 -4.310986 -4.568343 -4.824716 -5.089998 -5.372998 -5.645347 -5.875518 -5.966939 -5.720788 -5.071004 -4.203040 -34.35604 -4.319196 -4.202734 -4.171370 -4.302286 -4.468002 -4.654978 -4.850398 -5.063240 -5.293056 -5.529696 -5.769467 -6.024486 -6.304435 -6.587978 -6.838010 -6.946295 -6.688087 -5.983262 -5.058212 -34.35604 -6.548304 -6.365258 -6.256927 -6.308756 -6.402649 -6.527885 -6.666425 -6.829173 -7.021606 -7.232511 -7.452911 -7.697111 -7.964738 -8.248663 -8.482692 -8.522699 -8.184131 -7.403565 -6.408772 -34.35604 -50.25966 -49.86649 -49.39024 -48.84141 -48.22889 -47.55996 -46.84056 -46.07592 -45.26905 -44.42434 -43.54432 -42.63144 -41.68784 -40.71538 -39.71572 -38.69033 -37.64054 -36.56752 -35.47236 -34.35604 3.291384 2.532831 2.090399 2.000309 1.869777 1.707950 1.522068 1.321014 1.113445 0.9093876 0.7222039 0.5592534 0.4277032 0.3292055 0.2620382 0.2194191 0.1950753 0.1823834 0.1769664 -38.40252 3.750558 3.099974 2.669921 2.487420 2.278263 2.050274 1.810467 1.565956 1.327662 1.106951 0.9177841 0.7705617 0.6706507 0.6184240 0.6060112 0.6230810 0.6608946 0.7115866 0.7704664 -38.40252 3.985509 3.426516 2.996928 2.708230 2.412462 2.114638 1.820326 1.532246 1.262534 1.022284 0.8250014 0.6845630 0.6066844 0.5914699 0.6261427 0.6972753 0.7930802 0.9047017 1.026672 -38.40252 4.048378 3.566049 3.137495 2.765521 2.398039 2.041324 1.697435 1.366513 1.065325 0.7988972 0.5840092 0.4369924 0.3694177 0.3803261 0.4555385 0.5771196 0.7291588 0.9008171 1.085581 -38.40252 3.980078 3.561872 3.141098 2.710972 2.291584 1.887130 1.503647 1.139289 0.8026950 0.5053519 0.2641097 9.8937869E-02 2.8903488E-02 5.5173852E-02 0.1636608 0.3321496 0.5389948 0.7702431 1.017722 -38.40252 3.810111 3.444992 3.037112 2.572589 2.117252 1.679285 1.266350 0.8773934 0.5104866 0.1818408 -9.3680352E-02 -0.2855541 -0.3731430 -0.3441091 -0.2105662 3.1561637E-04 0.2602800 0.5506415 0.8607903 -38.40252 3.556300 3.237672 2.847029 2.361964 1.885379 1.429991 0.9990541 0.5901053 0.2022953 -0.1551486 -0.4645850 -0.6906976 -0.8078598 -0.7923428 -0.6444396 -0.3978357 -8.7288715E-02 0.2614892 0.6342367 -38.40252 3.227695 2.951974 2.579778 2.088484 1.606607 1.143196 0.7012836 0.2813294 -0.1213042 -0.4994989 -0.8346277 -1.099643 -1.256375 -1.270346 -1.123187 -0.8492312 -0.4921005 -8.6125873E-02 0.3490719 -38.40252 2.832309 2.595277 2.245043 1.761717 1.283128 0.8182913 0.3720682 -5.3590912E-02 -0.4621623 -0.8464756 -1.205533 -1.500545 -1.702197 -1.756371 -1.630685 -1.341452 -0.9432149 -0.4817345 1.5664626E-02 -38.40252 2.379369 2.178434 1.852546 1.381254 0.9119086 0.4543653 8.1901411E-03 -0.4161929 -0.8205990 -1.207107 -1.574740 -1.897688 -2.135815 -2.239745 -2.152535 -1.864621 -1.433045 -0.9184754 -0.3592315 -38.40252 1.866522 1.699705 1.400994 0.9476680 0.4927470 4.6505392E-02 -0.3887652 -0.8051953 -1.202648 -1.582410 -1.952308 -2.291478 -2.556094 -2.712456 -2.678008 -2.411170 -1.957752 -1.393706 -0.7731891 -38.40252 1.291647 1.158623 0.8882080 0.4574416 2.2944676E-02 -0.4043095 -0.8221193 -1.227076 -1.610774 -1.982080 -2.342494 -2.681699 -2.974950 -3.172222 -3.202616 -2.978056 -2.517165 -1.908752 -1.227829 -38.40252 0.6508490 0.5509862 0.3108941 -9.0279102E-02 -0.4986112 -0.9020665 -1.297095 -1.684704 -2.054200 -2.407389 -2.749734 -3.091100 -3.395018 -3.629388 -3.721255 -3.561893 -3.111768 -2.465903 -1.725510 -38.40252 -6.5474771E-02 -0.1308171 -0.3354289 -0.7010334 -1.078625 -1.453255 -1.821163 -2.184313 -2.531236 -2.867346 -3.197735 -3.523787 -3.835692 -4.093575 -4.246011 -4.163017 -3.744967 -3.070225 -2.271481 -38.40252 -0.8736694 -0.9014134 -1.065470 -1.388595 -1.727726 -2.065685 -2.400300 -2.736024 -3.065067 -3.380732 -3.692179 -4.007749 -4.314717 -4.591211 -4.790815 -4.788464 -4.418930 -3.724198 -2.868202 -38.40252 -1.798580 -1.783499 -1.901226 -2.173846 -2.467419 -2.766990 -3.067162 -3.371094 -3.676794 -3.974111 -4.266076 -4.566396 -4.870797 -5.158829 -5.396669 -5.467525 -5.165872 -4.455974 -3.543249 -38.40252 -2.900998 -2.838228 -2.903080 -3.115966 -3.357851 -3.612869 -3.872502 -4.143192 -4.425026 -4.701269 -4.977394 -5.266317 -5.564443 -5.862047 -6.122327 -6.259244 -6.002800 -5.271941 -4.299563 -38.40252 -4.326357 -4.209531 -4.213464 -4.360837 -4.544046 -4.744728 -4.961296 -5.195260 -5.449434 -5.706392 -5.965613 -6.242339 -6.541522 -6.852276 -7.135312 -7.290053 -7.038390 -6.255217 -5.219194 -38.40252 -6.661897 -6.465654 -6.389225 -6.455835 -6.561783 -6.692173 -6.850405 -7.036588 -7.248133 -7.483697 -7.724688 -7.985193 -8.284881 -8.590425 -8.867174 -8.962333 -8.619262 -7.751385 -6.641140 -38.40252 -56.10111 -55.67155 -55.14565 -54.53650 -53.85496 -53.10971 -52.30780 -51.45489 -50.55564 -49.61390 -48.63295 -47.61557 -46.56417 -45.48087 -44.36753 -43.22580 -42.05716 -40.86295 -39.64437 -38.40252 3.579003 2.743556 2.351488 2.263981 2.128109 1.957251 1.760234 1.542858 1.316713 1.093922 0.8885194 0.7095690 0.5661956 0.4603105 0.3893771 0.3458071 0.3214810 0.3092885 0.3043877 -42.55429 4.108987 3.392750 2.982795 2.789162 2.565137 2.324154 2.068983 1.807624 1.550844 1.313653 1.110991 0.9537752 0.8511716 0.8001871 0.7928041 0.8169441 0.8619530 0.9198648 0.9858043 -42.55429 4.384287 3.768393 3.329362 3.015036 2.697626 2.381650 2.066137 1.760362 1.472133 1.214887 1.005186 0.8578525 0.7821430 0.7743254 0.8204921 0.9048014 1.014380 1.139602 1.275121 -42.55429 4.465523 3.932678 3.473190 3.070099 2.675183 2.293797 1.926560 1.574533 1.251592 0.9668040 0.7374318 0.5837904 0.5184094 0.5416347 0.6339949 0.7747073 0.9468241 1.138547 1.343395 -42.55429 4.404775 3.941181 3.476168 3.010109 2.557741 2.125838 1.717121 1.326302 0.9670094 0.6467361 0.3876021 0.2119062 0.1416506 0.1814896 0.3121782 0.5056817 0.7389106 0.9966756 1.270820 -42.55429 4.232027 3.827108 3.367323 2.861699 2.372978 1.906279 1.465533 1.047651 0.6555544 0.2992308 3.4930424E-03 -0.2071277 -0.2983692 -0.2566799 -9.8616816E-02 0.1430460 0.4357615 0.7591944 1.102644 -42.55429 3.967268 3.614073 3.165542 2.641476 2.130707 1.643144 1.183746 0.7450829 0.3294521 -5.5395987E-02 -0.3903498 -0.6396214 -0.7705928 -0.7455702 -0.5729795 -0.2903162 5.9347901E-02 0.4478504 0.8605791 -42.55429 3.623470 3.316982 2.885441 2.356451 1.837711 1.341743 0.8696811 0.4194391 -7.9954164E-03 -0.4165661 -0.7810608 -1.070190 -1.248751 -1.263898 -1.093885 -0.7810041 -0.3785574 7.3948503E-02 0.5558594 -42.55429 3.210326 2.946085 2.535741 2.011259 1.498613 1.000728 0.5228987 6.9640510E-02 -0.3654622 -0.7823123 -1.166835 -1.490757 -1.718741 -1.788854 -1.644660 -1.315016 -0.8660527 -0.3513579 0.1995285 -42.55429 2.734178 2.507768 2.123840 1.613505 1.109922 0.6178375 0.1432491 -0.3104236 -0.7428197 -1.155188 -1.552639 -1.900506 -2.174409 -2.300156 -2.207072 -1.880480 -1.393502 -0.8191112 -0.1995903 -42.55429 2.196703 2.007000 1.650267 1.159497 0.6711239 0.1914960 -0.2748216 -0.7205357 -1.141851 -1.548196 -1.941451 -2.309197 -2.611036 -2.796761 -2.767399 -2.468764 -1.955870 -1.325437 -0.6377623 -42.55429 1.593594 1.440077 1.113432 0.6470958 0.1773697 -0.2828567 -0.7304447 -1.162845 -1.570821 -1.964141 -2.350968 -2.720227 -3.042192 -3.276868 -3.323753 -3.077855 -2.558422 -1.877615 -1.122663 -42.55429 0.9187914 0.8011894 0.5081977 7.1961574E-02 -0.3702540 -0.8049220 -1.230170 -1.642231 -2.035434 -2.415138 -2.783723 -3.146167 -3.479740 -3.746591 -3.869509 -3.699331 -3.194520 -2.470883 -1.649761 -42.55429 0.1644306 8.3847918E-02 -0.1707241 -0.5693772 -0.9790514 -1.383095 -1.779633 -2.169559 -2.543489 -2.898909 -3.254343 -3.604460 -3.937615 -4.231247 -4.412206 -4.336046 -3.872787 -3.116357 -2.230195 -42.55429 -0.6850033 -0.7252601 -0.9375803 -1.291458 -1.661397 -2.029324 -2.390545 -2.750437 -3.103518 -3.440394 -3.774095 -4.111793 -4.442168 -4.744253 -4.977459 -4.992874 -4.592369 -3.814469 -2.864527 -42.55429 -1.661559 -1.656594 -1.819112 -2.117491 -2.437783 -2.762225 -3.087843 -3.417804 -3.747107 -4.063582 -4.379333 -4.700025 -5.021294 -5.334451 -5.602254 -5.703325 -5.380484 -4.588267 -3.574796 -42.55429 -2.824010 -2.764376 -2.868540 -3.106059 -3.371814 -3.645709 -3.932640 -4.227302 -4.532026 -4.824066 -5.120329 -5.432237 -5.744936 -6.066751 -6.358311 -6.529282 -6.273925 -5.464747 -4.385662 -42.55429 -4.323774 -4.200487 -4.236658 -4.406027 -4.607619 -4.826060 -5.066561 -5.323590 -5.597969 -5.869148 -6.148474 -6.453579 -6.761437 -7.093439 -7.410157 -7.615918 -7.378809 -6.518100 -5.369025 -42.55429 -6.751021 -6.541004 -6.492430 -6.577521 -6.701382 -6.844957 -7.023736 -7.230865 -7.463934 -7.712193 -7.974360 -8.269446 -8.581840 -8.911620 -9.229745 -9.382962 -9.043439 -8.090868 -6.863259 -42.55429 -62.09480 -61.62828 -61.05136 -60.38003 -59.62731 -58.80344 -57.91656 -56.97319 -55.97860 -54.93717 -53.85256 -52.72791 -51.56593 -50.36896 -49.13909 -47.87815 -46.58780 -45.26950 -43.92459 -42.55429 3.854055 2.941964 2.606362 2.526536 2.386338 2.207791 1.997964 1.765139 1.518863 1.275867 1.052402 0.8567895 0.7007756 0.5877740 0.5127453 0.4679621 0.4434447 0.4317339 0.4272729 -46.80515 4.458679 3.674414 3.290780 3.086154 2.850090 2.594325 2.323475 2.044741 1.768634 1.513895 1.296504 1.129632 1.023177 0.9739832 0.9716302 1.002512 1.054595 1.119697 1.192724 -46.80515 4.777153 4.103955 3.656568 3.318934 2.977916 2.642702 2.307261 1.982550 1.674549 1.401455 1.178555 1.024502 0.9513621 0.9511490 1.009262 1.107262 1.230407 1.369345 1.518590 -46.80515 4.878098 4.294850 3.806154 3.368736 2.946164 2.541119 2.148532 1.775588 1.431719 1.128509 0.8840625 0.7219942 0.6614358 0.6964937 0.8064378 0.9668726 1.159094 1.371068 1.596321 -46.80515 4.823643 4.314970 3.805336 3.303226 2.818691 2.359122 1.924115 1.509111 1.125880 0.7832831 0.5050134 0.3179698 0.2491697 0.3037588 0.4569142 0.6760574 0.9358952 1.220570 1.521843 -46.80515 4.647707 4.202523 3.691557 3.145652 2.622952 2.127463 1.659214 1.213724 0.7959689 0.4141253 9.6031263E-02 -0.1329550 -0.2297651 -0.1753544 9.1138538E-03 0.2819845 0.6077045 0.9647003 1.342045 -46.80515 4.372429 3.983983 3.478511 2.914741 2.370353 1.852458 1.362745 0.8967655 0.4539774 3.9440501E-02 -0.3160476 -0.5933310 -0.7374248 -0.7053568 -0.5067423 -0.1878474 0.2012144 0.6299823 1.083429 -46.80515 4.013172 3.675139 3.184830 2.617808 2.066032 1.535263 1.033544 0.5549902 9.9506333E-02 -0.3344394 -0.7240021 -1.043607 -1.246565 -1.262679 -1.071118 -0.7183803 -0.2701967 0.2293516 0.7588434 -46.80515 3.583720 3.290326 2.821681 2.259176 1.708871 1.178817 0.6706132 0.1881938 -0.2692778 -0.7128128 -1.124404 -1.480487 -1.737093 -1.822287 -1.663917 -1.295031 -0.7945125 -0.2258354 0.3795346 -46.80515 3.086324 2.834359 2.390762 1.842238 1.302631 0.7791106 0.2721918 -0.2055802 -0.6620958 -1.101050 -1.523494 -1.901900 -2.207536 -2.363328 -2.266183 -1.903136 -1.360330 -0.7251528 -4.4181596E-02 -46.80515 2.523628 2.310539 1.895635 1.368199 0.8440104 0.3341959 -0.1622978 -0.6340021 -1.080572 -1.510748 -1.929841 -2.321783 -2.661338 -2.877084 -2.860890 -2.532938 -1.961444 -1.263474 -0.5073744 -46.80515 1.892928 1.718329 1.335487 0.8340400 0.3311584 -0.1607583 -0.6392496 -1.096748 -1.530664 -1.946376 -2.356768 -2.753146 -3.103964 -3.373972 -3.443542 -3.182654 -2.603975 -1.849375 -1.018906 -46.80515 1.186608 1.050904 0.7049433 0.2343465 -0.2415591 -0.7067363 -1.161297 -1.601268 -2.015774 -2.416690 -2.816393 -3.196503 -3.558607 -3.859249 -4.013800 -3.842613 -3.283810 -2.481085 -1.577425 -46.80515 0.3969805 0.3005701 -5.0973049E-03 -0.4363797 -0.8782023 -1.311077 -1.735124 -2.152789 -2.550111 -2.928197 -3.306736 -3.677211 -4.033519 -4.357225 -4.574389 -4.510892 -4.001667 -3.161970 -2.186304 -46.80515 -0.4940000 -0.5476933 -0.8073199 -1.191582 -1.590968 -1.985948 -2.378646 -2.765173 -3.136731 -3.494769 -3.856793 -4.208949 -4.560122 -4.889565 -5.155556 -5.196685 -4.766920 -3.903182 -2.856817 -46.80515 -1.519828 -1.522701 -1.729128 -2.058738 -2.405116 -2.754802 -3.109498 -3.463533 -3.812513 -4.146262 -4.490887 -4.828478 -5.165064 -5.498794 -5.798068 -5.931763 -5.597700 -4.721444 -3.604844 -46.80515 -2.742204 -2.684336 -2.826120 -3.090499 -3.379246 -3.680686 -3.992671 -4.312996 -4.631381 -4.944899 -5.265235 -5.591570 -5.918748 -6.255272 -6.580465 -6.786304 -6.543787 -5.653160 -4.464901 -46.80515 -4.311934 -4.185189 -4.253392 -4.444029 -4.665774 -4.909593 -5.172610 -5.452303 -5.736880 -6.030473 -6.331754 -6.652753 -6.973589 -7.324154 -7.671837 -7.927253 -7.714705 -6.775028 -5.510437 -46.80515 -6.826602 -6.613158 -6.583845 -6.685626 -6.821434 -6.992313 -7.190991 -7.419108 -7.672149 -7.937226 -8.225816 -8.545291 -8.868386 -9.224651 -9.569346 -9.784109 -9.464064 -8.428557 -7.080649 -46.80515 -68.23173 -67.72771 -67.09842 -66.36314 -65.53720 -64.63274 -63.65836 -62.62212 -61.52973 -60.38608 -59.19526 -57.96076 -56.68557 -55.37229 -54.02348 -52.64041 -51.22565 -49.78056 -48.30661 -46.80515 4.121181 3.133853 2.859552 2.783738 2.645329 2.458561 2.236870 1.986807 1.720664 1.459301 1.214784 1.003025 0.8341818 0.7130954 0.6341547 0.5878417 0.5632704 0.5520849 0.5479949 -51.14960 4.800287 3.946965 3.590786 3.379596 3.131735 2.862783 2.575408 2.278284 1.983791 1.711313 1.479357 1.303370 1.192853 1.146042 1.148975 1.186569 1.245834 1.318224 1.398379 -51.14960 5.163301 4.430731 3.978282 3.617242 3.255450 2.898638 2.543622 2.199096 1.873053 1.583034 1.346319 1.186959 1.115203 1.123959 1.194359 1.305771 1.442682 1.595494 1.758621 -51.14960 5.286302 4.652058 4.133994 3.664294 3.211656 2.782466 2.365582 1.971615 1.606778 1.285954 1.024822 0.8555419 0.7993121 0.8470376 0.9752693 1.155746 1.368239 1.600757 1.846704 -51.14960 5.237044 4.683247 4.131313 3.590338 3.074639 2.587323 2.125190 1.687690 1.280992 0.9169886 0.6173539 0.4170255 0.3510101 0.4201265 0.5962421 0.8413681 1.128109 1.440067 1.768882 -51.14960 5.057693 4.572318 4.009221 3.424745 2.867984 2.343631 1.847572 1.378431 0.9320937 0.5289643 0.1845246 -6.3523434E-02 -0.1663976 -9.8192349E-02 0.1124965 0.4168849 0.7761017 1.167242 1.579015 -51.14960 4.771520 4.347063 3.785703 3.183097 2.604433 2.056015 1.538365 1.045162 0.5750995 0.1373803 -0.2458190 -0.5481923 -0.7091479 -0.6714423 -0.4457943 -9.0619102E-02 0.3383992 0.8081642 1.302961 -51.14960 4.398294 4.027438 3.479603 2.872970 2.288356 1.727118 1.193196 0.6898274 0.2084252 -0.2510357 -0.6668213 -1.018332 -1.246222 -1.266409 -1.055008 -0.6624724 -0.1680051 0.3794707 0.9572815 -51.14960 3.951575 3.628056 3.100940 2.502123 1.918154 1.352696 0.8155329 0.3082179 -0.1748150 -0.6412872 -1.080587 -1.466199 -1.757244 -1.857403 -1.690129 -1.281488 -0.7288436 -0.1052390 0.5554796 -51.14960 3.434236 3.155514 2.654282 2.067838 1.492772 0.9365957 0.4013106 -0.1027239 -0.5817263 -1.047164 -1.493366 -1.902868 -2.237986 -2.424424 -2.329248 -1.931840 -1.331908 -0.6348330 0.1085489 -51.14960 2.846322 2.609940 2.137627 1.574277 1.015564 0.4734783 -5.0351620E-02 -0.5483650 -1.019287 -1.475424 -1.918740 -2.332386 -2.702823 -2.955415 -2.956592 -2.602867 -1.971647 -1.205140 -0.3795160 -51.14960 2.187896 1.992716 1.555747 1.018736 0.4824144 -3.9718326E-02 -0.5477805 -1.033072 -1.488632 -1.932306 -2.360888 -2.776794 -3.160778 -3.464744 -3.562791 -3.291988 -2.653407 -1.823905 -0.9167712 -51.14960 1.452458 1.298125 0.9007251 0.3957029 -0.1128963 -0.6090240 -1.092335 -1.560577 -1.996783 -2.419868 -2.840133 -3.242041 -3.626702 -3.963648 -4.149030 -3.987157 -3.375407 -2.492574 -1.505021 -51.14960 0.6288119 0.5162685 0.1612942 -0.3043528 -0.7758585 -1.240304 -1.693402 -2.135769 -2.551863 -2.957630 -3.356849 -3.743301 -4.123853 -4.472560 -4.725410 -4.683181 -4.133904 -3.210545 -2.144011 -51.14960 -0.3023663 -0.3674902 -0.6749008 -1.091852 -1.520017 -1.945984 -2.365810 -2.778600 -3.168497 -3.547090 -3.932623 -4.300271 -4.671391 -5.024174 -5.319446 -5.393198 -4.941954 -3.993970 -2.849686 -51.14960 -1.374891 -1.385342 -1.635948 -1.995891 -2.372276 -2.750845 -3.130386 -3.508323 -3.873280 -4.230671 -4.595556 -4.950863 -5.302819 -5.653675 -5.977320 -6.149780 -5.814287 -4.857115 -3.635832 -51.14960 -2.651815 -2.597884 -2.779326 -3.070287 -3.383353 -3.712059 -4.049548 -4.392182 -4.728455 -5.063123 -5.406298 -5.744065 -6.086047 -6.434578 -6.781138 -7.030548 -6.809537 -5.842419 -4.542731 -51.14960 -4.289283 -4.163187 -4.260905 -4.473505 -4.714598 -4.984032 -5.271409 -5.569989 -5.876698 -6.185087 -6.511595 -6.841272 -7.182845 -7.536612 -7.912302 -8.219365 -8.040816 -7.023698 -5.641110 -51.14960 -6.893284 -6.668230 -6.664493 -6.779285 -6.931003 -7.125476 -7.347151 -7.595263 -7.868031 -8.157743 -8.473709 -8.805860 -9.156427 -9.524501 -9.900269 -10.16593 -9.867943 -8.752537 -7.280874 -51.14960 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.39429 -67.20177 -65.95354 -64.65410 -63.30730 -61.91644 -60.48462 -59.01363 -57.50642 -55.96472 -54.39030 -52.78478 -51.14960 4.380928 3.319403 3.111791 3.040363 2.901603 2.710778 2.476072 2.209260 1.923940 1.642839 1.376559 1.147493 0.9665093 0.8373237 0.7546464 0.7067385 0.6823175 0.6715095 0.6677427 -55.58271 5.136058 4.214394 3.888613 3.667066 3.411406 3.127182 2.825288 2.509253 2.196022 1.907055 1.657515 1.472575 1.360170 1.315970 1.324320 1.368770 1.435425 1.515134 1.602475 -55.58271 5.542316 4.750020 4.292538 3.911178 3.527785 3.150152 2.775934 2.410661 2.068928 1.758398 1.507744 1.343476 1.274636 1.293162 1.375836 1.500819 1.651744 1.818557 1.995745 -55.58271 5.687858 5.001272 4.457048 3.954313 3.473810 3.018500 2.578198 2.164232 1.778949 1.434977 1.157720 0.9839859 0.9321136 0.9942739 1.140989 1.341449 1.574602 1.827877 2.094811 -55.58271 5.645954 5.047156 4.451776 3.873827 3.325195 2.811079 2.322674 1.863441 1.429133 1.044253 0.7236017 0.5118150 0.4488617 0.5333472 0.7328534 1.004479 1.318581 1.658143 2.014920 -55.58271 5.461816 4.935956 4.321878 3.698409 3.108830 2.554828 2.033174 1.535610 1.064083 0.6378770 0.2694478 -1.7906839E-04 -0.1076760 -2.7016766E-02 0.2095839 0.5460349 0.9394405 1.365084 1.811820 -55.58271 5.164941 4.703962 4.087106 3.446573 2.834207 2.255550 1.707583 1.189478 0.6922255 0.2334149 -0.1779985 -0.5069613 -0.6839893 -0.6418331 -0.3908302 1.2178156E-03 0.4710387 0.9823498 1.519148 -55.58271 4.778946 4.374291 3.768921 3.125089 2.505547 1.911233 1.349811 0.8192643 0.3153538 -0.1676527 -0.6095407 -0.9920405 -1.245460 -1.275607 -1.044524 -0.6119139 -7.0440970E-02 0.5255790 1.152470 -55.58271 4.314607 3.960858 3.376775 2.738654 2.120234 1.523136 0.9552464 0.4244791 -8.1594728E-02 -0.5721303 -1.035155 -1.451912 -1.774407 -1.895696 -1.723714 -1.274402 -0.6688547 1.0316145E-02 0.7272239 -55.58271 3.776328 3.470552 2.912302 2.288781 1.678317 1.089732 0.5267399 -1.8045485E-03 -0.5043203 -0.9944206 -1.462720 -1.897577 -2.265047 -2.479984 -2.395142 -1.962674 -1.304919 -0.5450280 0.2617297 -55.58271 3.165153 2.905397 2.377340 1.775048 1.183605 0.6101515 5.6409597E-02 -0.4643643 -0.9584993 -1.441265 -1.901566 -2.340799 -2.738170 -3.030837 -3.055460 -2.681064 -1.991427 -1.155620 -0.2594767 -55.58271 2.479355 2.263047 1.773219 1.200053 0.6316158 7.8189947E-02 -0.4595144 -0.9691203 -1.447158 -1.916396 -2.362841 -2.797839 -3.211145 -3.545443 -3.682984 -3.407013 -2.712509 -1.807579 -0.8227525 -55.58271 1.716053 1.543150 1.093264 0.5542492 1.5206713E-02 -0.5141802 -1.027490 -1.517181 -1.976688 -2.425171 -2.859257 -3.287338 -3.689457 -4.054713 -4.280878 -4.132748 -3.471434 -2.507897 -1.435399 -55.58271 0.8589185 0.7317388 0.3258702 -0.1722529 -0.6762015 -1.172320 -1.655229 -2.115248 -2.553686 -2.984353 -3.404703 -3.807026 -4.204364 -4.575315 -4.871537 -4.855165 -4.270243 -3.263151 -2.104537 -55.58271 -0.1104622 -0.1873634 -0.5417364 -0.9911998 -1.450722 -1.906844 -2.353908 -2.785273 -3.201147 -3.604460 -4.004356 -4.391130 -4.770876 -5.148094 -5.475663 -5.585835 -5.117351 -4.086480 -2.843143 -55.58271 -1.225274 -1.244865 -1.539657 -1.929644 -2.334472 -2.745653 -3.150344 -3.547885 -3.933991 -4.317229 -4.693509 -5.065045 -5.431375 -5.798318 -6.147924 -6.360184 -6.029834 -4.993424 -3.666542 -55.58271 -2.555475 -2.507570 -2.726862 -3.043890 -3.384946 -3.740784 -4.102849 -4.464322 -4.823332 -5.181490 -5.536826 -5.888753 -6.242476 -6.606431 -6.972899 -7.264990 -7.070422 -6.030572 -4.619214 -55.58271 -4.261297 -4.130842 -4.259419 -4.491871 -4.761765 -5.052967 -5.362654 -5.685917 -6.009725 -6.341833 -6.681036 -7.018384 -7.373820 -7.745151 -8.141629 -8.486854 -8.350662 -7.268063 -5.766634 -55.58271 -6.951734 -6.711239 -6.731009 -6.858459 -7.035094 -7.246917 -7.491270 -7.769160 -8.062877 -8.372367 -8.704791 -9.041410 -9.409966 -9.789573 -10.19515 -10.51258 -10.26900 -9.073160 -7.475553 -55.58271 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.76147 -67.25262 -65.69942 -64.10464 -62.47066 -60.79965 -59.09354 -57.35403 -55.58271 4.636945 3.501043 3.359739 3.295782 3.157570 2.961060 2.714443 2.430372 2.126341 1.822394 1.537365 1.290277 1.095976 0.9589405 0.8718352 0.8227551 0.7982870 0.7877244 0.7842415 -60.10012 5.466112 4.476653 4.183730 3.952132 3.686372 3.389871 3.070602 2.737324 2.405110 2.097156 1.834074 1.640016 1.526320 1.484783 1.498948 1.550668 1.624792 1.711802 1.806407 -60.10012 5.916154 5.064427 4.603092 4.198305 3.796971 3.395591 3.003506 2.618411 2.256289 1.928280 1.664752 1.494639 1.430330 1.458520 1.553536 1.692571 1.857624 2.038569 2.230012 -60.10012 6.082476 5.344248 4.772663 4.240520 3.730629 3.250103 2.786737 2.349815 1.945560 1.579201 1.286581 1.107737 1.061695 1.138649 1.303746 1.524879 1.778905 2.053172 2.341404 -60.10012 6.048462 5.404388 4.767826 4.151762 3.572102 3.029310 2.516062 2.030885 1.576174 1.168103 0.8251244 0.6029273 0.5424022 0.6428410 0.8662900 1.165004 1.506806 1.874287 2.259441 -60.10012 5.861012 5.294864 4.628334 3.968239 3.344294 2.760979 2.211720 1.687994 1.195334 0.7427182 0.3505711 6.0638197E-02 -5.2831851E-02 3.8282037E-02 0.3017515 0.6714321 1.099306 1.559859 2.042093 -60.10012 5.553470 5.055403 4.384119 3.704792 3.058846 2.448336 1.872944 1.331309 0.8100685 0.3268924 -0.1106038 -0.4671674 -0.6626003 -0.6197748 -0.3431812 8.6443126E-02 0.5976222 1.150859 1.730305 -60.10012 5.154308 4.714979 4.053657 3.371404 2.717016 2.089844 1.502887 0.9481145 0.4191083 -8.5737258E-02 -0.5552125 -0.9649671 -1.246613 -1.290476 -1.039801 -0.5669674 2.2140117E-02 0.6672306 1.343961 -60.10012 4.672091 4.288423 3.646326 2.970501 2.316403 1.689648 1.093742 0.5381146 6.9375825E-03 -0.5058395 -0.9902197 -1.434909 -1.787544 -1.936678 -1.760516 -1.272436 -0.6139669 0.1213327 0.8953239 -60.10012 4.113054 3.780724 3.164606 2.504901 1.861653 1.238933 0.6488867 9.6284211E-02 -0.4320634 -0.9412645 -1.429514 -1.887844 -2.289266 -2.536807 -2.468219 -2.003518 -1.288924 -0.4658947 0.4052032 -60.10012 3.478781 3.195036 2.612779 1.974166 1.347876 0.7435589 0.1606488 -0.3845192 -0.9017406 -1.405396 -1.883408 -2.345272 -2.766641 -3.097708 -3.152741 -2.761793 -2.014574 -1.108688 -0.1409100 -60.10012 2.767328 2.529847 1.985665 1.378620 0.7777813 0.1911620 -0.3742436 -0.9063398 -1.407906 -1.898364 -2.364248 -2.815539 -3.249711 -3.621970 -3.798468 -3.523545 -2.775905 -1.794610 -0.7308210 -60.10012 1.975408 1.783937 1.282976 0.7095463 0.1386606 -0.4232478 -0.9646292 -1.475006 -1.957678 -2.431461 -2.878899 -3.321016 -3.747251 -4.140441 -4.406443 -4.279204 -3.573509 -2.528264 -1.369466 -60.10012 1.086784 0.9441474 0.4903017 -4.2662948E-02 -0.5784215 -1.106799 -1.616032 -2.098691 -2.558506 -3.010843 -3.445260 -3.865738 -4.279839 -4.675854 -5.004031 -5.023632 -4.412163 -3.320676 -2.068459 -60.10012 8.3185583E-02 -7.1100630E-03 -0.4089737 -0.8894340 -1.380670 -1.868418 -2.340650 -2.794551 -3.230313 -3.657471 -4.064843 -4.472074 -4.867098 -5.264791 -5.619237 -5.770207 -5.297012 -4.182307 -2.838324 -60.10012 -1.073459 -1.103755 -1.441094 -1.860443 -2.297283 -2.736257 -3.169499 -3.586636 -3.993948 -4.395960 -4.782956 -5.171151 -5.551730 -5.938734 -6.308207 -6.556989 -6.245013 -5.128674 -3.694113 -60.10012 -2.456334 -2.413021 -2.669173 -3.011555 -3.385092 -3.764987 -4.154349 -4.538488 -4.916041 -5.293272 -5.658837 -6.025440 -6.389000 -6.769406 -7.156655 -7.483024 -7.322602 -6.209708 -4.683866 -60.10012 -4.228912 -4.095089 -4.253726 -4.505745 -4.803455 -5.120476 -5.455114 -5.798324 -6.145710 -6.492008 -6.839128 -7.192920 -7.560465 -7.942387 -8.358985 -8.743816 -8.658914 -7.512770 -5.890535 -60.10012 -7.004883 -6.752289 -6.791777 -6.933213 -7.137952 -7.373961 -7.640055 -7.930108 -8.246586 -8.577622 -8.925213 -9.280377 -9.655554 -10.05830 -10.48072 -10.84557 -10.65965 -9.390813 -7.665954 -60.10012 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -67.52827 -65.72571 -63.88562 -62.00987 -60.10012 4.885449 3.674512 3.607634 3.550207 3.415636 3.209860 2.950607 2.648436 2.327423 2.001008 1.695286 1.429935 1.221931 1.075949 0.9845471 0.9342332 0.9095994 0.8992482 0.8960047 -64.69788 5.790372 4.733721 4.472536 4.235739 3.958806 3.648232 3.311838 2.960452 2.608863 2.282792 2.006161 1.803578 1.687547 1.648661 1.669134 1.728163 1.809692 1.904041 2.005977 -64.69788 6.284323 5.374303 4.910213 4.482609 4.059583 3.638247 3.224234 2.821461 2.439353 2.093573 1.817919 1.643478 1.584508 1.621947 1.730620 1.883890 2.063206 2.258413 2.464296 -64.69788 6.471738 5.684517 5.083951 4.519423 3.984411 3.474737 2.991119 2.530483 2.105215 1.720012 1.412694 1.228198 1.189467 1.281163 1.465939 1.708175 1.983266 2.278804 2.588631 -64.69788 6.443157 5.754623 5.076689 4.426372 3.813107 3.242739 2.703584 2.192470 1.720533 1.288006 0.9231894 0.6909121 0.6318138 0.7493608 0.9976102 1.324034 1.693720 2.089507 2.503449 -64.69788 6.253690 5.647119 4.931056 4.232206 3.575167 2.960352 2.384994 1.838580 1.323838 0.8474010 0.4271533 0.1187059 -5.0361394E-03 9.7631440E-02 0.3887741 0.7919042 1.254447 1.750371 2.268615 -64.69788 5.937977 5.401670 4.675885 3.958679 3.277160 2.635154 2.035733 1.470096 0.9266139 0.4175928 -4.5398813E-02 -0.4296162 -0.6459169 -0.6039127 -0.3015953 0.1661546 0.7186788 1.314450 1.937166 -64.69788 5.524276 5.050999 4.333064 3.612150 2.921648 2.266035 1.651928 1.074552 0.5185841 -6.0564927E-03 -0.4999668 -0.9374359 -1.248407 -1.309358 -1.041503 -0.5300527 0.1071142 0.8019088 1.529206 -64.69788 5.023480 4.609396 3.910776 3.196697 2.509651 1.851801 1.230051 0.6478729 9.2122130E-02 -0.4383094 -0.9451035 -1.415437 -1.798613 -1.981542 -1.801330 -1.278540 -0.5665444 0.2256313 1.057526 -64.69788 4.443547 4.084205 3.413285 2.716068 2.040647 1.387365 0.7656045 0.1911935 -0.3628717 -0.8892851 -1.398318 -1.878536 -2.307759 -2.593240 -2.543961 -2.053770 -1.281887 -0.3950097 0.5413722 -64.69788 3.786549 3.478813 2.843203 2.170149 1.509627 0.8722916 0.2616114 -0.3056794 -0.8490821 -1.369259 -1.868030 -2.346934 -2.792533 -3.157868 -3.246309 -2.845919 -2.039937 -1.063119 -2.2589110E-02 -64.69788 3.051616 2.793140 2.195633 1.552255 0.9184583 0.3000916 -0.2922965 -0.8459196 -1.374683 -1.881639 -2.365403 -2.831940 -3.283912 -3.691163 -3.905374 -3.643272 -2.843236 -1.785018 -0.6410457 -64.69788 2.230704 2.020614 1.469223 0.8627316 0.2567344 -0.3347454 -0.9036341 -1.436375 -1.944177 -2.432527 -2.897014 -3.350428 -3.800902 -4.216309 -4.522816 -4.426003 -3.681670 -2.554613 -1.308292 -64.69788 1.313240 1.154120 0.6511919 8.7704733E-02 -0.4829670 -1.041583 -1.577026 -2.084433 -2.566874 -3.030266 -3.479459 -3.916323 -4.347670 -4.770066 -5.125548 -5.188416 -4.557288 -3.381582 -2.034442 -64.69788 0.2750825 0.1709736 -0.2758995 -0.7878264 -1.312392 -1.829309 -2.328037 -2.803664 -3.259279 -3.704082 -4.124080 -4.544519 -4.958896 -5.371384 -5.751107 -5.948674 -5.477781 -4.280508 -2.834665 -64.69788 -0.9201704 -0.9608282 -1.341231 -1.789029 -2.259326 -2.724668 -3.185802 -3.629596 -4.050029 -4.469881 -4.871090 -5.266562 -5.669010 -6.063278 -6.451034 -6.746146 -6.459720 -5.265628 -3.722319 -64.69788 -2.353602 -2.315313 -2.610618 -2.979707 -3.381766 -3.792832 -4.202531 -4.609971 -5.002314 -5.396518 -5.774385 -6.148824 -6.539113 -6.921783 -7.312882 -7.682658 -7.567678 -6.388054 -4.746923 -64.69788 -4.190730 -4.055157 -4.242109 -4.518124 -4.843091 -5.191219 -5.543184 -5.904772 -6.264693 -6.633518 -6.988723 -7.352707 -7.732424 -8.129959 -8.537232 -8.963447 -8.951285 -7.753027 -6.009198 -64.69788 -7.044780 -6.781364 -6.835784 -6.995701 -7.222956 -7.489555 -7.775392 -8.088304 -8.408307 -8.763923 -9.119003 -9.483333 -9.872954 -10.29343 -10.71740 -11.13506 -11.03242 -9.703384 -7.849924 -64.69788 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.76240 -66.74822 -64.69788 5.128067 3.842077 3.853071 3.805878 3.675173 3.458104 3.183691 2.866227 2.524102 2.179352 1.850533 1.564932 1.344916 1.189078 1.093427 1.041765 1.016940 1.006824 1.003770 -69.07755 6.109308 4.986001 4.760732 4.517983 4.229170 3.900486 3.548361 3.177253 2.811865 2.465102 2.171274 1.962228 1.843973 1.808299 1.835309 1.901639 1.990606 2.092367 2.201699 -69.07755 6.648646 5.683243 5.214520 4.765040 4.316018 3.874598 3.440041 3.020897 2.618092 2.252543 1.963168 1.788966 1.733998 1.781916 1.904658 2.072212 2.265864 2.475499 2.695995 -69.07755 6.853311 6.021381 5.392093 4.793196 4.231333 3.696359 3.189451 2.711100 2.262217 1.854787 1.536833 1.350850 1.320608 1.428938 1.635150 1.898807 2.195313 2.512405 2.844117 -69.07755 6.831811 6.101425 5.379143 4.694080 4.051069 3.450190 2.889601 2.353443 1.856474 1.400091 1.020580 0.7757476 0.7185363 0.8548968 1.129037 1.483443 1.881404 2.305886 2.749002 -69.07755 6.638749 5.992200 5.227405 4.492793 3.800798 3.158290 2.556409 1.984034 1.443735 0.9484255 0.5028158 0.1719173 3.5345294E-02 0.1508249 0.4689874 0.9056954 1.403207 1.934990 2.489724 -69.07755 6.316681 5.741935 4.963016 4.207827 3.492467 2.819451 2.192359 1.600173 1.037793 0.5067275 1.7723050E-02 -0.3926231 -0.6331883 -0.5931529 -0.2675951 0.2384106 0.8326299 1.471511 2.138074 -69.07755 5.887764 5.380682 4.608056 3.848272 3.123845 2.435716 1.793643 1.194169 0.6176475 7.1463138E-02 -0.4444598 -0.9101191 -1.253289 -1.331736 -1.052645 -0.5018254 0.1835052 0.9287235 1.707256 -69.07755 5.368957 4.925292 4.169870 3.418932 2.696446 2.005463 1.360579 0.7556658 0.1749801 -0.3729450 -0.9012196 -1.391630 -1.810611 -2.019598 -1.843941 -1.284846 -0.5185451 0.3315183 1.222092 -69.07755 4.768367 4.382401 3.655885 2.921870 2.211752 1.530167 0.8823986 0.2826155 -0.2950758 -0.8402092 -1.363977 -1.865938 -2.322249 -2.641530 -2.619302 -2.105700 -1.276486 -0.3246978 0.6778232 -69.07755 4.089280 3.756956 3.066718 2.360242 1.667130 0.9952164 0.3614100 -0.2313217 -0.8002386 -1.334134 -1.849829 -2.345094 -2.817619 -3.208580 -3.344348 -2.941273 -2.078602 -1.030303 8.3823800E-02 -69.07755 3.330679 3.049954 2.401482 1.723588 1.054441 0.4044493 -0.2118503 -0.7907963 -1.341705 -1.861576 -2.361835 -2.846015 -3.317711 -3.750185 -4.009285 -3.770244 -2.919546 -1.783862 -0.5587819 -69.07755 2.482748 2.253064 1.652359 1.012201 0.3734613 -0.2512697 -0.8428583 -1.400405 -1.929799 -2.427987 -2.912661 -3.377080 -3.847453 -4.280232 -4.630274 -4.573638 -3.794045 -2.585482 -1.250538 -69.07755 1.536497 1.360771 0.8101444 0.2142409 -0.3887325 -0.9780093 -1.540387 -2.070235 -2.572507 -3.047406 -3.511519 -3.967327 -4.411682 -4.842913 -5.234721 -5.348860 -4.705712 -3.447267 -2.004054 -69.07755 0.4668642 0.3486108 -0.1442696 -0.6866981 -1.245740 -1.790916 -2.316399 -2.814078 -3.286134 -3.743122 -4.183159 -4.611547 -5.048529 -5.459711 -5.872860 -6.115897 -5.658589 -4.381721 -2.832495 -69.07755 -0.7674576 -0.8187891 -1.240183 -1.719994 -2.220673 -2.718294 -3.197762 -3.663646 -4.104157 -4.535535 -4.949965 -5.357256 -5.776826 -6.177083 -6.592542 -6.920192 -6.669480 -5.405849 -3.751765 -69.07755 -2.249503 -2.217275 -2.547633 -2.948613 -3.380393 -3.819547 -4.251309 -4.673583 -5.086666 -5.492956 -5.881056 -6.268543 -6.670063 -7.063206 -7.475846 -7.873564 -7.808320 -6.569833 -4.810760 -69.07755 -4.145495 -4.009895 -4.223669 -4.524187 -4.878147 -5.249975 -5.633060 -6.011222 -6.386048 -6.771244 -7.137253 -7.507206 -7.900148 -8.301069 -8.733055 -9.192923 -9.243781 -7.989767 -6.121448 -69.07755 -7.081620 -6.809000 -6.881516 -7.058579 -7.313545 -7.601380 -7.921805 -8.249642 -8.586082 -8.960666 -9.325021 -9.712978 -10.11280 -10.53391 -10.98222 -11.43373 -11.40409 -10.01510 -8.030935 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.255385 -1.223638 -1.191134 -1.157880 -1.123885 -1.089157 -1.053705 -1.017533 -0.9806455 -0.9430605 -0.9047861 -0.8658299 -0.8261999 -0.7859035 -0.7449444 -0.7033269 -0.6610700 -0.6181808 -0.5746661 -0.5305336 -1.266476 -1.267829 -1.269170 -1.282760 -1.297909 -1.312835 -1.325855 -1.335763 -1.341509 -1.351320 -1.371452 -1.406336 -1.437760 -1.466259 -1.490675 -1.522087 -1.558593 -1.594342 -1.627156 -1.674184 -1.297189 -1.296969 -1.296680 -1.308222 -1.321480 -1.334568 -1.345921 -1.354312 -1.358735 -1.366948 -1.385229 -1.420970 -1.453478 -1.481748 -1.505265 -1.535918 -1.571248 -1.605029 -1.634902 -1.674184 -1.329289 -1.327484 -1.325567 -1.335116 -1.346522 -1.357820 -1.367606 -1.374542 -1.377691 -1.384436 -1.400991 -1.437377 -1.469682 -1.497496 -1.519892 -1.549915 -1.583902 -1.615534 -1.642362 -1.674184 -1.362823 -1.359360 -1.355783 -1.363354 -1.372863 -1.382410 -1.390661 -1.396110 -1.397992 -1.403339 -1.418320 -1.455287 -1.487115 -1.513968 -1.535356 -1.564555 -1.597069 -1.626395 -1.650106 -1.674184 -1.398432 -1.393263 -1.388020 -1.393610 -1.401181 -1.409021 -1.415780 -1.419795 -1.420439 -1.424402 -1.437796 -1.473787 -1.504954 -1.530697 -1.551186 -1.579359 -1.610249 -1.637008 -1.657477 -1.674184 -1.435177 -1.428260 -1.421332 -1.424932 -1.430514 -1.436654 -1.441812 -1.444417 -1.443746 -1.446274 -1.458080 -1.492936 -1.522797 -1.547107 -1.566861 -1.593631 -1.622694 -1.646588 -1.663707 -1.674184 -1.473011 -1.464291 -1.455658 -1.457399 -1.461002 -1.465472 -1.468978 -1.470121 -1.468027 -1.469047 -1.479305 -1.512989 -1.541513 -1.564514 -1.583301 -1.608455 -1.635444 -1.656292 -1.669923 -1.674184 -1.513551 -1.502894 -1.492340 -1.492168 -1.493751 -1.496477 -1.498285 -1.497957 -1.494351 -1.493826 -1.502416 -1.534313 -1.561167 -1.583151 -1.600660 -1.623938 -1.648540 -1.666147 -1.676126 -1.674184 -1.556635 -1.543878 -1.531211 -1.529104 -1.528533 -1.529312 -1.529331 -1.527396 -1.522162 -1.520005 -1.526845 -1.557038 -1.582384 -1.603334 -1.619144 -1.640508 -1.662247 -1.676447 -1.682584 -1.674184 -1.603403 -1.588249 -1.573292 -1.568971 -1.566223 -1.564845 -1.562923 -1.559179 -1.552218 -1.548250 -1.553191 -1.581277 -1.605441 -1.624964 -1.638776 -1.657836 -1.676323 -1.686920 -1.689000 -1.674184 -1.654150 -1.636165 -1.618677 -1.611797 -1.606725 -1.603006 -1.598958 -1.593096 -1.584214 -1.578144 -1.581032 -1.607312 -1.629936 -1.647552 -1.659292 -1.675300 -1.689884 -1.696811 -1.694571 -1.674184 -1.711085 -1.690004 -1.669479 -1.659642 -1.651908 -1.645597 -1.639173 -1.630992 -1.620035 -1.611642 -1.612262 -1.636657 -1.657220 -1.672574 -1.681779 -1.694111 -1.704552 -1.707407 -1.700597 -1.674184 -1.777031 -1.752157 -1.727941 -1.714809 -1.703808 -1.694425 -1.685094 -1.674163 -1.660754 -1.649693 -1.647684 -1.669559 -1.687470 -1.700495 -1.705949 -1.713749 -1.720019 -1.718321 -1.706626 -1.674184 -1.853006 -1.824180 -1.795736 -1.778761 -1.763874 -1.750760 -1.737865 -1.723628 -1.707211 -1.693059 -1.687940 -1.706716 -1.721959 -1.730920 -1.731901 -1.734377 -1.736062 -1.729275 -1.712329 -1.674184 -1.944178 -1.910883 -1.877639 -1.856344 -1.837314 -1.819547 -1.802313 -1.783856 -1.763605 -1.745798 -1.737036 -1.752316 -1.762912 -1.766791 -1.764610 -1.759316 -1.755602 -1.743169 -1.720774 -1.674184 -2.056771 -2.018066 -1.979286 -1.952886 -1.928885 -1.905619 -1.882931 -1.859021 -1.833632 -1.811183 -1.797763 -1.807292 -1.812228 -1.811424 -1.804475 -1.790450 -1.779580 -1.760823 -1.732749 -1.674184 -2.202908 -2.158703 -2.114362 -2.076527 -2.046755 -2.016448 -1.987264 -1.956843 -1.925094 -1.893213 -1.874247 -1.877240 -1.875842 -1.868878 -1.855135 -1.834443 -1.811038 -1.785489 -1.751440 -1.674184 -2.408280 -2.361276 -2.313663 -2.264951 -2.215365 -2.176197 -2.138889 -2.101834 -2.062744 -2.021765 -1.982564 -1.976962 -1.966367 -1.949800 -1.926961 -1.897486 -1.862452 -1.827204 -1.807627 -1.674184 -2.774264 -2.714281 -2.652869 -2.588823 -2.532285 -2.473706 -2.413583 -2.351231 -2.300307 -2.248844 -2.197379 -2.165803 -2.130589 -2.096108 -2.062539 -2.024132 -1.980956 -1.888164 -1.797429 -1.674184 -3.260566 -3.199027 -3.134730 -3.067733 -2.998085 -2.925848 -2.851094 -2.773875 -2.694229 -2.612236 -2.527951 -2.441415 -2.352676 -2.261804 -2.169087 -2.073822 -1.976803 -1.877834 -1.777196 -1.674184 -0.9799256 -1.024587 -1.071227 -1.118364 -1.167155 -1.228930 -1.287814 -1.340227 -1.381699 -1.416169 -1.452273 -1.499102 -1.543546 -1.585386 -1.623565 -1.659552 -1.701734 -1.742149 -1.780312 -2.912270 -1.022422 -1.060928 -1.101990 -1.144589 -1.189058 -1.244547 -1.297898 -1.348216 -1.395290 -1.434194 -1.475705 -1.526676 -1.573794 -1.616392 -1.654003 -1.688095 -1.727852 -1.764550 -1.797323 -2.912270 -1.071068 -1.103295 -1.139116 -1.177022 -1.217306 -1.267232 -1.315639 -1.363726 -1.414774 -1.457582 -1.504746 -1.558987 -1.607575 -1.650319 -1.687168 -1.719489 -1.756754 -1.789945 -1.817293 -2.912270 -1.125697 -1.152299 -1.182787 -1.215821 -1.251848 -1.296886 -1.340712 -1.387177 -1.440468 -1.488930 -1.540175 -1.596561 -1.645967 -1.688655 -1.724632 -1.755582 -1.790389 -1.820470 -1.842422 -2.912270 -1.186301 -1.207660 -1.232853 -1.260760 -1.292427 -1.332800 -1.372105 -1.416667 -1.473483 -1.526455 -1.581150 -1.638500 -1.688168 -1.730754 -1.765681 -1.795618 -1.828283 -1.855385 -1.872020 -2.912270 -1.253253 -1.269390 -1.289438 -1.312320 -1.339352 -1.374856 -1.410109 -1.452931 -1.513597 -1.569982 -1.626550 -1.684132 -1.733795 -1.776338 -1.810450 -1.839485 -1.870361 -1.894614 -1.906167 -2.912270 -1.326525 -1.337790 -1.352822 -1.370730 -1.393035 -1.423842 -1.455059 -1.495796 -1.558779 -1.617139 -1.673936 -1.731173 -1.780688 -1.822655 -1.856311 -1.884372 -1.913498 -1.934989 -1.941429 -2.912270 -1.405244 -1.411911 -1.422192 -1.435685 -1.453441 -1.479427 -1.506397 -1.545021 -1.608714 -1.666957 -1.723158 -1.779341 -1.828659 -1.869827 -1.903316 -1.929985 -1.957859 -1.976263 -1.977584 -2.912270 -1.489054 -1.491514 -1.497121 -1.506619 -1.519954 -1.541030 -1.563900 -1.599531 -1.662005 -1.718962 -1.773469 -1.828600 -1.876756 -1.917290 -1.950422 -1.976143 -2.002504 -2.017187 -2.013295 -2.912270 -1.578129 -1.576523 -1.577680 -1.583123 -1.592041 -1.608160 -1.626476 -1.658236 -1.718081 -1.772594 -1.825294 -1.878437 -1.924683 -1.964879 -1.996815 -2.021473 -2.046589 -2.056607 -2.047153 -2.912270 -1.671502 -1.666211 -1.663342 -1.664722 -1.669406 -1.680527 -1.694292 -1.722063 -1.777900 -1.829986 -1.880436 -1.930222 -1.975022 -2.014323 -2.045205 -2.068916 -2.092031 -2.097014 -2.081855 -2.912270 -1.769129 -1.760488 -1.753864 -1.751106 -1.751617 -1.758031 -1.767170 -1.790797 -1.842840 -1.891794 -1.938338 -1.985223 -2.028191 -2.065546 -2.096131 -2.119037 -2.138521 -2.138284 -2.116804 -2.912270 -1.875915 -1.862535 -1.852345 -1.845151 -1.841329 -1.843052 -1.847246 -1.866704 -1.913540 -1.957311 -2.000395 -2.044405 -2.084043 -2.120631 -2.149843 -2.171219 -2.185074 -2.179459 -2.150664 -2.912270 -1.994430 -1.974878 -1.960456 -1.949073 -1.940342 -1.937214 -1.936073 -1.949721 -1.990222 -2.029761 -2.068846 -2.108322 -2.146026 -2.180274 -2.208580 -2.224621 -2.231964 -2.220118 -2.182810 -2.912270 -2.128149 -2.102816 -2.081507 -2.065911 -2.051705 -2.043381 -2.036322 -2.044369 -2.079434 -2.112724 -2.147022 -2.184083 -2.218288 -2.250678 -2.273557 -2.281816 -2.282618 -2.262627 -2.215461 -2.912270 -2.291700 -2.258078 -2.229508 -2.205658 -2.186084 -2.170583 -2.156879 -2.157944 -2.187330 -2.215742 -2.245937 -2.279202 -2.309466 -2.333773 -2.347387 -2.347134 -2.340188 -2.309950 -2.250943 -2.912270 -2.512913 -2.468199 -2.429387 -2.395662 -2.365794 -2.342822 -2.319374 -2.313162 -2.335684 -2.357845 -2.381325 -2.405729 -2.424772 -2.438336 -2.444275 -2.434902 -2.412868 -2.369525 -2.297182 -2.912270 -2.831920 -2.775330 -2.723402 -2.674253 -2.630835 -2.595163 -2.561313 -2.543163 -2.554476 -2.563020 -2.571287 -2.583931 -2.593096 -2.595071 -2.586694 -2.561486 -2.517555 -2.456713 -2.370164 -2.912270 -3.405381 -3.329570 -3.261038 -3.193480 -3.127121 -3.059286 -3.001808 -2.962502 -2.957481 -2.949851 -2.937780 -2.919419 -2.901837 -2.877766 -2.839696 -2.785183 -2.711581 -2.625392 -2.525133 -2.912270 -5.512444 -5.420481 -5.322550 -5.218822 -5.109506 -4.994788 -4.874834 -4.749855 -4.619989 -4.485431 -4.346325 -4.202818 -4.055072 -3.903190 -3.747334 -3.587605 -3.424126 -3.257015 -3.086354 -2.912270 -0.5858257 -0.6861088 -0.7932338 -0.8991556 -1.000330 -1.105919 -1.180996 -1.245512 -1.302403 -1.352244 -1.394860 -1.443339 -1.489995 -1.534224 -1.578859 -1.620113 -1.662392 -1.702025 -1.739739 -4.241012 -0.6181895 -0.7051747 -0.7999459 -0.8955271 -0.9865490 -1.080756 -1.167936 -1.244038 -1.310296 -1.368032 -1.416544 -1.470585 -1.520808 -1.567418 -1.611266 -1.648945 -1.685817 -1.718060 -1.746530 -4.241012 -0.6689103 -0.7441522 -0.8278330 -0.9142483 -0.9972273 -1.083382 -1.178270 -1.262237 -1.336101 -1.399729 -1.454784 -1.514087 -1.567520 -1.616797 -1.659656 -1.694332 -1.726392 -1.751817 -1.771690 -4.241012 -0.7340297 -0.7986999 -0.8718276 -0.9493089 -1.025247 -1.103832 -1.203449 -1.293569 -1.373025 -1.441636 -1.503739 -1.567587 -1.624660 -1.676062 -1.718159 -1.750366 -1.778132 -1.797457 -1.809164 -4.241012 -0.8109527 -0.8656658 -0.9286183 -0.9968347 -1.065431 -1.136670 -1.239346 -1.333358 -1.416274 -1.490644 -1.558877 -1.626268 -1.687503 -1.739873 -1.781147 -1.811202 -1.835054 -1.848665 -1.852614 -4.241012 -0.8999970 -0.9452264 -0.9989596 -1.058073 -1.118824 -1.183010 -1.286702 -1.382373 -1.468522 -1.548368 -1.621412 -1.692942 -1.757494 -1.810791 -1.851697 -1.880165 -1.901106 -1.909776 -1.906540 -4.241012 -1.000483 -1.036506 -1.081293 -1.131992 -1.184738 -1.241658 -1.344057 -1.440647 -1.530590 -1.614598 -1.691398 -1.767442 -1.833990 -1.888427 -1.929727 -1.957405 -1.976315 -1.981343 -1.971530 -4.241012 -1.110599 -1.137622 -1.173692 -1.216459 -1.260821 -1.309872 -1.409764 -1.508080 -1.600520 -1.686002 -1.766831 -1.844539 -1.912335 -1.967786 -2.009795 -2.037317 -2.054650 -2.057581 -2.041041 -4.241012 -1.230591 -1.248939 -1.276881 -1.311481 -1.347901 -1.388619 -1.487120 -1.585311 -1.677444 -1.764910 -1.846764 -1.924503 -1.992650 -2.048947 -2.091530 -2.119705 -2.136322 -2.137993 -2.115203 -4.241012 -1.363761 -1.373216 -1.393296 -1.419673 -1.448389 -1.480764 -1.576112 -1.671111 -1.762542 -1.849220 -1.929280 -2.005620 -2.073029 -2.129518 -2.172993 -2.202105 -2.218263 -2.218884 -2.189998 -4.241012 -1.509546 -1.510029 -1.521904 -1.540965 -1.562038 -1.586562 -1.675954 -1.767055 -1.854681 -1.937419 -2.014523 -2.088006 -2.153648 -2.209013 -2.253526 -2.283186 -2.300031 -2.299213 -2.264124 -4.241012 -1.665342 -1.657902 -1.661808 -1.674109 -1.687970 -1.705009 -1.788269 -1.872050 -1.953399 -2.031104 -2.103744 -2.173180 -2.235517 -2.290460 -2.335769 -2.365934 -2.385477 -2.380793 -2.339545 -4.241012 -1.831147 -1.816805 -1.813334 -1.818326 -1.825632 -1.835506 -1.909935 -1.986120 -2.059550 -2.130190 -2.196953 -2.260901 -2.320562 -2.374353 -2.418727 -2.450474 -2.473044 -2.463087 -2.415124 -4.241012 -2.009050 -1.987846 -1.977437 -1.974820 -1.975232 -1.977721 -2.042952 -2.110530 -2.173858 -2.234993 -2.294322 -2.354322 -2.410864 -2.461826 -2.505927 -2.541508 -2.561788 -2.545790 -2.489924 -4.241012 -2.206397 -2.177003 -2.159247 -2.148829 -2.140747 -2.136113 -2.188846 -2.244700 -2.296514 -2.349350 -2.402454 -2.458205 -2.509257 -2.557588 -2.603135 -2.639421 -2.652480 -2.630893 -2.563537 -4.241012 -2.419750 -2.383191 -2.357321 -2.339227 -2.323037 -2.310540 -2.350462 -2.395935 -2.439039 -2.484119 -2.529295 -2.577588 -2.624892 -2.673643 -2.717352 -2.742880 -2.747277 -2.716484 -2.634232 -4.241012 -2.687266 -2.637887 -2.602986 -2.573889 -2.547894 -2.524660 -2.554011 -2.588568 -2.621873 -2.655436 -2.693779 -2.739319 -2.784466 -2.823151 -2.852881 -2.867294 -2.862176 -2.814516 -2.711750 -4.241012 -3.072026 -3.006130 -2.954586 -2.910869 -2.868585 -2.831649 -2.849238 -2.874482 -2.899143 -2.922814 -2.949131 -2.977598 -3.006118 -3.029268 -3.048333 -3.047662 -3.019176 -2.946392 -2.817003 -4.241012 -3.776300 -3.687265 -3.607479 -3.533880 -3.463298 -3.398330 -3.395419 -3.400351 -3.405988 -3.408545 -3.414155 -3.418048 -3.425275 -3.424491 -3.408794 -3.369546 -3.292127 -3.177219 -3.016676 -4.241012 -7.981893 -7.858880 -7.725512 -7.582214 -7.429440 -7.267611 -7.097131 -6.918402 -6.731766 -6.537592 -6.336168 -6.127824 -5.912805 -5.691397 -5.463824 -5.230321 -4.991343 -4.746349 -4.496265 -4.241012 -0.1773521 -0.3378774 -0.5095266 -0.6835161 -0.8525183 -0.9229541 -1.007042 -1.086292 -1.159844 -1.226993 -1.284424 -1.337538 -1.387059 -1.430283 -1.470242 -1.511078 -1.550780 -1.586993 -1.619831 -5.652469 -0.1819702 -0.3218067 -0.4727123 -0.6253394 -0.7749514 -0.8655786 -0.9680445 -1.063965 -1.152124 -1.230027 -1.294611 -1.353314 -1.404359 -1.446858 -1.483324 -1.518247 -1.547871 -1.571308 -1.589134 -5.652469 -0.2199826 -0.3412646 -0.4738355 -0.6089593 -0.7425420 -0.8546140 -0.9721466 -1.082242 -1.182263 -1.268124 -1.340710 -1.404389 -1.457170 -1.499642 -1.534450 -1.563591 -1.584307 -1.596126 -1.600115 -5.652469 -0.2862053 -0.3909233 -0.5071749 -0.6273012 -0.7469000 -0.8744830 -1.004928 -1.126349 -1.234446 -1.327969 -1.408346 -1.476674 -1.531932 -1.574919 -1.609888 -1.633968 -1.646915 -1.648284 -1.639422 -5.652469 -0.3757676 -0.4655651 -0.5671332 -0.6727965 -0.7798207 -0.9188800 -1.058928 -1.187011 -1.300439 -1.401842 -1.488132 -1.560534 -1.619527 -1.664119 -1.699852 -1.719897 -1.726079 -1.717982 -1.697206 -5.652469 -0.4871385 -0.5634978 -0.6517752 -0.7444346 -0.8394227 -0.9854139 -1.129935 -1.260038 -1.378783 -1.484806 -1.575890 -1.652579 -1.715167 -1.764661 -1.800377 -1.817501 -1.818189 -1.801703 -1.770007 -5.652469 -0.6184831 -0.6823328 -0.7584600 -0.8397440 -0.9232945 -1.071131 -1.214890 -1.347153 -1.468380 -1.577272 -1.671936 -1.753696 -1.820419 -1.876126 -1.912661 -1.928702 -1.925707 -1.902500 -1.861358 -5.652469 -0.7670351 -0.8180605 -0.8831204 -0.9534547 -1.026197 -1.170528 -1.313280 -1.445234 -1.566419 -1.676440 -1.774661 -1.859866 -1.934359 -1.994347 -2.032943 -2.049477 -2.044884 -2.017115 -1.967951 -5.652469 -0.9290781 -0.9673219 -1.021246 -1.080400 -1.142724 -1.283971 -1.421613 -1.550043 -1.669393 -1.780041 -1.879826 -1.969173 -2.049661 -2.111981 -2.153136 -2.171357 -2.166602 -2.135694 -2.079756 -5.652469 -1.106649 -1.132529 -1.174938 -1.223916 -1.275980 -1.408586 -1.539860 -1.662594 -1.779577 -1.889277 -1.989930 -2.084669 -2.166389 -2.230367 -2.274391 -2.295610 -2.292244 -2.261121 -2.198841 -5.652469 -1.295830 -1.309724 -1.340411 -1.379427 -1.421047 -1.544285 -1.667810 -1.785042 -1.896854 -2.004152 -2.107627 -2.201710 -2.281917 -2.346657 -2.392901 -2.417819 -2.416976 -2.388397 -2.319826 -5.652469 -1.498927 -1.501843 -1.520707 -1.548677 -1.580506 -1.692483 -1.807908 -1.917032 -2.024360 -2.129892 -2.229293 -2.319057 -2.396834 -2.460654 -2.508914 -2.537006 -2.539812 -2.514394 -2.440115 -5.652469 -1.716879 -1.709482 -1.717377 -1.734530 -1.757156 -1.856132 -1.960687 -2.064160 -2.166037 -2.263430 -2.354513 -2.438918 -2.513302 -2.575921 -2.625059 -2.656164 -2.664544 -2.642675 -2.563012 -5.652469 -1.950258 -1.932920 -1.931027 -1.937839 -1.950224 -2.039248 -2.133188 -2.226292 -2.316563 -2.403601 -2.484948 -2.561727 -2.632798 -2.693510 -2.742364 -2.776232 -2.795294 -2.770627 -2.685302 -5.652469 -2.211616 -2.183175 -2.171453 -2.166910 -2.168582 -2.243944 -2.321917 -2.399482 -2.476341 -2.551623 -2.622907 -2.693012 -2.758558 -2.816254 -2.863312 -2.902621 -2.926739 -2.897058 -2.804504 -5.652469 -2.498356 -2.459803 -2.437037 -2.420680 -2.411009 -2.467208 -2.527663 -2.587329 -2.651523 -2.717698 -2.780287 -2.840044 -2.898550 -2.952629 -3.001926 -3.046539 -3.062223 -3.028487 -2.921715 -5.652469 -2.818335 -2.769222 -2.735519 -2.707296 -2.685285 -2.726149 -2.771632 -2.817045 -2.867049 -2.919216 -2.970456 -3.020689 -3.072647 -3.131721 -3.177999 -3.207295 -3.213063 -3.167316 -3.039157 -5.652469 -3.270468 -3.198910 -3.148060 -3.102190 -3.060992 -3.081459 -3.106220 -3.135300 -3.169025 -3.211814 -3.255400 -3.297932 -3.339222 -3.378041 -3.406715 -3.425930 -3.412964 -3.341193 -3.176990 -5.652469 -4.075594 -3.970318 -3.882360 -3.804008 -3.735246 -3.729620 -3.730731 -3.733618 -3.744024 -3.758040 -3.778774 -3.798959 -3.818913 -3.834778 -3.844020 -3.826406 -3.764588 -3.633377 -3.418432 -5.652469 -10.64238 -10.48770 -10.31713 -10.13155 -9.931753 -9.718550 -9.492695 -9.254854 -9.005666 -8.745723 -8.475543 -8.195615 -7.906399 -7.608299 -7.301691 -6.986933 -6.664346 -6.334222 -5.996845 -5.652469 0.2131644 -9.3234740E-03 -0.2503733 -0.4945734 -0.6424026 -0.7262664 -0.8160863 -0.9129547 -1.004320 -1.085712 -1.159265 -1.223824 -1.279539 -1.326588 -1.366283 -1.401773 -1.438750 -1.472025 -1.500708 -7.138974 0.2521997 5.7727881E-02 -0.1513329 -0.3631916 -0.5154885 -0.6246600 -0.7421227 -0.8605803 -0.9679717 -1.064303 -1.147805 -1.215892 -1.271780 -1.314006 -1.345464 -1.369972 -1.391794 -1.406181 -1.413256 -7.138974 0.2399633 7.0615947E-02 -0.1119525 -0.2980330 -0.4561312 -0.5946776 -0.7363186 -0.8720355 -0.9951345 -1.105185 -1.197031 -1.269162 -1.325252 -1.363598 -1.388332 -1.403581 -1.411351 -1.408433 -1.395541 -7.138974 0.1840202 3.7061233E-02 -0.1219329 -0.2847987 -0.4493704 -0.6136141 -0.7734323 -0.9232069 -1.061856 -1.183529 -1.281894 -1.359857 -1.416632 -1.452753 -1.472159 -1.480286 -1.475541 -1.456744 -1.425265 -7.138974 9.0262190E-02 -3.7418615E-02 -0.1769707 -0.3191865 -0.4879181 -0.6690679 -0.8402091 -1.003840 -1.154777 -1.284464 -1.389855 -1.473047 -1.531770 -1.567853 -1.584224 -1.587275 -1.571746 -1.538581 -1.489766 -7.138974 -3.6911909E-02 -0.1473333 -0.2697161 -0.3945034 -0.5628070 -0.7520311 -0.9341984 -1.107169 -1.264508 -1.398434 -1.511358 -1.598322 -1.660387 -1.698575 -1.715618 -1.714059 -1.689680 -1.643704 -1.578848 -7.138974 -0.1923398 -0.2857139 -0.3930153 -0.5023707 -0.6668102 -0.8628700 -1.051103 -1.227773 -1.385035 -1.524754 -1.641002 -1.732231 -1.799008 -1.840762 -1.862461 -1.858314 -1.827474 -1.770947 -1.691680 -7.138974 -0.3732122 -0.4501584 -0.5432509 -0.6386114 -0.7996566 -0.9982083 -1.184590 -1.356468 -1.515952 -1.657208 -1.775138 -1.870247 -1.942634 -1.990920 -2.017828 -2.013544 -1.978753 -1.914004 -1.822277 -7.138974 -0.5791247 -0.6405602 -0.7199983 -0.8035049 -0.9575410 -1.150441 -1.327771 -1.496709 -1.653535 -1.793371 -1.913219 -2.011902 -2.089375 -2.148901 -2.180376 -2.179048 -2.143616 -2.073796 -1.972179 -7.138974 -0.8034395 -0.8511246 -0.9168936 -0.9891797 -1.130847 -1.311469 -1.483319 -1.645256 -1.795239 -1.932279 -2.053118 -2.155289 -2.241405 -2.308475 -2.345729 -2.349830 -2.317486 -2.246248 -2.137590 -7.138974 -1.039579 -1.074251 -1.125498 -1.185879 -1.317051 -1.486523 -1.645840 -1.798518 -1.942193 -2.074252 -2.194182 -2.300198 -2.392761 -2.463534 -2.507234 -2.517602 -2.491025 -2.421660 -2.308394 -7.138974 -1.294554 -1.315771 -1.353090 -1.400830 -1.517318 -1.669826 -1.817078 -1.960209 -2.095761 -2.222481 -2.340454 -2.448884 -2.541426 -2.614062 -2.663054 -2.680422 -2.661407 -2.599131 -2.481380 -7.138974 -1.563355 -1.570569 -1.595126 -1.628495 -1.730347 -1.868196 -2.000420 -2.132937 -2.259893 -2.382222 -2.496061 -2.598258 -2.687765 -2.761475 -2.813736 -2.838403 -2.827780 -2.776804 -2.655745 -7.138974 -1.852805 -1.846346 -1.858378 -1.876800 -1.961428 -2.083707 -2.202554 -2.322465 -2.440871 -2.552983 -2.656730 -2.750601 -2.834738 -2.906476 -2.961076 -2.991993 -2.990764 -2.951451 -2.827471 -7.138974 -2.168633 -2.147295 -2.146470 -2.152060 -2.219225 -2.325043 -2.429112 -2.532203 -2.634526 -2.733201 -2.826020 -2.910418 -2.986539 -3.055203 -3.110565 -3.146252 -3.163022 -3.126360 -2.999038 -7.138974 -2.521929 -2.485219 -2.469746 -2.461908 -2.508863 -2.591690 -2.675805 -2.760776 -2.845701 -2.929630 -3.010337 -3.084873 -3.151475 -3.213916 -3.267939 -3.314739 -3.338958 -3.298301 -3.164857 -7.138974 -2.917554 -2.867299 -2.834102 -2.811401 -2.837252 -2.896032 -2.958789 -3.026058 -3.093221 -3.161652 -3.228090 -3.291154 -3.346825 -3.402448 -3.468044 -3.515354 -3.528182 -3.484631 -3.330926 -7.138974 -3.435084 -3.359636 -3.305633 -3.260375 -3.263007 -3.296022 -3.335511 -3.380332 -3.426890 -3.475442 -3.526845 -3.585270 -3.640202 -3.689616 -3.736471 -3.763874 -3.769519 -3.701333 -3.508794 -7.138974 -4.330360 -4.213808 -4.115901 -4.033947 -4.003971 -4.004558 -4.008815 -4.023859 -4.045299 -4.069358 -4.094952 -4.124629 -4.162079 -4.190865 -4.216789 -4.225210 -4.183504 -4.048183 -3.785340 -7.138974 -13.47237 -13.28541 -13.07594 -12.84544 -12.59528 -12.32678 -12.04111 -11.73969 -11.42246 -11.09134 -10.74676 -10.38945 -10.02005 -9.639140 -9.247262 -8.844901 -8.432501 -8.010466 -7.579174 -7.138974 0.5835451 0.2899732 -2.1189023E-02 -0.3214607 -0.4211500 -0.5191494 -0.6195867 -0.7304823 -0.8370047 -0.9369112 -1.025418 -1.102113 -1.169232 -1.222412 -1.265373 -1.300364 -1.332222 -1.362726 -1.388137 -8.693932 0.6690419 0.4132275 0.1441249 -0.1170669 -0.2469355 -0.3751207 -0.5085205 -0.6455642 -0.7742003 -0.8910295 -0.9887780 -1.070993 -1.135203 -1.180636 -1.210234 -1.228295 -1.239858 -1.245293 -1.242715 -8.693932 0.6862537 0.4633894 0.2296620 -1.8745338E-03 -0.1633409 -0.3256505 -0.4896917 -0.6505222 -0.8001578 -0.9297864 -1.038952 -1.126593 -1.188113 -1.226500 -1.244333 -1.246740 -1.239797 -1.221998 -1.193283 -8.693932 0.6478983 0.4545174 0.2514567 4.5962226E-02 -0.1469488 -0.3394414 -0.5283196 -0.7111490 -0.8772314 -1.020390 -1.141037 -1.233044 -1.294091 -1.327029 -1.335184 -1.323737 -1.300061 -1.260549 -1.207003 -8.693932 0.5591487 0.3911002 0.2133545 3.1013342E-02 -0.1871173 -0.4019189 -0.6108211 -0.8098048 -0.9876736 -1.145211 -1.276296 -1.371628 -1.434820 -1.464216 -1.465564 -1.443960 -1.404656 -1.345063 -1.267931 -8.693932 0.4241933 0.2795598 0.1239752 -3.8984034E-02 -0.2737110 -0.5040448 -0.7265081 -0.9335697 -1.124545 -1.292884 -1.428904 -1.530613 -1.595987 -1.625267 -1.622798 -1.594527 -1.541778 -1.463924 -1.364689 -8.693932 0.2500688 0.1266386 -1.0202901E-02 -0.1556997 -0.4010294 -0.6386619 -0.8643835 -1.080936 -1.281115 -1.454281 -1.593804 -1.701221 -1.770160 -1.802517 -1.798951 -1.768536 -1.705301 -1.611528 -1.491930 -8.693932 4.2446725E-02 -6.2491298E-02 -0.1824521 -0.3134382 -0.5600973 -0.7970018 -1.027446 -1.247324 -1.449091 -1.621708 -1.766906 -1.877538 -1.952951 -1.991266 -1.993316 -1.962996 -1.893327 -1.786875 -1.649312 -8.693932 -0.1931462 -0.2811931 -0.3848871 -0.5030524 -0.7440171 -0.9803626 -1.210050 -1.426193 -1.620132 -1.794125 -1.939637 -2.054662 -2.138215 -2.184016 -2.198082 -2.171080 -2.099631 -1.984726 -1.832240 -8.693932 -0.4561272 -0.5275670 -0.6155952 -0.7205082 -0.9557108 -1.183984 -1.402692 -1.607493 -1.797713 -1.965326 -2.108664 -2.228355 -2.318206 -2.376778 -2.401917 -2.381304 -2.312030 -2.192976 -2.028878 -8.693932 -0.7446924 -0.8007023 -0.8741110 -0.9659541 -1.188116 -1.397679 -1.601930 -1.797371 -1.976409 -2.137509 -2.278715 -2.398708 -2.494982 -2.569309 -2.604162 -2.594211 -2.532318 -2.414547 -2.243333 -8.693932 -1.051351 -1.092070 -1.151067 -1.228668 -1.429600 -1.624277 -1.811712 -1.990502 -2.158777 -2.314333 -2.450547 -2.567945 -2.675887 -2.757653 -2.803052 -2.805717 -2.756768 -2.646883 -2.473772 -8.693932 -1.378000 -1.401809 -1.445511 -1.507694 -1.686982 -1.859824 -2.029181 -2.193780 -2.350134 -2.494849 -2.625506 -2.745288 -2.851279 -2.936102 -2.989780 -3.004059 -2.969850 -2.873842 -2.700461 -8.693932 -1.724641 -1.730220 -1.758059 -1.803328 -1.957937 -2.111626 -2.265062 -2.412539 -2.553139 -2.688151 -2.814298 -2.926533 -3.025726 -3.110800 -3.169168 -3.195726 -3.177377 -3.103008 -2.930737 -8.693932 -2.103742 -2.089972 -2.100477 -2.128657 -2.258396 -2.389657 -2.521223 -2.652424 -2.778466 -2.899020 -3.010710 -3.113500 -3.204144 -3.283512 -3.345635 -3.380187 -3.378090 -3.325095 -3.154059 -8.693932 -2.525782 -2.490893 -2.482166 -2.492526 -2.594230 -2.699314 -2.808255 -2.918359 -3.024315 -3.126893 -3.223363 -3.313515 -3.393882 -3.466387 -3.528061 -3.569484 -3.595676 -3.546608 -3.375489 -8.693932 -2.999555 -2.945390 -2.915025 -2.904681 -2.975156 -3.050389 -3.132066 -3.218658 -3.305319 -3.388205 -3.467868 -3.542837 -3.613456 -3.675543 -3.736428 -3.799907 -3.826535 -3.775782 -3.593547 -8.693932 -3.585072 -3.504696 -3.449290 -3.412528 -3.451179 -3.494316 -3.546088 -3.605512 -3.668650 -3.730535 -3.789265 -3.850282 -3.917312 -3.983516 -4.044828 -4.090346 -4.105959 -4.041198 -3.823147 -8.693932 -4.545488 -4.422613 -4.321749 -4.243183 -4.242821 -4.248768 -4.262849 -4.287332 -4.317784 -4.356647 -4.395206 -4.432648 -4.476235 -4.526979 -4.566862 -4.596454 -4.581703 -4.452818 -4.148200 -8.693932 -16.45456 -16.23471 -15.98469 -15.70678 -15.40311 -15.07563 -14.72610 -14.35606 -13.96687 -13.55976 -13.13582 -12.69600 -12.24118 -11.77213 -11.28955 -10.79407 -10.28626 -9.766654 -9.235729 -8.693932 0.9378788 0.5674209 0.1891316 -7.3089764E-02 -0.1817250 -0.2979990 -0.4162245 -0.5383728 -0.6584281 -0.7731028 -0.8779533 -0.9691778 -1.045478 -1.107912 -1.155086 -1.190947 -1.219397 -1.246532 -1.268757 -10.31178 1.077546 0.7574089 0.4304496 0.1824529 3.3130981E-02 -0.1190127 -0.2695686 -0.4222495 -0.5680447 -0.7015730 -0.8190198 -0.9124240 -0.9854808 -1.035415 -1.064810 -1.077606 -1.079343 -1.075542 -1.063512 -10.31178 1.127435 0.8506668 0.5660815 0.3222898 0.1321674 -5.3799402E-02 -0.2377304 -0.4190595 -0.5878513 -0.7394978 -0.8662140 -0.9634907 -1.033138 -1.071062 -1.083432 -1.074485 -1.051180 -1.017920 -0.9734808 -10.31178 1.102638 0.8612917 0.6130565 0.3736531 0.1504600 -6.6324629E-02 -0.2818002 -0.4886670 -0.6795037 -0.8492058 -0.9851818 -1.090029 -1.158030 -1.187958 -1.185678 -1.157685 -1.111583 -1.050693 -0.9753243 -10.31178 1.015877 0.8052130 0.5877957 0.3556838 0.1076618 -0.1381375 -0.3773341 -0.6055027 -0.8161271 -0.9977347 -1.148008 -1.261621 -1.329076 -1.354776 -1.341465 -1.297204 -1.230927 -1.144115 -1.039062 -10.31178 0.8774338 0.6960502 0.5057626 0.2803598 1.0217976E-02 -0.2529583 -0.5102785 -0.7569513 -0.9795711 -1.172451 -1.335948 -1.456487 -1.527134 -1.550710 -1.530419 -1.473120 -1.389638 -1.278761 -1.145290 -10.31178 0.6919064 0.5360874 0.3687577 0.1516136 -0.1296080 -0.4057968 -0.6753754 -0.9299434 -1.159467 -1.364776 -1.537224 -1.662277 -1.738968 -1.762528 -1.739595 -1.674893 -1.576177 -1.443460 -1.283016 -10.31178 0.4668903 0.3329698 0.1867888 -2.2668675E-02 -0.3081928 -0.5915800 -0.8647967 -1.119615 -1.357017 -1.568910 -1.743262 -1.877085 -1.959916 -1.989254 -1.968010 -1.902816 -1.793224 -1.642101 -1.457131 -10.31178 0.2038305 8.9368753E-02 -3.7608657E-02 -0.2378484 -0.5231533 -0.8007429 -1.070457 -1.328553 -1.567574 -1.774739 -1.951338 -2.091157 -2.181278 -2.221181 -2.207659 -2.148938 -2.034249 -1.869282 -1.662907 -10.31178 -9.4954453E-02 -0.1911092 -0.3017357 -0.4888913 -0.7624750 -1.032299 -1.297646 -1.550244 -1.779265 -1.982774 -2.157119 -2.298241 -2.398937 -2.449547 -2.454628 -2.404759 -2.292128 -2.119156 -1.895567 -10.31178 -0.4218987 -0.4992651 -0.5943800 -0.7656924 -1.028700 -1.288321 -1.539937 -1.774830 -1.993804 -2.189567 -2.356814 -2.498951 -2.606722 -2.672283 -2.697868 -2.662316 -2.558383 -2.384957 -2.149496 -10.31178 -0.7804383 -0.8394207 -0.9189999 -1.074006 -1.318701 -1.556419 -1.788091 -2.007643 -2.209798 -2.391697 -2.554161 -2.692486 -2.804204 -2.890460 -2.929824 -2.912392 -2.823206 -2.656873 -2.415640 -10.31178 -1.166946 -1.206539 -1.269207 -1.404530 -1.622424 -1.837524 -2.047452 -2.244818 -2.429357 -2.599545 -2.751013 -2.884896 -3.007457 -3.101810 -3.155058 -3.156782 -3.090400 -2.941153 -2.702629 -10.31178 -1.583647 -1.600449 -1.643573 -1.757392 -1.944709 -2.130135 -2.314774 -2.493455 -2.660658 -2.813645 -2.955233 -3.089288 -3.207246 -3.303352 -3.366548 -3.383614 -3.341937 -3.219014 -2.986130 -10.31178 -2.026808 -2.019498 -2.041792 -2.129949 -2.286483 -2.445223 -2.604594 -2.759676 -2.907579 -3.048830 -3.179193 -3.299997 -3.409427 -3.503198 -3.569459 -3.601104 -3.583382 -3.495126 -3.270186 -10.31178 -2.513279 -2.481110 -2.480397 -2.541382 -2.665301 -2.792220 -2.924262 -3.056946 -3.185504 -3.306389 -3.419074 -3.524974 -3.622712 -3.707693 -3.776266 -3.817572 -3.827281 -3.765759 -3.547773 -10.31178 -3.056981 -3.000272 -2.973496 -3.004997 -3.094285 -3.188036 -3.288631 -3.393256 -3.496835 -3.597305 -3.690985 -3.779535 -3.862851 -3.938938 -4.005410 -4.063399 -4.096364 -4.037057 -3.821695 -10.31178 -3.707428 -3.621731 -3.565627 -3.562061 -3.614079 -3.673975 -3.741181 -3.814412 -3.891379 -3.965266 -4.039120 -4.110066 -4.178957 -4.255527 -4.332599 -4.393635 -4.408612 -4.352736 -4.106193 -10.31178 -4.741441 -4.607402 -4.502018 -4.447381 -4.448203 -4.464672 -4.492779 -4.528256 -4.571082 -4.617490 -4.668346 -4.723471 -4.775319 -4.827582 -4.891550 -4.939323 -4.940876 -4.824245 -4.479371 -10.31178 -19.57490 -19.32156 -19.02936 -18.70164 -18.34150 -17.95167 -17.53456 -17.09226 -16.62661 -16.13920 -15.63144 -15.10481 -14.55992 -13.99774 -13.41964 -12.82640 -12.21801 -11.59584 -10.96025 -10.31178 1.277085 0.8264762 0.3760951 0.1771110 6.3018285E-02 -6.5120623E-02 -0.1992325 -0.3397969 -0.4746750 -0.6027326 -0.7226265 -0.8278648 -0.9158058 -0.9855707 -1.038166 -1.075911 -1.103257 -1.126415 -1.145689 -11.98777 1.475157 1.088351 0.7009247 0.4842687 0.3210561 0.1506711 -2.3138447E-02 -0.1953183 -0.3551910 -0.5050017 -0.6366016 -0.7448004 -0.8243731 -0.8786777 -0.9070001 -0.9152675 -0.9091644 -0.8953696 -0.8741082 -11.98777 1.558824 1.225375 0.8908252 0.6469174 0.4349519 0.2206345 1.0007564E-02 -0.1884547 -0.3758439 -0.5451689 -0.6883263 -0.7984818 -0.8718473 -0.9113739 -0.9171162 -0.8974161 -0.8595238 -0.8106674 -0.7509277 -11.98777 1.550841 1.260943 0.9692802 0.7045919 0.4490989 0.1987959 -4.0416103E-02 -0.2686213 -0.4815263 -0.6709347 -0.8287886 -0.9428859 -1.015651 -1.043420 -1.030887 -0.9861627 -0.9187843 -0.8364641 -0.7396648 -11.98777 1.468320 1.216014 0.9597141 0.6790104 0.3936016 0.1185739 -0.1486987 -0.4027085 -0.6367299 -0.8459157 -1.016595 -1.139880 -1.214812 -1.234423 -1.206852 -1.140257 -1.045954 -0.9314401 -0.7985945 -11.98777 1.323236 1.103543 0.8769965 0.5896397 0.2868372 -9.7329067E-03 -0.2989168 -0.5730513 -0.8258407 -1.051443 -1.234373 -1.370768 -1.448998 -1.466828 -1.428069 -1.343968 -1.226053 -1.081322 -0.9136099 -11.98777 1.126959 0.9357921 0.7359228 0.4513565 0.1342291 -0.1792122 -0.4824217 -0.7704208 -1.036394 -1.270089 -1.469947 -1.619086 -1.702802 -1.723333 -1.679729 -1.582701 -1.445793 -1.273297 -1.072259 -11.98777 0.8863631 0.7214128 0.5473638 0.2619147 -6.0752045E-02 -0.3815329 -0.6935692 -0.9902461 -1.258301 -1.500588 -1.712085 -1.868685 -1.963611 -1.989505 -1.947752 -1.844426 -1.693149 -1.496179 -1.263721 -11.98777 0.6007288 0.4592708 0.3072489 2.9053571E-02 -0.2949547 -0.6165053 -0.9291253 -1.221604 -1.494180 -1.740291 -1.952188 -2.117486 -2.222991 -2.259180 -2.225839 -2.126389 -1.966085 -1.749288 -1.488300 -11.98777 0.2743394 0.1549941 2.1684228E-02 -0.2462639 -0.5649336 -0.8796847 -1.181137 -1.470040 -1.739766 -1.980561 -2.188257 -2.359603 -2.474106 -2.526617 -2.506774 -2.422029 -2.261298 -2.031286 -1.746039 -11.98777 -9.2929564E-02 -0.1912637 -0.3076719 -0.5606900 -0.8623178 -1.162945 -1.455523 -1.733422 -1.987689 -2.217049 -2.421023 -2.589044 -2.714480 -2.782170 -2.788296 -2.722088 -2.571166 -2.336702 -2.033107 -11.98777 -0.4983290 -0.5745206 -0.6725639 -0.9061395 -1.188970 -1.471389 -1.745501 -2.000309 -2.238501 -2.453629 -2.644734 -2.810163 -2.940842 -3.024709 -3.059911 -3.017297 -2.885386 -2.658118 -2.344145 -11.98777 -0.9416921 -0.9950247 -1.073865 -1.285183 -1.540872 -1.793496 -2.041613 -2.276242 -2.492316 -2.687265 -2.867560 -3.025177 -3.155046 -3.259991 -3.313232 -3.297179 -3.190927 -2.981835 -2.666337 -11.98777 -1.416467 -1.445457 -1.503906 -1.686524 -1.909458 -2.132229 -2.349773 -2.556795 -2.752100 -2.930876 -3.092893 -3.242209 -3.378701 -3.487253 -3.556188 -3.564682 -3.493841 -3.316947 -3.012780 -11.98777 -1.926611 -1.928319 -1.963148 -2.111730 -2.297944 -2.485559 -2.673771 -2.856425 -3.027676 -3.185364 -3.335485 -3.476872 -3.603020 -3.709542 -3.784899 -3.813265 -3.774581 -3.642337 -3.351566 -11.98777 -2.475343 -2.447873 -2.455890 -2.568738 -2.719195 -2.872862 -3.028066 -3.180833 -3.331646 -3.472646 -3.601958 -3.725683 -3.839787 -3.937233 -4.013507 -4.056061 -4.046636 -3.962880 -3.688341 -11.98777 -3.088928 -3.032598 -3.010028 -3.081984 -3.191506 -3.308684 -3.431583 -3.552828 -3.675107 -3.793539 -3.903341 -4.006012 -4.102321 -4.190859 -4.264356 -4.316959 -4.349557 -4.283626 -4.021128 -11.98777 -3.812195 -3.723531 -3.667481 -3.693469 -3.758404 -3.835912 -3.921818 -4.010176 -4.100328 -4.192802 -4.279372 -4.361612 -4.440832 -4.518963 -4.605384 -4.677484 -4.701884 -4.641266 -4.359974 -11.98777 -4.916431 -4.776222 -4.668048 -4.636163 -4.642496 -4.668536 -4.707018 -4.753865 -4.807038 -4.868257 -4.934576 -4.999791 -5.065360 -5.129848 -5.197266 -5.263820 -5.276453 -5.167930 -4.785647 -11.98777 -22.82174 -22.53431 -22.19836 -21.81857 -21.39915 -20.94380 -20.45568 -19.93749 -19.39182 -18.81995 -18.22434 -17.60654 -16.96739 -16.30807 -15.63013 -14.93428 -14.22137 -13.49219 -12.74743 -11.98777 1.594771 1.062231 0.5402356 0.4216543 0.3042420 0.1683593 1.9778533E-02 -0.1344721 -0.2888366 -0.4352285 -0.5688295 -0.6888964 -0.7892520 -0.8672050 -0.9256239 -0.9654807 -0.9925534 -1.012893 -1.029712 -13.71782 1.857719 1.402244 0.9510065 0.7795221 0.6071740 0.4198774 0.2285138 3.7514873E-02 -0.1453564 -0.3100195 -0.4564151 -0.5765211 -0.6664565 -0.7224805 -0.7507092 -0.7544551 -0.7412972 -0.7182544 -0.6882051 -13.71782 1.980279 1.588876 1.200644 0.9668970 0.7338669 0.4965310 0.2632839 3.9079335E-02 -0.1671409 -0.3529536 -0.5109176 -0.6324375 -0.7116096 -0.7491881 -0.7490932 -0.7190396 -0.6676527 -0.6031714 -0.5284754 -13.71782 1.991811 1.652458 1.316167 1.029617 0.7458988 0.4667247 0.1972366 -5.5216201E-02 -0.2870175 -0.4965755 -0.6686673 -0.7973109 -0.8718231 -0.8962966 -0.8720286 -0.8110313 -0.7236618 -0.6194901 -0.5014921 -13.71782 1.913882 1.618426 1.323219 0.9995671 0.6808274 0.3688670 7.0662156E-02 -0.2045386 -0.4635364 -0.6953344 -0.8849123 -1.021809 -1.099567 -1.114878 -1.071540 -0.9827425 -0.8615772 -0.7192445 -0.5588512 -13.71782 1.765460 1.507273 1.245335 0.9006622 0.5564678 0.2224153 -9.2780307E-02 -0.3935305 -0.6739064 -0.9261445 -1.134955 -1.283742 -1.370315 -1.381381 -1.324991 -1.213211 -1.061697 -0.8827434 -0.6809881 -13.71782 1.558235 1.332360 1.100242 0.7439188 0.3874267 4.2275444E-02 -0.2939465 -0.6116666 -0.9049814 -1.174509 -1.397470 -1.565250 -1.662925 -1.676274 -1.612597 -1.483744 -1.306296 -1.092993 -0.8511199 -13.71782 1.298576 1.101580 0.8969581 0.5395896 0.1796131 -0.1778902 -0.5232726 -0.8505923 -1.155089 -1.429099 -1.669199 -1.855270 -1.963390 -1.987968 -1.924682 -1.786368 -1.589736 -1.345644 -1.065560 -13.71782 0.9927789 0.8241583 0.6445419 0.2907386 -7.3287606E-02 -0.4323507 -0.7786936 -1.109114 -1.412333 -1.691793 -1.941961 -2.137926 -2.262342 -2.301114 -2.247763 -2.109012 -1.901458 -1.631479 -1.315874 -13.71782 0.6384117 0.4964482 0.3383161 -7.2197439E-03 -0.3643207 -0.7183912 -1.059341 -1.380136 -1.680820 -1.960968 -2.208804 -2.409055 -2.547335 -2.603091 -2.568040 -2.442042 -2.230883 -1.941558 -1.594185 -13.71782 0.2354101 0.1187891 -1.8690603E-02 -0.3498990 -0.6920772 -1.031954 -1.357686 -1.670157 -1.962610 -2.230056 -2.468002 -2.669620 -2.815239 -2.892778 -2.880688 -2.782106 -2.579772 -2.280980 -1.907921 -13.71782 -0.2116745 -0.3040889 -0.4213290 -0.7317917 -1.049623 -1.368954 -1.680134 -1.976597 -2.247564 -2.496746 -2.722917 -2.915835 -3.068084 -3.161354 -3.184780 -3.116976 -2.937119 -2.641898 -2.251646 -13.71782 -0.6990406 -0.7664233 -0.8621240 -1.146325 -1.440668 -1.735053 -2.018254 -2.287336 -2.537690 -2.765073 -2.971196 -3.155107 -3.306201 -3.415730 -3.470613 -3.437102 -3.290721 -3.015646 -2.619765 -13.71782 -1.229418 -1.270897 -1.344295 -1.596113 -1.855884 -2.115582 -2.367364 -2.607804 -2.831682 -3.035294 -3.225061 -3.390709 -3.541369 -3.664255 -3.736668 -3.736855 -3.631686 -3.393067 -3.005508 -13.71782 -1.800379 -1.812919 -1.860899 -2.071821 -2.293083 -2.514604 -2.730066 -2.938581 -3.138013 -3.318849 -3.485690 -3.643497 -3.788324 -3.907821 -3.992256 -4.015847 -3.957165 -3.771611 -3.407365 -13.71782 -2.417470 -2.397810 -2.416289 -2.578878 -2.757585 -2.940317 -3.121192 -3.295715 -3.466411 -3.628026 -3.779179 -3.918033 -4.045593 -4.158577 -4.240286 -4.283683 -4.264323 -4.143562 -3.804658 -13.71782 -3.098800 -3.045827 -3.030290 -3.143311 -3.275617 -3.415712 -3.558204 -3.702032 -3.843339 -3.978980 -4.106142 -4.225304 -4.332388 -4.431991 -4.510649 -4.566498 -4.588005 -4.512157 -4.196689 -13.71782 -3.897710 -3.807900 -3.752345 -3.808894 -3.889577 -3.984763 -4.087029 -4.192030 -4.299546 -4.407397 -4.508462 -4.603600 -4.693413 -4.780309 -4.861379 -4.943016 -4.976042 -4.909610 -4.591873 -13.71782 -5.077416 -4.928069 -4.814285 -4.802010 -4.816756 -4.854796 -4.907209 -4.965015 -5.027411 -5.103106 -5.182598 -5.260393 -5.338153 -5.414585 -5.486145 -5.562543 -5.583662 -5.488866 -5.070604 -13.71782 -26.18526 -25.86317 -25.48193 -25.04787 -24.56653 -24.04271 -23.48039 -22.88297 -22.25331 -21.59388 -20.90677 -20.19380 -19.45657 -18.69648 -17.91479 -17.11261 -16.29095 -15.45073 -14.59276 -13.71782 1.899899 1.284092 0.7608504 0.6659229 0.5421494 0.3984914 0.2407358 7.2761625E-02 -9.7920291E-02 -0.2640271 -0.4162735 -0.5499629 -0.6622854 -0.7503000 -0.8129857 -0.8557221 -0.8829827 -0.9013218 -0.9160247 -15.49837 2.229132 1.701051 1.235451 1.068585 0.8842525 0.6851197 0.4788119 0.2700764 6.7920811E-02 -0.1190833 -0.2800402 -0.4131455 -0.5102522 -0.5703903 -0.5972934 -0.5967774 -0.5770112 -0.5455629 -0.5071353 -15.49837 2.389059 1.936849 1.520818 1.274346 1.022530 0.7664795 0.5118664 0.2665122 3.5267044E-02 -0.1693926 -0.3425115 -0.4759643 -0.5613939 -0.5970859 -0.5912232 -0.5504202 -0.4860274 -0.4068858 -0.3176676 -15.49837 2.421472 2.030462 1.655833 1.344536 1.035611 0.7280090 0.4347786 0.1558912 -0.1033203 -0.3283305 -0.5180385 -0.6572544 -0.7372361 -0.7554598 -0.7205129 -0.6429300 -0.5360780 -0.4106396 -0.2717367 -15.49837 2.352025 2.012005 1.672225 1.314447 0.9601244 0.6183083 0.2913435 -1.5528098E-02 -0.2976520 -0.5496451 -0.7579154 -0.9102246 -0.9905171 -0.9993488 -0.9406205 -0.8299109 -0.6827756 -0.5124212 -0.3246577 -15.49837 2.201930 1.904441 1.593814 1.205505 0.8250738 0.4555289 0.1042952 -0.2200816 -0.5273867 -0.8046626 -1.034440 -1.203716 -1.293092 -1.299823 -1.224101 -1.084698 -0.9003746 -0.6869997 -0.4512419 -15.49837 1.982917 1.721749 1.438381 1.036168 0.6391695 0.2540076 -0.1103038 -0.4553170 -0.7782015 -1.075177 -1.328954 -1.515148 -1.622523 -1.632260 -1.549245 -1.387868 -1.170653 -0.9164587 -0.6338173 -15.49837 1.707302 1.479592 1.221633 0.8136241 0.4094287 2.0754777E-02 -0.3555147 -0.7110246 -1.044887 -1.356188 -1.624214 -1.833609 -1.962160 -1.983195 -1.901221 -1.727008 -1.483482 -1.191585 -0.8636749 -15.49837 1.377387 1.181291 0.9467257 0.5431964 0.1433398 -0.2506367 -0.6284531 -0.9872558 -1.326808 -1.640641 -1.919760 -2.148862 -2.294296 -2.337884 -2.267015 -2.091581 -1.831439 -1.506927 -1.136250 -15.49837 0.9956623 0.8305584 0.6192148 0.2264775 -0.1666107 -0.5549273 -0.9288863 -1.286315 -1.618004 -1.930231 -2.214727 -2.449585 -2.614506 -2.680580 -2.633384 -2.469214 -2.205263 -1.855438 -1.445832 -15.49837 0.5633629 0.4268907 0.2383621 -0.1385912 -0.5171719 -0.8927566 -1.256949 -1.600262 -1.923119 -2.227937 -2.501597 -2.736317 -2.911886 -2.999697 -2.983351 -2.847536 -2.590933 -2.225623 -1.782498 -15.49837 8.2099244E-02 -2.7461935E-02 -0.1925640 -0.5491389 -0.9084519 -1.261611 -1.604891 -1.935534 -2.243952 -2.526637 -2.783848 -3.011245 -3.188264 -3.298100 -3.312427 -3.221358 -2.989538 -2.623391 -2.155533 -15.49837 -0.4482154 -0.5316709 -0.6722959 -0.9994198 -1.330674 -1.660293 -1.979983 -2.285859 -2.566736 -2.827781 -3.064273 -3.273381 -3.452221 -3.570091 -3.625745 -3.578348 -3.387866 -3.040604 -2.560778 -15.49837 -1.025830 -1.081068 -1.195482 -1.489699 -1.789057 -2.084916 -2.369285 -2.642594 -2.897985 -3.130725 -3.343101 -3.536718 -3.703476 -3.836271 -3.915014 -3.910661 -3.771334 -3.465303 -2.990298 -15.49837 -1.654681 -1.680305 -1.765651 -2.015154 -2.272466 -2.527588 -2.774571 -3.011518 -3.235671 -3.442799 -3.631412 -3.802563 -3.967905 -4.100727 -4.189530 -4.217752 -4.137066 -3.892786 -3.444298 -15.49837 -2.338085 -2.328623 -2.378296 -2.576406 -2.784623 -2.994097 -3.201725 -3.403589 -3.595867 -3.775143 -3.943770 -4.100000 -4.246937 -4.372817 -4.459632 -4.508010 -4.478291 -4.312889 -3.899372 -15.49837 -3.089691 -3.042191 -3.049145 -3.190863 -3.346498 -3.510121 -3.675046 -3.838889 -4.002165 -4.156156 -4.297433 -4.431150 -4.556231 -4.668546 -4.751855 -4.809778 -4.823370 -4.729691 -4.352487 -15.49837 -3.959553 -3.870923 -3.830253 -3.909359 -4.009406 -4.121369 -4.241632 -4.364596 -4.490245 -4.614298 -4.728512 -4.836092 -4.937318 -5.041516 -5.121167 -5.200406 -5.247615 -5.168704 -4.807411 -15.49837 -5.216663 -5.065305 -4.957973 -4.958940 -4.988160 -5.034179 -5.097400 -5.170435 -5.249819 -5.334262 -5.426049 -5.516453 -5.605477 -5.702470 -5.788678 -5.850990 -5.893194 -5.796146 -5.338404 -15.49837 -29.65708 -29.29974 -28.87173 -28.38127 -27.83554 -27.24046 -26.60099 -25.92123 -25.20463 -24.45409 -23.67208 -22.86075 -22.02195 -21.15731 -20.26828 -19.35616 -18.42211 -17.46717 -16.49230 -15.49837 2.195788 1.501416 1.006921 0.9071327 0.7818468 0.6293685 0.4612988 0.2817000 9.5252112E-02 -8.8415541E-02 -0.2603905 -0.4089282 -0.5331910 -0.6296877 -0.6981496 -0.7437504 -0.7712805 -0.7881618 -0.8008696 -17.32631 2.588714 1.989540 1.531384 1.355388 1.157573 0.9451990 0.7257558 0.5018570 0.2815278 7.5408719E-02 -0.1056493 -0.2487144 -0.3541124 -0.4175854 -0.4422929 -0.4374493 -0.4111473 -0.3716679 -0.3250667 -17.32631 2.790248 2.275217 1.844753 1.575491 1.301507 1.027481 0.7566344 0.4899129 0.2385474 1.1070851E-02 -0.1780912 -0.3219800 -0.4125248 -0.4478875 -0.4340866 -0.3828311 -0.3056403 -0.2121860 -0.1085637 -17.32631 2.842953 2.398343 1.990353 1.648313 1.312765 0.9839444 0.6668059 0.3640388 8.1504755E-02 -0.1662577 -0.3703190 -0.5210596 -0.6040993 -0.6173746 -0.5701976 -0.4754911 -0.3492211 -0.2028916 -4.3139409E-02 -17.32631 2.780547 2.394319 2.008796 1.617055 1.233245 0.8609644 0.5083259 0.1733916 -0.1381757 -0.4083575 -0.6364671 -0.8013693 -0.8883035 -0.8891368 -0.8150548 -0.6814430 -0.5084923 -0.3105834 -9.5432892E-02 -17.32631 2.629937 2.291678 1.928168 1.504670 1.086606 0.6848441 0.3032494 -5.3208575E-02 -0.3846531 -0.6848742 -0.9386993 -1.124857 -1.221575 -1.221809 -1.127938 -0.9607508 -0.7439889 -0.4959840 -0.2261213 -17.32631 2.402838 2.106448 1.765668 1.321565 0.8868919 0.4667788 6.8723328E-02 -0.3011406 -0.6521736 -0.9770318 -1.255372 -1.468401 -1.584306 -1.594044 -1.490071 -1.295915 -1.039555 -0.7438821 -0.4202682 -17.32631 2.108939 1.850383 1.531473 1.083875 0.6398985 0.2135981 -0.1893363 -0.5715853 -0.9366598 -1.275702 -1.576617 -1.812011 -1.956565 -1.982961 -1.882662 -1.671603 -1.381839 -1.041755 -0.6657842 -17.32631 1.756789 1.533682 1.236954 0.7931890 0.3535105 -6.9476932E-02 -0.4783680 -0.8657346 -1.235032 -1.582203 -1.893035 -2.151521 -2.324391 -2.375031 -2.291033 -2.076943 -1.763772 -1.383930 -0.9578156 -17.32631 1.349676 1.159488 0.8858876 0.4560049 2.9055538E-02 -0.3914815 -0.7982667 -1.183781 -1.550852 -1.892427 -2.208177 -2.481725 -2.670940 -2.754242 -2.698588 -2.498061 -2.176149 -1.764177 -1.291461 -17.32631 0.8912262 0.7326953 0.4851281 7.1091816E-02 -0.3430522 -0.7508798 -1.147352 -1.526156 -1.878863 -2.212996 -2.523314 -2.794052 -2.997975 -3.105791 -3.089661 -2.919154 -2.606541 -2.173412 -1.659538 -17.32631 0.3785309 0.2496136 2.8601980E-02 -0.3640614 -0.7585427 -1.148088 -1.525159 -1.885817 -2.225276 -2.544180 -2.832243 -3.094966 -3.301060 -3.427021 -3.448955 -3.329003 -3.042204 -2.603134 -2.056225 -17.32631 -0.1892379 -0.2891824 -0.4835674 -0.8474050 -1.215069 -1.576860 -1.929545 -2.269193 -2.585931 -2.874012 -3.141864 -3.385123 -3.585826 -3.725466 -3.780948 -3.721664 -3.483267 -3.060782 -2.494308 -17.32631 -0.8116506 -0.8821341 -1.046553 -1.374088 -1.709361 -2.040251 -2.360368 -2.664223 -2.950893 -3.211742 -3.449834 -3.668842 -3.861728 -4.002439 -4.091983 -4.084472 -3.909850 -3.532889 -2.966484 -17.32631 -1.493955 -1.532524 -1.662784 -1.947129 -2.238105 -2.526675 -2.805935 -3.073174 -3.325676 -3.554221 -3.766195 -3.956867 -4.135631 -4.284828 -4.384142 -4.415299 -4.309549 -4.003580 -3.461234 -17.32631 -2.240926 -2.242391 -2.330991 -2.559334 -2.798635 -3.039501 -3.272868 -3.500387 -3.718826 -3.916061 -4.099289 -4.271362 -4.435203 -4.574419 -4.674558 -4.724196 -4.685494 -4.470817 -3.975846 -17.32631 -3.062602 -3.021470 -3.060404 -3.225616 -3.408144 -3.596796 -3.783151 -3.968567 -4.151283 -4.323116 -4.480416 -4.627093 -4.767470 -4.890196 -4.982311 -5.043770 -5.053510 -4.934921 -4.491417 -17.32631 -4.004322 -3.917839 -3.902179 -3.996025 -4.115838 -4.250640 -4.386166 -4.528327 -4.672927 -4.810851 -4.938208 -5.057915 -5.172237 -5.282343 -5.372389 -5.446761 -5.503790 -5.414383 -5.008067 -17.32631 -5.334528 -5.181235 -5.092575 -5.101278 -5.140040 -5.203348 -5.276074 -5.361379 -5.460272 -5.560734 -5.656334 -5.757378 -5.860659 -5.968549 -6.065075 -6.129345 -6.183826 -6.089282 -5.592088 -17.32631 -33.22993 -32.83676 -32.36051 -31.81168 -31.19915 -30.53023 -29.81083 -29.04619 -28.23932 -27.39461 -26.51458 -25.60171 -24.65810 -23.68565 -22.68599 -21.66060 -20.61081 -19.53779 -18.44263 -17.32631 2.485039 1.711285 1.252954 1.151611 1.018951 0.8626556 0.6833158 0.4901580 0.2893510 8.7523229E-02 -0.1012758 -0.2681958 -0.4043665 -0.5099439 -0.5841864 -0.6317936 -0.6598750 -0.6759022 -0.6868313 -19.19886 2.942691 2.274494 1.827874 1.637321 1.428747 1.204556 0.9697787 0.7309240 0.4945047 0.2698575 7.2625168E-02 -8.5158087E-02 -0.1975040 -0.2630160 -0.2859004 -0.2761867 -0.2430400 -0.1959180 -0.1412704 -19.19886 3.182042 2.605625 2.162320 1.871075 1.577243 1.282960 0.9944145 0.7108727 0.4403451 0.1938710 -1.3878846E-02 -0.1680155 -0.2633194 -0.2957641 -0.2735850 -0.2112319 -0.1207946 -1.3120701E-02 0.1048395 -19.19886 3.256219 2.757422 2.318333 1.946536 1.581432 1.230243 0.8930869 0.5659376 0.2644240 -6.0601505E-03 -0.2288984 -0.3904044 -0.4775905 -0.4859872 -0.4247338 -0.3130808 -0.1672619 -2.4607824E-04 0.1803085 -19.19886 3.202857 2.769539 2.339515 1.910447 1.495402 1.097628 0.7196835 0.3592626 2.4722479E-02 -0.2725303 -0.5177833 -0.6962592 -0.7870314 -0.7810175 -0.6890906 -0.5322097 -0.3330607 -0.1076777 0.1349412 -19.19886 3.049222 2.669810 2.253804 1.792002 1.341879 0.9090741 0.5008628 0.1163432 -0.2449576 -0.5682052 -0.8456437 -1.049176 -1.157344 -1.149633 -1.036645 -0.8403557 -0.5908242 -0.3084641 -4.3980493E-03 -19.19886 2.814000 2.481685 2.083925 1.602052 1.129151 0.6779609 0.2514816 -0.1506243 -0.5283559 -0.8783376 -1.185672 -1.419753 -1.552227 -1.559098 -1.435405 -1.208126 -0.9124078 -0.5750288 -0.2102940 -19.19886 2.505669 2.216498 1.837412 1.347932 0.8692486 0.4096840 -2.5928015E-02 -0.4354704 -0.8277040 -1.196009 -1.525887 -1.791169 -1.953934 -1.988737 -1.868450 -1.620595 -1.285100 -0.8960419 -0.4718621 -19.19886 2.130907 1.880422 1.523388 1.041542 0.5660530 0.1069685 -0.3298045 -0.7461487 -1.144042 -1.518129 -1.866606 -2.149506 -2.348132 -2.415731 -2.318413 -2.065384 -1.700058 -1.264262 -0.7826040 -19.19886 1.701791 1.486684 1.153848 0.6842856 0.2200933 -0.2296519 -0.6679887 -1.083251 -1.478114 -1.852012 -2.199215 -2.500455 -2.723917 -2.826483 -2.766527 -2.528813 -2.148968 -1.673849 -1.137889 -19.19886 1.216568 1.034707 0.7292300 0.2799314 -0.1696078 -0.6097209 -1.037399 -1.445913 -1.831868 -2.191364 -2.533449 -2.841044 -3.072145 -3.206867 -3.192920 -2.991066 -2.618446 -2.115608 -1.530471 -19.19886 0.6747954 0.5262247 0.2489107 -0.1786652 -0.6082990 -1.030251 -1.441010 -1.834305 -2.199626 -2.545470 -2.870975 -3.162298 -3.400192 -3.552549 -3.585731 -3.439645 -3.097746 -2.584418 -1.958306 -19.19886 7.2794661E-02 -4.4096127E-02 -0.2920684 -0.6902211 -1.094547 -1.490947 -1.873500 -2.243978 -2.590798 -2.910907 -3.204034 -3.478389 -3.706774 -3.870499 -3.937233 -3.864354 -3.577886 -3.078995 -2.425468 -19.19886 -0.5920463 -0.6778845 -0.8922613 -1.252797 -1.622532 -1.986415 -2.338869 -2.678511 -2.991040 -3.279346 -3.544086 -3.787625 -4.003691 -4.164047 -4.264600 -4.253908 -4.044355 -3.593130 -2.933189 -19.19886 -1.323228 -1.374972 -1.550264 -1.866737 -2.195872 -2.517074 -2.825381 -3.123684 -3.402621 -3.656061 -3.888288 -4.104839 -4.296044 -4.457963 -4.571905 -4.606830 -4.479165 -4.110168 -3.472949 -19.19886 -2.128968 -2.141654 -2.271748 -2.530661 -2.803301 -3.073465 -3.334408 -3.587351 -3.829245 -4.050042 -4.248304 -4.437438 -4.614592 -4.764627 -4.876557 -4.933479 -4.885988 -4.622595 -4.044255 -19.19886 -3.019984 -2.986534 -3.061798 -3.250205 -3.458284 -3.671678 -3.880527 -4.087540 -4.292583 -4.481270 -4.653734 -4.817069 -4.969445 -5.100595 -5.198677 -5.268853 -5.277047 -5.130113 -4.616706 -19.19886 -4.033730 -3.948463 -3.960338 -4.072200 -4.211440 -4.361629 -4.517413 -4.679179 -4.844113 -4.999178 -5.138499 -5.271069 -5.399478 -5.513448 -5.607125 -5.678460 -5.743772 -5.654362 -5.194376 -19.19886 -5.438166 -5.274366 -5.205607 -5.226889 -5.281175 -5.354353 -5.440272 -5.542421 -5.655984 -5.775643 -5.884305 -5.988245 -6.110625 -6.223502 -6.323494 -6.397200 -6.455285 -6.368101 -5.831966 -19.19886 -36.89745 -36.46789 -35.94199 -35.33284 -34.65129 -33.90605 -33.10414 -32.25123 -31.35198 -30.41024 -29.42929 -28.41191 -27.36051 -26.27721 -25.16387 -24.02214 -22.85350 -21.65929 -20.44071 -19.19886 2.762966 1.906436 1.492955 1.395180 1.258604 1.092605 0.9053621 0.6980674 0.4801613 0.2608851 5.3055063E-02 -0.1308812 -0.2820723 -0.3966570 -0.4766179 -0.5266824 -0.5554655 -0.5710148 -0.5806550 -21.11357 3.289462 2.550644 2.121015 1.919466 1.695869 1.460320 1.212286 0.9573295 0.7036587 0.4610677 0.2476966 7.5413473E-02 -4.3540638E-02 -0.1109313 -0.1315391 -0.1158649 -7.6050915E-02 -2.1541342E-02 4.0945545E-02 -21.11357 3.569313 2.932210 2.478265 2.160839 1.845599 1.535304 1.226593 0.9265169 0.6382602 0.3727418 0.1492731 -1.7984755E-02 -0.1150672 -0.1436870 -0.1129084 -3.8403567E-02 6.5539874E-02 0.1871742 0.3194945 -21.11357 3.662875 3.110766 2.639991 2.236481 1.845446 1.470485 1.111051 0.7650864 0.4415724 0.1511062 -9.0531789E-02 -0.2631058 -0.3529640 -0.3534376 -0.2781419 -0.1484699 1.7350437E-02 0.2050207 0.4064850 -21.11357 3.617597 3.136379 2.662606 2.198038 1.750554 1.325904 0.9253200 0.5392532 0.1820101 -0.1391135 -0.4063282 -0.5983429 -0.6944700 -0.6808706 -0.5695583 -0.3889802 -0.1634001 8.9306936E-02 0.3595299 -21.11357 3.462542 3.041509 2.574284 2.071352 1.587993 1.128686 0.6936827 0.2809859 -0.1052437 -0.4586552 -0.7554961 -0.9796213 -1.096502 -1.082684 -0.9483118 -0.7226995 -0.4400513 -0.1234489 0.2150804 -21.11357 3.217163 2.848853 2.393918 1.872965 1.367587 0.8848979 0.4304674 -1.0848563E-03 -0.4085566 -0.7843839 -1.116228 -1.374270 -1.526707 -1.529556 -1.385713 -1.124009 -0.7884785 -0.4097429 -3.5706654E-03 -21.11357 2.893892 2.573035 2.135890 1.609712 1.094202 0.6024061 0.1364037 -0.3055687 -0.7213123 -1.118269 -1.475677 -1.766070 -1.955472 -1.996053 -1.858390 -1.573832 -1.192141 -0.7541895 -0.2814220 -21.11357 2.502859 2.224499 1.808485 1.285044 0.7755865 0.2825552 -0.1880534 -0.6304855 -1.053625 -1.458020 -1.831965 -2.146799 -2.372278 -2.459937 -2.349544 -2.058575 -1.641247 -1.149283 -0.6116966 -21.11357 2.050045 1.809052 1.419289 0.9105301 0.4104697 -7.5461581E-02 -0.5403517 -0.9842237 -1.405428 -1.805390 -2.186031 -2.512659 -2.770841 -2.897918 -2.836925 -2.563393 -2.126658 -1.588338 -0.9888934 -21.11357 1.540053 1.334707 0.9718910 0.4833283 7.2643592E-04 -0.4714867 -0.9297853 -1.366745 -1.777638 -2.167550 -2.534671 -2.871692 -3.140427 -3.304628 -3.297383 -3.068104 -2.635159 -2.062369 -1.405836 -21.11357 0.9692993 0.7991027 0.4669454 4.6819346E-03 -0.4599424 -0.9140415 -1.354943 -1.778228 -2.171180 -2.540889 -2.894870 -3.220038 -3.487109 -3.672937 -3.719351 -3.553669 -3.157731 -2.569306 -1.864050 -21.11357 0.3346665 0.1993937 -9.9991947E-02 -0.5329341 -0.9712031 -1.400755 -1.816961 -2.213991 -2.586514 -2.936056 -3.259570 -3.560076 -3.817164 -4.006387 -4.095253 -4.008353 -3.676888 -3.100049 -2.359473 -21.11357 -0.3686236 -0.4699272 -0.7328048 -1.128855 -1.532870 -1.927621 -2.310692 -2.680651 -3.024622 -3.335906 -3.629630 -3.900063 -4.135293 -4.321671 -4.432625 -4.422439 -4.182299 -3.654579 -2.900870 -21.11357 -1.145133 -1.210238 -1.431870 -1.780692 -2.142588 -2.497996 -2.837371 -3.163549 -3.470805 -3.748138 -4.003829 -4.242720 -4.454368 -4.626667 -4.756123 -4.795439 -4.652114 -4.218135 -3.484518 -21.11357 -2.007301 -2.031483 -2.204614 -2.492793 -2.796191 -3.096113 -3.385601 -3.666891 -3.933557 -4.173602 -4.394279 -4.599385 -4.789318 -4.951989 -5.076476 -5.140020 -5.082882 -4.771533 -4.098043 -21.11357 -2.964579 -2.937294 -3.048997 -3.265234 -3.501271 -3.736156 -3.972023 -4.203954 -4.429528 -4.633461 -4.822094 -5.004878 -5.167667 -5.310276 -5.418425 -5.491940 -5.499427 -5.323503 -4.733021 -21.11357 -4.053926 -3.966259 -4.004763 -4.139133 -4.299682 -4.469168 -4.648249 -4.830997 -5.014809 -5.182557 -5.337071 -5.489719 -5.624352 -5.744308 -5.846585 -5.924324 -5.986438 -5.893053 -5.373379 -21.11357 -5.533234 -5.360703 -5.309177 -5.346729 -5.420563 -5.508458 -5.615059 -5.734644 -5.863388 -5.992748 -6.115096 -6.238573 -6.363195 -6.482433 -6.592028 -6.674915 -6.730899 -6.646055 -6.070080 -21.11357 -40.65407 -40.18756 -39.61063 -38.93930 -38.18658 -37.36271 -36.47584 -35.53246 -34.53788 -33.49644 -32.41183 -31.28719 -30.12520 -28.92823 -27.69836 -26.43742 -25.14707 -23.82877 -22.48386 -21.11357 3.026621 2.085815 1.722953 1.632390 1.495134 1.324705 1.123697 0.9034007 0.6657879 0.4273532 0.1988696 -4.2262445E-03 -0.1722534 -0.2979175 -0.3848764 -0.4383016 -0.4684383 -0.4838279 -0.4924822 -23.06822 3.626079 2.813182 2.406055 2.195741 1.962972 1.712546 1.450180 1.179590 0.9061462 0.6460275 0.4135477 0.2276327 9.9100694E-02 2.9376587E-02 1.1074506E-02 3.1932388E-02 7.8210339E-02 0.1399471 0.2101025 -23.06822 3.949693 3.250716 2.788043 2.449066 2.110220 1.781069 1.454631 1.135928 0.8292745 0.5454282 0.3054355 0.1261004 2.5429554E-02 2.3364748E-05 3.9965112E-02 0.1271722 0.2443144 0.3798828 0.5265622 -23.06822 4.064472 3.459117 2.959766 2.521668 2.102877 1.706154 1.322544 0.9573476 0.6139205 0.3036719 4.4897806E-02 -0.1418093 -0.2322080 -0.2251395 -0.1349429 1.3711904E-02 0.1995228 0.4078437 0.6304389 -23.06822 4.026646 3.498327 2.980022 2.479194 2.000785 1.549413 1.123713 0.7161281 0.3351277 -7.6037515E-03 -0.2956859 -0.5035744 -0.6033212 -0.5796184 -0.4487382 -0.2433077 8.9983186E-03 0.2892777 0.5874506 -23.06822 3.868903 3.405760 2.888386 2.345579 1.828785 1.341197 0.8812149 0.4414261 3.1120239E-02 -0.3470574 -0.6677218 -0.9130177 -1.040395 -1.020037 -0.8622338 -0.6066054 -0.2907411 6.0341958E-02 0.4337568 -23.06822 3.614137 3.209256 2.698289 2.137764 1.599113 1.087901 0.6035145 0.1459214 -0.2876342 -0.6932423 -1.045501 -1.332295 -1.502381 -1.505129 -1.339259 -1.043171 -0.6678815 -0.2476296 0.2005139 -23.06822 3.275936 2.922669 2.427614 1.863760 1.316350 0.7899726 0.2952609 -0.1744261 -0.6183628 -1.040001 -1.421681 -1.742623 -1.960456 -2.006817 -1.853094 -1.530939 -1.102893 -0.6161655 -9.4175011E-02 -23.06822 2.869240 2.560884 2.087842 1.526973 0.9799543 0.4556884 -4.5546521E-02 -0.5175069 -0.9623970 -1.393092 -1.793387 -2.141020 -2.397031 -2.502467 -2.384179 -2.057291 -1.587849 -1.039347 -0.4450923 -23.06822 2.395854 2.128684 1.680102 1.133406 0.5981702 8.0062330E-02 -0.4175743 -0.8849929 -1.330267 -1.756269 -2.162950 -2.522043 -2.810952 -2.969802 -2.909143 -2.603261 -2.109860 -1.507810 -0.8439688 -23.06822 1.860153 1.631149 1.211862 0.6866589 0.1673825 -0.3347672 -0.8231976 -1.286046 -1.722100 -2.137297 -2.533701 -2.895351 -3.201317 -3.395598 -3.402673 -3.148578 -2.657222 -2.013618 -1.284704 -23.06822 1.262116 1.070629 0.6831318 0.1857359 -0.3117614 -0.7978384 -1.269353 -1.718703 -2.139972 -2.534577 -2.914328 -3.268507 -3.565716 -3.784535 -3.849738 -3.672258 -3.219203 -2.554068 -1.767878 -23.06822 0.5964898 0.4426540 9.1457643E-02 -0.3761620 -0.8478311 -1.308247 -1.755947 -2.183778 -2.579428 -2.952260 -3.310577 -3.633144 -3.919092 -4.138073 -4.248000 -4.156297 -3.780499 -3.124170 -2.294360 -23.06822 -0.1432208 -0.2604424 -0.5724867 -1.001948 -1.439938 -1.865923 -2.278295 -2.677673 -3.048387 -3.386553 -3.707659 -4.002275 -4.260215 -4.469798 -4.598865 -4.593483 -4.322051 -3.716508 -2.865872 -23.06822 -0.9638547 -1.043112 -1.310500 -1.690913 -2.083745 -2.468681 -2.843441 -3.200171 -3.530061 -3.831455 -4.117067 -4.373895 -4.602352 -4.790477 -4.934860 -4.982932 -4.825875 -4.322284 -3.487251 -23.06822 -1.877565 -1.911091 -2.126902 -2.450225 -2.783835 -3.112389 -3.434753 -3.742863 -4.031728 -4.290606 -4.537575 -4.760282 -4.957174 -5.132070 -5.268701 -5.341575 -5.281190 -4.918555 -4.146254 -23.06822 -2.901731 -2.879845 -3.027816 -3.273953 -3.537086 -3.802433 -4.064166 -4.320786 -4.562120 -4.782684 -4.991492 -5.187372 -5.358598 -5.509627 -5.627426 -5.705269 -5.718085 -5.508443 -4.837297 -23.06822 -4.065989 -3.978928 -4.044422 -4.201851 -4.383657 -4.577876 -4.779927 -4.983141 -5.178449 -5.362891 -5.534667 -5.700251 -5.839459 -5.968617 -6.072763 -6.156788 -6.220505 -6.120705 -5.543661 -23.06822 -5.616639 -5.444869 -5.404933 -5.460490 -5.545104 -5.654911 -5.782886 -5.920935 -6.063956 -6.202317 -6.341402 -6.481819 -6.602575 -6.730911 -6.841010 -6.932418 -6.991548 -6.913372 -6.301987 -23.06822 -44.49479 -43.99077 -43.36148 -42.62620 -41.80026 -40.89581 -39.92142 -38.88518 -37.79279 -36.64914 -35.45832 -34.22382 -32.94863 -31.63536 -30.28654 -28.90348 -27.48871 -26.04362 -24.56968 -23.06822 3.280943 2.255705 1.947259 1.861604 1.728739 1.554364 1.344150 1.106434 0.8518039 0.5914037 0.3427572 0.1169043 -6.8385787E-02 -0.2068561 -0.3010344 -0.3585459 -0.3901247 -0.4053742 -0.4133033 -25.06082 3.952378 3.063056 2.680682 2.464238 2.223084 1.963021 1.683995 1.396370 1.102420 0.8238441 0.5702205 0.3673788 0.2275929 0.1547448 0.1382263 0.1636529 0.2162426 0.2851831 0.3628449 -25.06082 4.322101 3.558183 3.089504 2.729116 2.372656 2.022484 1.677134 1.340097 1.013884 0.7136672 0.4517846 0.2605914 0.1543422 0.1332289 0.1827220 0.2818074 0.4123088 0.5619048 0.7229079 -25.06082 4.460973 3.800596 3.272575 2.804196 2.355825 1.934994 1.529711 1.142066 0.7817364 0.4498272 0.1692901 -3.0731615E-02 -0.1234764 -0.1086569 -3.0714306E-03 0.1643605 0.3701905 0.5993413 0.8431373 -25.06082 4.429793 3.854007 3.294708 2.755181 2.245457 1.768571 1.314891 0.8887510 0.4847006 0.1180314 -0.1934752 -0.4194348 -0.5216193 -0.4882065 -0.3375752 -0.1072697 0.1718892 0.4799156 0.8062585 -25.06082 4.269944 3.764900 3.196015 2.614696 2.065268 1.547978 1.062973 0.6018927 0.1610534 -0.2384144 -0.5857820 -0.8517317 -0.9888501 -0.9593192 -0.7790068 -0.4929560 -0.1433821 0.2426328 0.6512522 -25.06082 4.004492 3.562191 2.996969 2.398013 1.824415 1.284690 0.7745486 0.2878299 -0.1729141 -0.6013467 -0.9807162 -1.292220 -1.481645 -1.484921 -1.296660 -0.9659516 -0.5504739 -8.8135585E-02 0.4023436 -25.06082 3.653633 3.266617 2.714852 2.110916 1.532427 0.9766340 0.4483289 -4.6448037E-02 -0.5164670 -0.9634905 -1.369693 -1.720434 -1.963969 -2.020477 -1.852687 -1.493181 -1.018548 -0.4823659 8.9247078E-02 -25.06082 3.229781 2.890544 2.360245 1.764188 1.183537 0.6230465 9.2553973E-02 -0.4052142 -0.8760818 -1.328563 -1.754580 -2.129848 -2.421577 -2.546044 -2.425198 -2.062531 -1.540813 -0.9353494 -0.2839963 -25.06082 2.737180 2.442759 1.938016 1.353056 0.7819625 0.2308577 -0.2965814 -0.7903918 -1.257496 -1.708770 -2.138068 -2.528006 -2.847106 -3.036762 -2.981626 -2.645698 -2.094909 -1.427791 -0.6990021 -25.06082 2.176389 1.923835 1.447822 0.8867412 0.3320716 -0.2039464 -0.7191193 -1.208068 -1.667535 -2.108144 -2.529963 -2.915242 -3.252988 -3.482658 -3.507671 -3.233518 -2.683147 -1.968077 -1.166204 -25.06082 1.550798 1.338503 0.8973936 0.3630908 -0.1680469 -0.6841321 -1.185198 -1.661432 -2.104425 -2.528805 -2.929961 -3.306524 -3.638325 -3.888449 -3.978407 -3.796220 -3.287158 -2.545146 -1.677697 -25.06082 0.8548388 0.6820446 0.2806140 -0.2214522 -0.7258540 -1.216841 -1.693213 -2.150416 -2.570229 -2.967926 -3.351023 -3.698541 -4.009260 -4.259880 -4.392505 -4.306478 -3.888029 -3.152292 -2.232718 -25.06082 8.1234090E-02 -5.2138232E-02 -0.4122389 -0.8756114 -1.343644 -1.802517 -2.245950 -2.672197 -3.065206 -3.434196 -3.780474 -4.093822 -4.376826 -4.608046 -4.760022 -4.762033 -4.464301 -3.782430 -2.834210 -25.06082 -0.7799706 -0.8710216 -1.185084 -1.599747 -2.022804 -2.440310 -2.845587 -3.232497 -3.584152 -3.909155 -4.221323 -4.495653 -4.743834 -4.950265 -5.104211 -5.165441 -4.997368 -4.427655 -3.489618 -25.06082 -1.743141 -1.785648 -2.044550 -2.400929 -2.768748 -3.129157 -3.479504 -3.814215 -4.122036 -4.405743 -4.674492 -4.913791 -5.121572 -5.306717 -5.452072 -5.537273 -5.472834 -5.064764 -4.191836 -25.06082 -2.828812 -2.813843 -3.000138 -3.276814 -3.567189 -3.861894 -4.152766 -4.431224 -4.690740 -4.931135 -5.159681 -5.365187 -5.547149 -5.702871 -5.826559 -5.912511 -5.924966 -5.690267 -4.936466 -25.06082 -4.067486 -3.983927 -4.075584 -4.256726 -4.460251 -4.680391 -4.906494 -5.128237 -5.341318 -5.540013 -5.732155 -5.904982 -6.053770 -6.180748 -6.288929 -6.378964 -6.437601 -6.338241 -5.701798 -25.06082 -5.693504 -5.515724 -5.494077 -5.563285 -5.663530 -5.795596 -5.944605 -6.099556 -6.257222 -6.412559 -6.565621 -6.713001 -6.843460 -6.966137 -7.080718 -7.177924 -7.235813 -7.173553 -6.521971 -25.06082 -48.41520 -47.87312 -47.19015 -46.38920 -45.48810 -44.50049 -43.43712 -42.30551 -41.11300 -39.86476 -38.56532 -37.21853 -35.82767 -34.39585 -32.92485 -31.41764 -29.87594 -28.30153 -26.69601 -25.06082 3.525904 2.415944 2.168486 2.086810 1.957958 1.783804 1.566028 1.311560 1.037520 0.7572826 0.4839617 0.2358147 3.1434156E-02 -0.1209025 -0.2226613 -0.2848004 -0.3176524 -0.3330731 -0.3404578 -27.08958 4.271824 3.306164 2.950336 2.725581 2.479383 2.208837 1.917848 1.609203 1.298489 0.9967327 0.7227669 0.5013668 0.3499449 0.2729966 0.2578168 0.2877827 0.3469545 0.4230812 0.5081990 -27.08958 4.685678 3.855906 3.382458 3.002770 2.628325 2.260694 1.895864 1.539344 1.195830 0.8735025 0.5912657 0.3859282 0.2733735 0.2564471 0.3147269 0.4257517 0.5698769 0.7335430 0.9089226 -27.08958 4.849704 4.132720 3.579041 3.079902 2.606496 2.160234 1.731556 1.326336 0.9439850 0.5909225 0.2888660 7.5592108E-02 -2.0527160E-02 4.1528419E-03 0.1252022 0.3114025 0.5377783 0.7879141 1.053078 -27.08958 4.828023 4.204431 3.603121 3.028358 2.486225 1.981932 1.505173 1.055324 0.6290891 0.2397298 -9.6424721E-02 -0.3401282 -0.4454063 -0.4018719 -0.2312517 2.4497068E-02 0.3310060 0.6669976 1.021770 -27.08958 4.665032 4.117715 3.499292 2.879206 2.296602 1.751937 1.239766 0.7548804 0.2892318 -0.1324992 -0.5071506 -0.7977701 -0.9428886 -0.9069014 -0.7046734 -0.3876770 -3.7735882E-03 0.4172976 0.8614833 -27.08958 4.389934 3.909889 3.289751 2.653101 2.046833 1.475760 0.9387388 0.4282308 -5.8818307E-02 -0.5108026 -0.9187479 -1.255114 -1.461467 -1.465496 -1.256116 -0.8896968 -0.4329996 7.1850523E-02 0.6051123 -27.08958 4.026801 3.604736 2.997021 2.355787 1.741747 1.155737 0.6005031 7.8982614E-02 -0.4160427 -0.8875560 -1.318468 -1.697167 -1.967518 -2.039643 -1.857962 -1.461132 -0.9393997 -0.3534068 0.2682812 -27.08958 3.585743 3.215662 2.629120 1.994168 1.380778 0.7885519 0.2278168 -0.2959293 -0.7910012 -1.267189 -1.714188 -2.119078 -2.441866 -2.589427 -2.468944 -2.068981 -1.494062 -0.8311181 -0.1221794 -27.08958 3.072478 2.750716 2.190375 1.569002 0.9622510 0.3787855 -0.1785735 -0.6984493 -1.188405 -1.662650 -2.113076 -2.528823 -2.880879 -3.098531 -3.058627 -2.693573 -2.085512 -1.353045 -0.5589680 -27.08958 2.489441 2.213180 1.682001 1.081995 0.4935854 -7.5216077E-02 -0.6216604 -1.132173 -1.613557 -2.080426 -2.520455 -2.933286 -3.297296 -3.564104 -3.611825 -3.321623 -2.713725 -1.926217 -1.051161 -27.08958 1.835619 1.601887 1.108429 0.5371078 -2.7568419E-02 -0.5745844 -1.104243 -1.603994 -2.069914 -2.521505 -2.943021 -3.340531 -3.701762 -3.980785 -4.104805 -3.919001 -3.357165 -2.537452 -1.588743 -27.08958 1.110782 0.9188606 0.4652763 -7.0450112E-02 -0.6046974 -1.128322 -1.634576 -2.114784 -2.560173 -2.985370 -3.384611 -3.760232 -4.091752 -4.369710 -4.534767 -4.458599 -3.997418 -3.182298 -2.173307 -27.08958 0.3044610 0.1558315 -0.2537953 -0.7493262 -1.249770 -1.741638 -2.216976 -2.663503 -3.080525 -3.476601 -3.847286 -4.180316 -4.483677 -4.736438 -4.918322 -4.930057 -4.607939 -3.851641 -2.806726 -27.08958 -0.5956984 -0.6989496 -1.058979 -1.507391 -1.963689 -2.412667 -2.846698 -3.255332 -3.635697 -3.988073 -4.318956 -4.614416 -4.875662 -5.101441 -5.270969 -5.345689 -5.165398 -4.533355 -3.493425 -27.08958 -1.604614 -1.657746 -1.959182 -2.347146 -2.745709 -3.142115 -3.520592 -3.878305 -4.210047 -4.520532 -4.805291 -5.059242 -5.281945 -5.474232 -5.632282 -5.728078 -5.660320 -5.211290 -4.239154 -27.08958 -2.748156 -2.741758 -2.965523 -3.271936 -3.593786 -3.918208 -4.235727 -4.537229 -4.817802 -5.080337 -5.320209 -5.535336 -5.727129 -5.891544 -6.024130 -6.116268 -6.128392 -5.870923 -5.034880 -27.08958 -4.063651 -3.980730 -4.101070 -4.303762 -4.536024 -4.780354 -5.028204 -5.272478 -5.502588 -5.719474 -5.922403 -6.099183 -6.258680 -6.392307 -6.506248 -6.597636 -6.653661 -6.557744 -5.858020 -27.08958 -5.769488 -5.584009 -5.581207 -5.661334 -5.783644 -5.934892 -6.102774 -6.280947 -6.457942 -6.625424 -6.790855 -6.938789 -7.081014 -7.201685 -7.328881 -7.427880 -7.496853 -7.437712 -6.743411 -27.08958 -52.41130 -51.83061 -51.09270 -50.22443 -49.24631 -48.17379 -47.01863 -45.78998 -44.49514 -43.14007 -41.72974 -40.26834 -38.75949 -37.20630 -35.61151 -33.97754 -32.30653 -30.60041 -28.86091 -27.08958 3.766524 2.571370 2.382616 2.309317 2.183150 2.009081 1.786426 1.518838 1.226263 0.9256810 0.6259418 0.3566144 0.1325423 -3.3653308E-02 -0.1445363 -0.2104924 -0.2448625 -0.2605803 -0.2674931 -29.15287 4.583809 3.541403 3.215545 2.980952 2.728201 2.448737 2.149181 1.821771 1.492831 1.167207 0.8717549 0.6314127 0.4681143 0.3856586 0.3715630 0.4065149 0.4722716 0.5555032 0.6480947 -29.15287 5.043795 4.147925 3.669245 3.267628 2.876935 2.494176 2.111779 1.735478 1.374418 1.024990 0.7259969 0.5037741 0.3856112 0.3710594 0.4376255 0.5611584 0.7189407 0.8967650 1.086639 -29.15287 5.229962 4.456785 3.876594 3.348782 2.852047 2.381812 1.930432 1.507115 1.100942 0.7251886 0.4021125 0.1738450 7.3754400E-02 0.1063681 0.2419517 0.4475521 0.6945307 0.9657866 1.252531 -29.15287 5.218600 4.546567 3.905192 3.296215 2.724000 2.191151 1.693624 1.217185 0.7690639 0.3583500 -4.4740839E-03 -0.2658755 -0.3777299 -0.3253569 -0.1348414 0.1466079 0.4806827 0.8448091 1.228308 -29.15287 5.054812 4.465213 3.796832 3.140517 2.523536 1.952634 1.413210 0.8995194 0.4171268 -3.1671237E-02 -0.4321011 -0.7469246 -0.9046999 -0.8662737 -0.6420128 -0.2934845 0.1248073 0.5811062 1.061245 -29.15287 4.770799 4.252437 3.578935 2.903338 2.266182 1.663029 1.096259 0.5663729 5.5481888E-02 -0.4213609 -0.8551134 -1.219181 -1.445162 -1.453815 -1.223150 -0.8206373 -0.3222102 0.2251900 0.8017567 -29.15287 4.394763 3.936942 3.274597 2.597038 1.947114 1.327275 0.7493958 0.2038071 -0.3170913 -0.8111332 -1.269515 -1.673563 -1.971480 -2.060866 -1.865386 -1.430758 -0.8611376 -0.2251071 0.4472841 -29.15287 3.936791 3.536372 2.893068 2.219541 1.571102 0.9507117 0.3619100 -0.1875466 -0.7087451 -1.207789 -1.675178 -2.105757 -2.456954 -2.632836 -2.513265 -2.077651 -1.449733 -0.7291794 3.8059432E-02 -29.15287 3.402672 3.054050 2.436543 1.780100 1.141101 0.5229270 -6.2205378E-02 -0.6070948 -1.123600 -1.616536 -2.086070 -2.525084 -2.909135 -3.158742 -3.138154 -2.745419 -2.081530 -1.283960 -0.4238609 -29.15287 2.796873 2.496668 1.912294 1.276009 0.6519948 5.1765125E-02 -0.5244856 -1.060020 -1.564084 -2.051417 -2.509785 -2.945339 -3.333818 -3.637525 -3.714035 -3.411608 -2.749253 -1.888927 -0.9398372 -29.15287 2.116676 1.861982 1.314535 0.7092127 0.1116644 -0.4692748 -1.026201 -1.548705 -2.037833 -2.511434 -2.952937 -3.369110 -3.753880 -4.068957 -4.225438 -4.041310 -3.431467 -2.533483 -1.502482 -29.15287 1.362865 1.151942 0.6482538 7.7640787E-02 -0.4882091 -1.044367 -1.578745 -2.080117 -2.549101 -3.000799 -3.415809 -3.810196 -4.167974 -4.473055 -4.669515 -4.608039 -4.110780 -3.215315 -2.115646 -29.15287 0.5251918 0.3603054 -9.6136615E-02 -0.6265185 -1.158674 -1.682774 -2.185268 -2.656119 -3.095853 -3.516671 -3.905118 -4.260184 -4.582561 -4.860397 -5.064786 -5.092268 -4.755908 -3.923734 -2.780615 -29.15287 -0.4106949 -0.5276006 -0.9334216 -1.413003 -1.901680 -2.383473 -2.844242 -3.278352 -3.682269 -4.061287 -4.403506 -4.722018 -5.000575 -5.246023 -5.429453 -5.517673 -5.337051 -4.642351 -3.498936 -29.15287 -1.462980 -1.527674 -1.870375 -2.289019 -2.721582 -3.149115 -3.558999 -3.939822 -4.294946 -4.626430 -4.924579 -5.196749 -5.433039 -5.638448 -5.806273 -5.909209 -5.847099 -5.355431 -4.280252 -29.15287 -2.664025 -2.664840 -2.925885 -3.261339 -3.617585 -3.970124 -4.316013 -4.641253 -4.942943 -5.222780 -5.474018 -5.699041 -5.897789 -6.074592 -6.216498 -6.310701 -6.325336 -6.047287 -5.121574 -29.15287 -4.054618 -3.972760 -4.124071 -4.349572 -4.609331 -4.880044 -5.151441 -5.412507 -5.662662 -5.893500 -6.103789 -6.292204 -6.458198 -6.595803 -6.715878 -6.809273 -6.865017 -6.768323 -6.009367 -29.15287 -5.840997 -5.649929 -5.664776 -5.759228 -5.905775 -6.078972 -6.264541 -6.454034 -6.646226 -6.829947 -7.004528 -7.160977 -7.303444 -7.436710 -7.559323 -7.664210 -7.741399 -7.689878 -6.961422 -29.15287 -56.47953 -55.85970 -55.06561 -54.12841 -53.07148 -51.91215 -50.66346 -49.33548 -47.93621 -46.47219 -44.94880 -43.37063 -41.74159 -40.06506 -38.34400 -36.58102 -34.77846 -32.93838 -31.06262 -29.15287 3.997607 2.716030 2.596395 2.525975 2.405831 2.224525 1.999793 1.728217 1.416481 1.091071 0.7676868 0.4732437 0.2288847 4.7822010E-02 -7.2471090E-02 -0.1427032 -0.1787450 -0.1948508 -0.2013875 -31.24921 4.889987 3.771666 3.471844 3.232589 2.967151 2.681154 2.374004 2.035724 1.686078 1.337487 1.018948 0.7605645 0.5861146 0.4992594 0.4869850 0.5273001 0.5997768 0.6902254 0.7903510 -31.24921 5.394385 4.433121 3.950967 3.524088 3.115184 2.718035 2.324366 1.931547 1.546159 1.173959 0.8531308 0.6151686 0.4921331 0.4785549 0.5546281 0.6907198 0.8623030 1.054379 1.258891 -31.24921 5.604169 4.777411 4.166344 3.607396 3.088996 2.599438 2.129424 1.681394 1.254116 0.8524902 0.5082634 0.2652270 0.1627595 0.2018080 0.3529837 0.5784055 0.8461620 1.138797 1.447365 -31.24921 5.599814 4.879768 4.198104 3.557064 2.957927 2.399084 1.876325 1.373827 0.9046775 0.4678580 7.8777261E-02 -0.2006639 -0.3227565 -0.2638425 -5.4304421E-02 0.2529900 0.6144909 1.007030 1.419575 -31.24921 5.436933 4.804516 4.088936 3.397369 2.749020 2.147387 1.581613 1.043540 0.5379888 6.4658374E-02 -0.3645538 -0.7007761 -0.8786106 -0.8397056 -0.5946686 -0.2151566 0.2373077 0.7291487 1.245638 -31.24921 5.147696 4.589799 3.863518 3.152099 2.479448 1.844883 1.252695 0.6973583 0.1635387 -0.3376872 -0.7953800 -1.186395 -1.436281 -1.453435 -1.202820 -0.7643352 -0.2247326 0.3656065 0.9859639 -31.24921 4.757888 4.265463 3.548846 2.832285 2.146686 1.496804 0.8906870 0.3216875 -0.2251698 -0.7380395 -1.218592 -1.648952 -1.974237 -2.083138 -1.874532 -1.403433 -0.7853334 -9.8769903E-02 0.6249756 -31.24921 4.281937 3.850958 3.151868 2.440207 1.757432 1.105406 0.4899265 -8.5363984E-02 -0.6307259 -1.146437 -1.635983 -2.090415 -2.470541 -2.678637 -2.557213 -2.090001 -1.408175 -0.6294532 0.1968030 -31.24921 3.726983 3.351290 2.679144 1.984469 1.312495 0.6638181 4.7261368E-02 -0.5193605 -1.061060 -1.571437 -2.061403 -2.522249 -2.932748 -3.217803 -3.216482 -2.802895 -2.082497 -1.219377 -0.2924336 -31.24921 3.097809 2.773342 2.135853 1.464385 0.8067447 0.1735567 -0.4305571 -0.9883571 -1.518487 -2.022348 -2.501998 -2.955630 -3.369119 -3.705457 -3.813712 -3.508945 -2.792112 -1.859082 -0.8350285 -31.24921 2.393339 2.117235 1.517678 0.8760498 0.2456459 -0.3673877 -0.9518640 -1.495544 -2.011545 -2.502561 -2.963293 -3.396747 -3.801510 -4.150368 -4.338018 -4.169518 -3.514779 -2.538727 -1.424414 -31.24921 1.611057 1.380990 0.8278439 0.2237347 -0.3776419 -0.9628476 -1.524800 -2.048837 -2.543854 -3.011699 -3.445856 -3.854655 -4.239250 -4.567490 -4.795315 -4.758327 -4.231773 -3.257381 -2.066175 -31.24921 0.7436776 0.5617679 5.7326771E-02 -0.5031697 -1.069940 -1.624323 -2.154157 -2.651129 -3.114827 -3.549552 -3.955506 -4.330543 -4.673817 -4.978159 -5.202802 -5.255014 -4.905552 -3.998553 -2.755287 -31.24921 -0.2270436 -0.3579301 -0.8075238 -1.318654 -1.841533 -2.354121 -2.842845 -3.300998 -3.726751 -4.126692 -4.484892 -4.819630 -5.120317 -5.383064 -5.583366 -5.687457 -5.509931 -4.754112 -3.505107 -31.24921 -1.320032 -1.396158 -1.781686 -2.229574 -2.696685 -3.153398 -3.593724 -4.003025 -4.374235 -4.725888 -5.040327 -5.324808 -5.582855 -5.795422 -5.966205 -6.087810 -6.036386 -5.502585 -4.322206 -31.24921 -2.576048 -2.583933 -2.884669 -3.249968 -3.638160 -4.023436 -4.392248 -4.741612 -5.060460 -5.359373 -5.622644 -5.855881 -6.071753 -6.252466 -6.388996 -6.497149 -6.521778 -6.224599 -5.204684 -31.24921 -4.040122 -3.960442 -4.140535 -4.394962 -4.683538 -4.983328 -5.273293 -5.553094 -5.812353 -6.062275 -6.278936 -6.475525 -6.650292 -6.798717 -6.904187 -7.006439 -7.075086 -6.973623 -6.153946 -31.24921 -5.901797 -5.707151 -5.737106 -5.852991 -6.020855 -6.219323 -6.423808 -6.633287 -6.828842 -7.030887 -7.209664 -7.372466 -7.522476 -7.663191 -7.772850 -7.887000 -7.975899 -7.933748 -7.174120 -31.24921 -60.61663 -59.95713 -59.10564 -58.09798 -56.96054 -55.71258 -54.36846 -52.93920 -51.43352 -49.85850 -48.22001 -46.52299 -44.77167 -42.96970 -41.12026 -39.22618 -37.28992 -35.31372 -33.29955 -31.24921 4.221165 2.852161 2.803618 2.738650 2.617598 2.426281 2.206289 1.927885 1.605539 1.253235 0.9035487 0.5864427 0.3208212 0.1221530 -8.4244423E-03 -8.3568841E-02 -0.1215486 -0.1380634 -0.1443419 -33.37725 5.188638 3.994509 3.725757 3.474521 3.192223 2.898354 2.587686 2.246973 1.873414 1.501076 1.160170 0.8846847 0.6961791 0.6044084 0.5936800 0.6391787 0.7183549 0.8160971 0.9237673 -33.37725 5.740141 4.716855 4.224787 3.770855 3.338797 2.932891 2.531080 2.122998 1.711506 1.316675 0.9760956 0.7264451 0.5954652 0.5844907 0.6704975 0.8195096 1.005033 1.211581 1.430872 -33.37725 5.968050 5.091711 4.448069 3.855141 3.317006 2.809392 2.323730 1.850348 1.398744 0.9746875 0.6104652 0.3521946 0.2445886 0.2898389 0.4575476 0.7027661 0.9915117 1.305780 1.636404 -33.37725 5.973028 5.206707 4.481564 3.809377 3.185137 2.603804 2.052018 1.525264 1.032839 0.5703662 0.1593170 -0.1464628 -0.2841865 -0.2225915 4.4279862E-03 0.3366674 0.7255110 1.146755 1.588638 -33.37725 5.810409 5.135227 4.373254 3.649813 2.971370 2.336444 1.744599 1.182074 0.6528740 0.1589284 -0.2988432 -0.6626778 -0.8668176 -0.8316608 -0.5694678 -0.1603016 0.3260033 0.8537765 1.406975 -33.37725 5.517992 4.919924 4.144843 3.396741 2.686848 2.021358 1.402446 0.8224187 0.2684589 -0.2551591 -0.7384474 -1.155144 -1.435825 -1.465842 -1.201204 -0.7284824 -0.1481066 0.4856209 1.150169 -33.37725 5.115910 4.589516 3.818238 3.061198 2.341538 1.659898 1.026963 0.4347510 -0.1326507 -0.6672288 -1.167803 -1.624292 -1.981063 -2.106534 -1.890127 -1.381501 -0.7149388 2.2896791E-02 0.7985000 -33.37725 4.621395 4.160374 3.404306 2.655758 1.937866 1.253086 0.6136900 1.5703235E-02 -0.5550435 -1.087417 -1.597739 -2.073476 -2.487487 -2.719657 -2.608565 -2.110285 -1.374539 -0.5368686 0.3489102 -33.37725 4.045388 3.642656 2.915425 2.183883 1.476808 0.7998434 0.1571456 -0.4350549 -0.9997928 -1.528631 -2.034987 -2.517654 -2.953098 -3.269298 -3.297678 -2.868064 -2.092141 -1.162798 -0.1685425 -33.37725 3.393384 3.043989 2.352347 1.647372 0.9575337 0.2895125 -0.3376528 -0.9206857 -1.476138 -1.995256 -2.492768 -2.962607 -3.401837 -3.761907 -3.914121 -3.610641 -2.840523 -1.834320 -0.7349193 -33.37725 2.665233 2.366089 1.716453 1.040413 0.3748247 -0.2695904 -0.8781424 -1.447333 -1.986937 -2.491444 -2.969008 -3.420411 -3.847166 -4.221062 -4.447822 -4.300585 -3.602256 -2.547588 -1.349667 -33.37725 1.855371 1.605386 1.003867 0.3664750 -0.2675319 -0.8861275 -1.471731 -2.021757 -2.538247 -3.016394 -3.471696 -3.894627 -4.302814 -4.650635 -4.913753 -4.907217 -4.353549 -3.301575 -2.018500 -33.37725 0.9591308 0.7604016 0.2091599 -0.3837612 -0.9832357 -1.569183 -2.126223 -2.645946 -3.129876 -3.578205 -4.002272 -4.399716 -4.761580 -5.075709 -5.330997 -5.413613 -5.053134 -4.076478 -2.733261 -33.37725 -4.4035457E-02 -0.1895516 -0.6846038 -1.226090 -1.783027 -2.324728 -2.841620 -3.322930 -3.767416 -4.183325 -4.564875 -4.911800 -5.237108 -5.502913 -5.730364 -5.846600 -5.674665 -4.866314 -3.512250 -33.37725 -1.178024 -1.265449 -1.691019 -2.171755 -2.670495 -3.160650 -3.622807 -4.057077 -4.450903 -4.817573 -5.147014 -5.445803 -5.723185 -5.942441 -6.126013 -6.253920 -6.209347 -5.646603 -4.362529 -33.37725 -2.486670 -2.502272 -2.839019 -3.239049 -3.659944 -4.075434 -4.468501 -4.835483 -5.174746 -5.489702 -5.762965 -6.009062 -6.232241 -6.415754 -6.564599 -6.674830 -6.699227 -6.392539 -5.281770 -33.37725 -4.019727 -3.943830 -4.152103 -4.433671 -4.755254 -5.078846 -5.397137 -5.693875 -5.964488 -6.225952 -6.450638 -6.652322 -6.834905 -6.978925 -7.094160 -7.194332 -7.265166 -7.161831 -6.283909 -33.37725 -5.960910 -5.763710 -5.809534 -5.944328 -6.138709 -6.357025 -6.585224 -6.809355 -7.013653 -7.225327 -7.407387 -7.579659 -7.731219 -7.861346 -7.977055 -8.092204 -8.189138 -8.148482 -7.369318 -33.37725 -64.81963 -64.11994 -63.20986 -62.13051 -60.91066 -59.57233 -58.13097 -56.59856 -54.98480 -53.29662 -51.54107 -49.72323 -47.84765 -45.91824 -43.93842 -41.91119 -39.83922 -37.72486 -35.57022 -33.37725 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -1.740018 -1.669210 -1.596737 -1.522613 -1.446855 -1.369479 -1.290500 -1.209936 -1.127807 -1.044121 -0.9588939 -0.8721413 -0.7838790 -0.6941226 -0.6028836 -0.5101730 -0.4160210 -0.3204429 -0.2234533 -0.1250684 -0.7956956 -0.7773596 -0.7637632 -0.7653962 -0.7729985 -0.7845116 -0.7967473 -0.8062217 -0.8093717 -0.8171764 -0.8425899 -0.8995926 -0.9508307 -0.9989654 -1.040408 -1.094685 -1.161597 -1.231314 -1.299802 -1.268719 -0.8446379 -0.8237805 -0.8077056 -0.8061382 -0.8108826 -0.8196187 -0.8295925 -0.8373637 -0.8395715 -0.8459943 -0.8689665 -0.9264474 -0.9809221 -1.028780 -1.068756 -1.122011 -1.187219 -1.253682 -1.316701 -1.268719 -0.8964797 -0.8729478 -0.8542635 -0.8494712 -0.8512799 -0.8572327 -0.8649992 -0.8710506 -0.8722656 -0.8775304 -0.8983805 -0.9569901 -1.010708 -1.058480 -1.096821 -1.149557 -1.212873 -1.275840 -1.333262 -1.268719 -0.9511156 -0.9246610 -0.9031339 -0.8949350 -0.8935043 -0.8965116 -0.9018149 -0.9057454 -0.9055916 -0.9094434 -0.9282959 -0.9891540 -1.042206 -1.088566 -1.125677 -1.177619 -1.238901 -1.298155 -1.349901 -1.268719 -1.009909 -0.9804582 -0.9560304 -0.9443398 -0.9395573 -0.9396448 -0.9425427 -0.9444259 -0.9429896 -0.9455001 -0.9624868 -1.020772 -1.073543 -1.118645 -1.154949 -1.205795 -1.264864 -1.319933 -1.365777 -1.268719 -1.071796 -1.039217 -1.011766 -0.9965183 -0.9882058 -0.9852401 -0.9854500 -0.9851426 -0.9820815 -0.9829494 -0.9979832 -1.054417 -1.105206 -1.148293 -1.184238 -1.233290 -1.289819 -1.340085 -1.379831 -1.268719 -1.136069 -1.100121 -1.069479 -1.050686 -1.038759 -1.032616 -1.029845 -1.026975 -1.021672 -1.020319 -1.033168 -1.088421 -1.137838 -1.179268 -1.214440 -1.261306 -1.314853 -1.359965 -1.393303 -1.268719 -1.206418 -1.166703 -1.132441 -1.109890 -1.094169 -1.084641 -1.078729 -1.073206 -1.065407 -1.061732 -1.072024 -1.124558 -1.171676 -1.212105 -1.245909 -1.290091 -1.340038 -1.379578 -1.406108 -1.268719 -1.282649 -1.238675 -1.200324 -1.173724 -1.153813 -1.140354 -1.130864 -1.122148 -1.111291 -1.104735 -1.111969 -1.162586 -1.207717 -1.247246 -1.278813 -1.320299 -1.365632 -1.399217 -1.418446 -1.268719 -1.366883 -1.318106 -1.275182 -1.244033 -1.219694 -1.201884 -1.188465 -1.176135 -1.161900 -1.151961 -1.155730 -1.203079 -1.246847 -1.284780 -1.313492 -1.351462 -1.391338 -1.418462 -1.429784 -1.268719 -1.460354 -1.406049 -1.357902 -1.321528 -1.292321 -1.269709 -1.251924 -1.235345 -1.217192 -1.203101 -1.202902 -1.247395 -1.289173 -1.324553 -1.350369 -1.383227 -1.416137 -1.436563 -1.439223 -1.268719 -1.566207 -1.505808 -1.451568 -1.409155 -1.374324 -1.346234 -1.323490 -1.302143 -1.279620 -1.260754 -1.255971 -1.297505 -1.336157 -1.368194 -1.390205 -1.416595 -1.441888 -1.454455 -1.447659 -1.268719 -1.689638 -1.622157 -1.560713 -1.511417 -1.469935 -1.435352 -1.406635 -1.379639 -1.351939 -1.327458 -1.317222 -1.354521 -1.388778 -1.417393 -1.433079 -1.451181 -1.468486 -1.471818 -1.454587 -1.268719 -1.833275 -1.758082 -1.688344 -1.631217 -1.582006 -1.539731 -1.503821 -1.470103 -1.436155 -1.405146 -1.388398 -1.420302 -1.450286 -1.471934 -1.479725 -1.487899 -1.495873 -1.488390 -1.459564 -1.268719 -2.005632 -1.921515 -1.842143 -1.776105 -1.718275 -1.666797 -1.622138 -1.580052 -1.538276 -1.499528 -1.475092 -1.500913 -1.522846 -1.535364 -1.536912 -1.530655 -1.526981 -1.506966 -1.465759 -1.268719 -2.219325 -2.124598 -2.033779 -1.957377 -1.889256 -1.826858 -1.771132 -1.718217 -1.666064 -1.617478 -1.583197 -1.598827 -1.610805 -1.614108 -1.606038 -1.582715 -1.563313 -1.528669 -1.474137 -1.268719 -2.496013 -2.390347 -2.287795 -2.194125 -2.113602 -2.036800 -1.967115 -1.900166 -1.834380 -1.769271 -1.722413 -1.726350 -1.725338 -1.715533 -1.692667 -1.654887 -1.608700 -1.557639 -1.488978 -1.268719 -2.881601 -2.768467 -2.657699 -2.548267 -2.440094 -2.344510 -2.255704 -2.171655 -2.087663 -2.003683 -1.924459 -1.909457 -1.888320 -1.856788 -1.812623 -1.753729 -1.681435 -1.607195 -1.496507 -1.268719 -3.595244 -3.460763 -3.323500 -3.181402 -3.051029 -2.919284 -2.787164 -2.652697 -2.535439 -2.420154 -2.308367 -2.244429 -2.172156 -2.098520 -2.024972 -1.941195 -1.847725 -1.676428 -1.507981 -1.268719 -4.807698 -4.670463 -4.527156 -4.377888 -4.222779 -4.061938 -3.895463 -3.723468 -3.546040 -3.363326 -3.175438 -2.982467 -2.784512 -2.581722 -2.374439 -2.161988 -1.945243 -1.724068 -1.498784 -1.268719 -0.3173012 -0.3423458 -0.3780478 -0.4195499 -0.4651516 -0.5281332 -0.5907467 -0.6513095 -0.7110225 -0.7613858 -0.8140761 -0.8868061 -0.9560029 -1.022547 -1.084603 -1.143416 -1.214377 -1.286137 -1.359047 -2.506804 -0.3743362 -0.3917457 -0.4203629 -0.4565722 -0.4978264 -0.5540438 -0.6113524 -0.6713122 -0.7390440 -0.7957591 -0.8575241 -0.9361156 -1.009866 -1.078264 -1.139639 -1.195226 -1.261823 -1.326511 -1.388521 -2.506804 -0.4398974 -0.4494493 -0.4711331 -0.5016140 -0.5382211 -0.5879477 -0.6400086 -0.6984202 -0.7717258 -0.8344740 -0.9061978 -0.9896119 -1.066090 -1.135340 -1.196120 -1.249229 -1.311728 -1.370120 -1.421415 -2.506804 -0.5137209 -0.5160058 -0.5306134 -0.5547397 -0.5860504 -0.6293970 -0.6760409 -0.7332270 -0.8094416 -0.8818387 -0.9599321 -1.046513 -1.125107 -1.195266 -1.255652 -1.307535 -1.366431 -1.419767 -1.460756 -2.506804 -0.5962157 -0.5915467 -0.5990209 -0.6162193 -0.6416005 -0.6785007 -0.7191552 -0.7737853 -0.8555244 -0.9351122 -1.018802 -1.107080 -1.186769 -1.257873 -1.317866 -1.369687 -1.426092 -1.475236 -1.506550 -2.506804 -0.6883075 -0.6765509 -0.6768944 -0.6870046 -0.7057927 -0.7357936 -0.7702007 -0.8223634 -0.9094662 -0.9940912 -1.080482 -1.169471 -1.250052 -1.322404 -1.382664 -1.434987 -1.490127 -1.535762 -1.558496 -2.506804 -0.7900893 -0.7716058 -0.7649461 -0.7679490 -0.7799226 -0.8030454 -0.8311881 -0.8802159 -0.9696786 -1.057018 -1.143733 -1.232607 -1.313722 -1.386464 -1.447809 -1.500822 -1.555254 -1.598223 -1.612698 -2.506804 -0.9009659 -0.8756279 -0.8620970 -0.8585498 -0.8638530 -0.8799052 -0.9015887 -0.9466109 -1.036535 -1.123132 -1.209002 -1.296208 -1.377899 -1.450543 -1.513657 -1.566769 -1.621928 -1.662129 -1.668833 -2.506804 -1.021504 -0.9892913 -0.9688005 -0.9588568 -0.9574918 -0.9664021 -0.9814978 -1.021316 -1.108966 -1.193120 -1.276003 -1.361524 -1.442045 -1.514724 -1.579357 -1.633701 -1.689389 -1.726011 -1.725202 -2.506804 -1.153211 -1.113878 -1.086347 -1.069730 -1.061447 -1.062899 -1.070839 -1.104223 -1.187006 -1.267143 -1.346712 -1.429136 -1.506664 -1.580013 -1.644611 -1.700105 -1.757055 -1.788611 -1.779828 -2.506804 -1.295069 -1.248511 -1.213942 -1.190413 -1.175109 -1.168708 -1.169347 -1.195744 -1.271710 -1.347534 -1.423444 -1.499882 -1.574863 -1.647724 -1.712571 -1.769439 -1.826282 -1.852347 -1.835627 -2.506804 -1.449242 -1.394927 -1.352802 -1.321719 -1.298962 -1.284417 -1.277339 -1.296348 -1.365965 -1.436667 -1.505778 -1.576483 -1.648200 -1.718402 -1.784883 -1.843038 -1.896936 -1.917234 -1.891144 -2.506804 -1.623141 -1.559468 -1.508936 -1.469334 -1.438350 -1.415087 -1.399365 -1.410948 -1.472582 -1.534272 -1.596932 -1.662213 -1.727886 -1.797504 -1.863118 -1.921124 -1.968291 -1.982442 -1.944711 -2.506804 -1.822494 -1.747637 -1.687059 -1.638160 -1.597931 -1.565184 -1.539575 -1.541251 -1.592095 -1.646257 -1.701884 -1.758810 -1.820712 -1.886366 -1.951042 -2.002639 -2.041158 -2.046582 -1.993345 -2.506804 -2.057189 -1.969279 -1.895735 -1.835595 -1.784219 -1.740324 -1.703163 -1.694186 -1.735680 -1.779114 -1.826009 -1.877922 -1.932223 -1.993181 -2.050490 -2.090907 -2.120250 -2.111622 -2.038329 -2.506804 -2.349028 -2.244640 -2.155395 -2.079618 -2.014718 -1.956925 -1.905849 -1.883073 -1.914182 -1.948448 -1.986303 -2.028389 -2.073796 -2.122538 -2.165669 -2.193536 -2.209407 -2.180530 -2.080385 -2.506804 -2.739397 -2.614271 -2.504657 -2.409053 -2.324284 -2.249304 -2.179715 -2.141336 -2.156585 -2.176376 -2.200779 -2.228762 -2.256373 -2.287939 -2.318557 -2.330421 -2.317725 -2.258997 -2.126084 -2.506804 -3.292641 -3.143603 -3.008941 -2.885367 -2.772997 -2.671616 -2.577974 -2.516168 -2.510404 -2.508686 -2.510044 -2.518134 -2.527546 -2.538502 -2.543327 -2.523466 -2.463642 -2.359936 -2.189583 -2.506804 -4.269985 -4.088015 -3.919365 -3.758485 -3.604844 -3.454515 -3.313537 -3.210883 -3.175729 -3.142594 -3.107216 -3.069935 -3.033510 -2.991903 -2.932367 -2.842505 -2.708331 -2.536362 -2.325234 -2.506804 -8.316067 -8.111013 -7.892805 -7.661813 -7.418384 -7.162858 -6.895586 -6.616974 -6.327317 -6.027030 -5.716424 -5.395820 -5.065582 -4.725929 -4.377237 -4.019726 -3.653683 -3.279375 -2.896981 -2.506804 0.1498654 7.6763928E-02 -2.1810386E-02 -0.1282645 -0.2284923 -0.3315852 -0.4202335 -0.5020676 -0.5795994 -0.6519114 -0.7158715 -0.7924034 -0.8691213 -0.9436616 -1.018026 -1.086705 -1.157390 -1.225967 -1.295979 -3.835547 0.1072459 4.9930472E-02 -3.2602880E-02 -0.1265721 -0.2181922 -0.3117825 -0.4149481 -0.5118356 -0.6025889 -0.6872973 -0.7612511 -0.8481818 -0.9319959 -1.011290 -1.084910 -1.147615 -1.208175 -1.261957 -1.312409 -3.835547 4.4256032E-02 5.0043454E-04 -6.7056462E-02 -0.1487567 -0.2322016 -0.3196723 -0.4314131 -0.5382785 -0.6400496 -0.7340946 -0.8205276 -0.9173156 -1.008087 -1.092854 -1.166449 -1.225101 -1.277308 -1.317944 -1.350547 -3.835547 -3.5838470E-02 -6.7478187E-02 -0.1210497 -0.1900853 -0.2642138 -0.3440109 -0.4610594 -0.5760533 -0.6859636 -0.7883372 -0.8876659 -0.9928937 -1.091235 -1.180799 -1.255424 -1.311692 -1.357249 -1.386773 -1.402871 -3.835547 -0.1315883 -0.1518225 -0.1923732 -0.2483528 -0.3119904 -0.3820692 -0.5027790 -0.6229368 -0.7380474 -0.8497784 -0.9595715 -1.071220 -1.176684 -1.269821 -1.345565 -1.400530 -1.440790 -1.460581 -1.461409 -3.835547 -0.2432528 -0.2524779 -0.2811970 -0.3247091 -0.3770531 -0.4365974 -0.5586542 -0.6812143 -0.8005341 -0.9200839 -1.037221 -1.155054 -1.265657 -1.362253 -1.439970 -1.495024 -1.532646 -1.545054 -1.532471 -3.835547 -0.3705104 -0.3688169 -0.3863589 -0.4185686 -0.4594981 -0.5082974 -0.6287562 -0.7522867 -0.8759102 -0.9998290 -1.121184 -1.243636 -1.357529 -1.457498 -1.538182 -1.594976 -1.632302 -1.640867 -1.617031 -3.835547 -0.5126951 -0.5000153 -0.5067661 -0.5286376 -0.5583280 -0.5960768 -0.7137597 -0.8383800 -0.9639218 -1.087800 -1.211241 -1.334031 -1.449340 -1.551713 -1.635378 -1.695194 -1.733548 -1.742281 -1.707873 -3.835547 -0.6703274 -0.6468632 -0.6433519 -0.6552446 -0.6745060 -0.7013569 -0.8170035 -0.9403157 -1.063302 -1.185935 -1.306974 -1.427493 -1.542439 -1.645708 -1.731335 -1.795645 -1.837139 -1.848656 -1.805865 -3.835547 -0.8476174 -0.8134038 -0.7994256 -0.8013430 -0.8107489 -0.8271956 -0.9386504 -1.056334 -1.174755 -1.292626 -1.408480 -1.524584 -1.636302 -1.738319 -1.826131 -1.895268 -1.940613 -1.956149 -1.906478 -3.835547 -1.045243 -0.9999779 -0.9749658 -0.9669030 -0.9666744 -0.9731848 -1.076647 -1.186389 -1.297120 -1.407564 -1.517131 -1.626422 -1.732093 -1.830130 -1.919796 -1.992609 -2.044203 -2.063689 -2.007993 -3.835547 -1.261014 -1.204910 -1.168550 -1.150177 -1.140327 -1.137073 -1.230895 -1.330068 -1.430800 -1.533206 -1.634443 -1.734010 -1.831000 -1.926083 -2.016563 -2.092307 -2.153773 -2.173357 -2.113017 -3.835547 -1.498670 -1.431141 -1.382843 -1.353058 -1.332878 -1.319580 -1.401495 -1.489464 -1.579632 -1.670659 -1.760175 -1.848008 -1.937797 -2.028429 -2.116124 -2.196121 -2.267774 -2.285990 -2.220982 -3.835547 -1.764749 -1.684334 -1.622734 -1.580343 -1.548368 -1.523963 -1.594349 -1.669505 -1.744256 -1.820051 -1.895897 -1.975035 -2.056991 -2.140620 -2.225656 -2.312633 -2.385482 -2.401512 -2.329880 -3.835547 -2.073261 -1.977499 -1.900588 -1.843732 -1.797479 -1.760022 -1.813160 -1.870136 -1.926672 -1.988911 -2.053925 -2.124115 -2.194583 -2.270282 -2.354397 -2.442244 -2.508678 -2.523970 -2.437178 -3.835547 -2.432392 -2.316954 -2.220721 -2.146670 -2.083794 -2.030292 -2.065504 -2.105759 -2.148026 -2.197453 -2.249600 -2.304881 -2.364836 -2.435264 -2.512449 -2.586090 -2.644155 -2.649787 -2.537354 -3.835547 -2.900893 -2.758061 -2.635069 -2.537973 -2.452745 -2.377305 -2.396056 -2.417987 -2.441414 -2.469601 -2.506094 -2.549420 -2.597817 -2.650864 -2.707800 -2.766877 -2.813990 -2.791952 -2.635090 -3.835547 -3.575739 -3.396948 -3.235764 -3.103963 -2.986495 -2.880338 -2.871616 -2.871071 -2.872236 -2.875811 -2.890519 -2.905546 -2.929340 -2.958601 -2.998314 -3.035014 -3.044839 -2.969713 -2.745402 -3.835547 -4.767932 -4.543530 -4.324227 -4.135075 -3.959338 -3.797346 -3.743759 -3.703475 -3.666703 -3.630217 -3.603928 -3.582523 -3.569481 -3.558166 -3.544579 -3.514566 -3.424923 -3.240886 -2.926665 -3.835547 -12.20372 -11.92947 -11.63238 -11.31330 -10.97300 -10.61234 -10.23213 -9.833250 -9.416419 -8.982460 -8.532002 -8.065803 -7.584402 -7.088464 -6.578495 -6.055039 -5.518823 -4.969557 -4.408422 -3.835547 0.5790781 0.4487855 0.2865846 0.1082082 -6.7203842E-02 -0.1324417 -0.2280766 -0.3259601 -0.4239269 -0.5202525 -0.6075380 -0.6927285 -0.7772211 -0.8547632 -0.9279898 -1.000337 -1.069080 -1.132319 -1.192933 -5.247004 0.5689939 0.4622022 0.3234386 0.1689265 1.1494129E-02 -8.0653287E-02 -0.1987900 -0.3183005 -0.4373933 -0.5510632 -0.6519499 -0.7498896 -0.8406337 -0.9201958 -0.9895244 -1.051877 -1.101873 -1.139391 -1.167956 -5.247004 0.5225586 0.4376257 0.3209995 0.1879594 4.9241081E-02 -7.1712039E-02 -0.2077989 -0.3458435 -0.4820712 -0.6089573 -0.7256636 -0.8359870 -0.9345339 -1.018837 -1.088665 -1.143121 -1.177581 -1.192222 -1.191489 -5.247004 0.4444739 0.3789803 0.2827981 0.1693580 4.8018482E-02 -9.0812288E-02 -0.2421602 -0.3947594 -0.5422173 -0.6814651 -0.8129503 -0.9347310 -1.042575 -1.133371 -1.207700 -1.257046 -1.279315 -1.274241 -1.246727 -5.247004 0.3393328 0.2911569 0.2134386 0.1188344 1.4763509E-02 -0.1371591 -0.2990072 -0.4590694 -0.6132751 -0.7644547 -0.9063308 -1.037795 -1.156322 -1.255244 -1.335724 -1.382942 -1.396202 -1.374482 -1.322803 -5.247004 0.2097176 0.1766015 0.1151271 3.7502587E-02 -5.0053671E-02 -0.2093358 -0.3761916 -0.5378309 -0.6978052 -0.8539764 -1.003181 -1.143134 -1.270256 -1.380852 -1.466631 -1.514260 -1.521860 -1.486635 -1.413471 -5.247004 5.7458013E-02 3.7966933E-02 -9.0735285E-03 -7.1830772E-02 -0.1440603 -0.3051504 -0.4705968 -0.6342287 -0.7949881 -0.9530504 -1.105909 -1.252758 -1.387378 -1.509080 -1.600978 -1.652554 -1.658988 -1.614872 -1.524330 -5.247004 -0.1168918 -0.1227170 -0.1562575 -0.2051785 -0.2630275 -0.4200460 -0.5838499 -0.7454819 -0.9045835 -1.061615 -1.216344 -1.365197 -1.508112 -1.636649 -1.735247 -1.793075 -1.803030 -1.755766 -1.652095 -5.247004 -0.3119571 -0.3038862 -0.3236933 -0.3591268 -0.4031457 -0.5562423 -0.7136387 -0.8704187 -1.025910 -1.180783 -1.333484 -1.483293 -1.629695 -1.760256 -1.864155 -1.929549 -1.946147 -1.899884 -1.787242 -5.247004 -0.5292774 -0.5073998 -0.5132213 -0.5359516 -0.5671740 -0.7106690 -0.8607351 -1.010551 -1.160972 -1.310779 -1.459922 -1.609319 -1.752745 -1.882146 -1.989323 -2.063053 -2.088863 -2.050773 -1.931794 -5.247004 -0.7683257 -0.7319251 -0.7231514 -0.7328923 -0.7517150 -0.8855186 -1.026314 -1.167838 -1.309631 -1.452688 -1.597799 -1.741442 -1.877267 -2.002154 -2.109829 -2.190993 -2.227259 -2.203528 -2.080305 -5.247004 -1.032037 -0.9812221 -0.9579746 -0.9540824 -0.9603415 -1.082460 -1.211801 -1.341627 -1.474129 -1.609839 -1.746151 -1.878821 -2.005399 -2.122542 -2.229606 -2.315182 -2.362873 -2.355003 -2.230767 -5.247004 -1.323627 -1.258007 -1.219766 -1.201727 -1.194888 -1.302374 -1.417596 -1.535978 -1.658932 -1.782017 -1.903946 -2.023916 -2.138812 -2.248977 -2.351462 -2.439557 -2.500911 -2.510021 -2.387966 -5.247004 -1.648167 -1.566639 -1.512277 -1.479339 -1.458131 -1.550061 -1.652048 -1.756651 -1.862002 -1.969224 -2.073611 -2.178008 -2.283746 -2.384892 -2.480767 -2.569412 -2.651133 -2.666910 -2.549063 -5.247004 -2.024038 -1.924610 -1.852298 -1.802213 -1.764566 -1.837056 -1.917847 -2.001997 -2.086622 -2.172984 -2.260697 -2.354508 -2.446539 -2.536976 -2.623728 -2.716329 -2.807462 -2.827765 -2.712937 -5.247004 -2.464530 -2.342905 -2.249539 -2.178863 -2.121317 -2.166682 -2.220886 -2.277826 -2.344739 -2.416214 -2.488537 -2.562708 -2.640573 -2.718051 -2.800662 -2.893151 -2.975982 -3.004991 -2.877926 -5.247004 -3.005700 -2.852026 -2.728637 -2.631881 -2.549187 -2.570869 -2.602850 -2.636277 -2.679966 -2.726279 -2.777908 -2.831747 -2.894100 -2.963946 -3.032975 -3.104055 -3.179110 -3.200272 -3.040635 -5.247004 -3.793299 -3.593075 -3.424556 -3.287177 -3.167585 -3.151644 -3.145852 -3.146942 -3.159298 -3.179480 -3.206128 -3.232956 -3.270128 -3.309371 -3.353468 -3.411157 -3.464365 -3.448899 -3.208846 -5.247004 -5.183207 -4.915492 -4.671891 -4.460348 -4.270519 -4.193302 -4.132224 -4.077346 -4.039460 -4.007304 -3.988889 -3.974401 -3.969293 -3.973079 -3.983293 -3.991728 -3.971524 -3.828869 -3.447958 -5.247004 -16.41989 -16.07507 -15.69522 -15.28189 -14.83665 -14.36113 -13.85695 -13.32554 -12.76832 -12.18663 -11.58164 -10.95447 -10.30616 -9.637654 -8.949813 -8.243467 -7.519357 -6.778149 -6.020502 -5.247004 0.9775064 0.7885991 0.5578188 0.3063318 0.1569741 7.3389910E-02 -2.4299644E-02 -0.1428397 -0.2632826 -0.3790003 -0.4919493 -0.5972367 -0.6939421 -0.7804737 -0.8567559 -0.9253960 -0.9929595 -1.052689 -1.105870 -6.733509 1.012856 0.8543164 0.6583290 0.4417521 0.2848676 0.1710646 3.6232430E-02 -0.1110193 -0.2555695 -0.3972344 -0.5308378 -0.6479770 -0.7518220 -0.8359095 -0.9017710 -0.9520977 -0.9911370 -1.012634 -1.019555 -6.733509 0.9935233 0.8636715 0.6983257 0.5134501 0.3510430 0.2004907 3.4857970E-02 -0.1351552 -0.3033592 -0.4688640 -0.6206939 -0.7520602 -0.8650484 -0.9510542 -1.012049 -1.049331 -1.063600 -1.050629 -1.014932 -6.733509 0.9266366 0.8229979 0.6846106 0.5292707 0.3610602 0.1819074 -4.1782404E-03 -0.1917051 -0.3817006 -0.5656071 -0.7310075 -0.8794370 -1.002595 -1.095421 -1.156365 -1.187188 -1.181478 -1.137995 -1.062991 -6.733509 0.8192345 0.7379596 0.6218644 0.4915507 0.3206684 0.1243453 -7.3303901E-02 -0.2758974 -0.4797329 -0.6733442 -0.8513921 -1.013247 -1.148458 -1.252269 -1.319248 -1.349447 -1.329365 -1.259992 -1.149072 -6.733509 0.6763146 0.6146559 0.5178807 0.4079196 0.2394000 3.5485785E-02 -0.1730379 -0.3841601 -0.5919752 -0.7880476 -0.9764592 -1.146251 -1.293724 -1.410884 -1.489965 -1.522570 -1.494078 -1.403732 -1.260562 -6.733509 0.5016022 0.4587482 0.3802479 0.2882298 0.1245208 -8.5096501E-02 -0.2984076 -0.5100721 -0.7135087 -0.9136796 -1.103150 -1.278905 -1.436489 -1.566377 -1.661927 -1.701284 -1.670742 -1.565963 -1.395108 -6.733509 0.2976971 0.2723443 0.2114146 0.1354974 -2.3353921E-02 -0.2335218 -0.4427334 -0.6464584 -0.8487636 -1.046428 -1.234607 -1.413436 -1.578506 -1.720721 -1.830344 -1.880359 -1.854119 -1.742018 -1.549374 -6.733509 6.6385135E-02 5.6690335E-02 1.2006278E-02 -4.9276941E-02 -0.1996571 -0.4019277 -0.5999509 -0.7986788 -0.9946496 -1.186388 -1.373080 -1.551749 -1.720131 -1.874045 -1.993307 -2.056830 -2.041537 -1.930687 -1.723798 -6.733509 -0.1888852 -0.1834894 -0.2126848 -0.2592776 -0.3962753 -0.5857815 -0.7760742 -0.9645444 -1.150902 -1.336868 -1.518928 -1.696039 -1.866936 -2.023850 -2.149935 -2.226527 -2.227793 -2.127138 -1.914440 -6.733509 -0.4675094 -0.4458358 -0.4590324 -0.4900192 -0.6139187 -0.7917835 -0.9678417 -1.144842 -1.322706 -1.499186 -1.675571 -1.849065 -2.016731 -2.170131 -2.299643 -2.386267 -2.405932 -2.322748 -2.111936 -6.733509 -0.7761989 -0.7372087 -0.7337167 -0.7491643 -0.8558347 -1.016838 -1.179542 -1.344972 -1.510614 -1.677790 -1.845883 -2.010953 -2.169704 -2.316532 -2.444179 -2.537884 -2.575170 -2.519686 -2.313652 -6.733509 -1.116706 -1.058456 -1.036646 -1.035757 -1.125163 -1.269857 -1.415025 -1.566403 -1.720365 -1.876231 -2.030438 -2.181257 -2.328029 -2.465838 -2.588197 -2.685058 -2.736895 -2.715800 -2.520308 -6.733509 -1.497753 -1.419294 -1.377791 -1.359293 -1.428771 -1.553192 -1.682058 -1.817667 -1.954399 -2.093560 -2.229234 -2.363872 -2.495712 -2.622339 -2.736918 -2.833519 -2.898511 -2.909934 -2.729238 -6.733509 -1.931858 -1.830834 -1.766778 -1.728682 -1.779016 -1.881098 -1.987631 -2.099742 -2.213636 -2.332050 -2.449168 -2.564639 -2.680656 -2.794031 -2.898659 -2.990401 -3.079724 -3.107845 -2.945323 -6.733509 -2.442153 -2.314766 -2.224479 -2.163327 -2.186718 -2.258428 -2.336665 -2.421487 -2.511139 -2.606145 -2.704483 -2.800412 -2.895437 -2.993331 -3.084418 -3.180960 -3.276328 -3.312454 -3.166223 -6.733509 -3.069514 -2.905026 -2.780019 -2.688927 -2.679728 -2.718099 -2.765508 -2.820888 -2.881882 -2.951710 -3.024735 -3.096778 -3.167561 -3.246490 -3.336404 -3.421983 -3.503400 -3.554648 -3.394886 -6.733509 -3.956340 -3.735981 -3.556113 -3.419445 -3.367999 -3.362821 -3.370210 -3.387194 -3.406914 -3.438630 -3.481104 -3.525925 -3.572679 -3.625631 -3.687173 -3.747296 -3.825414 -3.857716 -3.630912 -6.733509 -5.527146 -5.219203 -4.939331 -4.715272 -4.585011 -4.507197 -4.439845 -4.389455 -4.351367 -4.323752 -4.310504 -4.304178 -4.308822 -4.319682 -4.346913 -4.384599 -4.413518 -4.338857 -3.931360 -6.733509 -20.92498 -20.50825 -20.04181 -19.52830 -18.97052 -18.37119 -17.73287 -17.05829 -16.34861 -15.60687 -14.83452 -14.03322 -13.20442 -12.34952 -11.46973 -10.56617 -9.639880 -8.691771 -7.722713 -6.733509 1.357869 1.101505 0.7963260 0.4867709 0.3922830 0.2929079 0.1840556 5.0338186E-02 -8.8576846E-02 -0.2298119 -0.3644831 -0.4897494 -0.6070834 -0.7057261 -0.7900389 -0.8609724 -0.9237177 -0.9805594 -1.028238 -8.288466 1.439570 1.223241 0.9645386 0.6954316 0.5677478 0.4316851 0.2791156 0.1095957 -6.3926637E-02 -0.2358331 -0.3932817 -0.5376534 -0.6600080 -0.7545221 -0.8211743 -0.8638389 -0.8877907 -0.8934594 -0.8809252 -8.288466 1.449674 1.270330 1.052822 0.8202957 0.6573309 0.4800111 0.2880881 8.6028762E-02 -0.1190663 -0.3146544 -0.4981920 -0.6629945 -0.7936540 -0.8887905 -0.9446369 -0.9645258 -0.9550518 -0.9137905 -0.8449880 -8.288466 1.399429 1.253122 1.070583 0.8720983 0.6745179 0.4641732 0.2440473 1.5297467E-02 -0.2110807 -0.4291883 -0.6368488 -0.8185792 -0.9630942 -1.064618 -1.118119 -1.122955 -1.086435 -1.002811 -0.8810023 -8.288466 1.296232 1.178436 1.023980 0.8533921 0.6296241 0.3966815 0.1563554 -8.7635510E-02 -0.3269509 -0.5633475 -0.7880507 -0.9824142 -1.144093 -1.257006 -1.317002 -1.318231 -1.260835 -1.140382 -0.9691040 -8.288466 1.144606 1.052532 0.9220504 0.7735780 0.5340020 0.2871359 3.6105614E-02 -0.2134246 -0.4644624 -0.7103903 -0.9392928 -1.146824 -1.321167 -1.450473 -1.523725 -1.531258 -1.461276 -1.310390 -1.093919 -8.288466 0.9522029 0.8828222 0.7738207 0.6439806 0.3955388 0.1446626 -0.1074153 -0.3630187 -0.6184469 -0.8637559 -1.093814 -1.307983 -1.492101 -1.638423 -1.728036 -1.751356 -1.678202 -1.504869 -1.248405 -8.288466 0.7250285 0.6755791 0.5861611 0.4720915 0.2240977 -2.4066931E-02 -0.2772770 -0.5315806 -0.7819659 -1.020767 -1.251913 -1.465470 -1.658598 -1.819351 -1.930963 -1.973294 -1.907877 -1.722672 -1.433638 -8.288466 0.4658376 0.4355702 0.3647567 0.2666338 2.3426425E-02 -0.2208188 -0.4684965 -0.7135384 -0.9514744 -1.185996 -1.410134 -1.623419 -1.821794 -1.992074 -2.126363 -2.189016 -2.140803 -1.956176 -1.643970 -8.288466 0.1740732 0.1622318 0.1091410 2.6950248E-02 -0.2070540 -0.4406715 -0.6742017 -0.9055083 -1.134995 -1.357376 -1.573616 -1.785966 -1.983718 -2.162651 -2.310465 -2.391783 -2.365838 -2.193267 -1.868387 -8.288466 -0.1480246 -0.1420067 -0.1779009 -0.2444815 -0.4625435 -0.6768280 -0.8960845 -1.114078 -1.329419 -1.540473 -1.749763 -1.954127 -2.149133 -2.332146 -2.484934 -2.582796 -2.583308 -2.434624 -2.110640 -8.288466 -0.5010128 -0.4753105 -0.4925074 -0.5419903 -0.7396177 -0.9369633 -1.137150 -1.337300 -1.540522 -1.742379 -1.939779 -2.132994 -2.323595 -2.500948 -2.654058 -2.762554 -2.790184 -2.676648 -2.368505 -8.288466 -0.8914871 -0.8434694 -0.8396823 -0.8707834 -1.045673 -1.221079 -1.400829 -1.586151 -1.776038 -1.963599 -2.147046 -2.328087 -2.505065 -2.671812 -2.819250 -2.931885 -2.981242 -2.910779 -2.624939 -8.288466 -1.326167 -1.252922 -1.225307 -1.235489 -1.385817 -1.539736 -1.702599 -1.867808 -2.037684 -2.208005 -2.374788 -2.538244 -2.696901 -2.849076 -2.986930 -3.099648 -3.164520 -3.145869 -2.889141 -8.288466 -1.822414 -1.721939 -1.667855 -1.655055 -1.780903 -1.908659 -2.046057 -2.186349 -2.331703 -2.479538 -2.623965 -2.767856 -2.906096 -3.040562 -3.166449 -3.272973 -3.350794 -3.376545 -3.152897 -8.288466 -2.404524 -2.274443 -2.189687 -2.148477 -2.241107 -2.335871 -2.441293 -2.552021 -2.666231 -2.787184 -2.906326 -3.029075 -3.145825 -3.258152 -3.368998 -3.467629 -3.572371 -3.613769 -3.426321 -8.288466 -3.116773 -2.946033 -2.823278 -2.744047 -2.795009 -2.850538 -2.916372 -2.991649 -3.074584 -3.163260 -3.254451 -3.347908 -3.440634 -3.527666 -3.623502 -3.729218 -3.827365 -3.882444 -3.713463 -8.288466 -4.095695 -3.863409 -3.682929 -3.548258 -3.545993 -3.551533 -3.568165 -3.597552 -3.636909 -3.684055 -3.734324 -3.795490 -3.863584 -3.929155 -4.003796 -4.082083 -4.170027 -4.228364 -4.022723 -8.288466 -5.794678 -5.459826 -5.171911 -4.935844 -4.849742 -4.776050 -4.709668 -4.660718 -4.626843 -4.613230 -4.608041 -4.610415 -4.626851 -4.651753 -4.684726 -4.742476 -4.809557 -4.803458 -4.401546 -8.288466 -25.68787 -25.19789 -24.64113 -24.02180 -23.34429 -22.61276 -21.83107 -21.00269 -20.13074 -19.21803 -18.26706 -17.28004 -16.25897 -15.20565 -14.12167 -13.00849 -11.86742 -10.69968 -9.506357 -8.288466 1.725258 1.394009 1.013088 0.7492114 0.6468655 0.5266715 0.3969593 0.2513126 9.6142150E-02 -6.3548081E-02 -0.2212286 -0.3684779 -0.5013526 -0.6183329 -0.7119745 -0.7867224 -0.8463141 -0.8991251 -0.9414073 -9.906311 1.858323 1.583373 1.259573 1.009016 0.8601898 0.6957530 0.5232801 0.3344579 0.1386266 -5.7370957E-02 -0.2460052 -0.4105739 -0.5530943 -0.6610746 -0.7319105 -0.7676371 -0.7755719 -0.7643284 -0.7325094 -9.906311 1.898928 1.670285 1.398911 1.155881 0.9601578 0.7550370 0.5389068 0.3104023 7.8947805E-02 -0.1511475 -0.3648141 -0.5520534 -0.7080960 -0.8127713 -0.8668338 -0.8698869 -0.8314765 -0.7598152 -0.6576766 -9.906311 1.862637 1.672024 1.443129 1.208233 0.9768546 0.7382802 0.4867297 0.2286239 -3.2375675E-02 -0.2902768 -0.5263513 -0.7403571 -0.9135479 -1.027917 -1.076253 -1.058160 -0.9822514 -0.8558504 -0.6870590 -9.906311 1.761997 1.604548 1.409657 1.184156 0.9283199 0.6611384 0.3877355 0.1078514 -0.1737207 -0.4448941 -0.7042028 -0.9412536 -1.131171 -1.263874 -1.319182 -1.292606 -1.190123 -1.015359 -0.7835190 -9.906311 1.605999 1.479383 1.313872 1.097547 0.8224316 0.5408680 0.2522309 -4.2631287E-02 -0.3320393 -0.6135304 -0.8878637 -1.137174 -1.345024 -1.496651 -1.569762 -1.547166 -1.430417 -1.214923 -0.9241326 -9.906311 1.401831 1.302079 1.162009 0.9552074 0.6723021 0.3819073 8.4849469E-02 -0.2123094 -0.5037483 -0.7932574 -1.072553 -1.325346 -1.547929 -1.716015 -1.813025 -1.809238 -1.688368 -1.441509 -1.096838 -9.906311 1.156149 1.080922 0.9636507 0.7668259 0.4817418 0.1884640 -0.1062415 -0.3990640 -0.6923120 -0.9800575 -1.253101 -1.510379 -1.738216 -1.924006 -2.044556 -2.071978 -1.960999 -1.695795 -1.305283 -9.906311 0.8701095 0.8176258 0.7205508 0.5361141 0.2539300 -3.0696273E-02 -0.3178782 -0.6085759 -0.8949357 -1.169528 -1.437315 -1.690227 -1.919631 -2.118924 -2.262317 -2.325251 -2.238056 -1.970253 -1.544459 -9.906311 0.5459653 0.5146307 0.4364247 0.2664394 -1.9658445E-03 -0.2759693 -0.5547946 -0.8348562 -1.105147 -1.369960 -1.625662 -1.869200 -2.099880 -2.302775 -2.470568 -2.562014 -2.509515 -2.256460 -1.809365 -9.906311 0.1859753 0.1761538 0.1180988 -3.5258651E-02 -0.2900000 -0.5492386 -0.8117137 -1.072678 -1.330695 -1.579953 -1.821101 -2.056569 -2.279514 -2.485408 -2.666731 -2.780708 -2.765607 -2.545019 -2.093759 -9.906311 -0.2134401 -0.2010676 -0.2381275 -0.3728004 -0.6077762 -0.8454694 -1.087709 -1.330627 -1.568824 -1.801093 -2.032340 -2.254045 -2.466949 -2.673146 -2.853357 -2.982409 -3.002249 -2.826427 -2.389752 -9.906311 -0.6548200 -0.6181856 -0.6320627 -0.7449586 -0.9556471 -1.170558 -1.388906 -1.607730 -1.826659 -2.044754 -2.259433 -2.467632 -2.670243 -2.864300 -3.038108 -3.172954 -3.223887 -3.103630 -2.704712 -9.906311 -1.149376 -1.085764 -1.073590 -1.159825 -1.341248 -1.525870 -1.718986 -1.916900 -2.116125 -2.312234 -2.508905 -2.702171 -2.886856 -3.062916 -3.225600 -3.357273 -3.429036 -3.370600 -3.017849 -9.906311 -1.705546 -1.610832 -1.569374 -1.624030 -1.774232 -1.929914 -2.095440 -2.267517 -2.440000 -2.612680 -2.786019 -2.957266 -3.121015 -3.276932 -3.422302 -3.546937 -3.630320 -3.635964 -3.337356 -9.906311 -2.351888 -2.222304 -2.147565 -2.166709 -2.279817 -2.399266 -2.529255 -2.669065 -2.811074 -2.953025 -3.097768 -3.242698 -3.384905 -3.516913 -3.642145 -3.756111 -3.855635 -3.903122 -3.660233 -9.906311 -3.137282 -2.962502 -2.846954 -2.821889 -2.887987 -2.962389 -3.049691 -3.147444 -3.250712 -3.360347 -3.473850 -3.587550 -3.700939 -3.807873 -3.910071 -4.023092 -4.132583 -4.188744 -4.001534 -9.906311 -4.201468 -3.954831 -3.777549 -3.691342 -3.696237 -3.714425 -3.747353 -3.793218 -3.850005 -3.910488 -3.981602 -4.055856 -4.137012 -4.223166 -4.307718 -4.403879 -4.488917 -4.573293 -4.379519 -9.906311 -6.030166 -5.659712 -5.366942 -5.170549 -5.073588 -4.996331 -4.946074 -4.908618 -4.885299 -4.875818 -4.882796 -4.903828 -4.929279 -4.964807 -5.013375 -5.079338 -5.169575 -5.222394 -4.838935 -9.906311 -30.68366 -30.11909 -29.46834 -28.73775 -27.93373 -27.06227 -26.12873 -25.13785 -24.09385 -23.00040 -21.86075 -20.67799 -19.45417 -18.19150 -16.89250 -15.55897 -14.19180 -12.79321 -11.36430 -9.906311 2.076205 1.663528 1.206455 1.014049 0.9064606 0.7737379 0.6248862 0.4567298 0.2846298 0.1090645 -6.7887388E-02 -0.2364031 -0.3885588 -0.5191504 -0.6246152 -0.7048122 -0.7643148 -0.8117443 -0.8490493 -11.58230 2.266348 1.927041 1.537968 1.324409 1.159110 0.9735695 0.7715170 0.5584509 0.3446574 0.1266886 -8.2959786E-02 -0.2748197 -0.4327235 -0.5540822 -0.6271134 -0.6567124 -0.6505159 -0.6201466 -0.5691257 -11.58230 2.338821 2.058465 1.732744 1.490321 1.268758 1.029702 0.7807885 0.5305958 0.2733743 1.8414376E-02 -0.2236285 -0.4393371 -0.6123458 -0.7324671 -0.7825603 -0.7689620 -0.7029118 -0.5993914 -0.4642891 -11.58230 2.317751 2.083611 1.808807 1.545423 1.277222 1.000319 0.7209761 0.4351813 0.1449600 -0.1415010 -0.4153652 -0.6555461 -0.8557171 -0.9863368 -1.031904 -0.9897595 -0.8739886 -0.7030941 -0.4875157 -11.58230 2.220763 2.025031 1.790329 1.512470 1.215891 0.9166582 0.6103016 0.2988054 -1.3541660E-02 -0.3241633 -0.6179287 -0.8845242 -1.112310 -1.263250 -1.318387 -1.264326 -1.111420 -0.8792266 -0.5862883 -11.58230 2.060029 1.897417 1.695358 1.413471 1.103477 0.7863304 0.4619370 0.1348734 -0.1934765 -0.5171344 -0.8231087 -1.111874 -1.358555 -1.538158 -1.614441 -1.567483 -1.393950 -1.109559 -0.7433562 -11.58230 1.845640 1.713289 1.540258 1.262043 0.9423469 0.6147822 0.2816666 -5.4552712E-02 -0.3882865 -0.7133235 -1.030981 -1.329901 -1.589180 -1.793258 -1.901232 -1.877095 -1.702927 -1.378143 -0.9443393 -11.58230 1.582705 1.479504 1.333080 1.058718 0.7377868 0.4070316 6.9655962E-02 -0.2668604 -0.5951890 -0.9210420 -1.239869 -1.535387 -1.805067 -2.024856 -2.166408 -2.178504 -2.021451 -1.671448 -1.177459 -11.58230 1.273248 1.197093 1.073788 0.8093394 0.4910478 0.1634014 -0.1684954 -0.4965405 -0.8212230 -1.141399 -1.447599 -1.738878 -2.007576 -2.238983 -2.407124 -2.466477 -2.342221 -1.986351 -1.443214 -11.58230 0.9198254 0.8688264 0.7674214 0.5143798 0.2053473 -0.1104728 -0.4290479 -0.7487473 -1.063128 -1.368125 -1.661720 -1.942372 -2.203780 -2.441963 -2.627622 -2.732711 -2.655390 -2.316574 -1.739928 -11.58230 0.5229854 0.4951968 0.4154817 0.1786233 -0.1127419 -0.4132372 -0.7173100 -1.021166 -1.315129 -1.605087 -1.884473 -2.148848 -2.403454 -2.636947 -2.840781 -2.974990 -2.950926 -2.652599 -2.063420 -11.58230 7.9872392E-02 7.6688409E-02 2.0563388E-02 -0.1956377 -0.4667343 -0.7463022 -1.029207 -1.308739 -1.584469 -1.854113 -2.115007 -2.368169 -2.609135 -2.836775 -3.045949 -3.197221 -3.219945 -2.983077 -2.407372 -11.58230 -0.4119455 -0.3887958 -0.4203037 -0.6100675 -0.8545203 -1.105636 -1.364771 -1.620030 -1.870990 -2.118903 -2.365452 -2.601285 -2.827720 -3.047581 -3.247258 -3.406021 -3.463213 -3.296426 -2.760227 -11.58230 -0.9560179 -0.9035563 -0.9080518 -1.066564 -1.280366 -1.500440 -1.728639 -1.956755 -2.183824 -2.413515 -2.636956 -2.854271 -3.067127 -3.268055 -3.454057 -3.607419 -3.690662 -3.598249 -3.133097 -11.58230 -1.569073 -1.482260 -1.456213 -1.577088 -1.753161 -1.937997 -2.135526 -2.337811 -2.536727 -2.738120 -2.940022 -3.135608 -3.324780 -3.505143 -3.672066 -3.814022 -3.908185 -3.892233 -3.501498 -11.58230 -2.275221 -2.147960 -2.085556 -2.164851 -2.299063 -2.445877 -2.606108 -2.771959 -2.939771 -3.109377 -3.281426 -3.448208 -3.612031 -3.768740 -3.912890 -4.038918 -4.138034 -4.186347 -3.876613 -11.58230 -3.131312 -2.953420 -2.846128 -2.874225 -2.955606 -3.053651 -3.168305 -3.289346 -3.416580 -3.547256 -3.684563 -3.820305 -3.952358 -4.081094 -4.200504 -4.312689 -4.433405 -4.499410 -4.268736 -11.58230 -4.278627 -4.023561 -3.848906 -3.807614 -3.819069 -3.851883 -3.907010 -3.974208 -4.050043 -4.134335 -4.219825 -4.312894 -4.409189 -4.508712 -4.613178 -4.717434 -4.815902 -4.904570 -4.707090 -11.58230 -6.230482 -5.837127 -5.535917 -5.373517 -5.269139 -5.194951 -5.153419 -5.134141 -5.129684 -5.138234 -5.154370 -5.183813 -5.230590 -5.279443 -5.337624 -5.417128 -5.513912 -5.603189 -5.249407 -11.58230 -35.89186 -35.25140 -34.50310 -33.65604 -32.71915 -31.70052 -30.60729 -29.44567 -28.22127 -26.93800 -25.60060 -24.21259 -22.77657 -21.29524 -19.77152 -18.20732 -16.60461 -14.96515 -13.29055 -11.58230 2.412120 1.915215 1.378479 1.274090 1.163248 1.022510 0.8565990 0.6728165 0.4774822 0.2807422 8.6428255E-02 -0.1028927 -0.2749083 -0.4202140 -0.5381968 -0.6237532 -0.6840653 -0.7277379 -0.7609099 -13.31235 2.663128 2.254710 1.797873 1.633805 1.456453 1.250631 1.026823 0.7894257 0.5468770 0.3108529 7.8798197E-02 -0.1340638 -0.3142379 -0.4434803 -0.5212941 -0.5440700 -0.5241790 -0.4752938 -0.4056748 -13.31235 2.770497 2.434217 2.053543 1.820045 1.572421 1.305535 1.027853 0.7438120 0.4635165 0.1856707 -8.1944853E-02 -0.3241975 -0.5180228 -0.6472391 -0.6961871 -0.6664819 -0.5732794 -0.4368813 -0.2691548 -13.31235 2.766629 2.486374 2.165042 1.876566 1.575534 1.265031 0.9480419 0.6322288 0.3172465 2.7916767E-03 -0.2974338 -0.5736141 -0.7948011 -0.9431836 -0.9844431 -0.9186465 -0.7632107 -0.5456386 -0.2832130 -13.31235 2.673033 2.437404 2.162592 1.838434 1.505565 1.165131 0.8227053 0.4843420 0.1400361 -0.1998094 -0.5275773 -0.8281516 -1.084979 -1.263106 -1.319067 -1.237331 -1.033361 -0.7417943 -0.3875787 -13.31235 2.508368 2.310467 2.072768 1.730968 1.378263 1.021461 0.6665183 0.3066203 -5.4903071E-02 -0.4116631 -0.7564356 -1.076125 -1.364237 -1.573579 -1.663245 -1.591128 -1.358956 -1.002725 -0.5606828 -13.31235 2.283316 2.118908 1.913222 1.563960 1.203904 0.8417494 0.4715191 0.1020043 -0.2663875 -0.6308781 -0.9795780 -1.315441 -1.621964 -1.859910 -1.989296 -1.950147 -1.714054 -1.306344 -0.7816609 -13.31235 2.003004 1.870357 1.693339 1.346226 0.9875613 0.6184447 0.2440397 -0.1277636 -0.4980854 -0.8565633 -1.208156 -1.549060 -1.857293 -2.118854 -2.286186 -2.295875 -2.085392 -1.645433 -1.046181 -13.31235 1.671899 1.570511 1.420380 1.079285 0.7224743 0.3562253 -1.4309375E-02 -0.3820439 -0.7423878 -1.098182 -1.444842 -1.774265 -2.083230 -2.353099 -2.552196 -2.615395 -2.455333 -2.007345 -1.345103 -13.31235 1.290258 1.217569 1.092619 0.7613177 0.4136706 5.7054993E-02 -0.3017082 -0.6549666 -1.006759 -1.354170 -1.685558 -2.001857 -2.302072 -2.570860 -2.790528 -2.907269 -2.808319 -2.379763 -1.670649 -13.31235 0.8580609 0.8113376 0.7112743 0.3957843 6.6122279E-02 -0.2733008 -0.6144518 -0.9545277 -1.291291 -1.618948 -1.933101 -2.234649 -2.519161 -2.785809 -3.010360 -3.170488 -3.138765 -2.760248 -2.028349 -13.31235 0.3775489 0.3567919 0.2812843 -1.0642273E-02 -0.3166303 -0.6345859 -0.9579974 -1.276588 -1.589374 -1.896827 -2.191249 -2.473090 -2.746444 -2.999383 -3.230426 -3.409255 -3.438027 -3.135054 -2.411529 -13.31235 -0.1557203 -0.1472256 -0.1971336 -0.4599950 -0.7400156 -1.031798 -1.326648 -1.618955 -1.906789 -2.191018 -2.461869 -2.728094 -2.983051 -3.226232 -3.450829 -3.632929 -3.703908 -3.491629 -2.813044 -13.31235 -0.7489101 -0.7080312 -0.7300171 -0.9580637 -1.203295 -1.462053 -1.726492 -1.988849 -2.248516 -2.507843 -2.759042 -3.000864 -3.239716 -3.469479 -3.676024 -3.851552 -3.947682 -3.824922 -3.227290 -13.31235 -1.414858 -1.336926 -1.326460 -1.512724 -1.717429 -1.937067 -2.165791 -2.396126 -2.628842 -2.860793 -3.084796 -3.304651 -3.522380 -3.727723 -3.916093 -4.072867 -4.181107 -4.140282 -3.652459 -13.31235 -2.181921 -2.058986 -2.008435 -2.144386 -2.303317 -2.480337 -2.669660 -2.863672 -3.060251 -3.260366 -3.456542 -3.644480 -3.833597 -4.013444 -4.176964 -4.315592 -4.425265 -4.460003 -4.079701 -13.31235 -3.104239 -2.926845 -2.825657 -2.903568 -3.006996 -3.130215 -3.269560 -3.418968 -3.571218 -3.729007 -3.888758 -4.042780 -4.198567 -4.346967 -4.484435 -4.605819 -4.724252 -4.796503 -4.519176 -13.31235 -4.332493 -4.074560 -3.898083 -3.895872 -3.923713 -3.975847 -4.050776 -4.139204 -4.236803 -4.343139 -4.454778 -4.561463 -4.674664 -4.791774 -4.908250 -5.023706 -5.130380 -5.216266 -5.012667 -13.31235 -6.401105 -5.993209 -5.676916 -5.536578 -5.437784 -5.371663 -5.343376 -5.337671 -5.346496 -5.375901 -5.413588 -5.460444 -5.515866 -5.584373 -5.652803 -5.744098 -5.839028 -5.955818 -5.636889 -13.31235 -41.29539 -40.57773 -39.72842 -38.75989 -37.68405 -36.51153 -35.25141 -33.91145 -32.49831 -31.01762 -29.47422 -27.87230 -26.21551 -24.50706 -22.74980 -20.94629 -19.09880 -17.20943 -15.28003 -13.31235 2.736266 2.152402 1.612053 1.531681 1.413846 1.264840 1.089097 0.8906248 0.6777598 0.4571642 0.2393463 3.1545859E-02 -0.1591368 -0.3227007 -0.4493693 -0.5417385 -0.6036960 -0.6447784 -0.6744046 -15.09291 3.049264 2.570262 2.095612 1.934773 1.742139 1.521343 1.279358 1.020980 0.7556989 0.4902593 0.2376198 2.3613684E-03 -0.1945426 -0.3369528 -0.4162164 -0.4325416 -0.3996105 -0.3333415 -0.2457490 -15.09291 3.192407 2.796746 2.386792 2.136733 1.865290 1.575065 1.270422 0.9599233 0.6486657 0.3460815 5.3116333E-02 -0.2139455 -0.4319515 -0.5712872 -0.6197277 -0.5726446 -0.4530472 -0.2851197 -8.5408971E-02 -15.09291 3.207142 2.876764 2.515635 2.198633 1.868199 1.523861 1.176690 0.8267376 0.4795104 0.1428660 -0.1865460 -0.4897610 -0.7417988 -0.9035276 -0.9446298 -0.8542113 -0.6595955 -0.3955913 -8.6580932E-02 -15.09291 3.119855 2.841563 2.520175 2.160101 1.789257 1.414165 1.036255 0.6592581 0.2889062 -7.8715794E-02 -0.4354591 -0.7727166 -1.059339 -1.263725 -1.324132 -1.216595 -0.9626377 -0.6100205 -0.1944803 -15.09291 2.951701 2.717120 2.429151 2.043099 1.652954 1.256360 0.8609728 0.4715979 7.9476543E-02 -0.3062108 -0.6824007 -1.042131 -1.361363 -1.611002 -1.713630 -1.618195 -1.328413 -0.8984674 -0.3800124 -15.09291 2.714113 2.517260 2.258833 1.864758 1.463749 1.057976 0.6557890 0.2525689 -0.1477456 -0.5415844 -0.9292986 -1.297208 -1.641481 -1.921459 -2.079131 -2.026455 -1.730409 -1.238340 -0.6221130 -15.09291 2.417522 2.256526 2.025100 1.629528 1.227463 0.8224998 0.4142519 8.6717224E-03 -0.3952844 -0.7920676 -1.174785 -1.549609 -1.902248 -2.201412 -2.405523 -2.416705 -2.150011 -1.617285 -0.9110823 -15.09291 2.063999 1.936880 1.731475 1.341832 0.9470204 0.5435864 0.1394974 -0.2625481 -0.6645778 -1.052087 -1.431410 -1.802303 -2.146360 -2.455854 -2.691071 -2.770515 -2.568427 -2.025236 -1.241203 -15.09291 1.655264 1.559493 1.381204 1.003958 0.6202712 0.2253921 -0.1692870 -0.5627727 -0.9499593 -1.329008 -1.698542 -2.053298 -2.389498 -2.693232 -2.947498 -3.082788 -2.966870 -2.449311 -1.605839 -15.09291 1.193639 1.126663 0.9755805 0.6164703 0.2490453 -0.1297531 -0.5097182 -0.8836061 -1.259063 -1.622873 -1.971582 -2.310317 -2.631550 -2.924320 -3.182863 -3.363285 -3.329185 -2.872772 -1.995139 -15.09291 0.6789770 0.6409051 0.5155022 0.1807873 -0.1643308 -0.5193852 -0.8782654 -1.234744 -1.589243 -1.928479 -2.256265 -2.575052 -2.876673 -3.160021 -3.410036 -3.616899 -3.654722 -3.290846 -2.415414 -15.09291 0.1070640 0.1001948 1.8278335E-03 -0.3014713 -0.6171526 -0.9465285 -1.279664 -1.610172 -1.935751 -2.252538 -2.554745 -2.851022 -3.136338 -3.399924 -3.647088 -3.853989 -3.942149 -3.688224 -2.860492 -15.09291 -0.5309820 -0.5026459 -0.5694596 -0.8367763 -1.117172 -1.412060 -1.712647 -2.012223 -2.307491 -2.597210 -2.874039 -3.150272 -3.410231 -3.661644 -3.891280 -4.088287 -4.200810 -4.054919 -3.321707 -15.09291 -1.247510 -1.179256 -1.209039 -1.432003 -1.671100 -1.925403 -2.187600 -2.450899 -2.712007 -2.976013 -3.225722 -3.473991 -3.716527 -3.942866 -4.150241 -4.326962 -4.449996 -4.393349 -3.798007 -15.09291 -2.071879 -1.955911 -1.939855 -2.109487 -2.298362 -2.505340 -2.725185 -2.948801 -3.172158 -3.401346 -3.622216 -3.840977 -4.055099 -4.253336 -4.433178 -4.587703 -4.707274 -4.731227 -4.273957 -15.09291 -3.059637 -2.885203 -2.810980 -2.915771 -3.044455 -3.195521 -3.362976 -3.537488 -3.715447 -3.900500 -4.084233 -4.265376 -4.446699 -4.612650 -4.763507 -4.895998 -5.012521 -5.089825 -4.763603 -15.09291 -4.361469 -4.099770 -3.944210 -3.965253 -4.014382 -4.089454 -4.187477 -4.298229 -4.414349 -4.543198 -4.680758 -4.812739 -4.948098 -5.083178 -5.202680 -5.329472 -5.445298 -5.524175 -5.306710 -15.09291 -6.542246 -6.117361 -5.808913 -5.682151 -5.594714 -5.544796 -5.530275 -5.542108 -5.567128 -5.606536 -5.668975 -5.739769 -5.816402 -5.903639 -5.986267 -6.073076 -6.178647 -6.295975 -6.005222 -15.09291 -46.87972 -46.08356 -45.12986 -44.03503 -42.81460 -41.48184 -40.04811 -38.52282 -36.91395 -35.22816 -33.47116 -31.64782 -29.76240 -27.81862 -25.81979 -23.76883 -21.66839 -19.52085 -17.32837 -15.09291 3.053089 2.383879 1.872943 1.784468 1.663615 1.504666 1.317876 1.108340 0.8791952 0.6381996 0.3957650 0.1679654 -4.1513857E-02 -0.2199287 -0.3582360 -0.4577815 -0.5211302 -0.5602216 -0.5865982 -16.92084 3.426279 2.874554 2.406289 2.230608 2.020491 1.782493 1.524589 1.250089 0.9639371 0.6741090 0.3930513 0.1403665 -7.5617917E-02 -0.2298506 -0.3088660 -0.3188947 -0.2725916 -0.1891147 -8.3897628E-02 -16.92084 3.606751 3.149692 2.722986 2.444799 2.146080 1.832560 1.507124 1.171226 0.8354555 0.5019770 0.1854178 -0.1055818 -0.3458095 -0.4995039 -0.5427085 -0.4797299 -0.3338075 -0.1344489 9.7129092E-02 -16.92084 3.639836 3.257365 2.860899 2.510140 2.148588 1.777292 1.399157 1.019654 0.6429039 0.2765616 -7.5817093E-02 -0.4081506 -0.6882442 -0.8676458 -0.9064380 -0.7913217 -0.5570472 -0.2466909 0.1089374 -16.92084 3.558821 3.235435 2.866905 2.471768 2.068381 1.657338 1.246941 0.8354563 0.4315615 4.1462734E-02 -0.3451212 -0.7115782 -1.037436 -1.265119 -1.333832 -1.200543 -0.8967834 -0.4831063 -6.0242908E-03 -16.92084 3.388353 3.114902 2.772684 2.351171 1.921349 1.487861 1.055768 0.6281171 0.2119532 -0.2017099 -0.6090325 -1.001141 -1.357516 -1.641427 -1.763793 -1.651164 -1.304614 -0.7986931 -0.2033643 -16.92084 3.140419 2.910590 2.593605 2.159192 1.719278 1.273709 0.8333039 0.3993925 -3.0460039E-02 -0.4544276 -0.8721015 -1.277638 -1.653386 -1.980260 -2.165185 -2.107318 -1.754745 -1.174767 -0.4661758 -16.92084 2.825022 2.634931 2.342313 1.908382 1.464970 1.019979 0.5810713 0.1409660 -0.2940169 -0.7206584 -1.141700 -1.546632 -1.932724 -2.276160 -2.518729 -2.538563 -2.222235 -1.593643 -0.7794087 -16.92084 2.450026 2.296457 2.028800 1.601587 1.166043 0.7284250 0.2905620 -0.1475883 -0.5803136 -1.003457 -1.416306 -1.820246 -2.203411 -2.547866 -2.824590 -2.926143 -2.688252 -2.045805 -1.138225 -16.92084 2.017661 1.897181 1.656744 1.244496 0.8237203 0.3930884 -3.6359839E-02 -0.4660490 -0.8912385 -1.299524 -1.704728 -2.099150 -2.464887 -2.805649 -3.093683 -3.260023 -3.129025 -2.517810 -1.536318 -16.92084 1.529379 1.441203 1.228754 0.8364439 0.4325317 1.7000541E-02 -0.3993601 -0.8141093 -1.221733 -1.617009 -2.007866 -2.378304 -2.731777 -3.056279 -3.345534 -3.549782 -3.525832 -2.991787 -1.965266 -16.92084 0.9830576 0.9274130 0.7427409 0.3756988 -5.5728578E-03 -0.3994628 -0.7945223 -1.188101 -1.578403 -1.954472 -2.317511 -2.670819 -3.001834 -3.309679 -3.587396 -3.814888 -3.871836 -3.449979 -2.417522 -16.92084 0.3738878 0.3520125 0.1975190 -0.1377746 -0.4888485 -0.8545683 -1.225186 -1.592955 -1.956887 -2.304830 -2.644724 -2.975184 -3.282422 -3.573008 -3.836003 -4.065473 -4.176757 -3.887237 -2.902963 -16.92084 -0.3049245 -0.2896381 -0.4086607 -0.7067502 -1.022826 -1.354883 -1.692876 -2.026148 -2.357873 -2.679512 -2.990079 -3.296891 -3.583384 -3.849478 -4.099773 -4.313357 -4.446939 -4.286741 -3.411070 -16.92084 -1.070197 -1.012921 -1.089486 -1.341790 -1.614135 -1.905030 -2.203315 -2.498146 -2.792162 -3.084118 -3.367889 -3.645660 -3.909046 -4.154354 -4.379229 -4.570427 -4.705695 -4.648812 -3.930071 -16.92084 -1.949322 -1.841042 -1.867712 -2.062575 -2.282806 -2.524335 -2.775393 -3.028490 -3.281920 -3.536645 -3.789678 -4.038197 -4.274292 -4.489277 -4.685143 -4.847771 -4.974313 -4.996008 -4.456067 -16.92084 -3.001250 -2.827886 -2.790920 -2.916799 -3.073453 -3.253978 -3.449179 -3.651314 -3.855719 -4.066976 -4.280642 -4.492280 -4.693853 -4.874482 -5.036542 -5.174575 -5.287992 -5.373140 -4.995840 -16.92084 -4.378233 -4.109921 -3.984065 -4.019664 -4.091208 -4.194448 -4.313811 -4.446851 -4.587559 -4.739435 -4.903123 -5.066811 -5.224608 -5.365828 -5.499655 -5.623323 -5.738981 -5.820249 -5.587512 -16.92084 -6.667308 -6.220007 -5.929641 -5.808777 -5.733616 -5.704255 -5.702741 -5.724984 -5.769210 -5.834490 -5.916891 -6.015080 -6.119296 -6.215779 -6.310637 -6.394987 -6.497439 -6.621558 -6.358365 -16.92084 -52.63235 -51.75642 -50.69499 -49.46933 -48.09883 -46.59997 -44.98634 -43.26956 -41.45790 -39.56013 -37.58248 -35.53057 -33.40927 -31.22282 -28.97499 -26.66912 -24.30820 -21.89492 -19.43173 -16.92084 3.360474 2.607363 2.132962 2.039960 1.908572 1.744760 1.546236 1.323363 1.079728 0.8189737 0.5564796 0.3031969 7.5403415E-02 -0.1192924 -0.2701961 -0.3748146 -0.4402770 -0.4785607 -0.5021081 -18.79339 3.796897 3.173323 2.716376 2.519820 2.293871 2.039726 1.763239 1.473375 1.168998 0.8573018 0.5534660 0.2752468 4.2247675E-02 -0.1216978 -0.2024671 -0.2047322 -0.1440823 -4.4070400E-02 7.8603499E-02 -18.79339 4.013153 3.494234 3.052343 2.745932 2.421146 2.081112 1.732961 1.377738 1.018128 0.6608641 0.3156886 3.6358171E-05 -0.2623940 -0.4262636 -0.4651577 -0.3845044 -0.2106145 2.0256786E-02 0.2837306 -18.79339 4.065581 3.629364 3.200179 2.815680 2.420048 2.019896 1.615718 1.207421 0.8063837 0.4115030 3.1181827E-02 -0.3296164 -0.6378685 -0.8372389 -0.8722843 -0.7339477 -0.4592617 -0.1028181 0.2994812 -18.79339 3.991415 3.621975 3.208213 2.775299 2.336469 1.894763 1.451123 1.010548 0.5783319 0.1555221 -0.2556902 -0.6538017 -1.011228 -1.266443 -1.343660 -1.186030 -0.8303996 -0.3555445 0.1834429 -18.79339 3.816722 3.503862 3.108426 2.649729 2.184065 1.714234 1.248440 0.7878823 0.3389286 -0.1009801 -0.5372891 -0.9585534 -1.355367 -1.668866 -1.818344 -1.689548 -1.284604 -0.7031521 -3.0596709E-02 -18.79339 3.559396 3.295372 2.921190 2.449357 1.968413 1.488062 1.012028 0.5413706 8.4345259E-02 -0.3704898 -0.8188277 -1.253084 -1.664338 -2.026390 -2.248956 -2.194692 -1.784483 -1.115002 -0.3135406 -18.79339 3.228316 3.008273 2.655890 2.181636 1.700668 1.218872 0.7417560 0.2700915 -0.1945432 -0.6538536 -1.106243 -1.543734 -1.958210 -2.343976 -2.624245 -2.664785 -2.302303 -1.574848 -0.6521124 -18.79339 2.831336 2.650087 2.323195 1.859668 1.385401 0.9091531 0.4386783 -3.5867382E-02 -0.4976287 -0.9544574 -1.404080 -1.833295 -2.248144 -2.629694 -2.946075 -3.078959 -2.813202 -2.070106 -1.038620 -18.79339 2.377143 2.232148 1.931975 1.483897 1.023731 0.5597035 9.3076110E-02 -0.3724174 -0.8277873 -1.275150 -1.711984 -2.133299 -2.535795 -2.906429 -3.230007 -3.432523 -3.293011 -2.588037 -1.468052 -18.79339 1.863388 1.753633 1.481666 1.056353 0.6148306 0.1642145 -0.2890679 -0.7410243 -1.184228 -1.612398 -2.038576 -2.444133 -2.822664 -3.179383 -3.495122 -3.731558 -3.717927 -3.107830 -1.930660 -18.79339 1.286652 1.212725 0.9717187 0.5723363 0.1543436 -0.2765606 -0.7102011 -1.138818 -1.563136 -1.973647 -2.380141 -2.760172 -3.118916 -3.453271 -3.757575 -4.003965 -4.082807 -3.610654 -2.421847 -18.79339 0.6433702 0.6059427 0.3984713 3.0425387E-02 -0.3580692 -0.7610568 -1.167082 -1.570056 -1.971161 -2.356461 -2.732201 -3.091699 -3.424306 -3.738069 -4.020213 -4.267074 -4.398726 -4.083402 -2.945263 -18.79339 -7.4762560E-02 -7.3569790E-02 -0.2421068 -0.5705315 -0.9235864 -1.292908 -1.667510 -2.037306 -2.401572 -2.759599 -3.106346 -3.438834 -3.748145 -4.034827 -4.301575 -4.530342 -4.680859 -4.511378 -3.495211 -18.79339 -0.8854023 -0.8395033 -0.9626961 -1.242922 -1.552834 -1.879589 -2.212318 -2.542454 -2.868230 -3.191940 -3.508526 -3.814448 -4.094456 -4.360281 -4.600551 -4.805566 -4.949094 -4.892500 -4.060762 -18.79339 -1.816386 -1.715579 -1.784906 -2.007882 -2.261670 -2.535815 -2.818965 -3.103189 -3.387726 -3.672893 -3.955415 -4.228792 -4.482414 -4.718787 -4.927495 -5.101001 -5.232046 -5.247028 -4.637586 -18.79339 -2.929796 -2.760747 -2.759781 -2.910288 -3.094234 -3.304596 -3.526550 -3.756302 -3.993277 -4.232536 -4.475586 -4.708578 -4.926754 -5.126702 -5.300534 -5.446792 -5.562574 -5.640060 -5.218762 -18.79339 -4.377307 -4.107714 -4.010771 -4.064683 -4.157631 -4.284459 -4.430514 -4.587558 -4.759409 -4.938474 -5.127171 -5.311833 -5.482428 -5.640822 -5.786629 -5.906886 -6.028339 -6.110393 -5.853135 -18.79339 -6.758193 -6.296173 -6.031637 -5.921007 -5.862456 -5.846166 -5.862072 -5.900567 -5.972459 -6.068048 -6.176153 -6.288735 -6.403750 -6.516252 -6.623254 -6.714234 -6.814677 -6.928584 -6.691126 -18.79339 -58.54242 -57.58545 -56.41307 -55.05213 -53.52650 -51.85592 -50.05655 -48.14149 -46.12145 -44.00527 -41.80044 -39.51331 -37.14940 -34.71348 -32.20979 -29.64209 -27.01372 -24.32770 -21.58677 -18.79339 3.658473 2.819205 2.388542 2.294908 2.156570 1.980089 1.774314 1.538152 1.277257 0.9990792 0.7142882 0.4390437 0.1891362 -2.2066643E-02 -0.1843115 -0.2946454 -0.3626500 -0.4006879 -0.4221223 -20.70810 4.160508 3.464253 3.022909 2.808939 2.561058 2.290639 1.998821 1.691258 1.368393 1.036321 0.7097453 0.4069224 0.1581372 -1.6720245E-02 -9.7860076E-02 -8.9584641E-02 -1.5263827E-02 0.1010326 0.2409339 -20.70810 4.414127 3.834163 3.379480 3.040521 2.687808 2.324167 1.950878 1.575460 1.195595 0.8146509 0.4440252 9.9593416E-02 -0.1790994 -0.3540023 -0.3885747 -0.2872379 -8.4783085E-02 0.1773614 0.4729747 -20.70810 4.484434 3.994593 3.533412 3.113605 2.685691 2.255116 1.822256 1.391846 0.9634102 0.5430985 0.1324216 -0.2549913 -0.5888709 -0.8064875 -0.8409686 -0.6767054 -0.3606243 4.2191904E-02 0.4915732 -20.70810 4.417103 4.000758 3.543463 3.072738 2.597209 2.122373 1.649583 1.179927 0.7197353 0.2677851 -0.1722955 -0.5983220 -0.9858779 -1.273251 -1.359172 -1.177176 -0.7699727 -0.2340833 0.3672869 -20.70810 4.239082 3.886216 3.438911 2.940793 2.437158 1.936155 1.435391 0.9440722 0.4636248 -1.0380915E-02 -0.4685613 -0.9199122 -1.345700 -1.696119 -1.873249 -1.730748 -1.268020 -0.6112097 0.1394173 -20.70810 3.970582 3.672121 3.241392 2.730706 2.213758 1.697619 1.185766 0.6821414 0.1903286 -0.2926529 -0.7674838 -1.228612 -1.673515 -2.066852 -2.333320 -2.283413 -1.817975 -1.060320 -0.1649278 -20.70810 3.624434 3.373235 2.963795 2.452986 1.931917 1.414947 0.8994713 0.3919364 -0.1007212 -0.5927972 -1.072127 -1.536823 -1.980755 -2.397876 -2.721812 -2.789953 -2.386760 -1.561103 -0.5284024 -20.70810 3.210248 3.001316 2.616291 2.113324 1.602096 1.088142 0.5768992 7.3143192E-02 -0.4211942 -0.9130515 -1.388722 -1.847396 -2.287868 -2.706037 -3.057034 -3.225989 -2.942910 -2.101135 -0.9439536 -20.70810 2.732809 2.563073 2.205574 1.720996 1.222482 0.7191380 0.2191638 -0.2817516 -0.7689906 -1.252607 -1.721932 -2.165957 -2.599567 -2.998945 -3.355825 -3.593373 -3.457715 -2.664658 -1.404567 -20.70810 2.193780 2.062606 1.734537 1.272186 0.7941751 0.3062105 -0.1816377 -0.6689118 -1.145946 -1.613841 -2.067739 -2.500809 -2.910361 -3.294628 -3.636976 -3.907388 -3.908021 -3.230545 -1.901581 -20.70810 1.588728 1.495978 1.201069 0.7665870 0.3117650 -0.1559244 -0.6244249 -1.090843 -1.548613 -1.996497 -2.435729 -2.843794 -3.230191 -3.590865 -3.915885 -4.186387 -4.289688 -3.777519 -2.432733 -20.70810 0.9130195 0.8588971 0.6011187 0.1993437 -0.2263187 -0.6670432 -1.109117 -1.547176 -1.981141 -2.408300 -2.815883 -3.199709 -3.561146 -3.894514 -4.198860 -4.462829 -4.616170 -4.282933 -2.993049 -20.70810 0.1574589 0.1447841 -7.2181471E-02 -0.4331597 -0.8220599 -1.228327 -1.637405 -2.044837 -2.445303 -2.837506 -3.216947 -3.573473 -3.906187 -4.216827 -4.493285 -4.741292 -4.910912 -4.736620 -3.585351 -20.70810 -0.6949870 -0.6602623 -0.8297690 -1.141732 -1.485274 -1.849735 -2.215727 -2.581486 -2.943773 -3.301829 -3.647644 -3.973649 -4.277538 -4.559988 -4.812551 -5.033103 -5.190819 -5.136184 -4.199006 -20.70810 -1.677067 -1.585022 -1.695207 -1.947310 -2.233346 -2.542896 -2.857259 -3.176727 -3.496365 -3.815046 -4.125530 -4.417138 -4.689167 -4.941401 -5.161457 -5.348928 -5.487822 -5.505285 -4.818933 -20.70810 -2.847812 -2.682545 -2.718965 -2.895473 -3.109698 -3.348840 -3.600896 -3.862967 -4.134295 -4.408928 -4.676699 -4.930606 -5.164736 -5.377688 -5.559499 -5.714547 -5.836766 -5.908563 -5.447848 -20.70810 -4.366140 -4.092357 -4.027300 -4.100327 -4.219914 -4.370255 -4.540221 -4.730607 -4.939070 -5.152554 -5.364539 -5.567761 -5.755284 -5.922088 -6.069249 -6.198878 -6.320700 -6.403183 -6.124159 -20.70810 -6.839694 -6.366797 -6.117502 -6.018121 -5.986982 -5.991656 -6.020599 -6.086567 -6.194524 -6.318759 -6.450923 -6.581618 -6.713350 -6.833569 -6.941854 -7.041203 -7.133501 -7.238083 -7.024559 -20.70810 -64.60039 -63.56111 -62.27468 -60.77422 -59.08852 -57.24100 -55.25039 -53.13168 -50.89702 -48.55643 -46.11829 -43.58974 -40.97692 -38.28519 -35.51925 -32.68327 -29.78099 -26.81573 -23.79052 -20.70810 3.946137 3.017437 2.633812 2.543506 2.401067 2.219081 1.999357 1.751318 1.472005 1.174535 0.8675116 0.5697367 0.2955721 6.6227719E-02 -0.1094845 -0.2278781 -0.2996103 -0.3377955 -0.3576806 -22.66275 4.516222 3.744530 3.322507 3.092016 2.828010 2.537099 2.229390 1.904604 1.561882 1.210226 0.8595186 0.5359470 0.2655261 7.9620436E-02 -2.1339161E-03 1.4089401E-02 0.1017201 0.2340772 0.3909230 -22.66275 4.809822 4.168132 3.701008 3.334124 2.949811 2.560181 2.164180 1.765975 1.365655 0.9627018 0.5674568 0.1995899 -0.1001566 -0.2884245 -0.3178691 -0.1949448 3.5267733E-02 0.3289122 0.6567685 -22.66275 4.898323 4.355351 3.864620 3.406173 2.945189 2.484257 2.022358 1.567681 1.115603 0.6703127 0.2335349 -0.1818937 -0.5395474 -0.7797468 -0.8125863 -0.6207151 -0.2632903 0.1863230 0.6833924 -22.66275 4.836531 4.373775 3.872936 3.363822 2.851751 2.343844 1.839781 1.344639 0.8543374 0.3772509 -9.0367302E-02 -0.5422082 -0.9594219 -1.278021 -1.374885 -1.168495 -0.7092675 -0.1109937 0.5536355 -22.66275 4.654907 4.261664 3.763607 3.225191 2.684690 2.149261 1.617277 1.094653 0.5834688 8.1726357E-02 -0.4026524 -0.8781799 -1.333659 -1.723989 -1.924311 -1.773101 -1.254707 -0.5209364 0.3088182 -22.66275 4.375598 4.042102 3.556057 3.005921 2.451724 1.902637 1.353381 0.8202965 0.2940890 -0.2191154 -0.7158414 -1.204204 -1.675335 -2.104057 -2.408026 -2.371666 -1.856637 -1.009737 -1.9034633E-02 -22.66275 4.014546 3.731634 3.266160 2.717049 2.160470 1.604497 1.053508 0.5134839 -1.6065087E-02 -0.5339753 -1.038196 -1.529433 -2.004081 -2.445832 -2.813136 -2.911639 -2.475791 -1.552808 -0.4084357 -22.66275 3.583841 3.346395 2.905019 2.364768 1.813465 1.263806 0.7149032 0.1764165 -0.3494276 -0.8731285 -1.374238 -1.861344 -2.326637 -2.770608 -3.158036 -3.368925 -3.078851 -2.138535 -0.8535451 -22.66275 3.085537 2.890954 2.476145 1.953981 1.418033 0.8768607 0.3400977 -0.1926334 -0.7152687 -1.232439 -1.727239 -2.199783 -2.656019 -3.085538 -3.473267 -3.746364 -3.626395 -2.748855 -1.345845 -22.66275 2.520894 2.368151 1.984996 1.485894 0.9694120 0.4458627 -7.7326186E-02 -0.5986267 -1.111834 -1.615861 -2.095061 -2.553961 -2.993932 -3.397249 -3.771265 -4.069588 -4.097967 -3.359529 -1.875595 -22.66275 1.889148 1.777200 1.428703 0.9586867 0.4672715 -3.7033010E-02 -0.5411405 -1.043237 -1.539010 -2.020035 -2.483677 -2.923703 -3.334709 -3.715751 -4.065175 -4.361671 -4.491785 -3.948702 -2.442285 -22.66275 1.182503 1.111862 0.8025219 0.3674310 -9.4904251E-02 -0.5720289 -1.050762 -1.526284 -1.994964 -2.455986 -2.895163 -3.302389 -3.690718 -4.041973 -4.367489 -4.646529 -4.826450 -4.488231 -3.041624 -22.66275 0.3911316 0.3645772 9.8989591E-02 -0.2951332 -0.7202982 -1.161518 -1.606529 -2.052033 -2.491822 -2.920090 -3.325640 -3.705596 -4.061913 -4.383964 -4.678614 -4.939977 -5.127865 -4.963367 -3.672508 -22.66275 -0.5030361 -0.4798745 -0.6933666 -1.037678 -1.416189 -1.815005 -2.219947 -2.623793 -3.024112 -3.416983 -3.788540 -4.134898 -4.460193 -4.748093 -5.017211 -5.248624 -5.419672 -5.377065 -4.329524 -22.66275 -1.532270 -1.448284 -1.600254 -1.883607 -2.202507 -2.545573 -2.896453 -3.252474 -3.610688 -3.961923 -4.293867 -4.605978 -4.897150 -5.152360 -5.386930 -5.583911 -5.727262 -5.756654 -4.994250 -22.66275 -2.761998 -2.599250 -2.672697 -2.875596 -3.121614 -3.393694 -3.675842 -3.974523 -4.281540 -4.586533 -4.874414 -5.144428 -5.397964 -5.613780 -5.806073 -5.968916 -6.089853 -6.163945 -5.664279 -22.66275 -4.350207 -4.074892 -4.038807 -4.133587 -4.280112 -4.458282 -4.655407 -4.881411 -5.123342 -5.365690 -5.594157 -5.810571 -6.013782 -6.185217 -6.339557 -6.478074 -6.588620 -6.677895 -6.384009 -22.66275 -6.909548 -6.425076 -6.202569 -6.112878 -6.094982 -6.125984 -6.186635 -6.287643 -6.421056 -6.567209 -6.712643 -6.857953 -6.997345 -7.127696 -7.242201 -7.349159 -7.427898 -7.529649 -7.347350 -22.66275 -69.07755 -69.07755 -68.27142 -66.62737 -64.77701 -62.74780 -60.56048 -58.23272 -55.77792 -53.20725 -50.53006 -47.75426 -44.88666 -41.93317 -38.89925 -35.78875 -32.60649 -29.35592 -26.04033 -22.66275 4.225875 3.205822 2.871368 2.781267 2.640491 2.453813 2.226408 1.961136 1.666789 1.347623 1.021469 0.6957737 0.3981138 0.1488001 -4.1588541E-02 -0.1695323 -0.2450299 -0.2834413 -0.3023493 -24.65536 4.863957 4.014345 3.610145 3.366471 3.087244 2.781970 2.455184 2.112501 1.749932 1.379362 1.005384 0.6567887 0.3634579 0.1662232 8.1714608E-02 0.1043781 0.2052021 0.3535961 0.5270843 -24.65536 5.198755 4.493328 4.014735 3.620170 3.209960 2.790970 2.371493 1.951598 1.529420 1.107954 0.6844897 0.2940523 -3.2017916E-02 -0.2308888 -0.2564232 -0.1154290 0.1431623 0.4683789 0.8283861 -24.65536 5.307727 4.711062 4.189400 3.696670 3.199681 2.706733 2.218143 1.735207 1.264076 0.7925367 0.3284817 -0.1122708 -0.4991122 -0.7601245 -0.7934883 -0.5769876 -0.1780306 0.3186335 0.8635015 -24.65536 5.250109 4.741129 4.199514 3.649026 3.101209 2.559343 2.023258 1.502952 0.9859276 0.4808503 -1.2087084E-02 -0.4902973 -0.9353589 -1.282700 -1.395680 -1.169575 -0.6579691 2.8861794E-03 0.7311919 -24.65536 5.064589 4.631408 4.082364 3.503918 2.926463 2.355127 1.793026 1.242770 0.6959556 0.1694169 -0.3420516 -0.8390450 -1.321975 -1.742528 -1.973454 -1.819842 -1.245030 -0.4330117 0.4764741 -24.65536 4.774621 4.405353 3.866049 3.275509 2.683744 2.100173 1.519717 0.9500861 0.3908724 -0.1485543 -0.6700193 -1.181376 -1.676270 -2.138058 -2.476058 -2.461417 -1.900091 -0.9621052 0.1245219 -24.65536 4.399799 4.084968 3.564137 2.974852 2.383018 1.791883 1.201590 0.6291835 6.3471489E-02 -0.4817302 -1.008399 -1.524482 -2.020670 -2.489993 -2.894943 -3.031106 -2.571382 -1.549421 -0.2927962 -24.65536 3.951917 3.685683 3.188540 2.611338 2.023266 1.432912 0.8490790 0.2754689 -0.2876644 -0.8356260 -1.362424 -1.872579 -2.361582 -2.828556 -3.249631 -3.503957 -3.220634 -2.183036 -0.7698532 -24.65536 3.433107 3.213943 2.744235 2.182921 1.608500 1.030360 0.4568098 -0.1102479 -0.6686931 -1.213455 -1.732010 -2.234192 -2.706137 -3.163338 -3.574528 -3.888700 -3.797077 -2.834347 -1.287653 -24.65536 2.843998 2.669407 2.231527 1.696213 1.141393 0.5798662 2.2413271E-02 -0.5345735 -1.082882 -1.615051 -2.122241 -2.605265 -3.064104 -3.492844 -3.889608 -4.218543 -4.283644 -3.491668 -1.852667 -24.65536 2.185701 2.054364 1.653521 1.147915 0.6187917 7.9606012E-02 -0.4615559 -0.9994212 -1.531526 -2.045895 -2.531940 -2.998040 -3.428861 -3.831856 -4.202467 -4.523320 -4.686881 -4.123566 -2.458209 -24.65536 1.449402 1.362303 1.002721 0.5328873 3.4019738E-02 -0.4780798 -0.9945652 -1.509427 -2.016007 -2.506836 -2.971804 -3.406488 -3.806563 -4.179501 -4.523100 -4.817524 -5.028445 -4.694617 -3.095780 -24.65536 0.6232473 0.5828206 0.2709074 -0.1575691 -0.6181943 -1.095943 -1.578247 -2.062232 -2.541737 -3.002638 -3.429220 -3.833879 -4.202449 -4.541254 -4.856369 -5.126438 -5.337376 -5.187152 -3.764362 -24.65536 -0.3091923 -0.2973738 -0.5558758 -0.9326079 -1.346015 -1.780461 -2.222420 -2.669182 -3.107038 -3.526834 -3.918142 -4.287150 -4.622426 -4.929319 -5.212315 -5.453189 -5.640620 -5.611001 -4.461178 -24.65536 -1.384691 -1.308698 -1.502965 -1.816365 -2.172196 -2.548417 -2.936093 -3.332814 -3.726398 -4.103370 -4.452338 -4.783844 -5.083107 -5.354721 -5.604274 -5.807574 -5.959785 -5.996408 -5.167454 -24.65536 -2.669387 -2.510401 -2.622837 -2.854541 -3.130952 -3.434635 -3.757441 -4.093595 -4.432243 -4.759243 -5.063961 -5.346841 -5.611630 -5.841045 -6.047285 -6.211257 -6.338667 -6.407554 -5.875230 -24.65536 -4.322051 -4.046865 -4.045752 -4.162919 -4.333308 -4.539441 -4.775586 -5.035119 -5.305688 -5.574705 -5.817307 -6.041259 -6.256010 -6.438484 -6.605668 -6.741307 -6.853489 -6.938831 -6.631258 -24.65536 -6.962078 -6.471787 -6.270233 -6.198713 -6.197909 -6.248650 -6.346024 -6.478693 -6.636902 -6.811417 -6.971039 -7.120897 -7.271780 -7.411047 -7.538272 -7.642181 -7.719370 -7.816813 -7.647243 -24.65536 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.36877 -65.98055 -63.43839 -60.75822 -57.95214 -55.03048 -52.00195 -48.87403 -45.65347 -42.34521 -38.95501 -35.48711 -31.94552 -28.33385 -24.65536 4.499068 3.384118 3.105763 3.013666 2.872602 2.687385 2.453450 2.173446 1.860159 1.524104 1.173548 0.8222544 0.5007828 0.2291363 2.3933316E-02 -0.1139014 -0.1928057 -0.2322702 -0.2503489 -26.68411 5.205826 4.276503 3.891936 3.632211 3.340642 3.019864 2.679793 2.315080 1.936354 1.543446 1.148406 0.7734445 0.4582873 0.2457308 0.1565026 0.1854631 0.2998412 0.4640765 0.6542042 -26.68411 5.580797 4.810180 4.320364 3.899829 3.463280 3.019062 2.574368 2.131667 1.691064 1.245479 0.8000586 0.3823684 3.1137686E-02 -0.1801207 -0.2062503 -4.7056060E-02 0.2402325 0.5969269 0.9892963 -26.68411 5.710851 5.059043 4.508176 3.980853 3.451892 2.924685 2.407984 1.901035 1.404761 0.9100106 0.4222587 -4.5942415E-02 -0.4615071 -0.7409450 -0.7794071 -0.5392914 -9.7813144E-02 0.4459854 1.039103 -26.68411 5.659189 5.103722 4.519992 3.931372 3.345820 2.768960 2.204479 1.653021 1.110891 0.5807440 6.4499572E-02 -0.4397147 -0.9101593 -1.286921 -1.420681 -1.176286 -0.6119600 0.1116151 0.9042658 -26.68411 5.468168 4.994952 4.397583 3.777345 3.163218 2.556492 1.963224 1.380573 0.8065882 0.2546486 -0.2826368 -0.8043306 -1.308051 -1.758944 -2.025187 -1.875427 -1.244213 -0.3546362 0.6354772 -26.68411 5.168044 4.763211 4.170638 3.539842 2.911517 2.290841 1.678228 1.075157 0.4837388 -8.1661083E-02 -0.6300468 -1.160120 -1.676648 -2.164420 -2.538439 -2.552752 -1.944442 -0.9147509 0.2690291 -26.68411 4.780059 4.432961 3.857327 3.228991 2.599120 1.972065 1.348026 0.7378336 0.1386350 -0.4321255 -0.9824734 -1.517116 -2.033670 -2.529053 -2.964164 -3.147536 -2.671713 -1.551817 -0.1817708 -26.68411 4.314579 4.020080 3.468305 2.851240 2.225941 1.600003 0.9778944 0.3673003 -0.2298371 -0.8005708 -1.352476 -1.882300 -2.391667 -2.878576 -3.331018 -3.632220 -3.361997 -2.229461 -0.6866466 -26.68411 3.774934 3.531162 3.006864 2.407455 1.794460 1.179617 0.5677118 -3.5597373E-02 -0.6254865 -1.195413 -1.739160 -2.260610 -2.752645 -3.229529 -3.665621 -4.024892 -3.967226 -2.925345 -1.233942 -26.68411 3.163542 2.966671 2.474806 1.901086 1.309058 0.7108582 0.1137508 -0.4760476 -1.059769 -1.617968 -2.149265 -2.652881 -3.126194 -3.583579 -3.997700 -4.362861 -4.466811 -3.629206 -1.834989 -26.68411 2.478240 2.327013 1.874406 1.332636 0.7660086 0.1912646 -0.3879638 -0.9630592 -1.530734 -2.071738 -2.581520 -3.064939 -3.514870 -3.939453 -4.331232 -4.680510 -4.873097 -4.298660 -2.476040 -26.68411 1.713082 1.608974 1.199449 0.6948446 0.1605356 -0.3877485 -0.9434192 -1.497450 -2.041383 -2.553816 -3.039999 -3.498607 -3.912427 -4.311311 -4.671730 -4.994247 -5.219036 -4.898438 -3.153715 -26.68411 0.8546308 0.8001155 0.4404034 -2.0850338E-02 -0.5178889 -1.031618 -1.555173 -2.077425 -2.590724 -3.074670 -3.525229 -3.947960 -4.333568 -4.698551 -5.027971 -5.317981 -5.536834 -5.404814 -3.862967 -26.68411 -0.1156673 -0.1151207 -0.4185983 -0.8283184 -1.278021 -1.747222 -2.231055 -2.716655 -3.189147 -3.630641 -4.040827 -4.430120 -4.780697 -5.112289 -5.403620 -5.661411 -5.852486 -5.834007 -4.599229 -26.68411 -1.234271 -1.167194 -1.403852 -1.748957 -2.137922 -2.552537 -2.981541 -3.416743 -3.841373 -4.240316 -4.606891 -4.953485 -5.270018 -5.562919 -5.819489 -6.032169 -6.186572 -6.225162 -5.350765 -26.68411 -2.569369 -2.416583 -2.568554 -2.829551 -3.138610 -3.475499 -3.836546 -4.211916 -4.580884 -4.930728 -5.249500 -5.551398 -5.826898 -6.080285 -6.289373 -6.455467 -6.583147 -6.642344 -6.101826 -26.68411 -4.287313 -4.014097 -4.042177 -4.186828 -4.386162 -4.622958 -4.893286 -5.187007 -5.487093 -5.777012 -6.040518 -6.287810 -6.508471 -6.710037 -6.875531 -7.006094 -7.113783 -7.196934 -6.891190 -26.68411 -7.012467 -6.517637 -6.335721 -6.289774 -6.312773 -6.387471 -6.510124 -6.676116 -6.864250 -7.055616 -7.237217 -7.408144 -7.571644 -7.718966 -7.848536 -7.947852 -8.025430 -8.103086 -7.954170 -26.68411 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -68.74316 -65.83266 -62.78613 -59.61488 -56.32845 -52.93499 -49.44159 -45.85444 -42.17899 -38.42010 -34.58214 -30.66897 -26.68411 4.766491 3.555748 3.332433 3.240609 3.099206 2.912685 2.676017 2.386158 2.055269 1.702149 1.323629 0.9518297 0.6050584 0.3110780 8.8633157E-02 -5.7748135E-02 -0.1412065 -0.1817400 -0.1991668 -28.74740 5.542799 4.531283 4.169114 3.890145 3.583859 3.250468 2.899485 2.516417 2.119679 1.705215 1.287907 0.8893817 0.5524699 0.3213681 0.2271985 0.2635652 0.3910818 0.5711672 0.7780210 -28.74740 5.958308 5.120267 4.619642 4.170389 3.709361 3.242079 2.774134 2.308493 1.848526 1.375895 0.9139797 0.4666352 9.3178637E-02 -0.1373874 -0.1670744 1.0823472E-02 0.3259296 0.7144071 1.139395 -28.74740 6.107696 5.399757 4.819328 4.258784 3.698614 3.139559 2.593504 2.063065 1.539429 1.024064 0.5149015 2.0226764E-02 -0.4219170 -0.7245135 -0.7746188 -0.5103613 -2.7318159E-02 0.5640739 1.205925 -28.74740 6.062259 5.459643 4.834646 4.208519 3.587477 2.974021 2.382680 1.798026 1.230079 0.6805632 0.1388819 -0.3873815 -0.8849694 -1.289667 -1.449318 -1.188349 -0.5721718 0.2146034 1.072270 -28.74740 5.866881 5.353647 4.707544 4.047843 3.394957 2.754727 2.128019 1.508933 0.9143502 0.3352977 -0.2250166 -0.7684156 -1.293867 -1.773215 -2.079580 -1.937199 -1.254653 -0.2874972 0.7840484 -28.74740 5.556351 5.115899 4.471539 3.799292 3.135834 2.476504 1.828159 1.194538 0.5752618 -1.6527828E-02 -0.5879592 -1.137157 -1.674335 -2.182924 -2.597786 -2.647636 -1.997584 -0.8775165 0.4045176 -28.74740 5.154278 4.774998 4.146111 3.478958 2.809354 2.144588 1.489097 0.8428805 0.2133977 -0.3835347 -0.9593893 -1.507902 -2.045406 -2.558954 -3.028636 -3.258840 -2.772550 -1.555983 -7.1014099E-02 -28.74740 4.671794 4.349599 3.742716 3.085545 2.422069 1.762607 1.103987 0.4557679 -0.1723093 -0.7699010 -1.342612 -1.887564 -2.417477 -2.921235 -3.405833 -3.747332 -3.500693 -2.279068 -0.6049337 -28.74740 4.111964 3.843067 3.263374 2.627258 1.978013 1.324311 0.6758192 3.3854496E-02 -0.5892883 -1.180050 -1.748261 -2.280338 -2.797423 -3.288742 -3.759711 -4.145691 -4.129315 -3.023410 -1.186309 -28.74740 3.478581 3.258956 2.714141 2.103688 1.472786 0.8382109 0.2015494 -0.4283084 -1.040218 -1.621486 -2.175618 -2.691737 -3.187311 -3.664454 -4.106933 -4.493803 -4.638425 -3.771811 -1.821731 -28.74740 2.766681 2.595735 2.090986 1.514074 0.9104089 0.2973225 -0.3193437 -0.9352391 -1.529889 -2.091889 -2.626878 -3.119871 -3.598232 -4.043792 -4.458576 -4.822974 -5.043004 -4.477071 -2.496876 -28.74740 1.972758 1.851446 1.393679 0.8530704 0.2833672 -0.3017143 -0.8968720 -1.490459 -2.061652 -2.596849 -3.104321 -3.577397 -4.023203 -4.439991 -4.817741 -5.152537 -5.393141 -5.102856 -3.213659 -28.74740 1.083864 1.015055 0.6086316 0.1115839 -0.4201023 -0.9713995 -1.536395 -2.098446 -2.637560 -3.142666 -3.617243 -4.055319 -4.471954 -4.853478 -5.193005 -5.487422 -5.720026 -5.620502 -3.963243 -28.74740 7.8305587E-02 6.6701889E-02 -0.2820083 -0.7239628 -1.209188 -1.717006 -2.242262 -2.764717 -3.269206 -3.730736 -4.163744 -4.568128 -4.949696 -5.292789 -5.588809 -5.848752 -6.046255 -6.052629 -4.737980 -28.74740 -1.080025 -1.023127 -1.301945 -1.678841 -2.103536 -2.555353 -3.026306 -3.496765 -3.953683 -4.371699 -4.765383 -5.129228 -5.469694 -5.767418 -6.024951 -6.239484 -6.393434 -6.448329 -5.526886 -28.74740 -2.467018 -2.321135 -2.508510 -2.801832 -3.146690 -3.520303 -3.918671 -4.328081 -4.729093 -5.096429 -5.443653 -5.761085 -6.054684 -6.310203 -6.516419 -6.680821 -6.804929 -6.873713 -6.315771 -28.74740 -4.250477 -3.980400 -4.040832 -4.215052 -4.447392 -4.716067 -5.019351 -5.346392 -5.674077 -5.979715 -6.272714 -6.532943 -6.770550 -6.967046 -7.124717 -7.254019 -7.353677 -7.444186 -7.141440 -28.74740 -7.057584 -6.558965 -6.401326 -6.379696 -6.433411 -6.533468 -6.680686 -6.883257 -7.092525 -7.300277 -7.507196 -7.699091 -7.870487 -8.016161 -8.132473 -8.229078 -8.300804 -8.378014 -8.253099 -28.74740 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -67.70477 -64.27908 -60.72985 -57.06591 -53.29494 -49.42364 -45.45790 -41.40299 -37.26356 -33.04377 -28.74740 5.027107 3.717159 3.557905 3.461961 3.323977 3.127055 2.888233 2.599409 2.253262 1.876939 1.475994 1.079459 0.7071672 0.3912666 0.1529993 -3.7525881E-03 -9.1227949E-02 -0.1328847 -0.1498276 -30.84375 5.874768 4.778153 4.436926 4.143535 3.815899 3.470333 3.109412 2.716636 2.299781 1.864643 1.421889 1.001529 0.6421160 0.3935804 0.2958404 0.3381577 0.4793454 0.6754210 0.8990891 -30.84375 6.331947 5.423007 4.914305 4.432679 3.943791 3.456064 2.969665 2.484629 1.998469 1.506003 1.018062 0.5472239 0.1529868 -0.1020182 -0.1320381 6.2105086E-02 0.4058116 0.8262012 1.284116 -30.84375 6.501065 5.735973 5.123176 4.526737 3.937318 3.350292 2.777320 2.218023 1.670207 1.131891 0.6004391 8.2464308E-02 -0.3808670 -0.7137215 -0.7742990 -0.4882350 3.6920503E-02 0.6765316 1.367621 -30.84375 6.457778 5.807128 5.141289 4.479523 3.823942 3.177943 2.553069 1.937485 1.344979 0.7714192 0.2076131 -0.3390967 -0.8584934 -1.295519 -1.486475 -1.216901 -0.5516143 0.2986015 1.221851 -30.84375 6.259133 5.705099 5.012803 4.313157 3.624774 2.946920 2.285423 1.634689 1.013378 0.4106606 -0.1712852 -0.7324727 -1.275769 -1.785609 -2.133728 -2.010487 -1.283497 -0.2392073 0.9144356 -30.84375 5.939347 5.463508 4.767107 4.057278 3.353424 2.656841 1.974210 1.304362 0.6607422 4.1073468E-02 -0.5465791 -1.115447 -1.666819 -2.202559 -2.655039 -2.740396 -2.063548 -0.8539255 0.5272167 -30.84375 5.523509 5.112611 4.431077 3.722797 3.013520 2.313374 1.620721 0.9397997 0.2822202 -0.3388766 -0.9311768 -1.498410 -2.052622 -2.590384 -3.085686 -3.360645 -2.876957 -1.564673 3.6612902E-02 -30.84375 5.023550 4.673339 4.011139 3.314433 2.613987 1.916606 1.222420 0.5354074 -0.1195984 -0.7408813 -1.329822 -1.893078 -2.441098 -2.971312 -3.471053 -3.847739 -3.639896 -2.331018 -0.5238532 -30.84375 4.443127 4.149114 3.515283 2.841166 2.155043 1.464434 0.7745708 9.6043937E-02 -0.5533351 -1.167126 -1.751165 -2.303043 -2.840337 -3.350972 -3.840848 -4.250311 -4.290459 -3.128162 -1.143748 -30.84375 3.787123 3.544940 2.947700 2.300505 1.632711 0.9587150 0.2831328 -0.3839990 -1.019723 -1.623786 -2.194983 -2.732599 -3.250441 -3.742672 -4.200972 -4.607080 -4.806456 -3.922205 -1.815580 -30.84375 3.051034 2.859711 2.304584 1.689751 1.050956 0.3992768 -0.2588003 -0.9080858 -1.529535 -2.111724 -2.666252 -3.183080 -3.682536 -4.145958 -4.570408 -4.948584 -5.210602 -4.662428 -2.527170 -30.84375 2.229191 2.090564 1.584440 1.007911 0.4009994 -0.2212360 -0.8592786 -1.485806 -2.083770 -2.640525 -3.165909 -3.664368 -4.136370 -4.560303 -4.949453 -5.293502 -5.561684 -5.307291 -3.282234 -30.84375 1.310273 1.226280 0.7733079 0.2437351 -0.3252665 -0.9155134 -1.522186 -2.118286 -2.685652 -3.210557 -3.709139 -4.174479 -4.607408 -4.994821 -5.343132 -5.644783 -5.895696 -5.830604 -4.065490 -30.84375 0.2719383 0.2472941 -0.1447377 -0.6197672 -1.141556 -1.690652 -2.253841 -2.811589 -3.341606 -3.832578 -4.288090 -4.716653 -5.111071 -5.455363 -5.760423 -6.020538 -6.231886 -6.260771 -4.876922 -30.84375 -0.9249948 -0.8795880 -1.199117 -1.608571 -2.071202 -2.562713 -3.073056 -3.580433 -4.059899 -4.506851 -4.922658 -5.308878 -5.658406 -5.955394 -6.213632 -6.432628 -6.592902 -6.659101 -5.702468 -30.84375 -2.361627 -2.223858 -2.450046 -2.776229 -3.159111 -3.571260 -4.007047 -4.453160 -4.874308 -5.267800 -5.636260 -5.969935 -6.270013 -6.524953 -6.728703 -6.895700 -7.018023 -7.091983 -6.523315 -30.84375 -4.208199 -3.940913 -4.034214 -4.239815 -4.505603 -4.811245 -5.151821 -5.513004 -5.856776 -6.187842 -6.496120 -6.773165 -7.011082 -7.209919 -7.363245 -7.493523 -7.589746 -7.674256 -7.379068 -30.84375 -7.095384 -6.587889 -6.454586 -6.460997 -6.539948 -6.675292 -6.862253 -7.085778 -7.314974 -7.550890 -7.769665 -7.969757 -8.138025 -8.292139 -8.405641 -8.501580 -8.572051 -8.637955 -8.533996 -30.84375 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.01932 -65.20261 -61.26350 -57.21024 -53.05005 -48.78927 -44.43353 -39.98778 -35.45650 -30.84375 5.283427 3.870611 3.775997 3.676584 3.534548 3.322811 3.091013 2.798377 2.448900 2.046962 1.622602 1.203645 0.8059154 0.4657934 0.2081845 4.0045977E-02 -5.2204419E-02 -9.5500834E-02 -0.1121823 -32.97178 6.203732 5.017542 4.702081 4.386285 4.032426 3.671084 3.305492 2.911603 2.474033 2.016357 1.552356 1.112128 0.7262606 0.4620492 0.3573435 0.4058638 0.5605853 0.7726772 1.013252 -32.97178 6.705737 5.721278 5.203087 4.686200 4.163678 3.659076 3.158452 2.654397 2.141664 1.628210 1.118019 0.6314967 0.2100553 -6.3466527E-02 -9.6212141E-02 0.1162430 0.4891241 0.9419403 1.433178 -32.97178 6.888592 6.064580 5.420269 4.784094 4.165549 3.554981 2.955752 2.366362 1.793878 1.235426 0.6844723 0.1451651 -0.3419901 -0.7054337 -0.7789901 -0.4721191 9.5349215E-02 0.7834820 1.524346 -32.97178 6.847761 6.148345 5.438713 4.741488 4.054725 3.378443 2.715247 2.071192 1.453584 0.8563836 0.2778126 -0.2909980 -0.8309488 -1.302275 -1.529558 -1.257431 -0.5466409 0.3672262 1.356685 -32.97178 6.644168 6.048718 5.310342 4.575079 3.849929 3.133735 2.435371 1.753171 1.105870 0.4845640 -0.1172285 -0.6953706 -1.258070 -1.799385 -2.184958 -2.095439 -1.336018 -0.2150429 1.021286 -32.97178 6.316730 5.804720 5.059247 4.310025 3.565535 2.831341 2.110858 1.408238 0.7423787 9.9654056E-02 -0.5050044 -1.092228 -1.660622 -2.223678 -2.700190 -2.837487 -2.150339 -0.8526449 0.6281047 -32.97178 5.887554 5.445382 4.710335 3.960184 3.213097 2.474203 1.744527 1.031689 0.3505974 -0.2970670 -0.9019132 -1.491048 -2.063241 -2.621321 -3.129829 -3.456983 -2.987729 -1.580612 0.1378019 -32.97178 5.369471 4.991567 4.273245 3.538411 2.799267 2.062659 1.332532 0.6121333 -6.9817282E-02 -0.7143051 -1.316228 -1.901978 -2.468211 -3.012185 -3.520832 -3.945017 -3.782048 -2.390726 -0.4502025 -32.97178 4.768551 4.449142 3.761387 3.048896 2.324424 1.597081 0.8686779 0.1554269 -0.5171042 -1.155481 -1.750787 -2.331057 -2.882539 -3.404519 -3.902862 -4.347649 -4.446290 -3.239507 -1.108583 -32.97178 4.089475 3.824744 3.175177 2.491333 1.787684 1.073265 0.3589270 -0.3416917 -1.001930 -1.626783 -2.215184 -2.780000 -3.312768 -3.810710 -4.282009 -4.712651 -4.960101 -4.073872 -1.813798 -32.97178 3.330405 3.118583 2.513373 1.861831 1.186142 0.4949335 -0.2039011 -0.8857687 -1.530728 -2.136724 -2.706782 -3.253328 -3.759487 -4.233775 -4.665987 -5.067807 -5.364379 -4.843509 -2.561057 -32.97178 2.481137 2.324817 1.770491 1.159769 0.5165736 -0.1487966 -0.8237736 -1.485888 -2.106292 -2.688229 -3.234190 -3.753958 -4.233165 -4.664543 -5.065334 -5.429577 -5.716197 -5.500073 -3.351375 -32.97178 1.534664 1.434567 0.9359128 0.3727585 -0.2325946 -0.8656266 -1.509988 -2.140207 -2.730347 -3.283464 -3.801121 -4.290835 -4.726908 -5.121888 -5.481966 -5.802361 -6.058746 -6.022666 -4.168571 -32.97178 0.4647461 0.4256773 -1.0365137E-02 -0.5178857 -1.078644 -1.667221 -2.269903 -2.861682 -3.414495 -3.935191 -4.411875 -4.856032 -5.255994 -5.609914 -5.921753 -6.195073 -6.408261 -6.446651 -5.010237 -32.97178 -0.7712407 -0.7372585 -1.096808 -1.541164 -2.042678 -2.575143 -3.126315 -3.667897 -4.169096 -4.640637 -5.073894 -5.470872 -5.826580 -6.135081 -6.394102 -6.624322 -6.781470 -6.844199 -5.864724 -32.97178 -2.255206 -2.125720 -2.388168 -2.749321 -3.169696 -3.623506 -4.102355 -4.574016 -5.019736 -5.438814 -5.818068 -6.159167 -6.463177 -6.726190 -6.934420 -7.103412 -7.217811 -7.280604 -6.702858 -32.97178 -4.159909 -3.895900 -4.022082 -4.258878 -4.562168 -4.908867 -5.292176 -5.672315 -6.045172 -6.400018 -6.716602 -6.997749 -7.239101 -7.437926 -7.592447 -7.716119 -7.803699 -7.870449 -7.570008 -32.97178 -7.140425 -6.623766 -6.516080 -6.550875 -6.665066 -6.834533 -7.058894 -7.300097 -7.554039 -7.813437 -8.038656 -8.237675 -8.409384 -8.550903 -8.662152 -8.749007 -8.808102 -8.851217 -8.745903 -32.97178 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -69.07755 -65.52477 -61.18473 -56.73114 -52.17076 -47.50960 -42.75293 -37.90555 -32.97178 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -2.171675 -2.139929 -2.107424 -2.074170 -2.040176 -2.005448 -1.969995 -1.933824 -1.896936 -1.859351 -1.821077 -1.782121 -1.742491 -1.702194 -1.661235 -1.619618 -1.577361 -1.534471 -1.490957 -1.446824 -1.604899 -1.608453 -1.612330 -1.628600 -1.646573 -1.664384 -1.680341 -1.693265 -1.702043 -1.715107 -1.739201 -1.780612 -1.816739 -1.848264 -1.874275 -1.903873 -1.934792 -1.962113 -1.984558 -2.590475 -1.653778 -1.655567 -1.657611 -1.671598 -1.687459 -1.703207 -1.717285 -1.728493 -1.735764 -1.747004 -1.769074 -1.812390 -1.850418 -1.882270 -1.907671 -1.936616 -1.966245 -1.991328 -2.010521 -2.590475 -1.705246 -1.705251 -1.705460 -1.717224 -1.731012 -1.744756 -1.757062 -1.766619 -1.772442 -1.782015 -1.802198 -1.847057 -1.885578 -1.917487 -1.942041 -1.970443 -1.998646 -2.021380 -2.037290 -2.590475 -1.759345 -1.757502 -1.755839 -1.765400 -1.777066 -1.788850 -1.799421 -1.807296 -1.811684 -1.819677 -1.838148 -1.884400 -1.923060 -1.954442 -1.978240 -2.005913 -2.032587 -2.052886 -2.065506 -2.590475 -1.816768 -1.813047 -1.809509 -1.816851 -1.826356 -1.836227 -1.845112 -1.851359 -1.854343 -1.860778 -1.877534 -1.923415 -1.961962 -1.992588 -2.015733 -2.042472 -2.067498 -2.085194 -2.094486 -2.590475 -1.876592 -1.870954 -1.865519 -1.870639 -1.877925 -1.885883 -1.892968 -1.897603 -1.899090 -1.903909 -1.918943 -1.964180 -2.001817 -2.031289 -2.053889 -2.079331 -2.102545 -2.117435 -2.123371 -2.590475 -1.938744 -1.931131 -1.923796 -1.926835 -1.931925 -1.938000 -1.943227 -1.946197 -1.946063 -1.949192 -1.962550 -2.007022 -2.043607 -2.072041 -2.093823 -2.117749 -2.138957 -2.150936 -2.153476 -2.590475 -2.005105 -1.995360 -1.985915 -1.986821 -1.989672 -1.993797 -1.997115 -1.998423 -1.996569 -1.997967 -2.009501 -2.052388 -2.087481 -2.115103 -2.135715 -2.157863 -2.176824 -2.185776 -2.184862 -2.590475 -2.075499 -2.063438 -2.051697 -2.050446 -2.050910 -2.052878 -2.054189 -2.053688 -2.049994 -2.049562 -2.059171 -2.100424 -2.134178 -2.160877 -2.179859 -2.200170 -2.216501 -2.222337 -2.217899 -2.590475 -2.151010 -2.136361 -2.122134 -2.118466 -2.116522 -2.116133 -2.115292 -2.112787 -2.107156 -2.104706 -2.112215 -2.151340 -2.183935 -2.209244 -2.226231 -2.244332 -2.257716 -2.260325 -2.252270 -2.590475 -2.232099 -2.214429 -2.197450 -2.191030 -2.186537 -2.183608 -2.180433 -2.175608 -2.167846 -2.163067 -2.168313 -2.205451 -2.236402 -2.259718 -2.274559 -2.289743 -2.299635 -2.299005 -2.287201 -2.590475 -2.320947 -2.299992 -2.279787 -2.270211 -2.262840 -2.257121 -2.251376 -2.244040 -2.234007 -2.226674 -2.229411 -2.264290 -2.292889 -2.313742 -2.325926 -2.337591 -2.343779 -2.339619 -2.323939 -2.590475 -2.420413 -2.395510 -2.371438 -2.358356 -2.347535 -2.338535 -2.329704 -2.319436 -2.306772 -2.296544 -2.296390 -2.328133 -2.353603 -2.371781 -2.380071 -2.387394 -2.389841 -2.381786 -2.362041 -2.590475 -2.531514 -2.502517 -2.474058 -2.456956 -2.442067 -2.429127 -2.416556 -2.402800 -2.386957 -2.373428 -2.369869 -2.397644 -2.419759 -2.433426 -2.437021 -2.439223 -2.437536 -2.425151 -2.401091 -2.590475 -2.659389 -2.625834 -2.592449 -2.570881 -2.551682 -2.533925 -2.516839 -2.498695 -2.478860 -2.461497 -2.453997 -2.477174 -2.493796 -2.501818 -2.501861 -2.496571 -2.490014 -2.472841 -2.444358 -2.590475 -2.810185 -2.771174 -2.732193 -2.705420 -2.681135 -2.657733 -2.635032 -2.611278 -2.586147 -2.563982 -2.551518 -2.567606 -2.577557 -2.580185 -2.575015 -2.561182 -2.548115 -2.525550 -2.492493 -2.590475 -2.995741 -2.951239 -2.906672 -2.868559 -2.838441 -2.807916 -2.778604 -2.748192 -2.716557 -2.684861 -2.666548 -2.674575 -2.677014 -2.672613 -2.660189 -2.639611 -2.614886 -2.586488 -2.548635 -2.590475 -3.241841 -3.194561 -3.146712 -3.097819 -3.048106 -3.008703 -2.971208 -2.934035 -2.894919 -2.854000 -2.815255 -2.812925 -2.804815 -2.789918 -2.767913 -2.738486 -2.702719 -2.665704 -2.715173 -2.590475 -3.649233 -3.589225 -3.527776 -3.463701 -3.407030 -3.348345 -3.288144 -3.225745 -3.174710 -3.123175 -3.071832 -3.041709 -3.007633 -2.973914 -2.940674 -2.902217 -2.858615 -2.795649 -2.709366 -2.590475 -4.176857 -4.115317 -4.051020 -3.984023 -3.914375 -3.842139 -3.767384 -3.690166 -3.610519 -3.528526 -3.444241 -3.357706 -3.268967 -3.178095 -3.085378 -2.990113 -2.893093 -2.794125 -2.693486 -2.590475 -1.087149 -1.134997 -1.185060 -1.235671 -1.288054 -1.353671 -1.416482 -1.474370 -1.524773 -1.567707 -1.611214 -1.663443 -1.710875 -1.753217 -1.789619 -1.821161 -1.853660 -1.880987 -1.903059 -3.828560 -1.141718 -1.183310 -1.227720 -1.273741 -1.321708 -1.380904 -1.437933 -1.494007 -1.551502 -1.600029 -1.649987 -1.707009 -1.757436 -1.800629 -1.836141 -1.865176 -1.894199 -1.916531 -1.932036 -3.828560 -1.204204 -1.239395 -1.278463 -1.319735 -1.363471 -1.417005 -1.468936 -1.523117 -1.585981 -1.639575 -1.696202 -1.757084 -1.809420 -1.852859 -1.887263 -1.913870 -1.939344 -1.956800 -1.965739 -3.828560 -1.274716 -1.304133 -1.337766 -1.374118 -1.413562 -1.462116 -1.509394 -1.562286 -1.628700 -1.689238 -1.750899 -1.814605 -1.868269 -1.911761 -1.944963 -1.969468 -1.991439 -2.004293 -2.006726 -3.828560 -1.353448 -1.377466 -1.405664 -1.436790 -1.471796 -1.515628 -1.558356 -1.609660 -1.681060 -1.747377 -1.813383 -1.878911 -1.933381 -1.976843 -2.008745 -2.031472 -2.050193 -2.058588 -2.054626 -3.828560 -1.441117 -1.459712 -1.482601 -1.508522 -1.538783 -1.577677 -1.616278 -1.666282 -1.742984 -1.813901 -1.882794 -1.949486 -2.004550 -2.048064 -2.078930 -2.100021 -2.115817 -2.119942 -2.109815 -3.828560 -1.538000 -1.551504 -1.569162 -1.589889 -1.615272 -1.649333 -1.683824 -1.732170 -1.812435 -1.886466 -1.956694 -2.023961 -2.079386 -2.122537 -2.152723 -2.172164 -2.185164 -2.185192 -2.168994 -3.828560 -1.643514 -1.652140 -1.664798 -1.680864 -1.701484 -1.730510 -1.760685 -1.807205 -1.889370 -1.964457 -2.035105 -2.102179 -2.157898 -2.200521 -2.230315 -2.247863 -2.258525 -2.254412 -2.232290 -3.828560 -1.757670 -1.761774 -1.769455 -1.781227 -1.797121 -1.820991 -1.846874 -1.890616 -1.972728 -2.047526 -2.117364 -2.184002 -2.239153 -2.281427 -2.310694 -2.326738 -2.335003 -2.326514 -2.298590 -3.828560 -1.881169 -1.880813 -1.883690 -1.891052 -1.902177 -1.920777 -1.941808 -1.981814 -2.062102 -2.135293 -2.203809 -2.269060 -2.322828 -2.364952 -2.392992 -2.407531 -2.413725 -2.400422 -2.366689 -3.828560 -2.013423 -2.008945 -2.007385 -2.010295 -2.016788 -2.029988 -2.046158 -2.082109 -2.158920 -2.230032 -2.296725 -2.359068 -2.411782 -2.453229 -2.480204 -2.493427 -2.497259 -2.479125 -2.439753 -3.828560 -2.154785 -2.146544 -2.140731 -2.139087 -2.140939 -2.148986 -2.160162 -2.191670 -2.264644 -2.332782 -2.395762 -2.455415 -2.506515 -2.546260 -2.572846 -2.584979 -2.585510 -2.562689 -2.517585 -3.828560 -2.309845 -2.296614 -2.286756 -2.280248 -2.277335 -2.280221 -2.286031 -2.312952 -2.380419 -2.443069 -2.502400 -2.559033 -2.606789 -2.645722 -2.670949 -2.681540 -2.677486 -2.650165 -2.598974 -3.828560 -2.482254 -2.462466 -2.448016 -2.436799 -2.428560 -2.426072 -2.426037 -2.446551 -2.506755 -2.564316 -2.618920 -2.670461 -2.715821 -2.752262 -2.776409 -2.782492 -2.773351 -2.741237 -2.683443 -3.828560 -2.675637 -2.649658 -2.628020 -2.612181 -2.597949 -2.589830 -2.583324 -2.597419 -2.650539 -2.700371 -2.748850 -2.796829 -2.837895 -2.871937 -2.891090 -2.890645 -2.876618 -2.838595 -2.773521 -3.828560 -2.904471 -2.869903 -2.840617 -2.816310 -2.796286 -2.780595 -2.766977 -2.773022 -2.818076 -2.860760 -2.903079 -2.945517 -2.981404 -3.007175 -3.017771 -3.010202 -2.990509 -2.945179 -2.871547 -3.828560 -3.196244 -3.150517 -3.110776 -3.076328 -3.045880 -3.022315 -2.998640 -2.996170 -3.031097 -3.064466 -3.097433 -3.129006 -3.152517 -3.167266 -3.170623 -3.155309 -3.123788 -3.069000 -2.985744 -3.828560 -3.590381 -3.532929 -3.480154 -3.430271 -3.386166 -3.349833 -3.315470 -3.299686 -3.319512 -3.335694 -3.350469 -3.367900 -3.379902 -3.382454 -3.372226 -3.343016 -3.293330 -3.225230 -3.131610 -3.828560 -4.242136 -4.165966 -4.096913 -4.028851 -3.962008 -3.893767 -3.835856 -3.797538 -3.796507 -3.792404 -3.783271 -3.767133 -3.750756 -3.726813 -3.687882 -3.631645 -3.555735 -3.466542 -3.362850 -3.828560 -6.428735 -6.336771 -6.238841 -6.135113 -6.025796 -5.911078 -5.791124 -5.666146 -5.536280 -5.401722 -5.262616 -5.119109 -4.971363 -4.819481 -4.663624 -4.503895 -4.340417 -4.173306 -4.002645 -3.828560 -0.6157154 -0.7178957 -0.8270296 -0.9350691 -1.038481 -1.146534 -1.227156 -1.297862 -1.361395 -1.418177 -1.467795 -1.522445 -1.573990 -1.620984 -1.664582 -1.701572 -1.735063 -1.762191 -1.783536 -5.157303 -0.6530688 -0.7419561 -0.8387295 -0.9363829 -1.029587 -1.126092 -1.219929 -1.303505 -1.377755 -1.443671 -1.500208 -1.561251 -1.616628 -1.665477 -1.707440 -1.739787 -1.766465 -1.784650 -1.795243 -5.157303 -0.7101007 -0.7872820 -0.8729891 -0.9614968 -1.046675 -1.135089 -1.237898 -1.330824 -1.414171 -1.487409 -1.551698 -1.618822 -1.677750 -1.728617 -1.768815 -1.796919 -1.817135 -1.826691 -1.826860 -5.157303 -0.7831249 -0.8497759 -0.9249741 -1.004610 -1.082798 -1.163680 -1.272657 -1.373372 -1.463982 -1.543751 -1.616495 -1.689044 -1.751855 -1.804309 -1.842901 -1.867140 -1.881208 -1.882532 -1.872504 -5.157303 -0.8699046 -0.9266320 -0.9917013 -1.062118 -1.133026 -1.206630 -1.320257 -1.426615 -1.522411 -1.609678 -1.689920 -1.766993 -1.833932 -1.887055 -1.923943 -1.944503 -1.952631 -1.945925 -1.925914 -5.157303 -0.9712509 -1.018510 -1.074413 -1.135756 -1.198897 -1.265501 -1.381871 -1.491769 -1.592713 -1.687325 -1.773859 -1.855955 -1.926388 -1.980232 -2.015858 -2.033222 -2.036125 -2.021887 -1.992242 -5.157303 -1.086912 -1.124987 -1.171964 -1.224940 -1.280130 -1.339555 -1.456456 -1.569310 -1.676190 -1.776778 -1.868647 -1.956065 -2.029101 -2.084026 -2.119161 -2.134033 -2.132442 -2.111552 -2.072696 -5.157303 -1.215670 -1.244745 -1.282975 -1.328042 -1.374866 -1.426501 -1.542798 -1.659578 -1.770958 -1.874936 -1.972113 -2.062324 -2.137308 -2.193305 -2.228339 -2.241306 -2.235654 -2.209141 -2.161116 -5.157303 -1.358470 -1.378792 -1.408848 -1.445730 -1.484628 -1.527988 -1.644981 -1.763632 -1.876731 -1.984246 -2.083790 -2.175270 -2.251489 -2.308530 -2.343517 -2.355404 -2.346486 -2.315086 -2.258333 -5.157303 -1.519680 -1.530948 -1.553051 -1.581590 -1.612740 -1.647761 -1.763469 -1.880864 -1.994812 -2.102966 -2.202140 -2.293352 -2.369729 -2.427304 -2.462602 -2.473838 -2.462076 -2.426239 -2.361109 -5.157303 -1.699753 -1.701712 -1.715428 -1.736424 -1.759767 -1.786857 -1.898272 -2.013206 -2.124722 -2.230256 -2.327576 -2.416976 -2.492406 -2.549311 -2.585220 -2.595783 -2.582330 -2.542252 -2.469050 -5.157303 -1.897115 -1.890724 -1.896078 -1.910052 -1.925853 -1.945198 -2.051747 -2.160549 -2.266738 -2.368188 -2.461962 -2.548125 -2.620990 -2.677802 -2.714316 -2.724532 -2.711246 -2.665984 -2.585258 -5.157303 -2.113067 -2.099215 -2.096599 -2.102863 -2.111644 -2.123409 -2.221888 -2.323666 -2.422426 -2.517344 -2.605735 -2.686844 -2.757350 -2.813422 -2.849286 -2.860453 -2.848336 -2.797691 -2.709795 -5.157303 -2.350405 -2.329186 -2.318971 -2.316996 -2.318516 -2.322310 -2.411620 -2.504791 -2.593368 -2.678483 -2.759258 -2.836204 -2.903603 -2.957187 -2.993041 -3.007314 -2.993384 -2.937698 -2.842753 -5.157303 -2.618206 -2.588263 -2.569962 -2.559474 -2.551945 -2.547926 -2.623935 -2.704293 -2.780276 -2.855762 -2.929135 -3.001011 -3.062476 -3.113386 -3.150667 -3.166081 -3.147492 -3.088095 -2.984735 -5.157303 -2.914078 -2.876325 -2.849262 -2.830381 -2.813944 -2.801508 -2.862346 -2.929989 -2.994683 -3.060156 -3.123295 -3.186011 -3.242372 -3.292671 -3.328274 -3.335775 -3.312130 -3.247550 -3.134354 -5.157303 -3.275287 -3.224498 -3.187931 -3.157478 -3.130718 -3.106939 -3.153672 -3.206502 -3.257605 -3.307855 -3.360773 -3.417531 -3.469431 -3.509035 -3.532264 -3.531827 -3.503217 -3.428589 -3.302192 -5.157303 -3.764388 -3.697121 -3.643948 -3.598553 -3.555173 -3.517397 -3.547354 -3.585451 -3.622500 -3.657746 -3.694116 -3.730288 -3.763319 -3.786805 -3.800574 -3.788880 -3.744207 -3.653401 -3.509154 -5.157303 -4.580369 -4.490570 -4.409716 -4.334870 -4.263376 -4.197578 -4.200777 -4.212068 -4.223730 -4.231823 -4.242093 -4.249432 -4.258272 -4.256916 -4.238113 -4.193254 -4.108772 -3.986192 -3.819293 -5.157303 -8.898183 -8.775170 -8.641802 -8.498505 -8.345731 -8.183902 -8.013422 -7.834692 -7.648057 -7.453883 -7.252459 -7.044115 -6.829096 -6.607687 -6.380114 -6.146612 -5.907633 -5.662640 -5.412556 -5.157303 -0.1850758 -0.3463829 -0.5188937 -0.6938446 -0.8639628 -0.9368649 -1.024035 -1.106906 -1.184624 -1.256444 -1.319012 -1.377388 -1.431944 -1.479479 -1.521849 -1.560854 -1.594331 -1.620494 -1.639755 -6.568760 -0.1913848 -0.3320285 -0.4837926 -0.6373622 -0.7880329 -0.8816473 -0.9878641 -1.088216 -1.181411 -1.264894 -1.335464 -1.400118 -1.456611 -1.503293 -1.541358 -1.572986 -1.595090 -1.607237 -1.610475 -6.568760 -0.2317075 -0.3538480 -0.4873015 -0.6233877 -0.7580304 -0.8737878 -0.9959876 -1.111564 -1.217823 -1.310477 -1.390150 -1.460741 -1.519523 -1.566047 -1.601305 -1.625743 -1.637284 -1.636109 -1.623931 -6.568760 -0.3010277 -0.4066799 -0.5238661 -0.6449966 -0.7657046 -0.8978784 -1.034134 -1.162384 -1.278207 -1.380029 -1.468934 -1.545326 -1.607297 -1.654250 -1.688168 -1.705986 -1.707724 -1.693906 -1.666806 -6.568760 -0.3947839 -0.4856122 -0.5881901 -0.6949095 -0.8031079 -0.9478796 -1.095150 -1.231691 -1.354602 -1.466116 -1.562677 -1.644521 -1.710914 -1.759243 -1.792360 -1.804303 -1.796862 -1.770950 -1.729388 -6.568760 -0.5118031 -0.5893184 -0.6787024 -0.7725044 -0.8687471 -1.021807 -1.175283 -1.315737 -1.445982 -1.564274 -1.667544 -1.755340 -1.826091 -1.878546 -1.910374 -1.917271 -1.901477 -1.864086 -1.808561 -6.568760 -0.6507899 -0.7159269 -0.7932974 -0.8758487 -0.9607337 -1.117321 -1.272006 -1.416833 -1.551940 -1.675486 -1.784610 -1.879213 -1.955059 -2.012990 -2.044441 -2.047817 -2.024976 -1.977141 -1.908443 -6.568760 -0.8097222 -0.8621372 -0.9285997 -1.000333 -1.074521 -1.229542 -1.385498 -1.532541 -1.670223 -1.797498 -1.912731 -2.012692 -2.096848 -2.159042 -2.191418 -2.192680 -2.164362 -2.107457 -2.026394 -6.568760 -0.9857964 -1.025459 -1.080939 -1.141620 -1.205500 -1.359639 -1.513038 -1.659192 -1.797736 -1.928447 -2.047565 -2.153385 -2.244328 -2.309210 -2.343045 -2.343247 -2.310560 -2.245531 -2.152844 -6.568760 -1.182155 -1.209435 -1.253495 -1.304153 -1.357867 -1.505825 -1.655541 -1.798675 -1.937740 -2.070028 -2.192312 -2.304899 -2.398514 -2.465667 -2.501512 -2.501987 -2.466322 -2.395145 -2.291269 -6.568760 -1.396379 -1.411566 -1.443833 -1.484672 -1.528017 -1.669068 -1.813829 -1.954296 -2.090553 -2.222713 -2.349522 -2.463318 -2.556900 -2.625486 -2.663018 -2.664730 -2.627303 -2.551995 -2.437262 -6.568760 -1.632370 -1.636362 -1.656572 -1.686398 -1.720039 -1.852417 -1.991735 -2.126415 -2.260105 -2.392055 -2.516663 -2.627845 -2.720207 -2.788608 -2.827751 -2.830741 -2.792926 -2.714535 -2.589756 -6.568760 -1.893724 -1.887009 -1.895791 -1.914540 -1.939021 -2.060444 -2.190917 -2.321593 -2.451436 -2.576710 -2.694353 -2.801419 -2.891431 -2.959215 -2.999447 -3.004317 -2.968494 -2.888430 -2.754632 -6.568760 -2.182990 -2.165782 -2.164127 -2.171968 -2.185999 -2.298845 -2.419856 -2.541536 -2.660843 -2.776417 -2.884689 -2.984711 -3.071840 -3.138289 -3.178687 -3.186048 -3.156985 -3.072646 -2.930917 -6.568760 -2.515163 -2.486219 -2.474009 -2.469690 -2.472402 -2.572431 -2.677874 -2.784051 -2.889765 -2.993101 -3.090476 -3.183156 -3.264688 -3.328271 -3.367651 -3.380270 -3.355716 -3.267459 -3.118588 -6.568760 -2.891628 -2.851568 -2.827556 -2.810425 -2.800812 -2.880871 -2.967686 -3.054207 -3.145144 -3.237277 -3.323827 -3.404269 -3.477555 -3.537195 -3.578778 -3.597271 -3.568849 -3.479581 -3.321277 -6.568760 -3.321555 -3.270145 -3.234388 -3.204440 -3.181422 -3.242925 -3.311281 -3.379719 -3.452495 -3.526597 -3.598050 -3.665415 -3.729479 -3.791966 -3.830751 -3.838586 -3.806792 -3.713487 -3.543100 -6.568760 -3.902040 -3.828059 -3.774897 -3.726914 -3.684102 -3.719837 -3.761480 -3.807440 -3.857660 -3.916103 -3.973927 -4.028251 -4.077560 -4.118612 -4.141479 -4.143873 -4.102956 -3.997029 -3.805227 -6.568760 -4.850027 -4.743106 -4.653451 -4.573461 -4.503171 -4.505179 -4.514808 -4.526227 -4.544849 -4.566615 -4.594281 -4.620020 -4.643387 -4.659471 -4.664306 -4.637098 -4.561046 -4.414489 -4.188174 -6.568760 -11.55867 -11.40399 -11.23343 -11.04784 -10.84804 -10.63484 -10.40899 -10.17114 -9.921957 -9.662013 -9.391833 -9.111906 -8.822689 -8.524590 -8.217982 -7.903224 -7.580637 -7.250513 -6.913136 -6.568760 0.2112717 -1.1483068E-02 -0.2528357 -0.4974003 -0.6459293 -0.7309323 -0.8222675 -0.9210916 -1.014912 -1.099301 -1.176405 -1.244967 -1.304920 -1.356192 -1.399401 -1.436352 -1.469744 -1.495318 -1.512976 -8.055264 0.2498010 5.5050090E-02 -0.1543187 -0.3665345 -0.5196553 -0.6302470 -0.7495922 -0.8704428 -0.9808007 -1.080691 -1.168292 -1.240862 -1.301278 -1.347720 -1.382189 -1.406924 -1.423915 -1.429758 -1.425528 -8.055264 0.2368181 6.7166254E-02 -0.1157282 -0.3021822 -0.4613061 -0.6016933 -0.7457395 -0.8845153 -1.011360 -1.125830 -1.222655 -1.300031 -1.361226 -1.403935 -1.431166 -1.445155 -1.446661 -1.433834 -1.408621 -8.055264 0.1797776 3.2473300E-02 -0.1268759 -0.2901468 -0.4560357 -0.6226737 -0.7856342 -0.9393638 -1.082846 -1.210151 -1.314706 -1.399019 -1.461722 -1.502430 -1.523745 -1.528765 -1.515908 -1.485313 -1.439832 -8.055264 8.4429838E-02 -4.3658126E-02 -0.1836130 -0.3262779 -0.4967081 -0.6810197 -0.8562577 -1.025050 -1.182242 -1.319137 -1.432309 -1.523364 -1.589075 -1.630037 -1.647501 -1.645179 -1.619181 -1.571726 -1.506613 -8.055264 -4.5051143E-02 -0.1559658 -0.2788178 -0.4041139 -0.5746415 -0.7680177 -0.9555573 -1.135240 -1.300642 -1.443699 -1.566462 -1.663184 -1.733529 -1.776832 -1.793494 -1.784283 -1.746460 -1.683043 -1.598935 -8.055264 -0.2038665 -0.2978353 -0.4056965 -0.5156442 -0.6829863 -0.8845208 -1.079770 -1.265125 -1.432592 -1.583879 -1.712487 -1.815713 -1.892421 -1.939661 -1.959015 -1.944605 -1.896640 -1.818613 -1.716330 -8.055264 -0.3897189 -0.4673730 -0.5611497 -0.6572033 -0.8220552 -1.027807 -1.223261 -1.406101 -1.578431 -1.734161 -1.867350 -1.977066 -2.061196 -2.115083 -2.137855 -2.120266 -2.063921 -1.972680 -1.853210 -8.055264 -0.6029893 -0.6652550 -0.7455295 -0.8298703 -0.9888891 -1.191169 -1.379966 -1.562593 -1.735392 -1.893002 -2.031321 -2.147647 -2.238929 -2.303855 -2.330008 -2.311962 -2.249725 -2.147253 -2.011955 -8.055264 -0.8382041 -0.8868304 -0.9536008 -1.026897 -1.174973 -1.367477 -1.553710 -1.732563 -1.901867 -2.060116 -2.203079 -2.325844 -2.427599 -2.500880 -2.531979 -2.515873 -2.450708 -2.339400 -2.189856 -8.055264 -1.090279 -1.125939 -1.178307 -1.239871 -1.379186 -1.563562 -1.740504 -1.913495 -2.079926 -2.236796 -2.382056 -2.511484 -2.621603 -2.700025 -2.736915 -2.723829 -2.658079 -2.540229 -2.377913 -8.055264 -1.368431 -1.390609 -1.429072 -1.478164 -1.604793 -1.775479 -1.943655 -2.110533 -2.272386 -2.426908 -2.572981 -2.707127 -2.819631 -2.901430 -2.943463 -2.934549 -2.870176 -2.749466 -2.574844 -8.055264 -1.670570 -1.678537 -1.704069 -1.738839 -1.852907 -2.012228 -2.168687 -2.328077 -2.484138 -2.636792 -2.780846 -2.910908 -3.022451 -3.106744 -3.152331 -3.148744 -3.087444 -2.967561 -2.781983 -8.055264 -2.007086 -2.000939 -2.013600 -2.033149 -2.132045 -2.278754 -2.424448 -2.573597 -2.723158 -2.867366 -3.002886 -3.125791 -3.233143 -3.316622 -3.365159 -3.366835 -3.310857 -3.193946 -2.998948 -8.055264 -2.387943 -2.366396 -2.365572 -2.371648 -2.454380 -2.586885 -2.719571 -2.853207 -2.987618 -3.118964 -3.243656 -3.357063 -3.456327 -3.537510 -3.587730 -3.594803 -3.552452 -3.435481 -3.233090 -8.055264 -2.830101 -2.792300 -2.775884 -2.767587 -2.830156 -2.940419 -3.053336 -3.168294 -3.284227 -3.399333 -3.509984 -3.611700 -3.700071 -3.774581 -3.824452 -3.842863 -3.809110 -3.691122 -3.483035 -8.055264 -3.343671 -3.291301 -3.256128 -3.231776 -3.271590 -3.355645 -3.444501 -3.538523 -3.632719 -3.728299 -3.820693 -3.906899 -3.981033 -4.046924 -4.107381 -4.129156 -4.092338 -3.978585 -3.760065 -8.055264 -4.008764 -3.931173 -3.874430 -3.826767 -3.839611 -3.891990 -3.951213 -4.016401 -4.083170 -4.151741 -4.221985 -4.296936 -4.364443 -4.420289 -4.462990 -4.471348 -4.437840 -4.316827 -4.078861 -8.055264 -5.075498 -4.957711 -4.857632 -4.773521 -4.748441 -4.758884 -4.773196 -4.798564 -4.830294 -4.864480 -4.899545 -4.937488 -4.980792 -5.011927 -5.034244 -5.030379 -4.967092 -4.805966 -4.524070 -8.055264 -14.38866 -14.20170 -13.99224 -13.76173 -13.51157 -13.24307 -12.95740 -12.65598 -12.33875 -12.00763 -11.66306 -11.30575 -10.93634 -10.55543 -10.16355 -9.761191 -9.348791 -8.926756 -8.495464 -8.055264 0.5830874 0.2894295 -2.1834144E-02 -0.3222400 -0.4222371 -0.5206981 -0.6218175 -0.7336876 -0.8415582 -0.9432796 -1.034127 -1.113713 -1.184144 -1.240875 -1.287280 -1.324704 -1.355838 -1.380764 -1.397199 -9.610223 0.6684457 0.4125426 0.1433387 -0.1179841 -0.2482482 -0.3770281 -0.5112887 -0.6495386 -0.7798254 -0.8988112 -0.9992682 -1.084688 -1.152390 -1.201338 -1.234016 -1.253656 -1.263207 -1.262484 -1.251096 -9.610223 0.6854349 0.4624719 0.2286343 -3.0505050E-03 -0.1650602 -0.3281698 -0.4933617 -0.6557894 -0.8075675 -0.9399443 -1.052467 -1.143924 -1.209388 -1.251509 -1.272189 -1.275364 -1.264919 -1.239913 -1.201810 -9.610223 0.6467257 0.4532279 0.2500411 4.4367108E-02 -0.1493013 -0.3429014 -0.5333453 -0.7183375 -0.8872803 -1.034060 -1.159032 -1.255780 -1.321510 -1.358551 -1.369295 -1.357632 -1.328576 -1.280316 -1.216223 -9.610223 0.5574195 0.3892266 0.2113298 2.8764501E-02 -0.1904398 -0.4067799 -0.6178480 -0.8197803 -1.001512 -1.163896 -1.300662 -1.402018 -1.470984 -1.505013 -1.508607 -1.485096 -1.438289 -1.367814 -1.278387 -9.610223 0.4215828 0.2767650 0.1209947 -4.2254113E-02 -0.2784981 -0.5109942 -0.7364485 -0.9475327 -1.143757 -1.318592 -1.462073 -1.571591 -1.644199 -1.678766 -1.678010 -1.645506 -1.582516 -1.490929 -1.376909 -9.610223 0.2460681 0.1223996 -1.4679723E-02 -0.1605541 -0.4080503 -0.6487023 -0.8785399 -1.100599 -1.307881 -1.489696 -1.638947 -1.756568 -1.834653 -1.873096 -1.870595 -1.832780 -1.755731 -1.644445 -1.506697 -9.610223 3.6230475E-02 -6.9019310E-02 -0.1892889 -0.3207791 -0.5705047 -0.8116232 -1.047755 -1.275099 -1.486360 -1.670233 -1.828238 -1.952078 -2.039037 -2.084594 -2.086238 -2.045204 -1.957060 -1.828062 -1.667803 -9.610223 -0.2028901 -0.2913476 -0.3954397 -0.5142913 -0.7595910 -1.001826 -1.239306 -1.465435 -1.671618 -1.860274 -2.022252 -2.154096 -2.252226 -2.306795 -2.318559 -2.277254 -2.181457 -2.037367 -1.856159 -9.610223 -0.4715582 -0.5435261 -0.6320654 -0.7379087 -0.9792610 -1.215653 -1.444786 -1.662468 -1.868478 -2.054566 -2.218438 -2.358998 -2.466852 -2.535287 -2.556894 -2.518061 -2.417556 -2.261014 -2.060545 -9.610223 -0.7693422 -0.8260054 -0.9000717 -0.9931518 -1.223924 -1.444338 -1.662084 -1.874117 -2.072877 -2.256666 -2.422680 -2.567950 -2.685716 -2.771180 -2.802371 -2.770169 -2.669206 -2.503780 -2.286469 -9.610223 -1.090808 -1.132278 -1.192099 -1.271286 -1.483777 -1.692754 -1.897445 -2.096796 -2.288971 -2.471583 -2.637050 -2.783491 -2.915915 -3.011605 -3.053934 -3.031104 -2.934843 -2.765250 -2.534145 -9.610223 -1.440805 -1.465375 -1.509994 -1.574152 -1.768703 -1.959744 -2.150398 -2.339546 -2.524004 -2.699778 -2.863095 -3.014653 -3.148180 -3.249689 -3.301127 -3.287629 -3.198400 -3.029246 -2.785753 -9.610223 -1.823987 -1.830118 -1.858742 -1.906344 -2.080176 -2.256062 -2.434836 -2.610765 -2.782810 -2.951654 -3.112882 -3.259284 -3.388303 -3.492244 -3.549777 -3.547690 -3.468362 -3.306525 -3.052572 -9.610223 -2.258810 -2.245076 -2.255880 -2.286472 -2.439284 -2.596384 -2.756502 -2.918734 -3.078247 -3.234239 -3.382189 -3.520044 -3.640947 -3.740103 -3.802859 -3.809097 -3.742626 -3.591326 -3.329262 -9.610223 -2.764122 -2.728296 -2.718885 -2.731176 -2.858369 -2.991361 -3.130335 -3.272393 -3.411992 -3.549521 -3.681086 -3.804649 -3.913837 -4.005898 -4.069112 -4.084370 -4.043229 -3.895637 -3.628920 -9.610223 -3.358083 -3.301398 -3.268927 -3.259211 -3.354971 -3.457202 -3.567399 -3.683718 -3.800754 -3.914677 -4.025242 -4.129469 -4.224939 -4.303926 -4.366624 -4.404823 -4.371207 -4.229580 -3.957772 -9.610223 -4.105491 -4.021803 -3.963002 -3.925180 -3.984126 -4.048717 -4.122941 -4.205461 -4.291927 -4.377315 -4.459053 -4.541628 -4.626756 -4.704668 -4.766228 -4.792759 -4.761389 -4.624264 -4.338562 -9.610223 -5.262821 -5.137578 -5.033704 -4.953280 -4.963593 -4.980683 -5.006448 -5.042977 -5.085736 -5.136922 -5.187433 -5.236081 -5.288894 -5.344925 -5.383562 -5.400465 -5.357400 -5.189749 -4.855114 -9.610223 -17.37085 -17.15100 -16.90098 -16.62307 -16.31940 -15.99193 -15.64239 -15.27235 -14.88316 -14.47605 -14.05211 -13.61229 -13.15747 -12.68842 -12.20584 -11.71036 -11.20255 -10.68295 -10.15202 -9.610223 0.9377723 0.5672904 0.1889714 -7.3302425E-02 -0.1820472 -0.2984960 -0.4170013 -0.5395927 -0.6603333 -0.7760243 -0.8823230 -0.9754815 -1.054205 -1.119438 -1.169526 -1.207960 -1.237295 -1.260800 -1.275884 -11.22807 1.077397 0.7572322 0.4302419 0.1821884 3.2720570E-02 -0.1196529 -0.2705749 -0.4238250 -0.5704732 -0.7052337 -0.8243616 -0.9199175 -0.9955113 -1.048168 -1.080144 -1.094817 -1.096419 -1.088439 -1.069690 -11.22807 1.127221 0.8504217 0.5658011 0.3219252 0.1315998 -5.4693662E-02 -0.2391404 -0.4212501 -0.5911883 -0.7444507 -0.8732897 -0.9731655 -1.045703 -1.086497 -1.101313 -1.093664 -1.069108 -1.030881 -0.9794711 -11.22807 1.102318 0.8609335 0.6126568 0.3731332 0.1496363 -6.7628175E-02 -0.2838442 -0.4918201 -0.6842637 -0.8561781 -0.9950000 -1.103196 -1.174712 -1.207881 -1.208036 -1.180680 -1.131914 -1.064814 -0.9816324 -11.22807 1.015372 0.8046579 0.5871875 0.3548998 0.1064181 -0.1400941 -0.3803725 -0.6101441 -0.8230566 -1.007758 -1.161951 -1.280044 -1.351968 -1.381510 -1.370586 -1.326085 -1.255192 -1.160387 -1.046126 -11.22807 0.8766127 0.6951619 0.5048038 0.2791366 8.2961936E-03 -0.2559405 -0.5148472 -0.7638460 -0.9897248 -1.186960 -1.355902 -1.482500 -1.558988 -1.587266 -1.569191 -1.510355 -1.419557 -1.298216 -1.153529 -11.22807 0.6905437 0.5346314 0.3672042 0.1496601 -0.1326220 -0.4103931 -0.6822991 -0.9402096 -1.174354 -1.385787 -1.565763 -1.698974 -1.783448 -1.812834 -1.791798 -1.723182 -1.613883 -1.467339 -1.292941 -11.22807 0.4645946 0.3305427 0.1842270 -2.5840729E-02 -0.3129738 -0.5987246 -0.8753381 -1.134928 -1.378855 -1.599255 -1.783803 -1.928789 -2.022057 -2.058712 -2.039026 -1.966490 -1.841916 -1.672303 -1.469426 -11.22807 0.1999191 8.5268155E-02 -4.1893736E-02 -0.2430706 -0.5308194 -0.8119072 -1.086541 -1.351432 -1.599544 -1.818130 -2.008464 -2.163346 -2.267402 -2.316711 -2.304305 -2.233870 -2.098337 -1.908476 -1.678695 -11.22807 -0.1016837 -0.1981109 -0.3089965 -0.4975828 -0.7748674 -1.049848 -1.322271 -1.584377 -1.825584 -2.044271 -2.236693 -2.397579 -2.516473 -2.579382 -2.584367 -2.518674 -2.377598 -2.171119 -1.916568 -11.22807 -0.4335885 -0.5113353 -0.6068164 -0.7802994 -1.048895 -1.316058 -1.577636 -1.825227 -2.060318 -2.275824 -2.466050 -2.632984 -2.764056 -2.845005 -2.870038 -2.814488 -2.673186 -2.454903 -2.178342 -11.22807 -0.8009154 -0.8604075 -0.9404977 -1.098756 -1.351744 -1.600103 -1.845211 -2.081629 -2.304428 -2.510970 -2.701496 -2.869904 -3.009822 -3.114222 -3.154321 -3.113070 -2.976772 -2.751702 -2.456365 -11.22807 -1.202911 -1.243115 -1.306444 -1.446472 -1.676062 -1.905782 -2.133608 -2.352462 -2.562442 -2.762137 -2.946820 -3.115397 -3.270002 -3.386686 -3.443080 -3.418968 -3.295754 -3.071415 -2.762248 -11.22807 -1.646383 -1.663712 -1.707524 -1.827951 -2.031307 -2.235894 -2.443182 -2.648102 -2.845433 -3.032314 -3.210737 -3.382686 -3.536042 -3.658021 -3.726795 -3.717666 -3.611181 -3.395267 -3.074806 -11.22807 -2.135062 -2.127804 -2.150494 -2.247285 -2.424454 -2.606860 -2.793391 -2.979033 -3.160550 -3.338471 -3.507807 -3.668480 -3.814924 -3.936416 -4.010599 -4.017228 -3.930230 -3.731840 -3.403490 -11.22807 -2.696045 -2.662810 -2.661671 -2.732779 -2.881357 -3.035476 -3.197668 -3.363195 -3.526982 -3.685334 -3.836888 -3.981753 -4.115389 -4.227658 -4.305437 -4.324014 -4.263014 -4.083026 -3.750789 -11.22807 -3.357051 -3.297433 -3.268679 -3.310282 -3.425620 -3.547113 -3.677845 -3.814365 -3.951356 -4.086286 -4.214876 -4.337902 -4.452956 -4.552978 -4.628258 -4.665833 -4.631999 -4.461786 -4.131472 -11.22807 -4.179165 -4.089142 -4.029046 -4.033031 -4.107236 -4.190103 -4.281843 -4.380745 -4.484196 -4.584897 -4.685407 -4.782271 -4.874722 -4.968804 -5.051471 -5.095889 -5.060050 -4.911571 -4.573112 -11.22807 -5.433322 -5.295951 -5.186695 -5.135080 -5.147737 -5.176426 -5.217641 -5.266745 -5.323595 -5.384279 -5.449311 -5.517968 -5.581924 -5.643023 -5.708761 -5.745482 -5.715158 -5.546435 -5.158556 -11.22807 -20.49119 -20.23785 -19.94565 -19.61794 -19.25779 -18.86796 -18.45085 -18.00855 -17.54290 -17.05549 -16.54773 -16.02110 -15.47621 -14.91403 -14.33593 -13.74269 -13.13430 -12.51213 -11.87654 -11.22807 1.277056 0.8264352 0.3760265 0.1770041 6.2880933E-02 -6.5333314E-02 -0.1995647 -0.3403293 -0.4755427 -0.6041526 -0.7248977 -0.8313815 -0.9210031 -0.9928796 -1.047842 -1.087894 -1.116585 -1.137882 -1.151589 -12.90406 1.475127 1.088317 0.7008839 0.4841925 0.3209209 0.1504493 -2.3509761E-02 -0.1959419 -0.3562354 -0.5067121 -0.6392996 -0.7488667 -0.8301805 -0.8864937 -0.9168540 -0.9268415 -0.9212702 -0.9050418 -0.8787762 -12.90406 1.558768 1.225310 0.8907490 0.6468086 0.4347633 0.2203156 9.4712451E-03 -0.1893548 -0.3773359 -0.5475616 -0.6920058 -0.8038448 -0.8792319 -0.9208898 -0.9285811 -0.9102135 -0.8721625 -0.8201073 -0.7552641 -12.90406 1.550754 1.260844 0.9691689 0.7044234 0.4488107 0.1983082 -4.1237038E-02 -0.2699926 -0.4837623 -0.6744670 -0.8341098 -0.9504603 -1.025770 -1.055999 -1.045449 -1.001666 -0.9332343 -0.8466527 -0.7441323 -12.90406 1.468172 1.215849 0.9595320 0.6787366 0.3931381 0.1177955 -0.1500023 -0.4048509 -0.6401666 -0.8512605 -1.024511 -1.150934 -1.229232 -1.251840 -1.226329 -1.160089 -1.063367 -0.9431596 -0.8035367 -12.90406 1.322980 1.103262 0.8766911 0.5891842 0.2860751 -1.1002648E-02 -0.3010019 -0.5764182 -0.8311607 -1.059583 -1.246264 -1.387142 -1.469951 -1.491616 -1.455027 -1.370335 -1.247950 -1.095445 -0.9193540 -12.90406 1.126501 0.9352979 0.7353911 0.4505782 0.1329453 -0.1813014 -0.4857785 -0.7757332 -1.044622 -1.282468 -1.487824 -1.643407 -1.733498 -1.759115 -1.717714 -1.618709 -1.474202 -1.290977 -1.079220 -12.90406 0.8855264 0.7205204 0.5464153 0.2605509 -6.2934011E-02 -0.3849889 -0.6989910 -0.9986319 -1.270981 -1.519310 -1.738760 -1.904462 -2.008430 -2.041220 -2.001596 -1.894003 -1.730795 -1.518891 -1.272424 -12.90406 0.5991762 0.4576324 0.3055251 2.6641419E-02 -0.2986975 -0.6222643 -0.9379054 -1.234805 -1.513684 -1.768446 -1.991446 -2.169580 -2.287808 -2.333396 -2.302322 -2.194833 -2.016925 -1.779214 -1.499491 -12.90406 0.2714349 0.1519551 1.8514670E-02 -0.2505778 -0.5714122 -0.8893411 -1.195376 -1.490824 -1.769622 -2.022425 -2.245243 -2.434338 -2.566396 -2.631772 -2.614894 -2.517081 -2.331083 -2.071701 -1.760874 -12.90406 -9.8419353E-02 -0.1969608 -0.3135723 -0.5684909 -0.8736131 -1.179198 -1.478692 -1.766096 -2.032882 -2.278432 -2.502697 -2.694136 -2.842885 -2.928288 -2.937663 -2.853930 -2.667952 -2.392447 -2.053533 -12.90406 -0.5088452 -0.5853348 -0.6836787 -0.9203906 -1.208809 -1.498844 -1.783126 -2.051057 -2.306230 -2.542712 -2.759762 -2.954641 -3.115172 -3.221991 -3.261829 -3.198104 -3.020113 -2.736160 -2.373312 -12.90406 -0.9620159 -1.015725 -1.094986 -1.311390 -1.575767 -1.839512 -2.101914 -2.354558 -2.592796 -2.814611 -3.026576 -3.219723 -3.385290 -3.517559 -3.578864 -3.539324 -3.375937 -3.091261 -2.709233 -12.90406 -1.455592 -1.484959 -1.543913 -1.734343 -1.970086 -2.208733 -2.445696 -2.676139 -2.899062 -3.110165 -3.309352 -3.498888 -3.675251 -3.816065 -3.897540 -3.883443 -3.745971 -3.472205 -3.078754 -12.90406 -2.001056 -2.002812 -2.038019 -2.197983 -2.402164 -2.610975 -2.824009 -3.035443 -3.239506 -3.433906 -3.624455 -3.808681 -3.977301 -4.118880 -4.210377 -4.218290 -4.107644 -3.856568 -3.454690 -12.90406 -2.614084 -2.585608 -2.593291 -2.721153 -2.894677 -3.074441 -3.259179 -3.444645 -3.631377 -3.810893 -3.981484 -4.148224 -4.304239 -4.436728 -4.530707 -4.556069 -4.474809 -4.256372 -3.852150 -12.90406 -3.338700 -3.279268 -3.254724 -3.343829 -3.479452 -3.624879 -3.778791 -3.933135 -4.090819 -4.246106 -4.394186 -4.535715 -4.669321 -4.789183 -4.879166 -4.918303 -4.881496 -4.684743 -4.285454 -12.90406 -4.238620 -4.144557 -4.084043 -4.125200 -4.213466 -4.315665 -4.428119 -4.544064 -4.663088 -4.785213 -4.901758 -5.013637 -5.120926 -5.222414 -5.320689 -5.380918 -5.351374 -5.180885 -4.782806 -12.90406 -5.583845 -5.438807 -5.325924 -5.301661 -5.320838 -5.360337 -5.413222 -5.475099 -5.543921 -5.621168 -5.703651 -5.784696 -5.864907 -5.941321 -6.014303 -6.072500 -6.051684 -5.878534 -5.437711 -12.90406 -23.73803 -23.45060 -23.11465 -22.73486 -22.31544 -21.86009 -21.37197 -20.85378 -20.30811 -19.73624 -19.14063 -18.52283 -17.88368 -17.22436 -16.54642 -15.85057 -15.13766 -14.40848 -13.66372 -12.90406 1.594712 1.062131 0.5400874 0.4215873 0.3041385 0.1682302 1.9587891E-02 -0.1347610 -0.2892966 -0.4359805 -0.5700754 -0.6909194 -0.7924198 -0.8719118 -0.9322080 -0.9740282 -1.002574 -1.022193 -1.034698 -14.63411 1.857729 1.402263 0.9510337 0.7794921 0.6071261 0.4197948 0.2283689 3.7257873E-02 -0.1458133 -0.3108226 -0.4577824 -0.5787340 -0.6698197 -0.7272815 -0.7570755 -0.7622525 -0.7498378 -0.7255366 -0.6917960 -14.63411 1.980266 1.588860 1.200625 0.9668524 0.7337981 0.4964106 0.2630662 3.8694412E-02 -0.1678196 -0.3541226 -0.5128430 -0.6354367 -0.7159676 -0.7550945 -0.7564941 -0.7275864 -0.6764128 -0.6100950 -0.5317079 -14.63411 1.991786 1.652429 1.316133 1.029560 0.7457951 0.4665394 0.1969030 -5.5811241E-02 -0.2880652 -0.4983560 -0.6715401 -0.8016592 -0.8779435 -0.9042461 -0.8815310 -0.8214461 -0.7337019 -0.6268559 -0.5047210 -14.63411 1.913839 1.618378 1.323165 0.9994692 0.6806520 0.3685535 7.0104510E-02 -0.2055229 -0.4652373 -0.6981676 -0.8893932 -1.028435 -1.108643 -1.126257 -1.084601 -0.9963689 -0.8739852 -0.7277482 -0.5624002 -14.63411 1.765381 1.507185 1.245238 0.9004914 0.5561633 0.2218778 -9.3724929E-02 -0.3951651 -0.6766745 -0.9306828 -1.142000 -1.294002 -1.384105 -1.398214 -1.343688 -1.231844 -1.077652 -0.8930889 -0.6850970 -14.63411 1.558082 1.332192 1.100060 0.7436077 0.3868836 4.1333605E-02 -0.2955638 -0.6143935 -0.9094884 -1.181753 -1.408555 -1.581197 -1.684041 -1.701615 -1.640037 -1.510009 -1.327501 -1.106099 -0.8561084 -14.63411 1.298272 1.101253 0.8966085 0.5390081 0.1786243 -0.1795544 -0.5260423 -0.8551381 -1.162404 -1.440566 -1.686517 -1.879926 -1.995660 -2.026360 -1.965502 -1.824303 -1.618761 -1.362857 -1.071861 -14.63411 0.9921687 0.8235099 0.6438552 0.2896305 -7.5106837E-02 -0.4353051 -0.7834488 -1.116671 -1.424117 -1.709819 -1.968690 -2.175379 -2.311112 -2.358895 -2.308480 -2.164276 -1.942033 -1.654742 -1.324115 -14.63411 0.6371637 0.4951371 0.3369392 -9.3549397E-03 -0.3676884 -0.7236661 -1.067522 -1.392665 -1.699739 -1.989080 -2.249296 -2.464828 -2.619482 -2.688328 -2.657288 -2.521607 -2.288221 -1.973587 -1.605207 -14.63411 0.2328341 0.1161109 -2.1480016E-02 -0.3540540 -0.6983615 -1.041409 -1.371781 -1.690962 -1.992891 -2.273298 -2.528320 -2.751119 -2.919478 -3.015646 -3.010026 -2.896472 -2.661836 -2.326153 -1.923104 -14.63411 -0.2170578 -0.3096286 -0.4270484 -0.7399579 -1.061436 -1.385981 -1.704499 -2.011070 -2.295426 -2.562374 -2.811515 -3.032258 -3.214372 -3.333347 -3.365875 -3.279473 -3.055023 -2.706755 -2.273392 -14.63411 -0.7104124 -0.7780063 -0.8739777 -1.162521 -1.463041 -1.765815 -2.060078 -2.343635 -2.612631 -2.863593 -3.099015 -3.317524 -3.505909 -3.647838 -3.716132 -3.662702 -3.459134 -3.109711 -2.652140 -14.63411 -1.253556 -1.295260 -1.369019 -1.628271 -1.897952 -2.170372 -2.438295 -2.698925 -2.947495 -3.180868 -3.406180 -3.612651 -3.806428 -3.967020 -4.058894 -4.040475 -3.867488 -3.529608 -3.055673 -14.63411 -1.850971 -1.863534 -1.911817 -2.134624 -2.371081 -2.611033 -2.848660 -3.083524 -3.313820 -3.530255 -3.737786 -3.940140 -4.131491 -4.292921 -4.401920 -4.411500 -4.279146 -3.968944 -3.488666 -14.63411 -2.521591 -2.501023 -2.519290 -2.699263 -2.899131 -3.106284 -3.315253 -3.521632 -3.727972 -3.928648 -4.122473 -4.307004 -4.481404 -4.636799 -4.745397 -4.779294 -4.686750 -4.419980 -3.938783 -14.63411 -3.305167 -3.249110 -3.231822 -3.366809 -3.524868 -3.693287 -3.867014 -4.044690 -4.222534 -4.396990 -4.564969 -4.726554 -4.875842 -5.013648 -5.117231 -5.166953 -5.120586 -4.896297 -4.423593 -14.63411 -4.281909 -4.186207 -4.125907 -4.203907 -4.309149 -4.430565 -4.560663 -4.695247 -4.833800 -4.973713 -5.107541 -5.235720 -5.357443 -5.472870 -5.572506 -5.648606 -5.627539 -5.435761 -4.975285 -14.63411 -5.721497 -5.566471 -5.446993 -5.446443 -5.474934 -5.527645 -5.595619 -5.669821 -5.749476 -5.842970 -5.940188 -6.035646 -6.130293 -6.221469 -6.302299 -6.374223 -6.362639 -6.191414 -5.697215 -14.63411 -27.10156 -26.77946 -26.39823 -25.96416 -25.48282 -24.95900 -24.39668 -23.79926 -23.16961 -22.51017 -21.82306 -21.11009 -20.37286 -19.61277 -18.83108 -18.02890 -17.20724 -16.36702 -15.50905 -14.63411 1.899941 1.284248 0.7612943 0.6663375 0.5426144 0.3990181 0.2413364 7.3445074E-02 -9.7169012E-02 -0.2632507 -0.4155776 -0.5495442 -0.6624299 -0.7513682 -0.8153614 -0.8596113 -0.8882290 -0.9065025 -0.9178756 -16.41466 2.229129 1.701039 1.235297 1.068499 0.8841669 0.6850010 0.4786459 0.2698316 6.7547172E-02 -0.1196721 -0.2809846 -0.4146441 -0.5125464 -0.5737153 -0.6018138 -0.6024572 -0.5834770 -0.5514801 -0.5103438 -16.41466 2.389053 1.936841 1.520823 1.274338 1.022518 0.7664481 0.5117986 0.2663741 3.4992084E-02 -0.1699153 -0.3434614 -0.4775664 -0.5638916 -0.6006723 -0.5959263 -0.5560528 -0.4920378 -0.4118767 -0.3199735 -16.41466 2.421463 2.030450 1.655818 1.344514 1.035569 0.7279319 0.4346310 0.1556166 -0.1038297 -0.3292516 -0.5196241 -0.6598031 -0.7409980 -0.7605661 -0.7268123 -0.6500101 -0.5431218 -0.4160632 -0.2741680 -16.41466 2.352011 2.011990 1.672208 1.314414 0.9600597 0.6181843 0.2911046 -1.5976598E-02 -0.2984843 -0.5511351 -0.7604348 -0.9141906 -0.9962174 -1.006792 -0.9493859 -0.8392347 -0.6914507 -0.5185835 -0.3272029 -16.41466 2.201906 1.904414 1.593780 1.205441 0.8249526 0.4552993 0.1038667 -0.2208718 -0.5288237 -0.8071777 -1.038614 -1.210151 -1.302156 -1.311292 -1.237103 -1.097859 -0.9119026 -0.6946059 -0.4542221 -16.41466 1.982865 1.721692 1.438314 1.036041 0.6389374 0.2535829 -0.1110779 -0.4567114 -0.7806607 -1.079391 -1.335825 -1.525607 -1.637049 -1.650275 -1.569086 -1.407073 -1.186483 -0.9262592 -0.6374629 -16.41466 1.707193 1.479473 1.221495 0.8133758 0.4089819 1.9958386E-02 -0.3569230 -0.7134719 -1.049071 -1.363173 -1.635397 -1.850458 -1.985339 -2.011657 -1.932012 -1.755711 -1.505755 -1.204664 -0.8682970 -16.41466 1.377147 1.181034 0.9464342 0.5426896 0.1424614 -0.2521468 -0.6310145 -0.9915454 -1.333892 -1.652097 -1.937720 -2.175573 -2.330743 -2.382631 -2.315009 -2.135221 -1.863594 -1.524984 -1.142349 -16.41466 0.9951292 0.8299963 0.6185836 0.2254239 -0.1683558 -0.5577958 -0.9335590 -1.293833 -1.629922 -1.948867 -2.243149 -2.490914 -2.670639 -2.749616 -2.707369 -2.535784 -2.252531 -1.881087 -1.454170 -16.41466 0.5621583 0.4256354 0.2369716 -0.1407981 -0.5206575 -0.8982353 -1.265494 -1.613422 -1.943133 -2.258008 -2.545675 -2.798867 -2.995800 -3.102824 -3.094534 -2.946822 -2.660717 -2.262603 -1.794119 -16.41466 7.9352781E-02 -3.0291807E-02 -0.1956508 -0.5538066 -0.9154773 -1.272129 -1.620546 -1.958607 -2.277440 -2.574499 -2.851213 -3.103967 -3.310085 -3.447038 -3.474734 -3.367440 -3.093069 -2.677808 -2.172230 -16.41466 -0.4545497 -0.5381278 -0.6792282 -1.009380 -1.344925 -1.680600 -2.008701 -2.326009 -2.621986 -2.903187 -3.165808 -3.407665 -3.623870 -3.777406 -3.852250 -3.788150 -3.540840 -3.121846 -2.585818 -16.41466 -1.040561 -1.095930 -1.211193 -1.511087 -1.818022 -2.123860 -2.421263 -2.711489 -2.988296 -3.247856 -3.493393 -3.727020 -3.938587 -4.113612 -4.218866 -4.200732 -3.992815 -3.586827 -3.029469 -16.41466 -1.688773 -1.714400 -1.801110 -2.060543 -2.330377 -2.601158 -2.867461 -3.128009 -3.380563 -3.621311 -3.849493 -4.066218 -4.280860 -4.460733 -4.582652 -4.603566 -4.448152 -4.074418 -3.508946 -16.41466 -2.415540 -2.405329 -2.456789 -2.670903 -2.898100 -3.130058 -3.363825 -3.596021 -3.822982 -4.041033 -4.252866 -4.456674 -4.654446 -4.828325 -4.950802 -4.998260 -4.895127 -4.574602 -4.009869 -16.41466 -3.259229 -3.208776 -3.216940 -3.380766 -3.561366 -3.753061 -3.948879 -4.146881 -4.347337 -4.541195 -4.725137 -4.904079 -5.075845 -5.231723 -5.348098 -5.408481 -5.356661 -5.099459 -4.546914 -16.41466 -4.305052 -4.209878 -4.167637 -4.269996 -4.395343 -4.534842 -4.684246 -4.838261 -4.996845 -5.155005 -5.304139 -5.447759 -5.584739 -5.721741 -5.826083 -5.907306 -5.901819 -5.684461 -5.155301 -16.41466 -5.837930 -5.679589 -5.568278 -5.582640 -5.626532 -5.688268 -5.768192 -5.859056 -5.957281 -6.060922 -6.171904 -6.281676 -6.389691 -6.503793 -6.602458 -6.664835 -6.675213 -6.492227 -5.940075 -16.41466 -30.57338 -30.21603 -29.78802 -29.29756 -28.75183 -28.15675 -27.51728 -26.83752 -26.12092 -25.37038 -24.58838 -23.77704 -22.93824 -22.07360 -21.18457 -20.27245 -19.33840 -18.38346 -17.40859 -16.41466 2.196383 1.502452 1.008170 0.9084731 0.7833597 0.6311288 0.4633686 0.2841649 9.8194152E-02 -8.4937967E-02 -0.2563720 -0.4044851 -0.5285560 -0.6252199 -0.6942784 -0.7408382 -0.7694135 -0.7865196 -0.7967038 -18.24260 2.588712 1.989525 1.531585 1.355387 1.157524 0.9451314 0.7256662 0.5017260 0.2813302 7.5093269E-02 -0.1061639 -0.2495611 -0.3554682 -0.4196438 -0.4452149 -0.4412726 -0.4156752 -0.3760582 -0.3275009 -18.24260 2.790232 2.275187 1.844758 1.575462 1.301477 1.027434 0.7565605 0.4897884 0.2383354 1.0701058E-02 -0.1787325 -0.3230571 -0.4142252 -0.4503637 -0.4374093 -0.3869039 -0.3101255 -0.2161597 -0.1106096 -18.24260 2.842952 2.398342 1.990342 1.648300 1.312748 0.9839107 0.6667387 0.3639088 8.1251346E-02 -0.1667371 -0.3711946 -0.5225477 -0.6064187 -0.6206445 -0.5743634 -0.4802987 -0.3541477 -0.2068664 -4.4966660E-02 -18.24260 2.780545 2.394317 2.008792 1.617044 1.233219 0.8609139 0.5082210 0.1731819 -0.1385892 -0.4091467 -0.6378980 -0.8037615 -0.8919201 -0.8940471 -0.8209829 -0.6878785 -0.5146244 -0.3151058 -9.7327590E-02 -18.24260 2.629929 2.291669 1.928156 1.504646 1.086558 0.6847464 0.3030538 -5.3591728E-02 -0.3853935 -0.6862625 -0.9411610 -1.128894 -1.227545 -1.229650 -1.136988 -0.9700294 -0.7522302 -0.5015820 -0.2283074 -18.24260 2.402820 2.106428 1.765642 1.321514 0.8867931 0.4665860 6.8352543E-02 -0.3018479 -0.6535056 -0.9794655 -1.259611 -1.475241 -1.594300 -1.606897 -1.504435 -1.309939 -1.051250 -0.7512183 -0.4229623 -18.24260 2.108898 1.850340 1.531416 1.083768 0.6396961 0.2132166 -0.1900469 -0.5728946 -0.9390373 -1.279919 -1.583799 -1.823471 -1.973195 -2.004146 -1.905889 -1.693359 -1.398926 -1.051738 -0.6692374 -18.24260 1.756694 1.533580 1.236827 0.7929559 0.3530873 -7.0243366E-02 -0.4797405 -0.8681551 -1.239254 -1.589426 -1.905018 -2.170381 -2.351619 -2.409754 -2.328866 -2.111340 -1.789262 -1.398012 -0.9624295 -18.24260 1.349449 1.159246 0.8855916 0.4554871 2.8156562E-02 -0.3930360 -0.8009213 -1.188258 -1.558313 -1.904670 -2.227882 -2.512101 -2.714304 -2.809965 -2.759633 -2.552874 -2.214933 -1.784657 -1.297842 -18.24260 0.8906661 0.7321099 0.4844253 6.9923222E-02 -0.3449802 -0.7540428 -1.152501 -1.534434 -1.892004 -2.233650 -2.555238 -2.841690 -3.065123 -3.192187 -3.185464 -3.005488 -2.666127 -2.203896 -1.668653 -18.24260 0.3771352 0.2481712 2.6910329E-02 -0.3667203 -0.7627015 -1.154562 -1.535164 -1.901130 -2.248421 -2.578775 -2.883049 -3.168178 -3.401708 -3.555516 -3.593509 -3.460562 -3.133433 -2.649025 -2.069453 -18.24260 -0.1927532 -0.2927702 -0.4876741 -0.8535091 -1.224104 -1.590181 -1.949065 -2.297513 -2.626400 -2.931097 -3.221806 -3.495265 -3.732242 -3.909333 -3.989456 -3.916817 -3.622553 -3.131221 -2.514273 -18.24260 -0.8205882 -0.8911516 -1.056624 -1.388220 -1.729128 -2.067710 -2.398215 -2.715883 -3.020696 -3.305050 -3.573471 -3.830808 -4.068651 -4.255445 -4.378043 -4.362281 -4.118865 -3.641895 -2.998072 -18.24260 -1.516760 -1.555307 -1.687569 -1.979732 -2.280827 -2.582371 -2.878130 -3.166122 -3.444190 -3.703826 -3.953764 -4.189718 -4.419631 -4.620307 -4.760264 -4.791171 -4.610437 -4.170485 -3.513664 -18.24260 -2.298075 -2.298907 -2.390829 -2.632989 -2.889070 -3.150102 -3.407476 -3.663499 -3.915087 -4.150117 -4.376710 -4.597596 -4.814793 -5.007352 -5.151230 -5.208994 -5.098324 -4.721023 -4.068321 -18.24260 -3.200898 -3.156928 -3.200095 -3.386202 -3.592744 -3.808578 -4.025463 -4.244849 -4.464992 -4.677243 -4.878689 -5.072842 -5.263143 -5.434801 -5.567443 -5.640514 -5.589009 -5.294916 -4.659503 -18.24260 -4.314244 -4.220681 -4.207403 -4.324708 -4.470651 -4.633783 -4.799673 -4.974278 -5.153257 -5.326931 -5.491467 -5.649681 -5.802868 -5.949950 -6.070455 -6.154415 -6.162894 -5.923694 -5.324103 -18.24260 -5.933733 -5.772523 -5.682058 -5.704625 -5.759052 -5.839316 -5.930116 -6.034753 -6.153779 -6.274698 -6.391016 -6.513033 -6.636876 -6.763997 -6.875978 -6.944479 -6.970018 -6.781235 -6.169989 -18.24260 -34.14622 -33.75305 -33.27680 -32.72797 -32.11544 -31.44652 -30.72712 -29.96248 -29.15561 -28.31090 -27.43088 -26.51800 -25.57439 -24.60194 -23.60228 -22.57689 -21.52710 -20.45408 -19.35892 -18.24260 2.484226 1.708581 1.247804 1.145025 1.011557 0.8540263 0.6729755 0.4775949 0.2739589 6.8628944E-02 -0.1242033 -0.2954733 -0.4359425 -0.5455466 -0.6232855 -0.6737919 -0.7041326 -0.7213360 -0.7309037 -20.11515 2.942809 2.274906 1.828417 1.638189 1.429804 1.205872 0.9714527 0.7330783 0.4972777 0.2733957 7.7013843E-02 -7.9950109E-02 -0.1916612 -0.2568497 -0.2797746 -0.2703815 -0.2376281 -0.1904557 -0.1343796 -20.11515 3.182039 2.605612 2.162305 1.871071 1.577228 1.282938 0.9943807 0.7108123 0.4402414 0.1936816 -1.4220074E-02 -0.1686187 -0.2643213 -0.2972926 -0.2757185 -0.2139407 -0.1238815 -1.5998524E-02 0.1033357 -20.11515 3.256217 2.757417 2.318334 1.946531 1.581426 1.230228 0.8930588 0.5658790 0.2643000 -6.3079647E-03 -0.2293751 -0.3912693 -0.4790103 -0.4880690 -0.4274826 -0.3163420 -0.1707031 -3.1532836E-03 0.1789477 -20.11515 3.202854 2.769536 2.339513 1.910444 1.495390 1.097605 0.7196367 0.3591628 2.4513120E-02 -0.2729523 -0.5185981 -0.6977078 -0.7893411 -0.7842583 -0.6931145 -0.5366661 -0.3374050 -0.1110171 0.1335120 -20.11515 3.049221 2.669809 2.253801 1.791992 1.341859 0.9090315 0.5007742 0.1161568 -0.2453392 -0.5689684 -0.8470945 -1.051710 -1.161290 -1.155001 -1.042975 -0.8469385 -0.5967646 -0.3126278 -6.0280086E-03 -20.11515 2.813995 2.481679 2.083917 1.602033 1.129109 0.6778743 0.2513038 -0.1509833 -0.5290723 -0.8797362 -1.188271 -1.424228 -1.559118 -1.568282 -1.445844 -1.218394 -0.9210173 -0.5805653 -0.2123090 -20.11515 2.505654 2.216482 1.837388 1.347888 0.8691567 0.4095007 -2.6286660E-02 -0.4361663 -0.8290473 -1.198541 -1.530479 -1.798954 -1.965880 -2.004574 -1.886069 -1.637162 -1.298131 -0.9037423 -0.4744789 -20.11515 2.130870 1.880382 1.523333 1.041435 0.5658481 0.1065802 -0.3305355 -0.7475092 -1.146544 -1.522658 -1.874580 -2.162767 -2.368425 -2.442750 -2.348372 -2.092663 -1.720303 -1.275374 -0.7861518 -20.11515 1.701693 1.486580 1.153708 0.6840316 0.2196308 -0.2304891 -0.6694908 -1.085906 -1.482760 -1.860037 -2.212821 -2.522568 -2.757390 -2.871480 -2.816978 -2.574060 -2.180887 -1.690374 -1.142863 -20.11515 1.216308 1.034434 0.7288755 0.2793165 -0.1706696 -0.6115411 -1.040490 -1.451100 -1.840471 -2.205480 -2.556373 -2.877113 -3.125502 -3.278976 -3.275325 -3.065606 -2.669251 -2.140810 -1.537667 -20.11515 0.6740887 0.5254930 0.2479873 -0.1801753 -0.6107543 -1.034224 -1.447394 -1.844448 -2.215530 -2.570221 -2.909126 -3.219581 -3.482782 -3.663122 -3.714497 -3.558693 -3.178698 -2.623600 -1.969050 -20.11515 7.0848748E-02 -4.6083901E-02 -0.2944953 -0.6939551 -1.100269 -1.499668 -1.886717 -2.263828 -2.620185 -2.953956 -3.266474 -3.567866 -3.830620 -4.032928 -4.128695 -4.046729 -3.705758 -3.140809 -2.441816 -20.11515 -0.5974579 -0.6833441 -0.8987008 -1.262101 -1.635948 -2.005651 -2.366247 -2.717115 -3.044657 -3.353221 -3.645203 -3.924265 -4.184253 -4.393332 -4.533431 -4.520200 -4.242263 -3.691609 -2.959276 -20.11515 -1.338384 -1.390095 -1.567484 -1.890003 -2.227250 -2.559067 -2.881249 -3.197483 -3.498994 -3.780711 -4.048700 -4.309135 -4.552129 -4.769455 -4.931138 -4.973795 -4.772667 -4.265960 -3.516702 -20.11515 -2.170907 -2.183063 -2.317164 -2.587767 -2.875052 -3.163141 -3.445836 -3.725003 -3.997944 -4.255164 -4.496405 -4.734908 -4.966933 -5.174624 -5.337933 -5.412925 -5.297432 -4.864984 -4.122863 -20.11515 -3.132163 -3.096237 -3.177664 -3.385338 -3.616236 -3.855888 -4.094331 -4.334863 -4.577088 -4.806588 -5.024087 -5.236638 -5.441143 -5.625803 -5.771528 -5.862971 -5.815866 -5.484329 -4.763776 -20.11515 -4.310637 -4.218561 -4.236135 -4.371524 -4.537176 -4.716395 -4.903373 -5.098663 -5.299172 -5.491331 -5.669928 -5.843162 -6.012908 -6.167675 -6.297132 -6.385977 -6.409464 -6.159218 -5.482746 -20.11515 -6.015465 -5.843161 -5.774649 -5.810647 -5.881502 -5.972612 -6.077937 -6.200696 -6.335574 -6.477063 -6.608054 -6.734212 -6.878698 -7.012856 -7.131087 -7.213079 -7.246507 -7.058127 -6.387136 -20.11515 -37.81374 -37.38418 -36.85828 -36.24913 -35.56758 -34.82234 -34.02043 -33.16752 -32.26827 -31.32653 -30.34558 -29.32820 -28.27680 -27.19350 -26.08016 -24.93843 -23.76979 -22.57558 -21.35700 -20.11515 2.760450 1.899543 1.481465 1.382730 1.244405 1.075764 0.8850058 0.6729634 0.4488421 0.2217211 4.5878389E-03 -0.1895043 -0.3507602 -0.4743314 -0.5615737 -0.6169870 -0.6494774 -0.6671293 -0.6763204 -22.02986 3.289182 2.549964 2.120253 1.918735 1.694965 1.459171 1.210803 0.9553803 0.7010760 0.4576510 0.2432648 6.9836959E-02 -5.0280981E-02 -0.1187810 -0.1403845 -0.1255773 -8.6452052E-02 -3.2172527E-02 3.1227354E-02 -22.02986 3.569360 2.932312 2.478281 2.160925 1.845691 1.535427 1.226765 0.9267539 0.6385821 0.3731653 0.1497947 -1.7412040E-02 -0.1145500 -0.1433631 -0.1128999 -3.8766652E-02 6.4881839E-02 0.1866070 0.3198926 -22.02986 3.662878 3.110773 2.640006 2.236486 1.845455 1.470497 1.111066 0.7651010 0.4415765 0.1510725 -9.0656169E-02 -0.2634194 -0.3535923 -0.3544852 -0.2796415 -0.1503529 1.5281619E-02 0.2032495 0.4058237 -22.02986 3.617597 3.136379 2.662606 2.198037 1.750553 1.325899 0.9253044 0.5392154 0.1819193 -0.1393153 -0.4067530 -0.5991652 -0.6958660 -0.6829203 -0.5721911 -0.3919655 -0.1663813 8.6963542E-02 0.3585851 -22.02986 3.462542 3.041509 2.574282 2.071349 1.587986 1.128670 0.6936442 0.2808993 -0.1054345 -0.4590629 -0.7563276 -0.9811816 -1.099073 -1.086303 -0.9526834 -0.7273102 -0.4442782 -0.1264620 0.2139571 -22.02986 3.217160 2.848850 2.393914 1.872957 1.367569 0.8848579 0.4303811 -1.2676999E-03 -0.4089442 -0.7851874 -1.117827 -1.377207 -1.531487 -1.536160 -1.393360 -1.131599 -0.7949148 -0.4139614 -5.1008398E-03 -22.02986 2.893886 2.573030 2.135881 1.609692 1.094160 0.6023180 0.1362229 -0.3059397 -0.7220690 -1.119787 -1.478602 -1.771357 -1.964058 -2.007909 -1.871810 -1.586494 -1.202087 -0.7601296 -0.2833831 -22.02986 2.502845 2.224483 1.808461 1.284995 0.7754868 0.2823575 -0.1884430 -0.6312490 -1.055105 -1.460857 -1.837250 -2.156114 -2.387381 -2.481037 -2.373405 -2.080341 -1.657325 -1.158083 -0.6144069 -22.02986 2.050004 1.809007 1.419223 0.9104043 0.4102315 -7.5912967E-02 -0.5411983 -0.9857971 -1.408314 -1.810638 -2.195396 -2.528677 -2.796581 -2.934257 -2.878811 -2.601069 -2.153048 -1.601773 -0.9927515 -22.02986 1.539931 1.334579 0.9717113 0.4830039 1.4268333E-04 -0.4725317 -0.9316407 -1.369993 -1.783255 -2.177193 -2.551024 -2.898678 -3.182681 -3.364735 -3.368443 -3.132620 -2.678737 -2.083369 -1.411499 -22.02986 0.9689416 0.7987315 0.4664417 3.8263218E-03 -0.4613929 -0.9164806 -1.359014 -1.784944 -2.182091 -2.558547 -2.923221 -3.264539 -3.554364 -3.767732 -3.834138 -3.661676 -3.229882 -2.603002 -1.872647 -22.02986 0.3335910 0.1982934 -0.1014245 -0.5352159 -0.9748241 -1.406468 -1.825912 -2.227861 -2.607722 -2.968333 -3.308149 -3.632112 -3.921217 -4.148982 -4.270001 -4.179306 -3.794807 -3.154757 -2.372841 -22.02986 -0.3718978 -0.4732322 -0.7369195 -1.134980 -1.541967 -1.941064 -2.330412 -2.709290 -3.065632 -3.394091 -3.711916 -4.014674 -4.291798 -4.527796 -4.683747 -4.677940 -4.370316 -3.744240 -2.922389 -22.02986 -1.155170 -1.220247 -1.443795 -1.797243 -2.165501 -2.529552 -2.880414 -3.221768 -3.548728 -3.851607 -4.140338 -4.420909 -4.683513 -4.914015 -5.097426 -5.153730 -4.939254 -4.364458 -3.521103 -22.02986 -2.037932 -2.061716 -2.238981 -2.536910 -2.852798 -3.168451 -3.477347 -3.782445 -4.077834 -4.352654 -4.615006 -4.869096 -5.115051 -5.338642 -5.520957 -5.612280 -5.491802 -5.003652 -4.164236 -22.02986 -3.055096 -3.025693 -3.144825 -3.378695 -3.635786 -3.895461 -4.159836 -4.424117 -4.686415 -4.931244 -5.165702 -5.398494 -5.615704 -5.815657 -5.977675 -6.081743 -6.041074 -5.672143 -4.861282 -22.02986 -4.300466 -4.205902 -4.252907 -4.410883 -4.597894 -4.796729 -5.007642 -5.224741 -5.445168 -5.651385 -5.846896 -6.042366 -6.220783 -6.384946 -6.527525 -6.629671 -6.657655 -6.394186 -5.635866 -22.02986 -6.089570 -5.907417 -5.858384 -5.911390 -6.002337 -6.109344 -6.236623 -6.378084 -6.529427 -6.681944 -6.827993 -6.975158 -7.123315 -7.265572 -7.395706 -7.490464 -7.526519 -7.335395 -6.602915 -22.02986 -41.57036 -41.10385 -40.52692 -39.85559 -39.10287 -38.27900 -37.39213 -36.44875 -35.45417 -34.41273 -33.32813 -32.20348 -31.04149 -29.84452 -28.61465 -27.35371 -26.06336 -24.74506 -23.40016 -22.02986 3.024110 2.078327 1.711153 1.620553 1.482229 1.309208 1.104711 0.8796801 0.6356080 0.3888815 0.1502614 -6.4159028E-02 -0.2436517 -0.3794890 -0.4745928 -0.5338073 -0.5678183 -0.5854157 -0.5939817 -23.98451 3.625523 2.811679 2.403876 2.194029 1.960844 1.709790 1.446557 1.174747 0.8995955 0.6372088 0.4019121 0.2128714 8.1290804E-02 8.9606307E-03 -1.1323967E-02 8.1396522E-03 5.3479359E-02 0.1147938 0.1855027 -23.98451 3.949593 3.250467 2.787838 2.448812 2.109881 1.780592 1.453951 1.134949 0.8278561 0.5433858 0.3025752 0.1222670 2.0595504E-02 -5.7294876E-03 3.3454530E-02 0.1200717 0.2368142 0.3723313 0.5196465 -23.98451 4.064477 3.459131 2.959774 2.521684 2.102898 1.706190 1.322594 0.9574245 0.6140312 0.3038197 4.5072287E-02 -0.1416529 -0.2321606 -0.2253006 -0.1353795 1.3002845E-02 0.1986576 0.4071565 0.6305233 -23.98451 4.026646 3.498328 2.980025 2.479193 2.000785 1.549414 1.123712 0.7161199 0.3350970 -7.6858560E-03 -0.2958859 -0.5040063 -0.6041210 -0.5808663 -0.4504059 -0.2452552 7.0147668E-03 0.2877030 0.5868738 -23.98451 3.868903 3.405760 2.888387 2.345579 1.828783 1.341192 0.8811972 0.4413831 3.1020738E-02 -0.3472851 -0.6682148 -0.9140053 -1.042110 -1.022541 -0.8653319 -0.6099232 -0.2938291 5.8090810E-02 0.4328899 -23.98451 3.614137 3.209255 2.698287 2.137758 1.599105 1.087883 0.6034721 0.1458275 -0.2878441 -0.6937027 -1.046476 -1.334213 -1.505694 -1.509878 -1.344874 -1.048784 -0.6726772 -0.2508002 0.1993657 -23.98451 3.275934 2.922666 2.427610 1.863751 1.316331 0.7899300 0.2951688 -0.1746250 -0.6187881 -1.040907 -1.423538 -1.746207 -1.966642 -2.015726 -1.863394 -1.540679 -1.110556 -0.6207451 -9.5680855E-02 -23.98451 2.869234 2.560877 2.087831 1.526950 0.9799049 0.4555884 -4.5755148E-02 -0.5179336 -0.9632697 -1.394861 -1.796863 -2.147549 -2.408270 -2.518959 -2.403299 -2.074743 -1.600602 -1.046304 -0.4472062 -23.98451 2.395836 2.128665 1.680071 1.133343 0.5980465 7.9818793E-02 -0.4180526 -0.8859214 -1.332056 -1.759684 -2.169349 -2.533607 -2.830633 -2.999171 -2.944085 -2.634769 -2.131675 -1.518702 -0.8470142 -23.98451 1.860097 1.631090 1.211771 0.6864872 0.1670608 -0.3353667 -0.8243083 -1.288073 -1.725760 -2.143866 -2.545318 -2.915432 -3.234629 -3.445443 -3.464112 -3.204832 -2.694637 -2.031126 -1.289248 -23.98451 1.261934 1.070441 0.6828572 0.1852508 -0.3126152 -0.7993330 -1.271943 -1.723131 -2.147458 -2.547160 -2.935272 -3.302879 -3.620157 -3.865231 -3.951928 -3.769796 -3.283396 -2.582860 -1.774870 -23.98451 0.5958952 0.4420446 9.0613723E-02 -0.3775547 -0.8501201 -1.311984 -1.761995 -2.193452 -2.594723 -2.976330 -3.348181 -3.690799 -4.006075 -4.262663 -4.407507 -4.316730 -3.889391 -3.172497 -2.305518 -23.98451 -0.1451989 -0.2624410 -0.5751155 -1.005977 -1.446102 -1.875300 -2.292434 -2.698810 -3.079607 -3.432274 -3.774115 -4.097791 -4.395363 -4.654498 -4.832859 -4.838924 -4.501150 -3.798102 -2.884035 -23.98451 -0.9704922 -1.049733 -1.318754 -1.702650 -2.100422 -2.492225 -2.876420 -3.245900 -3.592795 -3.916988 -4.232873 -4.528602 -4.806984 -5.054656 -5.258740 -5.332678 -5.106487 -4.459663 -3.518465 -23.98451 -1.899838 -1.933039 -2.152800 -2.484201 -2.828355 -3.170446 -3.509949 -3.839476 -4.154932 -4.446348 -4.733638 -5.004064 -5.257933 -5.496272 -5.696798 -5.806969 -5.688569 -5.142600 -4.203220 -23.98451 -2.974478 -2.950675 -3.106732 -3.368964 -3.651571 -3.939934 -4.228760 -4.516672 -4.793757 -5.055141 -5.310126 -5.556778 -5.784541 -5.995761 -6.173347 -6.290775 -6.263143 -5.854054 -4.950453 -23.98451 -4.285155 -4.190958 -4.267525 -4.448260 -4.656935 -4.880825 -5.115127 -5.353206 -5.585865 -5.810483 -6.024518 -6.234381 -6.420151 -6.596347 -6.745145 -6.860155 -6.898038 -6.622066 -5.783526 -23.98451 -6.153315 -5.970000 -5.935174 -6.006744 -6.109971 -6.240103 -6.389925 -6.550778 -6.717870 -6.880938 -7.044827 -7.209713 -7.355577 -7.508311 -7.640961 -7.747637 -7.792214 -7.604938 -6.814394 -23.98451 -45.41108 -44.90706 -44.27777 -43.54249 -42.71655 -41.81210 -40.83771 -39.80147 -38.70908 -37.56543 -36.37461 -35.14011 -33.86492 -32.55165 -31.20283 -29.81977 -28.40500 -26.95992 -25.48597 -23.98451 3.278928 2.249179 1.937856 1.851895 1.718156 1.541922 1.328749 1.086859 0.8264787 0.5584186 0.3002502 6.3307464E-02 -0.1333166 -0.2819418 -0.3841353 -0.4472746 -0.4825050 -0.4998268 -0.5078373 -25.97711 3.951981 3.061899 2.679069 2.462755 2.221478 1.960964 1.681244 1.392624 1.097232 0.8167117 0.5605785 0.3548964 0.2123110 0.1371148 0.1188512 0.1430840 0.1948868 0.2634363 0.3414770 -25.97711 4.322000 3.557911 3.089182 2.728830 2.372292 2.021973 1.676393 1.339005 1.012264 0.7112898 0.4483723 0.2559575 0.1484744 0.1262984 0.1749836 0.2734933 0.4036196 0.5531102 0.7145478 -25.97711 4.460950 3.800539 3.272522 2.804137 2.355736 1.934854 1.529489 1.141713 0.7811663 0.4489137 0.1678613 -3.2841466E-02 -0.1263463 -0.1122406 -7.2271284E-03 0.1597947 0.3653964 0.5946002 0.8389251 -25.97711 4.429796 3.854014 3.294710 2.755188 2.245469 1.768590 1.314920 0.8887951 0.4847706 0.1181316 -0.1933490 -0.4193213 -0.5216026 -0.4883766 -0.3379705 -0.1078420 0.1712869 0.4795816 0.8066379 -25.97711 4.269945 3.764901 3.196015 2.614696 2.065268 1.547976 1.062966 0.6018754 0.1610070 -0.2385296 -0.5860535 -0.8523172 -0.9899353 -0.9609762 -0.7811068 -0.4952331 -0.1455142 0.2410667 0.6507010 -25.97711 4.004492 3.562190 2.996969 2.398011 1.824412 1.284682 0.7745293 0.2877820 -0.1730275 -0.6016123 -0.9813129 -1.293476 -1.483944 -1.488353 -1.300805 -0.9701167 -0.5540507 -9.0539880E-02 0.4014665 -25.97711 3.653631 3.266615 2.714850 2.110913 1.532418 0.9766141 0.4482822 -4.6554815E-02 -0.5167072 -0.9640298 -1.370867 -1.722851 -1.968407 -2.027168 -1.860595 -1.500649 -1.024401 -0.4858675 8.8134453E-02 -25.97711 3.229778 2.890541 2.360239 1.764178 1.183515 0.6229948 9.2442684E-02 -0.4054543 -0.8765978 -1.329662 -1.756866 -2.134406 -2.429922 -2.558948 -2.440613 -2.076579 -1.551002 -0.9408860 -0.2856553 -25.97711 2.737173 2.442751 1.938002 1.353026 0.7818980 0.2307252 -0.2968523 -0.7909409 -1.258605 -1.710992 -2.142427 -2.536333 -2.862088 -3.060445 -3.010820 -2.672044 -2.112836 -1.436637 -0.7014173 -25.97711 2.176363 1.923808 1.447776 0.8866498 0.3318941 -0.2042918 -0.7197844 -1.209333 -1.669923 -2.112609 -2.538192 -2.930153 -3.279027 -3.523906 -3.560900 -3.282705 -2.715389 -1.982737 -1.169892 -25.97711 1.550706 1.338407 0.8972430 0.3628155 -0.1685507 -0.6850466 -1.186844 -1.664351 -2.109556 -2.537761 -2.945381 -3.332909 -3.682189 -3.956841 -4.069537 -3.884868 -3.344773 -2.569980 -1.683488 -25.97711 0.8545094 0.6817068 0.2801156 -0.2223018 -0.7273005 -1.219283 -1.697292 -2.157155 -2.581249 -2.985846 -3.379895 -3.744574 -4.081346 -4.368166 -4.537877 -4.457351 -3.989355 -3.195220 -2.242114 -25.97711 8.0040216E-02 -5.3346001E-02 -0.4139180 -0.8782629 -1.347819 -1.809047 -2.256071 -2.687761 -3.088883 -3.470014 -3.833913 -4.173065 -4.492872 -4.772604 -4.977078 -4.998158 -4.636424 -3.857258 -2.849869 -25.97711 -0.7843564 -0.8753906 -1.190791 -1.608059 -2.034925 -2.457849 -2.870760 -3.268317 -3.634533 -3.979473 -4.318906 -4.629495 -4.925781 -5.191789 -5.410385 -5.506460 -5.273448 -4.557400 -3.516814 -25.97711 -1.759298 -1.801523 -2.064022 -2.427006 -2.803733 -3.175700 -3.540972 -3.894730 -4.226803 -4.540901 -4.847720 -5.133677 -5.398219 -5.648997 -5.863310 -5.995136 -5.880762 -5.282770 -4.242025 -25.97711 -2.887065 -2.870353 -3.064956 -3.356136 -3.664445 -3.980493 -4.296664 -4.604985 -4.899169 -5.179847 -5.454330 -5.711647 -5.951406 -6.170229 -6.358354 -6.492496 -6.474975 -6.035538 -5.038134 -25.97711 -4.261718 -4.170928 -4.275533 -4.479845 -4.710105 -4.959888 -5.218809 -5.475749 -5.727133 -5.966959 -6.202728 -6.421627 -6.618909 -6.795330 -6.951930 -7.079076 -7.121568 -6.841880 -5.921879 -25.97711 -6.210908 -6.020078 -6.005112 -6.091867 -6.211657 -6.365247 -6.537494 -6.716379 -6.899243 -7.080392 -7.259389 -7.432872 -7.589324 -7.737692 -7.876720 -7.992159 -8.041157 -7.868020 -7.015484 -25.97711 -49.33149 -48.78941 -48.10644 -47.30549 -46.40439 -45.41678 -44.35341 -43.22180 -42.02929 -40.78105 -39.48161 -38.13482 -36.74396 -35.31214 -33.84114 -32.33393 -30.79223 -29.21782 -27.61230 -25.97711 3.524277 2.410221 2.161023 2.079039 1.949459 1.773785 1.553581 1.295477 1.016312 0.7291155 0.4467720 0.1878806 -2.7735516E-02 -0.1902473 -0.2999335 -0.3676091 -0.4039113 -0.4212901 -0.4288720 -28.00587 4.271549 3.305298 2.949223 2.724508 2.478198 2.207343 1.915834 1.606394 1.294524 0.9911356 0.7150174 0.4911081 0.3371877 0.2581611 0.2414679 0.2704267 0.3289481 0.4047282 0.4901077 -28.00587 4.685614 3.855721 3.382244 3.002561 2.628081 2.260350 1.895354 1.538574 1.194664 0.8717428 0.5886697 0.3823251 0.2687466 0.2509600 0.3085979 0.4191742 0.5630015 0.7265592 0.9022468 -28.00587 4.849687 4.132677 3.578992 3.079857 2.606430 2.160127 1.731382 1.326049 0.9435105 0.5901417 0.2876124 7.3703244E-02 -2.3118805E-02 9.2570839E-04 0.1214851 0.3073458 0.5335237 0.7836654 1.049205 -28.00587 4.828019 4.204420 3.603113 3.028348 2.486206 1.981900 1.505119 1.055224 0.6289051 0.2393894 -9.7045325E-02 -0.3411912 -0.4470428 -0.4040920 -0.2339340 2.1520201E-02 0.3279187 0.6640528 1.019332 -28.00587 4.665032 4.117715 3.499292 2.879207 2.296602 1.751939 1.239768 0.7548790 0.2892204 -0.1325385 -0.5072631 -0.7980511 -0.9434716 -0.9078592 -0.7059317 -0.3890652 -5.0714845E-03 0.4163914 0.8613262 -28.00587 4.389935 3.909890 3.289751 2.653102 2.046833 1.475758 0.9387314 0.4282083 -5.8875583E-02 -0.5109468 -0.9190962 -1.255898 -1.462995 -1.467881 -1.259036 -0.8926356 -0.4355097 7.0180967E-02 0.6046064 -28.00587 4.026800 3.604735 2.997020 2.355786 1.741743 1.155728 0.6004797 7.8926325E-02 -0.4161783 -0.8878765 -1.319207 -1.698792 -1.970694 -2.044677 -1.864030 -1.466867 -0.9438703 -0.3560882 0.2674854 -28.00587 3.585742 3.215660 2.629117 1.994162 1.380767 0.7885252 0.2277572 -0.2960649 -0.7913076 -1.267872 -1.715686 -2.122244 -2.448044 -2.599530 -2.481372 -2.080301 -1.502207 -0.8355492 -0.1234657 -28.00587 3.072475 2.750714 2.190368 1.568987 0.9622185 0.3787129 -0.1787272 -0.6987754 -1.189093 -1.664089 -2.116041 -2.534797 -2.892258 -3.117599 -3.083078 -2.715746 -2.100376 -1.360331 -0.5608878 -28.00587 2.489429 2.213167 1.681978 1.081946 0.4934866 -7.5415500E-02 -0.6220593 -1.132964 -1.615113 -2.083452 -2.526276 -2.944330 -3.317555 -3.598190 -3.657877 -3.364843 -2.741619 -1.938657 -1.054147 -28.00587 1.835572 1.601838 1.108347 0.5369506 -2.7866116E-02 -0.5751451 -1.105288 -1.605922 -2.073425 -2.527861 -2.954376 -3.360718 -3.736937 -4.038384 -4.185685 -3.999929 -3.409214 -2.559164 -1.593527 -28.00587 1.110599 0.9186732 0.4649820 -7.0969820E-02 -0.6056111 -1.129916 -1.637328 -2.119481 -2.568107 -2.998685 -3.406724 -3.796908 -4.151237 -4.463130 -4.666471 -4.600333 -4.092548 -3.220926 -2.181202 -28.00587 0.3037392 0.1551017 -0.2548669 -0.7510700 -1.252599 -1.746188 -2.224236 -2.674953 -3.098452 -3.504458 -3.890222 -4.245861 -4.582788 -4.882104 -5.118778 -5.157296 -4.774960 -3.921183 -2.820220 -28.00587 -0.5985957 -0.7018326 -1.062925 -1.513283 -1.972499 -2.425729 -2.865893 -3.283245 -3.676057 -4.045737 -4.400991 -4.730083 -5.036594 -5.321472 -5.559127 -5.677925 -5.438855 -4.657151 -3.517029 -28.00587 -1.616310 -1.669215 -1.973791 -2.367136 -2.773066 -3.179317 -3.570687 -3.945166 -4.298790 -4.637456 -4.957970 -5.257343 -5.535811 -5.795050 -6.026212 -6.178193 -6.070240 -5.425225 -4.283234 -28.00587 -2.794593 -2.786697 -3.018550 -3.338012 -3.676039 -4.020205 -4.361383 -4.690778 -5.004949 -5.306720 -5.592323 -5.860116 -6.110708 -6.340424 -6.541270 -6.690175 -6.683330 -6.216858 -5.125103 -28.00587 -4.234958 -4.144916 -4.279667 -4.505527 -4.764125 -5.038132 -5.318859 -5.598807 -5.867549 -6.126608 -6.374440 -6.598926 -6.808630 -6.994264 -7.159702 -7.294145 -7.343349 -7.063731 -6.058934 -28.00587 -6.268160 -6.068191 -6.074143 -6.172982 -6.315979 -6.490058 -6.682076 -6.885669 -7.088768 -7.283195 -7.475778 -7.650973 -7.820316 -7.967757 -8.120628 -8.240543 -8.305433 -8.135275 -7.218166 -28.00587 -53.32759 -52.74690 -52.00899 -51.14072 -50.16260 -49.09008 -47.93492 -46.70627 -45.41143 -44.05636 -42.64603 -41.18464 -39.67578 -38.12259 -36.52780 -34.89383 -33.22282 -31.51670 -29.77720 -28.00587 3.765203 2.566317 2.376633 2.303083 2.176314 2.001004 1.776343 1.505643 1.208543 0.9016712 0.5934012 0.3137911 7.8645147E-02 -9.7676046E-02 -0.2164885 -0.2878323 -0.3254849 -0.3430391 -0.3502340 -30.06916 4.583615 3.540747 3.214778 2.980199 2.727348 2.447646 2.147704 1.819666 1.489800 1.162809 0.8655110 0.6229555 0.4574261 0.3731062 0.3576843 0.3917838 0.4569995 0.5399318 0.6326993 -30.06916 5.043755 4.147802 3.669114 3.267494 2.876771 2.493946 2.111432 1.734944 1.373590 1.023696 0.7240397 0.5009896 0.3819847 0.3667309 0.4327843 0.5559687 0.7135144 0.8912398 1.081331 -30.06916 5.229953 4.456758 3.876565 3.348750 2.852006 2.381747 1.930323 1.506929 1.100625 0.7246466 0.4012122 0.1724528 7.1811028E-02 0.1039338 0.2391424 0.4444840 0.6913049 0.9625492 1.249562 -30.06916 5.218598 4.546562 3.905185 3.296209 2.723990 2.191133 1.693590 1.217117 0.7689361 0.3581084 -4.9292138E-03 -0.2666780 -0.3789921 -0.3270864 -0.1369376 0.1442767 0.4782519 0.8424669 1.226333 -30.06916 5.054811 4.465211 3.796831 3.140516 2.523534 1.952629 1.413198 0.8994939 0.4170696 -3.1799335E-02 -0.4323844 -0.7475191 -0.9057924 -0.8679382 -0.6441144 -0.2958027 0.1224966 0.5790610 1.059750 -30.06916 4.770799 4.252436 3.578935 2.903339 2.266183 1.663028 1.096257 0.5663654 5.5457301E-02 -0.4214295 -0.8552951 -1.219623 -1.446089 -1.455329 -1.225028 -0.8225157 -0.3237655 0.2242668 0.8017118 -30.06916 4.394763 3.936941 3.274597 2.597038 1.947111 1.327271 0.7493848 0.2037766 -0.3171690 -0.8113245 -1.269985 -1.674661 -1.973771 -2.064693 -1.870116 -1.435254 -0.8646415 -0.2272244 0.4466417 -30.06916 3.936791 3.536371 2.893067 2.219539 1.571096 0.9506983 0.3618782 -0.1876240 -0.7089264 -1.208214 -1.676160 -2.107960 -2.461519 -2.640743 -2.523333 -2.086865 -1.456294 -0.7327352 3.7036188E-02 -30.06916 3.402670 3.054048 2.436540 1.780093 1.141083 0.5228875 -6.2292598E-02 -0.6072881 -1.124028 -1.617469 -2.088090 -2.529353 -2.917751 -3.174042 -3.158741 -2.764268 -2.093956 -1.289957 -0.4253885 -30.06916 2.796867 2.496661 1.912282 1.275984 0.6519396 5.1649887E-02 -0.5247259 -1.060515 -1.565097 -2.053468 -2.513899 -2.953490 -3.349509 -3.665498 -3.753890 -3.449900 -2.773405 -1.899477 -0.9422656 -30.06916 2.116652 1.861956 1.314490 0.7091234 0.1114889 -0.4696188 -1.026866 -1.549976 -2.040237 -2.515933 -2.961296 -3.384512 -3.781882 -4.117213 -4.297032 -4.115528 -3.478530 -2.552460 -1.506450 -30.06916 1.362764 1.151838 0.6480794 7.7322289E-02 -0.4887868 -1.045408 -1.580603 -2.083389 -2.554807 -3.010672 -3.432773 -3.839213 -4.216950 -4.553112 -4.788404 -4.741535 -4.200176 -3.250084 -2.122327 -30.06916 0.5247549 0.3598636 -9.6822172E-02 -0.6276657 -1.160592 -1.685949 -2.190465 -2.664543 -3.109403 -3.538322 -3.939555 -4.314233 -4.666871 -4.988805 -5.249119 -5.310843 -4.918084 -3.988418 -2.792267 -30.06916 -0.4126072 -0.5295032 -0.9361508 -1.417180 -1.908067 -2.393183 -2.858823 -3.300104 -3.714457 -4.108483 -4.472172 -4.821388 -5.142596 -5.445768 -5.699352 -5.841039 -5.608643 -4.760968 -3.519686 -30.06916 -1.471422 -1.535939 -1.881310 -2.304301 -2.742909 -3.178735 -3.599688 -3.995217 -4.369837 -4.727092 -5.058772 -5.374392 -5.665355 -5.938399 -6.182641 -6.350935 -6.258682 -5.565466 -4.319314 -30.06916 -2.700936 -2.700456 -2.969128 -3.316156 -3.686985 -4.057435 -4.425245 -4.776967 -5.110419 -5.428559 -5.724785 -6.002506 -6.260988 -6.505542 -6.719673 -6.877650 -6.884552 -6.393261 -5.201995 -30.06916 -4.205624 -4.116792 -4.283382 -4.531425 -4.817446 -5.117416 -5.421325 -5.718671 -6.008268 -6.281740 -6.538126 -6.775765 -6.993633 -7.185371 -7.360487 -7.501791 -7.560005 -7.279946 -6.193735 -30.06916 -6.322285 -6.115292 -6.140934 -6.254667 -6.423311 -6.620343 -6.831185 -7.047198 -7.266860 -7.478376 -7.681176 -7.865961 -8.036433 -8.197361 -8.347228 -8.475224 -8.553320 -8.392943 -7.418452 -30.06916 -57.39582 -56.77599 -55.98190 -55.04470 -53.98777 -52.82844 -51.57975 -50.25177 -48.85251 -47.38848 -45.86509 -44.28692 -42.65788 -40.98135 -39.26029 -37.49731 -35.69476 -33.85467 -31.97891 -30.06916 3.996523 2.711516 2.591578 2.520941 2.400316 2.217950 1.991563 1.717408 1.401689 1.070532 0.7391911 0.4347979 0.1795156 -1.1684105E-02 -0.1399496 -0.2154963 -0.2546989 -0.2725391 -0.2794256 -32.16550 4.889851 3.771164 3.471309 3.232058 2.966535 2.680357 2.372911 2.034151 1.683755 1.334026 1.013901 0.7535733 0.5771400 0.4886234 0.4751910 0.5147858 0.5868167 0.6770125 0.7772489 -32.16550 5.394360 4.433039 3.950887 3.524003 3.115077 2.717881 2.324130 1.931176 1.545566 1.173003 0.8516423 0.6129999 0.4892685 0.4751077 0.5507700 0.6865886 0.8579855 1.049975 1.254637 -32.16550 5.604164 4.777395 4.166328 3.607378 3.088971 2.599398 2.129354 1.681272 1.253902 0.8521138 0.5076190 0.2642038 0.1613079 0.1999749 0.3508649 0.5760908 0.8437234 1.136340 1.445098 -32.16550 5.599813 4.879765 4.198101 3.557060 2.957922 2.399072 1.876305 1.373785 0.9045977 0.4676996 7.8467168E-02 -0.2012310 -0.3236741 -0.2651198 -5.5865128E-02 0.2512461 0.6126636 1.005258 1.418071 -32.16550 5.436932 4.804515 4.088935 3.397369 2.749018 2.147383 1.581608 1.043526 0.5379553 6.4579032E-02 -0.3647348 -0.7011760 -0.8793843 -0.8409252 -0.5962374 -0.2169008 0.2355572 0.7275912 1.244491 -32.16550 5.147696 4.589799 3.863517 3.152099 2.479449 1.844883 1.252693 0.6973506 0.1635187 -0.3377439 -0.7955326 -1.186779 -1.437125 -1.454876 -1.204678 -0.7662607 -0.2264393 0.3643764 0.9853929 -32.16550 4.757889 4.265464 3.548845 2.832284 2.146684 1.496801 0.8906807 0.3216706 -0.2252146 -0.7381555 -1.218891 -1.649695 -1.975896 -2.086069 -1.878270 -1.406991 -0.7881075 -0.1004525 0.6244292 -32.16550 4.281937 3.850958 3.151868 2.440206 1.757429 1.105399 0.4899097 -8.5408129E-02 -0.6308341 -1.146702 -1.636626 -2.091942 -2.473903 -2.684829 -2.565414 -2.097499 -1.413460 -0.6322741 0.1959980 -32.16550 3.726983 3.351289 2.679143 1.984465 1.312486 0.6637958 4.7211450E-02 -0.5194764 -1.061327 -1.572042 -2.062777 -2.525300 -2.939251 -3.230082 -3.233917 -2.818982 -2.092944 -1.224301 -0.2936710 -32.16550 3.097807 2.773339 2.135847 1.464371 0.8067144 0.1734909 -0.4307020 -0.9886668 -1.519147 -2.023738 -2.504910 -2.961659 -3.381251 -3.728317 -3.848346 -3.543039 -2.813247 -1.868017 -0.8370418 -32.16550 2.393327 2.117222 1.517653 0.8759988 0.2455412 -0.3675988 -0.9522876 -1.496383 -2.013192 -2.505755 -2.969460 -3.408526 -3.823731 -4.190697 -4.401423 -4.237994 -3.557672 -2.555326 -1.427767 -32.16550 1.611000 1.380931 0.8277401 0.2235397 -0.3780077 -0.9635292 -1.526053 -2.051119 -2.547964 -3.019035 -3.458878 -3.877612 -4.279469 -4.635829 -4.902504 -4.884813 -4.316535 -3.288865 -2.071951 -32.16550 0.7434130 0.5615002 5.6888111E-02 -0.5039257 -1.071238 -1.626537 -2.157880 -2.657344 -3.125099 -3.566358 -3.983008 -4.375083 -4.745235 -5.091112 -5.372067 -5.465070 -5.063384 -4.058606 -2.765476 -32.16550 -0.2283047 -0.3591837 -0.8094101 -1.321615 -1.846167 -2.361330 -2.853939 -3.317933 -3.752407 -4.165240 -4.542319 -4.904854 -5.245329 -5.564138 -5.836451 -6.001844 -5.779988 -4.867942 -3.523653 -32.16550 -1.326115 -1.402106 -1.789872 -2.241240 -2.713300 -3.176882 -3.626736 -4.048951 -4.437416 -4.812398 -5.158244 -5.483910 -5.795666 -6.075502 -6.325952 -6.521195 -6.449460 -5.709538 -4.357490 -32.16550 -2.605325 -2.612088 -2.919929 -3.295350 -3.696569 -4.098036 -4.486986 -4.861357 -5.210461 -5.546175 -5.853968 -6.139563 -6.416272 -6.665727 -6.878345 -7.056900 -7.084785 -6.571202 -5.277396 -32.16550 -4.173136 -4.086731 -4.282797 -4.558899 -4.873281 -5.202102 -5.524127 -5.840132 -6.139246 -6.432361 -6.696177 -6.943560 -7.171722 -7.376434 -7.539595 -7.694508 -7.774590 -7.492465 -6.324242 -32.16550 -6.366862 -6.154697 -6.196965 -6.332983 -6.524179 -6.747731 -6.978288 -7.215586 -7.439273 -7.670120 -7.878306 -8.070324 -8.249549 -8.419129 -8.557110 -8.696495 -8.791131 -8.643870 -7.614870 -32.16550 -61.53292 -60.87342 -60.02193 -59.01427 -57.87683 -56.62888 -55.28475 -53.85549 -52.34981 -50.77479 -49.13630 -47.43929 -45.68796 -43.88599 -42.03655 -40.14247 -38.20622 -36.23001 -34.21584 -32.16550 4.220269 2.848094 2.799703 2.734561 2.613095 2.420851 2.199524 1.918939 1.593170 1.235597 0.8784323 0.5517874 0.2753707 6.6402756E-02 -7.2278410E-02 -0.1527540 -0.1938279 -0.2120050 -0.2186934 -34.29354 5.188540 3.994118 3.725383 3.474142 3.191770 2.897761 2.586869 2.245790 1.871622 1.498333 1.156062 0.8788691 0.6885708 0.5953022 0.5835479 0.6284277 0.7072322 0.8047564 0.9124899 -34.29354 5.740126 4.716799 4.224738 3.770801 3.338725 2.932787 2.530918 2.122739 1.711077 1.315963 0.9749565 0.7247502 0.5931870 0.5817298 0.6674064 0.8162047 1.001583 1.208054 1.427446 -34.29354 5.968048 5.091702 4.448060 3.855130 3.316990 2.809367 2.323684 1.850269 1.398599 0.9744253 0.6100020 0.3514369 0.2434940 0.2884449 0.4559352 0.7010048 0.9896542 1.303899 1.634655 -34.29354 5.973028 5.206705 4.481562 3.809374 3.185133 2.603798 2.052007 1.525239 1.032786 0.5702625 0.1591076 -0.1468643 -0.2848588 -0.2235465 3.2498424E-03 0.3353424 0.7241175 1.145393 1.587473 -34.29354 5.810409 5.135227 4.373254 3.649812 2.971369 2.336443 1.744597 1.182065 0.6528534 0.1588786 -0.2989653 -0.6629602 -0.8673913 -0.8326005 -0.5706994 -0.1616847 0.3246098 0.8525181 1.406029 -34.29354 5.517992 4.919924 4.144842 3.396740 2.686849 2.021359 1.402444 0.8224133 0.2684433 -0.2552017 -0.7385636 -1.155451 -1.436538 -1.467133 -1.202918 -0.7303015 -0.1497697 0.4843119 1.149368 -34.29354 5.115910 4.589516 3.818238 3.061197 2.341537 1.659896 1.026960 0.4347424 -0.1326746 -0.6672963 -1.167986 -1.624773 -1.982205 -2.108664 -1.892884 -1.384090 -0.7168799 2.1806821E-02 0.7982901 -34.29354 4.621394 4.160374 3.404306 2.655757 1.937863 1.253082 0.6136799 1.5678708E-02 -0.5551081 -1.087583 -1.598160 -2.074529 -2.489959 -2.724511 -2.615249 -2.116407 -1.378783 -0.5391088 0.3482922 -34.29354 4.045387 3.642656 2.915423 2.183881 1.476803 0.7998317 0.1571166 -0.4351245 -0.9999588 -1.529024 -2.035920 -2.519839 -2.957990 -3.279145 -3.312479 -2.881921 -2.101006 -1.166924 -0.1695844 -34.29354 3.393383 3.043989 2.352343 1.647365 0.9575171 0.2894737 -0.3377398 -0.9208803 -1.476569 -1.996202 -2.494832 -2.967053 -3.411195 -3.780540 -3.944243 -3.641150 -2.859202 -1.842019 -0.7366371 -34.29354 2.665227 2.366082 1.716440 1.040383 0.3747621 -0.2697206 -0.8784119 -1.447887 -1.988065 -2.493718 -2.973548 -3.429398 -3.864773 -4.254719 -4.503812 -4.363921 -3.641652 -2.562340 -1.352598 -34.29354 1.855340 1.605354 1.003805 0.3663548 -0.2677636 -0.8865731 -1.472578 -2.023353 -2.541210 -3.021835 -3.481666 -3.912758 -4.335711 -4.708967 -5.009856 -5.026999 -4.434756 -3.330477 -2.023677 -34.29354 0.9589704 0.7602393 0.2088793 -0.3842592 -0.9841149 -1.570724 -2.128898 -2.650529 -3.137644 -3.591245 -4.024208 -4.436435 -4.822060 -5.174591 -5.485332 -5.615197 -5.208656 -4.133107 -2.742565 -34.29354 -4.4867221E-02 -0.1903787 -0.6859085 -1.228189 -1.786394 -2.330077 -2.850065 -3.336124 -3.787826 -4.214710 -4.612995 -4.984813 -5.347151 -5.666251 -5.966311 -6.151399 -5.945624 -4.977077 -3.529615 -34.29354 -1.182408 -1.269731 -1.697140 -2.180655 -2.683418 -3.179284 -3.649472 -4.095001 -4.504126 -4.891781 -5.250216 -5.587974 -5.917701 -6.203708 -6.468933 -6.677758 -6.626101 -5.853103 -4.395950 -34.29354 -2.509879 -2.524523 -2.867707 -3.276662 -3.709078 -4.139185 -4.550555 -4.940581 -5.308565 -5.658637 -5.975479 -6.273657 -6.558122 -6.812453 -7.040399 -7.226802 -7.266788 -6.743846 -5.350746 -34.29354 -4.136543 -4.054274 -4.278852 -4.581422 -4.927737 -5.279923 -5.630105 -5.962481 -6.273029 -6.578380 -6.851285 -7.104871 -7.343031 -7.545520 -7.720733 -7.877384 -7.968557 -7.691747 -6.446671 -34.29354 -6.409988 -6.194033 -6.253960 -6.409603 -6.628186 -6.872632 -7.128453 -7.379487 -7.613610 -7.855860 -8.068287 -8.270699 -8.452315 -8.612428 -8.757252 -8.899389 -9.006774 -8.869130 -7.799337 -34.29354 -65.73592 -65.03623 -64.12615 -63.04680 -61.82695 -60.48862 -59.04726 -57.51485 -55.90109 -54.21291 -52.45736 -50.63952 -48.76394 -46.83453 -44.85471 -42.82748 -40.75551 -38.64115 -36.48652 -34.29354 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.861521 -1.829774 -1.797269 -1.764016 -1.730021 -1.695293 -1.659840 -1.623669 -1.586781 -1.549196 -1.510922 -1.471966 -1.432336 -1.392039 -1.351080 -1.309463 -1.267206 -1.224316 -1.180802 -1.136669 -1.537448 -1.540730 -1.544276 -1.560122 -1.577652 -1.595032 -1.610577 -1.623091 -1.631480 -1.644069 -1.667410 -1.706929 -1.741661 -1.772259 -1.797771 -1.827928 -1.860670 -1.890861 -1.916948 -2.280320 -1.581085 -1.582640 -1.584392 -1.598000 -1.613459 -1.628817 -1.642523 -1.653357 -1.660270 -1.671076 -1.692414 -1.733515 -1.769887 -1.800640 -1.825463 -1.854958 -1.886500 -1.914616 -1.937639 -2.280320 -1.626799 -1.626611 -1.626571 -1.638001 -1.651429 -1.664823 -1.676795 -1.686014 -1.691508 -1.700683 -1.720152 -1.762492 -1.799122 -1.829764 -1.853658 -1.882609 -1.912812 -1.938729 -1.958642 -2.280320 -1.674604 -1.672610 -1.670743 -1.680015 -1.691368 -1.702840 -1.713115 -1.720690 -1.724778 -1.732403 -1.750173 -1.793597 -1.830139 -1.860103 -1.883159 -1.911379 -1.940138 -1.963754 -1.980538 -2.280320 -1.725137 -1.721302 -1.717606 -1.724709 -1.733945 -1.743545 -1.752171 -1.758154 -1.760867 -1.766965 -1.783028 -1.825824 -1.862031 -1.891107 -1.913420 -1.940707 -1.967901 -1.989020 -2.002614 -2.280320 -1.777426 -1.771713 -1.766169 -1.771101 -1.778168 -1.785898 -1.792762 -1.797175 -1.798425 -1.802940 -1.817292 -1.859203 -1.894319 -1.922123 -1.943817 -1.969801 -1.995255 -2.013648 -2.024000 -2.280320 -1.831361 -1.823713 -1.816317 -1.819223 -1.824143 -1.830037 -1.835084 -1.837873 -1.837542 -1.840401 -1.853085 -1.894000 -1.927908 -1.954543 -1.975356 -1.999821 -2.023327 -2.038863 -2.045901 -2.280320 -1.888691 -1.878963 -1.869499 -1.870328 -1.873061 -1.877050 -1.880234 -1.881398 -1.879390 -1.880555 -1.891430 -1.930589 -1.962874 -1.988580 -2.008169 -2.030856 -2.052146 -2.064679 -2.068306 -2.280320 -1.949194 -1.937208 -1.925491 -1.924225 -1.924630 -1.926511 -1.927737 -1.927133 -1.923329 -1.922705 -1.931678 -1.969064 -1.999864 -2.024559 -2.042474 -2.063334 -2.081984 -2.091396 -2.091494 -2.280320 -2.013923 -1.999396 -1.985242 -1.981613 -1.979673 -1.979243 -1.978366 -1.975797 -1.970101 -1.967501 -1.974406 -2.009542 -2.039084 -2.062319 -2.078218 -2.096868 -2.112530 -2.118671 -2.115092 -2.280320 -2.083206 -2.065706 -2.048860 -2.042529 -2.038105 -2.035186 -2.032025 -2.027179 -2.019395 -2.014517 -2.019194 -2.052272 -2.080110 -2.101325 -2.115090 -2.130800 -2.142876 -2.145703 -2.138251 -2.280320 -2.159175 -2.138436 -2.118409 -2.108975 -2.101734 -2.096078 -2.090394 -2.083077 -2.073061 -2.065681 -2.067895 -2.098716 -2.124212 -2.142984 -2.154121 -2.166269 -2.174526 -2.173687 -2.162168 -2.280320 -2.244606 -2.219952 -2.196094 -2.183216 -2.172569 -2.163691 -2.154962 -2.144753 -2.132138 -2.121913 -2.121292 -2.149076 -2.171534 -2.187717 -2.194991 -2.202731 -2.207122 -2.202183 -2.186334 -2.280320 -2.340431 -2.311713 -2.283497 -2.266644 -2.251975 -2.239215 -2.226787 -2.213131 -2.197369 -2.183889 -2.179935 -2.203975 -2.223273 -2.235070 -2.237708 -2.240252 -2.240354 -2.230810 -2.210305 -2.280320 -2.451734 -2.418463 -2.385336 -2.364049 -2.345113 -2.327569 -2.310667 -2.292656 -2.272928 -2.255648 -2.247830 -2.267621 -2.281698 -2.288027 -2.287256 -2.282180 -2.277200 -2.262519 -2.237181 -2.280320 -2.584621 -2.545876 -2.507138 -2.480662 -2.456659 -2.433496 -2.411008 -2.387413 -2.362411 -2.340353 -2.327656 -2.340842 -2.348614 -2.349814 -2.344000 -2.330275 -2.318487 -2.297999 -2.267609 -2.280320 -2.750956 -2.706676 -2.662319 -2.624443 -2.594600 -2.564311 -2.535215 -2.504977 -2.473479 -2.441895 -2.423436 -2.429178 -2.429913 -2.424431 -2.411533 -2.391072 -2.367178 -2.340399 -2.304660 -2.280320 -2.976471 -2.929370 -2.881695 -2.832961 -2.783395 -2.744190 -2.706883 -2.669881 -2.630903 -2.590089 -2.551255 -2.547402 -2.538166 -2.522555 -2.500256 -2.470934 -2.435676 -2.399724 -2.410371 -2.280320 -3.362242 -3.302252 -3.240832 -3.176782 -3.120209 -3.061612 -3.001491 -2.939160 -2.888235 -2.836799 -2.785459 -2.754654 -2.720058 -2.686020 -2.652699 -2.614367 -2.571095 -2.490856 -2.401890 -2.280320 -3.866702 -3.805162 -3.740865 -3.673868 -3.604220 -3.531984 -3.457229 -3.380011 -3.300364 -3.218371 -3.134086 -3.047551 -2.958812 -2.867940 -2.775223 -2.679958 -2.582939 -2.483970 -2.383332 -2.280320 -1.070651 -1.118064 -1.167663 -1.217814 -1.269721 -1.334790 -1.397052 -1.454026 -1.502599 -1.543728 -1.585553 -1.636367 -1.682856 -1.724794 -1.761325 -1.793672 -1.828254 -1.858685 -1.884862 -3.518405 -1.122904 -1.164072 -1.208022 -1.253584 -1.301080 -1.359737 -1.416245 -1.471328 -1.526677 -1.573147 -1.621167 -1.676606 -1.726001 -1.768753 -1.804472 -1.834470 -1.865869 -1.891682 -1.911666 -3.518405 -1.182663 -1.217443 -1.256064 -1.296878 -1.340142 -1.393141 -1.444565 -1.497665 -1.558060 -1.609318 -1.663739 -1.722869 -1.774049 -1.817014 -1.851718 -1.879469 -1.907638 -1.929005 -1.942812 -3.518405 -1.249942 -1.278969 -1.312167 -1.348062 -1.387032 -1.435054 -1.481827 -1.533541 -1.597162 -1.655017 -1.714198 -1.775955 -1.828311 -1.871295 -1.904897 -1.930761 -1.955772 -1.973034 -1.980746 -3.518405 -1.324858 -1.348509 -1.376292 -1.406972 -1.441512 -1.484810 -1.527027 -1.577056 -1.645259 -1.708525 -1.771769 -1.835089 -1.888083 -1.931019 -1.963411 -1.987742 -2.009900 -2.023238 -2.024992 -3.518405 -1.408000 -1.426260 -1.448759 -1.474266 -1.504073 -1.542438 -1.580527 -1.629119 -1.702181 -1.769660 -1.835460 -1.899643 -1.953038 -1.996006 -2.027453 -2.050416 -2.070095 -2.079731 -2.075797 -3.518405 -1.499504 -1.512711 -1.530015 -1.550366 -1.575318 -1.608867 -1.642847 -1.689632 -1.765820 -1.836007 -1.902752 -1.967186 -2.020772 -2.063324 -2.094198 -2.115795 -2.133146 -2.139281 -2.129762 -3.518405 -1.598628 -1.607009 -1.619358 -1.635093 -1.655320 -1.683869 -1.713535 -1.758360 -1.835986 -1.906770 -1.973530 -2.037442 -2.091143 -2.133098 -2.163707 -2.183680 -2.199227 -2.201793 -2.186838 -3.518405 -1.705188 -1.709111 -1.716540 -1.728041 -1.743604 -1.767041 -1.792445 -1.834362 -1.911425 -1.981456 -2.046999 -2.110197 -2.163101 -2.204634 -2.234850 -2.253644 -2.267325 -2.266022 -2.245738 -3.518405 -1.819606 -1.819160 -1.821858 -1.829024 -1.839894 -1.858124 -1.878736 -1.916789 -1.991553 -2.059509 -2.123410 -2.184911 -2.236209 -2.277552 -2.306653 -2.324276 -2.336460 -2.330740 -2.305060 -3.518405 -1.941002 -1.936545 -1.934900 -1.937697 -1.944027 -1.956948 -1.972757 -2.006665 -2.077501 -2.143014 -2.204739 -2.263039 -2.313085 -2.353704 -2.381865 -2.398521 -2.408823 -2.398598 -2.367632 -3.518405 -2.069397 -2.061288 -2.055519 -2.053852 -2.055654 -2.063529 -2.074417 -2.103848 -2.170522 -2.232695 -2.290389 -2.345756 -2.394033 -2.432889 -2.460840 -2.476763 -2.484047 -2.469382 -2.432891 -3.518405 -2.209231 -2.196195 -2.186511 -2.180085 -2.177221 -2.180054 -2.185669 -2.210491 -2.271351 -2.327788 -2.381613 -2.433816 -2.478657 -2.516751 -2.543492 -2.558169 -2.560902 -2.541881 -2.499292 -3.518405 -2.363404 -2.343940 -2.329764 -2.318788 -2.310699 -2.308298 -2.308203 -2.326644 -2.380125 -2.431392 -2.480439 -2.527535 -2.570055 -2.605739 -2.631634 -2.641782 -2.639300 -2.615404 -2.565920 -3.518405 -2.535150 -2.509631 -2.488363 -2.472890 -2.458964 -2.451043 -2.444633 -2.456764 -2.503294 -2.546971 -2.590075 -2.633837 -2.672261 -2.705790 -2.726690 -2.730077 -2.722452 -2.692196 -2.634810 -3.518405 -2.738502 -2.704491 -2.675708 -2.651835 -2.632257 -2.616877 -2.603482 -2.607795 -2.646705 -2.683734 -2.721181 -2.759887 -2.793551 -2.818915 -2.831093 -2.827016 -2.813204 -2.774788 -2.707814 -3.518405 -3.000559 -2.955398 -2.916218 -2.882293 -2.852324 -2.829204 -2.805840 -2.801965 -2.831665 -2.860284 -2.889227 -2.917753 -2.939448 -2.953915 -2.958768 -2.946516 -2.919690 -2.870482 -2.792502 -3.518405 -3.360515 -3.303536 -3.251261 -3.201865 -3.158247 -3.122357 -3.088383 -3.071657 -3.087651 -3.100402 -3.112277 -3.127599 -3.138454 -3.140983 -3.131938 -3.104960 -3.058334 -2.993999 -2.904016 -3.518405 -3.973954 -3.897985 -3.829226 -3.761469 -3.694944 -3.627001 -3.569387 -3.530665 -3.527740 -3.521989 -3.511511 -3.494397 -3.477556 -3.453701 -3.415363 -3.360154 -3.285554 -3.198022 -3.096210 -3.518405 -6.118580 -6.026617 -5.928686 -5.824958 -5.715641 -5.600924 -5.480969 -5.355991 -5.226125 -5.091567 -4.952461 -4.808954 -4.661208 -4.509326 -4.353469 -4.193740 -4.030262 -3.863151 -3.692490 -3.518405 -0.6117232 -0.7136723 -0.8225623 -0.9303488 -1.033500 -1.141262 -1.220991 -1.290635 -1.352964 -1.408424 -1.456645 -1.509912 -1.560213 -1.606286 -1.649683 -1.687175 -1.722165 -1.751786 -1.776789 -4.847148 -0.6482977 -0.7369499 -0.8334761 -0.9308766 -1.023821 -1.120050 -1.212804 -1.295093 -1.367896 -1.432253 -1.487182 -1.546646 -1.600680 -1.648660 -1.690563 -1.723613 -1.752086 -1.773123 -1.787748 -4.847148 -0.7043242 -0.7812620 -0.8667148 -0.9549618 -1.039871 -1.128008 -1.229507 -1.320874 -1.402492 -1.473884 -1.536297 -1.601629 -1.659085 -1.709160 -1.749424 -1.778477 -1.800852 -1.813694 -1.818364 -4.847148 -0.7760575 -0.8424569 -0.9173910 -0.9967536 -1.074658 -1.155250 -1.262649 -1.361495 -1.450040 -1.527633 -1.598168 -1.668684 -1.729895 -1.781615 -1.820421 -1.845901 -1.862562 -1.867706 -1.862722 -4.847148 -0.8611809 -0.9176506 -0.9824466 -1.052579 -1.123189 -1.196486 -1.308227 -1.412361 -1.505722 -1.590414 -1.668093 -1.742847 -1.808111 -1.860515 -1.897785 -1.919929 -1.931156 -1.928883 -1.914536 -4.847148 -0.9603971 -1.007395 -1.063015 -1.124069 -1.186895 -1.253176 -1.367302 -1.474566 -1.572635 -1.664204 -1.747771 -1.827251 -1.895885 -1.949006 -1.985201 -2.004541 -2.011162 -2.002083 -1.978821 -4.847148 -1.073330 -1.111141 -1.157832 -1.210511 -1.265375 -1.324457 -1.438703 -1.548447 -1.651915 -1.748964 -1.837391 -1.921886 -1.992901 -2.047066 -2.082977 -2.100284 -2.103124 -2.088286 -2.056633 -4.847148 -1.198592 -1.227404 -1.265357 -1.310123 -1.356621 -1.407896 -1.521071 -1.634171 -1.741575 -1.841435 -1.934707 -2.021604 -2.094307 -2.149487 -2.185519 -2.201449 -2.201027 -2.181680 -2.141701 -4.847148 -1.336909 -1.356986 -1.386777 -1.423363 -1.461935 -1.504925 -1.618227 -1.732603 -1.841083 -1.943908 -2.039037 -2.126752 -2.200362 -2.256504 -2.292702 -2.308157 -2.305383 -2.282406 -2.234641 -4.847148 -1.492297 -1.503357 -1.525214 -1.553487 -1.584322 -1.618977 -1.730400 -1.842852 -1.951557 -2.054418 -2.148600 -2.235569 -2.308990 -2.365556 -2.402324 -2.417786 -2.413161 -2.387085 -2.331940 -4.847148 -1.664807 -1.666634 -1.680151 -1.700930 -1.723995 -1.750743 -1.857228 -1.966562 -2.072183 -2.171787 -2.263539 -2.348197 -2.420321 -2.476091 -2.513753 -2.529204 -2.524025 -2.495051 -2.432846 -4.847148 -1.852353 -1.845931 -1.851181 -1.864997 -1.880596 -1.899658 -2.000624 -2.103147 -2.202812 -2.297691 -2.385300 -2.466237 -2.535442 -2.591047 -2.629594 -2.645362 -2.641711 -2.608634 -2.539916 -4.847148 -2.055556 -2.041808 -2.039234 -2.045440 -2.054128 -2.065706 -2.157984 -2.252858 -2.344468 -2.432203 -2.513886 -2.589341 -2.655947 -2.710739 -2.748826 -2.766259 -2.765127 -2.727535 -2.652536 -4.847148 -2.276529 -2.255542 -2.245532 -2.243671 -2.245183 -2.248935 -2.331481 -2.417167 -2.498046 -2.575544 -2.649210 -2.720246 -2.783604 -2.835864 -2.874187 -2.895597 -2.893396 -2.851401 -2.769959 -4.847148 -2.523037 -2.493500 -2.475607 -2.465437 -2.458059 -2.454178 -2.523017 -2.595557 -2.663541 -2.731252 -2.797435 -2.863346 -2.920775 -2.970463 -3.010604 -3.033717 -3.026928 -2.981651 -2.891693 -4.847148 -2.791438 -2.754307 -2.727865 -2.709512 -2.693472 -2.681322 -2.735028 -2.794891 -2.851808 -2.909688 -2.965971 -3.023010 -3.075697 -3.125276 -3.164101 -3.178934 -3.166708 -3.115844 -3.015133 -4.847148 -3.117963 -3.067890 -3.032131 -3.002408 -2.976192 -2.952899 -2.993020 -3.038760 -3.082814 -3.126313 -3.173223 -3.225271 -3.274313 -3.313591 -3.339773 -3.346016 -3.327890 -3.265209 -3.149199 -4.847148 -3.563820 -3.497253 -3.444908 -3.400375 -3.357660 -3.320450 -3.345149 -3.377688 -3.409330 -3.439479 -3.471397 -3.504140 -3.535231 -3.558748 -3.575256 -3.569055 -3.532323 -3.450253 -3.313145 -4.847148 -4.327983 -4.238577 -4.158283 -4.084102 -4.013150 -3.947869 -3.948174 -3.956437 -3.965224 -3.970679 -3.978766 -3.984540 -3.992742 -3.991881 -3.974882 -3.933105 -3.852416 -3.733889 -3.570324 -4.847148 -8.588029 -8.465016 -8.331647 -8.188350 -8.035576 -7.873747 -7.703267 -7.524538 -7.337902 -7.143728 -6.942304 -6.733960 -6.518941 -6.297533 -6.069960 -5.836457 -5.597478 -5.352485 -5.102401 -4.847148 -0.1841261 -0.3453463 -0.5177612 -0.6926055 -0.8626012 -0.9351751 -1.021905 -1.104227 -1.181273 -1.252290 -1.313919 -1.371253 -1.424707 -1.471180 -1.512747 -1.551712 -1.586056 -1.614025 -1.636125 -6.258605 -0.1902013 -0.3307543 -0.4824216 -0.6358850 -0.7864377 -0.8796453 -0.9853175 -1.084989 -1.177366 -1.259886 -1.329357 -1.392824 -1.448107 -1.493706 -1.531076 -1.562915 -1.586131 -1.600344 -1.606654 -6.258605 -0.2301984 -0.3522415 -0.4855945 -0.6215707 -0.7560936 -0.8713357 -0.9928463 -1.107570 -1.212806 -1.304276 -1.382636 -1.451830 -1.509252 -1.554655 -1.589372 -1.614258 -1.627228 -1.628481 -1.619740 -6.258605 -0.2990712 -0.4046162 -0.5216950 -0.6427084 -0.7632884 -0.8948041 -1.030183 -1.157354 -1.271889 -1.372248 -1.459547 -1.534279 -1.594690 -1.640458 -1.674049 -1.692583 -1.696152 -1.685238 -1.662063 -6.258605 -0.3922067 -0.4829158 -0.5853757 -0.6919706 -0.8000298 -0.9439608 -1.090117 -1.225293 -1.346594 -1.456290 -1.550878 -1.630737 -1.695348 -1.742438 -1.775458 -1.788450 -1.783339 -1.760923 -1.723897 -6.258605 -0.5083659 -0.5857463 -0.6749997 -0.7686654 -0.8647565 -1.016746 -1.168803 -1.307545 -1.435790 -1.551821 -1.652688 -1.738091 -1.806798 -1.858046 -1.889965 -1.898319 -1.885478 -1.852309 -1.802073 -6.258605 -0.6461518 -0.7111382 -0.7883604 -0.8707587 -0.9554805 -1.110698 -1.263598 -1.406284 -1.538903 -1.659662 -1.765849 -1.857587 -1.931058 -1.987802 -2.019524 -2.024863 -2.005755 -1.963056 -1.900600 -6.258605 -0.8033931 -0.8556476 -0.9219414 -0.9935044 -1.067515 -1.220799 -1.374522 -1.518896 -1.653508 -1.777382 -1.889024 -1.985564 -2.067051 -2.127942 -2.160774 -2.164594 -2.140975 -2.090373 -2.016711 -6.258605 -0.9770907 -1.016595 -1.071887 -1.132383 -1.196072 -1.348028 -1.498643 -1.641521 -1.776337 -1.902915 -2.017761 -2.119573 -2.207476 -2.270856 -2.305363 -2.308827 -2.281986 -2.224650 -2.140733 -6.258605 -1.170111 -1.197246 -1.241112 -1.291567 -1.345080 -1.490310 -1.636598 -1.775769 -1.910319 -2.037702 -2.154941 -2.262934 -2.352978 -2.418372 -2.455102 -2.459645 -2.431164 -2.369458 -2.275848 -6.258605 -1.379630 -1.394707 -1.426805 -1.467424 -1.510568 -1.648267 -1.788852 -1.924523 -2.055471 -2.181892 -2.302903 -2.411360 -2.500783 -2.567342 -2.605964 -2.612631 -2.583901 -2.520259 -2.417383 -6.258605 -1.609032 -1.612975 -1.633078 -1.662693 -1.696133 -1.824412 -1.958689 -2.087717 -2.215259 -2.340665 -2.458609 -2.563659 -2.651296 -2.717393 -2.757881 -2.766738 -2.739317 -2.674975 -2.563804 -6.258605 -1.861016 -1.854356 -1.863146 -1.881758 -1.906043 -2.022588 -2.147148 -2.271297 -2.394081 -2.511923 -2.622044 -2.722218 -2.806935 -2.872191 -2.913952 -2.925581 -2.902030 -2.838490 -2.720144 -6.258605 -2.137140 -2.120135 -2.118655 -2.126501 -2.140399 -2.247562 -2.361800 -2.475988 -2.587315 -2.694647 -2.794699 -2.887167 -2.968571 -3.032298 -3.074424 -3.089381 -3.074935 -3.008885 -2.884400 -6.258605 -2.450870 -2.422324 -2.410500 -2.406401 -2.409148 -2.502630 -2.600461 -2.698383 -2.795392 -2.889874 -2.978617 -3.063405 -3.138937 -3.199762 -3.241045 -3.262251 -3.253961 -3.185286 -3.055087 -6.258605 -2.801197 -2.761859 -2.738482 -2.721865 -2.712569 -2.785511 -2.864148 -2.942032 -3.024052 -3.107164 -3.185067 -3.257710 -3.325123 -3.382187 -3.426184 -3.454155 -3.442056 -3.373254 -3.233707 -6.258605 -3.194904 -3.144492 -3.109673 -3.080551 -3.058163 -3.112632 -3.172953 -3.233048 -3.297332 -3.363019 -3.426486 -3.486865 -3.545807 -3.606638 -3.648317 -3.664955 -3.648676 -3.574858 -3.421550 -6.258605 -3.726604 -3.653752 -3.601684 -3.554727 -3.512763 -3.542484 -3.577352 -3.616371 -3.659679 -3.711435 -3.763060 -3.812155 -3.857864 -3.897923 -3.923504 -3.933734 -3.905766 -3.815506 -3.636216 -6.258605 -4.611764 -4.505642 -4.416849 -4.337716 -4.268235 -4.266721 -4.272394 -4.279818 -4.294562 -4.312647 -4.337028 -4.360145 -4.381948 -4.398094 -4.405362 -4.383234 -4.314592 -4.175924 -3.955410 -6.258605 -11.24852 -11.09384 -10.92327 -10.73769 -10.53789 -10.32469 -10.09883 -9.860990 -9.611802 -9.351858 -9.081678 -8.801751 -8.512534 -8.214435 -7.907827 -7.593069 -7.270483 -6.940358 -6.602981 -6.258605 0.2114944 -1.1231858E-02 -0.2525525 -0.4970791 -0.6455256 -0.7303869 -0.8215266 -0.9200853 -1.013553 -1.097480 -1.173995 -1.241842 -1.300964 -1.351324 -1.393654 -1.430015 -1.463742 -1.490581 -1.510444 -7.745110 0.2500900 5.5369444E-02 -0.1539657 -0.3661423 -0.5191635 -0.6295753 -0.7486724 -0.8691917 -0.9791138 -1.078447 -1.165361 -1.237119 -1.296634 -1.342139 -1.375790 -1.400136 -1.417695 -1.424979 -1.423024 -7.745110 0.2372037 6.7584939E-02 -0.1152740 -0.3016871 -0.4606841 -0.6008336 -0.7445564 -0.8828998 -1.009184 -1.122952 -1.218933 -1.295345 -1.355504 -1.397206 -1.423661 -1.437491 -1.439821 -1.428712 -1.406000 -7.745110 0.1803095 3.3043098E-02 -0.1262671 -0.2894930 -0.4552154 -0.6215358 -0.7840629 -0.9372196 -1.079965 -1.206361 -1.309848 -1.392972 -1.454447 -1.494042 -1.514617 -1.519762 -1.508061 -1.479564 -1.436960 -7.745110 8.5177511E-02 -4.2866059E-02 -0.1827765 -0.3253911 -0.4956003 -0.6794811 -0.8541383 -1.022165 -1.178384 -1.314092 -1.425895 -1.515451 -1.579674 -1.619384 -1.636164 -1.634326 -1.609919 -1.565077 -1.503357 -7.745110 -4.3981019E-02 -0.1548418 -0.2776418 -0.4028807 -0.5731096 -0.7659026 -0.9526592 -1.131321 -1.295438 -1.436953 -1.557945 -1.652763 -1.721293 -1.763183 -1.779320 -1.770967 -1.735309 -1.675175 -1.595135 -7.745110 -0.2023075 -0.2962117 -0.4040102 -0.5138912 -0.6808300 -0.8815710 -1.075766 -1.259763 -1.425552 -1.574830 -1.701151 -1.801966 -1.876426 -1.922034 -1.941108 -1.928007 -1.882951 -1.809100 -1.711766 -7.745110 -0.3874171 -0.4649948 -0.5586949 -0.6546696 -0.8189737 -1.023645 -1.217691 -1.398754 -1.568898 -1.722028 -1.852293 -1.958971 -2.040329 -2.092375 -2.115093 -2.099385 -2.046900 -1.960983 -1.847599 -7.745110 -0.5995473 -0.6617258 -0.7419070 -0.8261527 -0.9844267 -1.185244 -1.372188 -1.552504 -1.722475 -1.876757 -2.011385 -2.123888 -2.211756 -2.274653 -2.300881 -2.285422 -2.228259 -2.132606 -2.004872 -7.745110 -0.8330040 -0.8815362 -0.9481966 -1.021378 -1.168454 -1.359019 -1.542817 -1.718678 -1.884390 -2.038471 -2.176799 -2.294856 -2.392502 -2.463357 -2.494612 -2.481910 -2.423344 -2.320778 -2.180680 -7.745110 -1.082384 -1.117955 -1.170207 -1.231639 -1.369616 -1.551429 -1.725220 -1.894411 -2.056366 -2.208079 -2.347695 -2.471424 -2.576655 -2.652090 -2.689229 -2.680449 -2.623120 -2.516392 -2.365802 -7.745110 -1.356384 -1.378495 -1.416859 -1.465805 -1.590667 -1.758025 -1.922208 -2.084348 -2.240676 -2.388996 -2.528340 -2.655782 -2.762438 -2.840645 -2.882969 -2.879356 -2.825485 -2.718994 -2.558542 -7.745110 -1.652128 -1.660092 -1.685580 -1.720220 -1.831999 -1.987086 -2.138570 -2.292152 -2.441581 -2.586886 -2.723120 -2.845399 -2.950115 -3.030205 -3.076094 -3.078831 -3.030277 -2.928337 -2.759683 -7.745110 -1.978847 -1.972815 -1.985533 -2.005044 -2.101034 -2.242462 -2.382100 -2.524303 -2.666068 -2.801789 -2.928377 -3.042529 -3.142224 -3.220932 -3.269809 -3.278817 -3.237951 -3.142874 -2.967734 -7.745110 -2.344723 -2.323457 -2.322867 -2.329081 -2.408284 -2.534339 -2.659824 -2.785417 -2.910944 -3.032771 -3.147657 -3.251559 -3.342619 -3.418607 -3.469210 -3.484410 -3.460178 -3.367916 -3.188262 -7.745110 -2.763751 -2.726529 -2.710639 -2.702759 -2.761314 -2.864066 -2.968791 -3.074876 -3.181204 -3.286204 -3.386659 -3.478631 -3.558707 -3.628021 -3.678394 -3.706082 -3.692210 -3.600605 -3.417459 -7.745110 -3.242158 -3.190715 -3.156450 -3.132902 -3.168523 -3.244602 -3.324925 -3.409880 -3.494582 -3.580288 -3.662860 -3.739955 -3.806475 -3.867754 -3.929616 -3.961040 -3.943469 -3.856678 -3.662508 -7.745110 -3.855583 -3.779039 -3.723541 -3.677011 -3.686188 -3.731339 -3.783023 -3.840246 -3.898900 -3.959230 -4.021495 -4.089228 -4.151065 -4.203867 -4.248231 -4.264963 -4.248790 -4.150896 -3.932461 -7.745110 -4.850717 -4.733604 -4.634611 -4.551585 -4.524362 -4.530362 -4.540098 -4.560730 -4.587697 -4.617139 -4.647713 -4.681710 -4.722207 -4.752264 -4.776512 -4.778979 -4.726679 -4.578523 -4.306103 -7.745110 -14.07850 -13.89154 -13.68208 -13.45157 -13.20142 -12.93292 -12.64724 -12.34582 -12.02859 -11.69747 -11.35290 -10.99559 -10.62619 -10.24528 -9.853398 -9.451036 -9.038636 -8.616601 -8.185309 -7.745110 0.5831426 0.2894959 -2.1754220E-02 -0.3221427 -0.4221022 -0.5205066 -0.6215405 -0.7332849 -0.8409755 -0.9424415 -1.032936 -1.112051 -1.181892 -1.237924 -1.283566 -1.320317 -1.351290 -1.377037 -1.395201 -9.300068 0.6685166 0.4126235 0.1434308 -0.1178783 -0.2480953 -0.3768017 -0.5109549 -0.6490487 -0.7791126 -0.8977907 -0.9978333 -1.082724 -1.149794 -1.198034 -1.229996 -1.249103 -1.258733 -1.258962 -1.249283 -9.300068 0.6855326 0.4625801 0.2287544 -2.9142005E-03 -0.1648569 -0.3278683 -0.4929136 -0.6551310 -0.8066144 -0.9385901 -1.050590 -1.141406 -1.206140 -1.247486 -1.267455 -1.270207 -1.260096 -1.236249 -1.199985 -9.300068 0.6468683 0.4533832 0.2502102 4.4556733E-02 -0.1490179 -0.3424785 -0.5327194 -0.7174206 -0.8859602 -1.032199 -1.156485 -1.252420 -1.317263 -1.353421 -1.363442 -1.351479 -1.323075 -1.276272 -1.214269 -9.300068 0.5576342 0.3894571 0.2115765 2.9037358E-02 -0.1900325 -0.4061740 -0.6169541 -0.8184791 -0.9996518 -1.161296 -1.297140 -1.397440 -1.465288 -1.498274 -1.501127 -1.477547 -1.431756 -1.363154 -1.276196 -9.300068 0.4219137 0.2771158 0.1213655 -4.1849419E-02 -0.2778981 -0.5101077 -0.7351538 -0.9456654 -1.141110 -1.314929 -1.457170 -1.565286 -1.636455 -1.669771 -1.668263 -1.636028 -1.574538 -1.485393 -1.374389 -9.300068 0.2465878 0.1229446 -1.4109139E-02 -0.1599390 -0.4071474 -0.6473880 -0.8766446 -1.097897 -1.304093 -1.484516 -1.632101 -1.747841 -1.824050 -1.860973 -1.857703 -1.820647 -1.745758 -1.637690 -1.503707 -9.300068 3.7060887E-02 -6.8156175E-02 -0.1883930 -0.3198231 -0.5691274 -0.8096504 -1.044953 -1.271167 -1.480927 -1.662925 -1.818666 -1.939988 -2.024493 -2.068142 -2.069118 -2.029381 -1.944304 -1.819594 -1.664133 -9.300068 -0.2015475 -0.2899628 -0.3940128 -0.5127802 -0.7574612 -0.9988334 -1.235135 -1.459694 -1.663863 -1.849982 -2.008932 -2.137436 -2.232343 -2.284484 -2.295737 -2.256357 -2.164845 -2.026520 -1.851515 -9.300068 -0.4693554 -0.5412714 -0.6297573 -0.7354843 -0.9759233 -1.211076 -1.438564 -1.654127 -1.857420 -2.040161 -2.200071 -2.336286 -2.439959 -2.505439 -2.526584 -2.490446 -2.395775 -2.246955 -2.054537 -9.300068 -0.7656859 -0.8222888 -0.8962897 -0.9892113 -1.218645 -1.437320 -1.652823 -1.861984 -2.057164 -2.236605 -2.397557 -2.537255 -2.649727 -2.731589 -2.762156 -2.733562 -2.640393 -2.485264 -2.278463 -9.300068 -1.084700 -1.126109 -1.185854 -1.264833 -1.475422 -1.681970 -1.883618 -2.079184 -2.266729 -2.443808 -2.602890 -2.742469 -2.868396 -2.959466 -3.000872 -2.982558 -2.896462 -2.740515 -2.523128 -9.300068 -1.430586 -1.455115 -1.499667 -1.563560 -1.755423 -1.943150 -2.129762 -2.314037 -2.492629 -2.661528 -2.817115 -2.960498 -3.086207 -3.181991 -3.232196 -3.224123 -3.147746 -2.996448 -2.770308 -9.300068 -1.806835 -1.812994 -1.841609 -1.888896 -2.059043 -2.230516 -2.404040 -2.573787 -2.738633 -2.899243 -3.051353 -3.188187 -3.308090 -3.405267 -3.461156 -3.465342 -3.401670 -3.262914 -3.030389 -9.300068 -2.230011 -2.216458 -2.227397 -2.257677 -2.405585 -2.556956 -2.710479 -2.865182 -3.016143 -3.162560 -3.300102 -3.427187 -3.538038 -3.629683 -3.690479 -3.703780 -3.655702 -3.532794 -3.296460 -9.300068 -2.715688 -2.680348 -2.671364 -2.683454 -2.804459 -2.930401 -3.061470 -3.194738 -3.324622 -3.451547 -3.571871 -3.684065 -3.782768 -3.866987 -3.928178 -3.951011 -3.931571 -3.815610 -3.578664 -9.300068 -3.276848 -3.221157 -3.189590 -3.180001 -3.268552 -3.362826 -3.464298 -3.571170 -3.678125 -3.781310 -3.880719 -3.973881 -4.059409 -4.131130 -4.192115 -4.239011 -4.227531 -4.118947 -3.878661 -9.300068 -3.971627 -3.889317 -3.831949 -3.794748 -3.846657 -3.903643 -3.969720 -4.043604 -4.121056 -4.197091 -4.269407 -4.342834 -4.419962 -4.492400 -4.553385 -4.587733 -4.576315 -4.469527 -4.211452 -9.300068 -5.050493 -4.926381 -4.823929 -4.744420 -4.750115 -4.762315 -4.782907 -4.814047 -4.851218 -4.896721 -4.941631 -4.984957 -5.033312 -5.086741 -5.125988 -5.149199 -5.120170 -4.971500 -4.651350 -9.300068 -17.06069 -16.84085 -16.59083 -16.31291 -16.00924 -15.68177 -15.33224 -14.96219 -14.57300 -14.16590 -13.74195 -13.30214 -12.84732 -12.37827 -11.89569 -11.40020 -10.89240 -10.37279 -9.841866 -9.300068 0.9377816 0.5673013 0.1889848 -7.3285364E-02 -0.1820170 -0.2984455 -0.4169181 -0.5394564 -0.6601117 -0.7756708 -0.8817707 -0.9746431 -1.052973 -1.117701 -1.167197 -1.205018 -1.233964 -1.257923 -1.274333 -10.91791 1.077416 0.7572545 0.4302675 0.1822136 3.2764990E-02 -0.1195815 -0.2704593 -0.4236392 -0.5701790 -0.7047760 -0.8236677 -0.9188973 -0.9940697 -1.046224 -1.077654 -1.091828 -1.093233 -1.085834 -1.068344 -10.91791 1.127248 0.8504520 0.5658358 0.3219691 0.1316666 -5.4587144E-02 -0.2389696 -0.4209804 -0.5907689 -0.7438112 -0.8723431 -0.9718139 -1.043859 -1.084104 -1.098372 -1.090302 -1.065735 -1.028245 -0.9781573 -10.91791 1.102356 0.8609752 0.6127028 0.3731940 0.1497341 -6.7472063E-02 -0.2835957 -0.4914300 -0.6836600 -0.8552672 -0.9936683 -1.101332 -1.172234 -1.204761 -1.204330 -1.176627 -1.128074 -1.061944 -0.9802639 -10.91791 1.015434 0.8047253 0.5872608 0.3549940 0.1065681 -0.1398552 -0.3799955 -0.6095574 -0.8221583 -1.006418 -1.160017 -1.277380 -1.348503 -1.377255 -1.365691 -1.320934 -1.250566 -1.157064 -1.044598 -10.91791 0.8767146 0.6952711 0.5049205 0.2792853 8.5326144E-03 -0.2555692 -0.5142688 -0.7629545 -0.9883769 -1.184972 -1.353068 -1.478654 -1.554064 -1.581337 -1.562564 -1.503619 -1.413792 -1.294222 -1.151757 -10.91791 0.6907162 0.5348138 0.3673968 0.1499027 -0.1322435 -0.4098080 -0.6814016 -0.9388483 -1.172325 -1.382832 -1.561605 -1.693411 -1.776410 -1.804494 -1.782700 -1.714296 -1.606528 -1.462412 -1.290827 -10.91791 0.4648928 0.3308546 0.1845531 -2.5437918E-02 -0.3123589 -0.5977909 -0.8739334 -1.132838 -1.375791 -1.594863 -1.777723 -1.920727 -2.011950 -2.046895 -2.026352 -1.954530 -1.832282 -1.666038 -1.466840 -10.91791 0.2004411 8.5809425E-02 -4.1333567E-02 -0.2423881 -0.5298036 -0.8104027 -1.084329 -1.348209 -1.594914 -1.811644 -1.999615 -2.151721 -2.252943 -2.299955 -2.286562 -2.217531 -2.085447 -1.900300 -1.675429 -10.91791 -0.1007566 -0.1971570 -0.3080165 -0.4964087 -0.7731687 -1.047400 -1.318764 -1.579396 -1.818632 -2.034738 -2.223909 -2.380982 -2.496001 -2.555775 -2.559727 -2.496135 -2.360078 -2.160212 -1.912309 -10.91791 -0.4319175 -0.5096288 -0.6050745 -0.7782509 -1.046019 -1.312038 -1.572054 -1.817573 -2.049920 -2.261892 -2.447751 -2.609626 -2.735468 -2.812257 -2.836037 -2.783384 -2.649122 -2.440116 -2.172625 -10.91791 -0.7978661 -0.8573147 -0.9373580 -1.095136 -1.346834 -1.593489 -1.836362 -2.069865 -2.288932 -2.490776 -2.675606 -2.837461 -2.970608 -3.069715 -3.107980 -3.070498 -2.943744 -2.731496 -2.448493 -10.91791 -1.197300 -1.237462 -1.300739 -1.440031 -1.667680 -1.894899 -2.119543 -2.334411 -2.539437 -2.733067 -2.910476 -3.070851 -3.217074 -3.326904 -3.380589 -3.360909 -3.250211 -3.043348 -2.750967 -10.91791 -1.636021 -1.653353 -1.697140 -1.816458 -2.016937 -2.217967 -2.420874 -2.620481 -2.811406 -2.990655 -3.160204 -3.322283 -3.465568 -3.579116 -3.644286 -3.640094 -3.549301 -3.356751 -3.058222 -10.91791 -2.115887 -2.108770 -2.131535 -2.226741 -2.399816 -2.577343 -2.758045 -2.936805 -3.110341 -3.279023 -3.437893 -3.587085 -3.721986 -3.833772 -3.903491 -3.915449 -3.847138 -3.679051 -3.378460 -10.91791 -2.660655 -2.627878 -2.627061 -2.696079 -2.839089 -2.986819 -3.141616 -3.298702 -3.452965 -3.600624 -3.740420 -3.872757 -3.994004 -4.095913 -4.168782 -4.192989 -4.153577 -4.009875 -3.711276 -10.91791 -3.292032 -3.233447 -3.205516 -3.244666 -3.353059 -3.466875 -3.588947 -3.715903 -3.842429 -3.966031 -4.082549 -4.193069 -4.295960 -4.386062 -4.456672 -4.500409 -4.489991 -4.358377 -4.066365 -10.91791 -4.061950 -3.973569 -3.915038 -3.916763 -3.983685 -4.058782 -4.142001 -4.231707 -4.325364 -4.415788 -4.505665 -4.591827 -4.674173 -4.760267 -4.839766 -4.890461 -4.875410 -4.764430 -4.461855 -10.91791 -5.232098 -5.096247 -4.988728 -4.935936 -4.943640 -4.967115 -5.002675 -5.045809 -5.096410 -5.150620 -5.209102 -5.271365 -5.329483 -5.386210 -5.450947 -5.492955 -5.478126 -5.334432 -4.966815 -10.91791 -20.18103 -19.92769 -19.63549 -19.30778 -18.94764 -18.55781 -18.14070 -17.69840 -17.23274 -16.74533 -16.23757 -15.71095 -15.16605 -14.60387 -14.02577 -13.43254 -12.82414 -12.20198 -11.56638 -10.91791 1.277061 0.8264465 0.3760575 0.1770553 6.2928289E-02 -6.5269366E-02 -0.1994818 -0.3402157 -0.4753803 -0.6039128 -0.7245378 -0.8308409 -0.9202017 -0.9917188 -1.046230 -1.085774 -1.114053 -1.135495 -1.150194 -12.59390 1.475125 1.088311 0.7008774 0.4841980 0.3209396 0.1504766 -2.3464788E-02 -0.1958653 -0.3561063 -0.5064976 -0.6389530 -0.7483258 -0.8293701 -0.8853384 -0.9152997 -0.9248829 -0.9190574 -0.9031096 -0.8777499 -12.59390 1.558775 1.225318 0.8907589 0.6468176 0.4347846 0.2203532 9.5344186E-03 -0.1892469 -0.3771534 -0.5472620 -0.6915309 -0.8031253 -0.8781916 -0.9194723 -0.9267629 -0.9080406 -0.8698483 -0.8182220 -0.7543163 -12.59390 1.550764 1.260854 0.9691798 0.7044404 0.4488429 0.1983645 -4.1141324E-02 -0.2698286 -0.4834887 -0.6740224 -0.8334176 -0.9494330 -1.024329 -1.054108 -1.043124 -0.9990213 -0.9305811 -0.8446201 -0.7431680 -12.59390 1.468190 1.215868 0.9595531 0.6787685 0.3931936 0.1178886 -0.1498433 -0.4045855 -0.6397325 -0.8505678 -1.023451 -1.149393 -1.227128 -1.249164 -1.223161 -1.156653 -1.060125 -0.9407960 -0.8024594 -12.59390 1.323011 1.103296 0.8767271 0.5892391 0.2861669 -1.0846937E-02 -0.3007431 -0.5759930 -0.8304743 -1.058504 -1.244633 -1.384805 -1.466826 -1.487732 -1.450566 -1.365698 -1.243823 -1.092576 -0.9181027 -12.59390 1.126559 0.9353591 0.7354565 0.4506731 0.1331040 -0.1810405 -0.4853526 -0.7750470 -1.043534 -1.280784 -1.485306 -1.639847 -1.728806 -1.753379 -1.711297 -1.612263 -1.468769 -1.287354 -1.077706 -12.59390 0.8856330 0.7206330 0.5465338 0.2607214 -6.2658243E-02 -0.3845472 -0.6982867 -0.9975208 -1.269258 -1.516689 -1.734895 -1.899075 -2.001388 -2.032710 -1.992279 -1.884940 -1.723479 -1.514197 -1.270541 -12.59390 0.5993787 0.4578436 0.3057451 2.6950248E-02 -0.2982130 -0.6215080 -0.9367318 -1.233002 -1.510950 -1.764378 -1.985575 -2.161481 -2.277295 -2.320801 -2.288705 -2.182000 -2.006862 -1.772974 -1.497090 -12.59390 0.2718251 0.1523588 1.8931534E-02 -0.2500083 -0.5705473 -0.8880320 -1.193408 -1.487887 -1.765289 -2.016159 -2.236408 -2.422290 -2.550870 -2.613269 -2.594978 -2.498724 -2.316976 -2.063195 -1.757732 -12.59390 -9.7656325E-02 -0.1961783 -0.3127702 -0.5674250 -0.8720494 -1.176911 -1.475368 -1.761297 -2.026061 -2.268868 -2.489507 -2.676475 -2.820350 -2.901469 -2.909001 -2.827567 -2.647902 -2.380595 -2.049284 -12.59390 -0.5073252 -0.5837896 -0.6821063 -0.9183625 -1.205947 -1.494816 -1.777491 -2.043266 -2.295534 -2.528179 -2.740293 -2.929167 -3.083051 -3.183966 -3.221215 -3.160460 -2.991385 -2.719376 -2.367377 -12.59390 -0.9589426 -1.012629 -1.091857 -1.307482 -1.570487 -1.832419 -2.092412 -2.341897 -2.576071 -2.792694 -2.998152 -3.183480 -3.340443 -3.465071 -3.522542 -3.486546 -3.335151 -3.067426 -2.700729 -12.59390 -1.449351 -1.478721 -1.537653 -1.726800 -1.960363 -2.196220 -2.429639 -2.655623 -2.873023 -3.077299 -3.268129 -3.447921 -3.613682 -3.744789 -3.820808 -3.810232 -3.688145 -3.437810 -3.065968 -12.59390 -1.988356 -1.990221 -2.025472 -2.183394 -2.384218 -2.588919 -2.796937 -3.002285 -3.199059 -3.384812 -3.565167 -3.737790 -3.893929 -4.024026 -4.108579 -4.119893 -4.027755 -3.808153 -3.434946 -12.59390 -2.588289 -2.560214 -2.568157 -2.692978 -2.861608 -3.035620 -3.213565 -3.391143 -3.568738 -3.737882 -3.896657 -4.050266 -4.192529 -4.312408 -4.398556 -4.427105 -4.366776 -4.188088 -3.820391 -12.59390 -3.286687 -3.228280 -3.204511 -3.289521 -3.418596 -3.556650 -3.702137 -3.847089 -3.994243 -4.137990 -4.273429 -4.401421 -4.521238 -4.628667 -4.710952 -4.753140 -4.739670 -4.586879 -4.231107 -12.59390 -4.135983 -4.043825 -3.984972 -4.021619 -4.102619 -4.196854 -4.300475 -4.406923 -4.515664 -4.626816 -4.731795 -4.831765 -4.927286 -5.018464 -5.110749 -5.174796 -5.166586 -5.039276 -4.684980 -12.59390 -5.393010 -5.250036 -5.139171 -5.111871 -5.125827 -5.159756 -5.206590 -5.262030 -5.324022 -5.394136 -5.469247 -5.542901 -5.616105 -5.686641 -5.756686 -5.818649 -5.813756 -5.671112 -5.257234 -12.59390 -23.42787 -23.14045 -22.80450 -22.42470 -22.00529 -21.54994 -21.06181 -20.54362 -19.99796 -19.42608 -18.83048 -18.21268 -17.57352 -16.91420 -16.23627 -15.54041 -14.82751 -14.09832 -13.35357 -12.59390 1.594766 1.062224 0.5402262 0.4216387 0.3042146 0.1683100 1.9688301E-02 -0.1346366 -0.2891359 -0.4357670 -0.5697822 -0.6905054 -0.7918273 -0.8710651 -0.9310203 -0.9724326 -1.000591 -1.020174 -1.033416 -14.32395 1.857711 1.402235 0.9509941 0.7795015 0.6071371 0.4198106 0.2283928 3.7296232E-02 -0.1457485 -0.3107125 -0.4575979 -0.5784332 -0.6693498 -0.7265791 -0.7560868 -0.7609528 -0.7482961 -0.7240906 -0.6909944 -14.32395 1.980267 1.588861 1.200627 0.9668661 0.7338107 0.4964294 0.2631010 3.8750950E-02 -0.1677238 -0.3539619 -0.5125793 -0.6350209 -0.7153451 -0.7542126 -0.7553245 -0.7261420 -0.6748121 -0.6087019 -0.5309715 -14.32395 1.991790 1.652434 1.316139 1.029567 0.7458077 0.4665607 0.1969420 -5.5740338E-02 -0.2879387 -0.4981354 -0.6711736 -0.8010847 -0.8770970 -0.9030862 -0.8800563 -0.8197142 -0.7318972 -0.6254057 -0.5040219 -14.32395 1.913844 1.618383 1.323171 0.9994817 0.6806736 0.3685918 7.0172630E-02 -0.2054011 -0.4650250 -0.6978062 -0.8888059 -1.027535 -1.107355 -1.124558 -1.082534 -0.9940645 -0.8717231 -0.7260529 -0.5616216 -14.32395 1.765390 1.507195 1.245249 0.9005116 0.5562000 0.2219427 -9.3609005E-02 -0.3949630 -0.6763253 -0.9300968 -1.141062 -1.292583 -1.382114 -1.395659 -1.340687 -1.228657 -1.074717 -0.8910199 -0.6842049 -14.32395 1.558100 1.332212 1.100082 0.7436453 0.3869505 4.1450381E-02 -0.2953623 -0.6140482 -0.9089062 -1.180793 -1.407039 -1.578933 -1.680912 -1.697674 -1.635533 -1.505427 -1.323534 -1.103447 -0.8550186 -14.32395 1.298311 1.101294 0.8966520 0.5390801 0.1787481 -0.1793453 -0.5256894 -0.8545487 -1.161435 -1.439005 -1.684082 -1.876325 -1.990743 -2.020229 -1.958636 -1.817545 -1.613235 -1.359336 -1.070485 -14.32395 0.9922472 0.8235924 0.6439418 0.2897702 -7.4875362E-02 -0.4349243 -0.7828270 -1.115664 -1.422510 -1.707289 -1.964811 -2.169733 -2.303440 -2.349375 -2.297965 -2.154177 -1.934149 -1.649926 -1.322316 -14.32395 0.6373282 0.4953080 0.3371165 -9.0780994E-03 -0.3672476 -0.7229669 -1.066420 -1.390941 -1.697070 -1.984997 -2.243212 -2.456113 -2.607714 -2.673769 -2.641296 -2.506615 -2.276826 -1.966877 -1.602816 -14.32395 0.2331847 0.1164708 -2.1109333E-02 -0.3534975 -0.6975111 -1.040111 -1.369811 -1.687991 -1.988455 -2.266768 -2.518885 -2.737852 -2.901750 -2.993754 -2.985889 -2.874128 -2.645092 -2.316566 -1.919846 -14.32395 -0.2162976 -0.3088560 -0.4262595 -0.7388219 -1.059773 -1.383547 -1.700950 -2.005934 -2.288099 -2.552005 -2.797004 -3.012390 -3.188257 -3.301166 -3.330394 -3.246340 -3.030212 -2.692794 -2.268801 -14.32395 -0.7087355 -0.7763186 -0.8722687 -1.160164 -1.459743 -1.761207 -2.053682 -2.334813 -2.600554 -2.847190 -3.076929 -3.288249 -3.468221 -3.601883 -3.665282 -3.614372 -3.422372 -3.089131 -2.645454 -14.32395 -1.249811 -1.291522 -1.365264 -1.623336 -1.891398 -2.161678 -2.426792 -2.683766 -2.927656 -3.155078 -3.372842 -3.570034 -3.753097 -3.903120 -3.987918 -3.971708 -3.813773 -3.499169 -3.045583 -14.32395 -1.842603 -1.855250 -1.903562 -2.124312 -2.358061 -2.594613 -2.827995 -3.057582 -3.281385 -3.489906 -3.687797 -3.878772 -4.057206 -4.205727 -4.305476 -4.316226 -4.202079 -3.923891 -3.472663 -14.32395 -2.502880 -2.482651 -2.501114 -2.677713 -2.873323 -3.075376 -3.278232 -3.477362 -3.675146 -3.865861 -4.048089 -4.219350 -4.379117 -4.520026 -4.617866 -4.652063 -4.579982 -4.355030 -3.912543 -14.32395 -3.263681 -3.208586 -3.191965 -3.321925 -3.473868 -3.635294 -3.800972 -3.969520 -4.137017 -4.299873 -4.454941 -4.602317 -4.736588 -4.859816 -4.952612 -5.002273 -4.977834 -4.802027 -4.377467 -14.32395 -4.192143 -4.098434 -4.039824 -4.111651 -4.209596 -4.322944 -4.444148 -4.568956 -4.696858 -4.825283 -4.946855 -5.062126 -5.170776 -5.273939 -5.364767 -5.441638 -5.441259 -5.297521 -4.888691 -14.32395 -5.540275 -5.387637 -5.270503 -5.265376 -5.288429 -5.335213 -5.396787 -5.464131 -5.536442 -5.622158 -5.711381 -5.798674 -5.885300 -5.969270 -6.045315 -6.118941 -6.122606 -5.986937 -5.526979 -14.32395 -26.79140 -26.46930 -26.08807 -25.65400 -25.17267 -24.64884 -24.08652 -23.48910 -22.85945 -22.20002 -21.51290 -20.79993 -20.06270 -19.30262 -18.52093 -17.71875 -16.89709 -16.05686 -15.19890 -14.32395 1.899898 1.284090 0.7608480 0.6659187 0.5421410 0.3984752 0.2407034 7.2697118E-02 -9.8048024E-02 -0.2642753 -0.4167443 -0.5508292 -0.6637840 -0.7527118 -0.8165836 -0.8606111 -0.8889535 -0.9071366 -0.9190750 -16.10451 2.229130 1.701049 1.235448 1.068579 0.8842409 0.6850970 0.4787672 0.2699883 6.7750499E-02 -0.1194051 -0.2806326 -0.4141778 -0.5119312 -0.5729123 -0.6007825 -0.6011767 -0.5819749 -0.5499676 -0.5092839 -16.10451 2.389055 1.936845 1.520813 1.274337 1.022512 0.7664430 0.5117952 0.2663744 3.5005093E-02 -0.1698776 -0.3433758 -0.4774011 -0.5636058 -0.6002215 -0.5952794 -0.5552048 -0.4910452 -0.4109714 -0.3195317 -16.10451 2.421467 2.030455 1.655824 1.344520 1.035578 0.7279465 0.4346578 0.1556610 -0.1037518 -0.3291160 -0.5193949 -0.6594352 -0.7404453 -0.7597892 -0.7258049 -0.6488039 -0.5418239 -0.4149537 -0.2735862 -16.10451 2.352014 2.011992 1.672209 1.314417 0.9600663 0.6181970 0.2911325 -1.5924515E-02 -0.2983856 -0.5509536 -0.7601190 -0.9136758 -0.9954435 -1.005727 -0.9480534 -0.8377165 -0.6899229 -0.5173944 -0.3266667 -16.10451 2.201908 1.904417 1.593785 1.205448 0.8249664 0.4553269 0.1039190 -0.2207744 -0.5286447 -0.8068572 -1.038069 -1.209281 -1.300879 -1.309596 -1.235067 -1.095659 -0.9098237 -0.6931032 -0.4535730 -16.10451 1.982872 1.721699 1.438322 1.036057 0.6389666 0.2536353 -0.1109823 -0.4565366 -0.7803470 -1.078842 -1.334905 -1.524156 -1.634949 -1.647542 -1.565907 -1.403796 -1.183577 -0.9242942 -0.6366588 -16.10451 1.707205 1.479487 1.221512 0.8134059 0.4090373 2.0057473E-02 -0.3567458 -0.7131597 -1.048527 -1.362243 -1.633862 -1.848060 -1.981901 -2.007232 -1.926965 -1.750716 -1.501599 -1.202018 -0.8672830 -16.10451 1.377178 1.181067 0.9464706 0.5427529 0.1425721 -0.2519554 -0.6306849 -0.9909846 -1.332947 -1.650527 -1.935179 -2.171653 -2.325166 -2.375458 -2.306913 -2.127434 -1.857468 -1.521285 -1.141010 -16.10451 0.9951985 0.8300686 0.6186641 0.2255590 -0.1681304 -0.5574215 -0.9329412 -1.292821 -1.628280 -1.946228 -2.238990 -2.484632 -2.661737 -2.738146 -2.694450 -2.523538 -2.243306 -1.875758 -1.452341 -16.10451 0.5623197 0.4258013 0.2371540 -0.1405073 -0.5201940 -0.8974980 -1.264326 -1.611586 -1.940273 -2.253587 -2.538970 -2.788971 -2.981933 -3.084955 -3.074308 -2.927865 -2.646717 -2.254805 -1.791582 -16.10451 7.9733595E-02 -2.9904639E-02 -0.1952323 -0.5531691 -0.9145083 -1.270658 -1.618319 -1.955254 -2.272449 -2.567147 -2.840496 -3.088605 -3.288972 -3.419932 -3.443735 -3.338285 -3.071609 -2.666141 -2.168621 -16.10451 -0.4536349 -0.5372072 -0.6782487 -1.007960 -1.342870 -1.677628 -2.004420 -2.319886 -2.613331 -2.890997 -3.148787 -3.384190 -3.592421 -3.737484 -3.806428 -3.744037 -3.507874 -3.104097 -2.580493 -16.10451 -1.038326 -1.093703 -1.208858 -1.507877 -1.813619 -2.117840 -2.413062 -2.700354 -2.973281 -3.227734 -3.466582 -3.691572 -3.892662 -4.056602 -4.153319 -4.136016 -3.942833 -3.559690 -3.021336 -16.10451 -1.683279 -1.708968 -1.795502 -2.053277 -2.320966 -2.588980 -2.851744 -3.107787 -3.354658 -3.588292 -3.807577 -4.013308 -4.214976 -4.381134 -4.491705 -4.511667 -4.374092 -4.032761 -3.495877 -16.10451 -2.402019 -2.392078 -2.443317 -2.654451 -2.878005 -3.105495 -3.333842 -3.559462 -3.778522 -3.987193 -4.187855 -4.378487 -4.561093 -4.719286 -4.828473 -4.873218 -4.789860 -4.512668 -3.987920 -16.10451 -3.226193 -3.176620 -3.184737 -3.343728 -3.518691 -3.703798 -3.892039 -4.081261 -4.271665 -4.454117 -4.625119 -4.789482 -4.945235 -5.085003 -5.187836 -5.244768 -5.213283 -5.008204 -4.507613 -16.10451 -4.226546 -4.133480 -4.091969 -4.187908 -4.306053 -4.437440 -4.577920 -4.722039 -4.869711 -5.016034 -5.152457 -5.282379 -5.405105 -5.528263 -5.621355 -5.700024 -5.714019 -5.548586 -5.078286 -16.10451 -5.665777 -5.510270 -5.400606 -5.409880 -5.448130 -5.503698 -5.576905 -5.660461 -5.750826 -5.846242 -5.948686 -6.049607 -6.148709 -6.254525 -6.346841 -6.408612 -6.433520 -6.289937 -5.779517 -16.10451 -30.26322 -29.90587 -29.47787 -28.98741 -28.44168 -27.84659 -27.20712 -26.52736 -25.81076 -25.06022 -24.27822 -23.46689 -22.62808 -21.76344 -20.87442 -19.96230 -19.02824 -18.07331 -17.09844 -16.10451 2.195788 1.501416 1.006920 0.9071312 0.7818441 0.6293632 0.4612874 0.2816750 9.5197923E-02 -8.8529892E-02 -0.2606243 -0.4093898 -0.5340577 -0.6311904 -0.7005302 -0.7471769 -0.7756814 -0.7927465 -0.8033864 -17.93244 2.588714 1.989539 1.531384 1.355386 1.157569 0.9451913 0.7257394 0.5018218 0.2814542 7.5257920E-02 -0.1059443 -0.2492690 -0.3550790 -0.4191293 -0.4445435 -0.4404192 -0.4146439 -0.3749707 -0.3267276 -17.93244 2.790247 2.275216 1.844752 1.575488 1.301501 1.027468 0.7566068 0.4898551 0.2384290 1.0835973E-02 -0.1785377 -0.3227777 -0.4138344 -0.4498360 -0.4367235 -0.3860560 -0.3091471 -0.2151971 -0.1099671 -17.93244 2.842951 2.398341 1.990350 1.648307 1.312754 0.9839205 0.6667564 0.3639373 8.1301026E-02 -0.1666519 -0.3710501 -0.5223119 -0.6060560 -0.6201263 -0.5736793 -0.4794641 -0.3532250 -0.2060355 -4.4503473E-02 -17.93244 2.780544 2.394316 2.008792 1.617045 1.233223 0.8609195 0.5082344 0.1732079 -0.1385373 -0.4090463 -0.6377134 -0.8034455 -0.8914258 -0.8933442 -0.8200848 -0.6868344 -0.5135455 -0.3142257 -9.6910037E-02 -17.93244 2.629930 2.291671 1.928158 1.504649 1.086563 0.6847575 0.3030777 -5.3544756E-02 -0.3853019 -0.6860881 -0.9408452 -1.128361 -1.226725 -1.228519 -1.135606 -0.9685149 -0.7507755 -0.5004951 -0.2278363 -17.93244 2.402822 2.106431 1.765645 1.321521 0.8868052 0.4666099 6.8398193E-02 -0.3017600 -0.6533381 -0.9791536 -1.259054 -1.474312 -1.592888 -1.604994 -1.502187 -1.307599 -1.049146 -0.7497701 -0.4223726 -17.93244 2.108903 1.850345 1.531424 1.083781 0.6397206 0.2132640 -0.1899583 -0.5727302 -0.9387332 -1.279368 -1.582834 -1.821877 -1.970786 -2.000930 -1.902170 -1.689656 -1.395802 -1.049748 -0.6684837 -17.93244 1.756706 1.533593 1.236843 0.7929852 0.3531398 -7.0146628E-02 -0.4795663 -0.8678436 -1.238701 -1.588456 -1.903360 -2.167676 -2.347550 -2.404318 -2.322627 -2.105330 -1.784495 -1.395160 -0.9614150 -17.93244 1.349478 1.159277 0.8856292 0.4555533 2.8270949E-02 -0.3928358 -0.8005756 -1.187666 -1.557306 -1.902974 -2.225064 -2.507593 -2.707591 -2.800927 -2.749218 -2.543004 -2.207500 -1.780446 -1.296437 -17.93244 0.8907405 0.7321866 0.4845165 7.0075281E-02 -0.3447278 -0.7536238 -1.151810 -1.533302 -1.890167 -2.230682 -2.550497 -2.834337 -3.054300 -3.177580 -3.168434 -2.989356 -2.654372 -2.197523 -1.666646 -17.93244 0.3773257 0.2483654 2.7136588E-02 -0.3663626 -0.7621374 -1.153673 -1.533769 -1.898953 -2.245049 -2.573590 -2.875168 -3.156357 -3.384704 -3.532709 -3.566529 -3.434835 -3.114815 -2.639252 -2.066552 -17.93244 -0.1922542 -0.2922677 -0.4871030 -0.8526540 -1.222826 -1.588271 -1.946218 -2.293294 -2.620214 -2.922103 -3.208756 -3.476517 -3.706113 -3.874794 -3.948222 -3.876533 -3.592947 -3.115904 -2.509940 -17.93244 -0.8192583 -0.8898270 -1.055154 -1.386139 -1.726185 -2.063560 -2.392386 -2.707741 -3.009390 -3.289449 -3.552018 -3.801461 -4.029279 -4.204709 -4.317592 -4.301233 -4.072196 -3.617599 -2.991339 -17.93244 -1.513164 -1.551758 -1.683730 -1.974628 -2.274046 -2.573377 -2.866228 -3.150414 -3.423575 -3.676927 -3.918713 -4.144266 -4.361392 -4.547795 -4.674789 -4.702691 -4.539307 -4.132181 -3.502780 -17.93244 -2.288342 -2.289392 -2.380797 -2.620480 -2.873463 -3.130646 -3.383258 -3.633368 -3.877727 -4.104041 -4.319957 -4.527930 -4.729862 -4.905706 -5.034179 -5.086272 -4.994291 -4.661505 -4.049574 -17.93244 -3.174686 -3.131516 -3.173975 -3.355706 -3.557054 -3.766786 -3.976523 -4.187560 -4.398010 -4.599165 -4.787742 -4.967158 -5.140891 -5.295037 -5.411759 -5.477997 -5.444734 -5.205498 -4.625453 -17.93244 -4.245630 -4.154229 -4.140593 -4.251687 -4.390487 -4.545588 -4.702535 -4.867166 -5.035110 -5.196755 -5.348148 -5.492084 -5.630149 -5.761961 -5.868977 -5.947176 -5.972888 -5.788861 -5.255202 -17.93244 -5.770147 -5.612056 -5.522385 -5.539809 -5.588372 -5.662149 -5.745860 -5.842758 -5.953511 -6.065785 -6.173063 -6.285615 -6.399894 -6.517760 -6.621955 -6.687782 -6.726214 -6.580110 -6.018368 -17.93244 -33.83607 -33.44289 -32.96664 -32.41782 -31.80529 -31.13636 -30.41697 -29.65233 -28.84545 -28.00074 -27.12072 -26.20784 -25.26424 -24.29178 -23.29213 -22.26674 -21.21694 -20.14392 -19.04876 -17.93244 2.485039 1.711285 1.252954 1.151611 1.018950 0.8626540 0.6833117 0.4901484 0.2893284 8.7470800E-02 -0.1013921 -0.2684420 -0.4048649 -0.5108710 -0.5857564 -0.6341963 -0.6631321 -0.6794829 -0.6889186 -19.80499 2.942690 2.274494 1.827873 1.637321 1.428746 1.204553 0.9697728 0.7309101 0.4944730 0.2697871 7.2477162E-02 -8.5454158E-02 -0.1980582 -0.2639567 -0.2873452 -0.2781872 -0.2455009 -0.1983679 -0.1425577 -19.80499 3.182042 2.605625 2.162319 1.871074 1.577241 1.282956 0.9944039 0.7108487 0.4402919 0.1937572 -1.4109139E-02 -0.1684556 -0.2640876 -0.2969693 -0.2752881 -0.2133942 -0.1232319 -1.5331129E-02 0.1037827 -19.80499 3.256219 2.757422 2.318332 1.946534 1.581428 1.230234 0.8930666 0.5658929 0.2643278 -6.2595606E-03 -0.2292911 -0.3911264 -0.4787833 -0.4877368 -0.4270330 -0.3157811 -0.1700656 -2.5524262E-03 0.1792913 -19.80499 3.202856 2.769538 2.339513 1.910444 1.495394 1.097610 0.7196440 0.3591776 2.4543827E-02 -0.2728923 -0.5184842 -0.6975052 -0.7890131 -0.7837824 -0.6924942 -0.5359333 -0.3366300 -0.1103528 0.1338485 -19.80499 3.049221 2.669808 2.253801 1.791994 1.341861 0.9090369 0.5007843 0.1161799 -0.2452921 -0.5688724 -0.8469095 -1.051378 -1.160755 -1.154239 -1.042025 -0.8458819 -0.5957307 -0.3118272 -5.6747571E-03 -19.80499 2.813995 2.481680 2.083917 1.602034 1.129113 0.6778840 0.2513251 -0.1509388 -0.5289830 -0.8795595 -1.187935 -1.423633 -1.558165 -1.566952 -1.444247 -1.216719 -0.9194996 -0.5794917 -0.2118743 -19.80499 2.505656 2.216484 1.837392 1.347892 0.8691674 0.4095235 -2.6241930E-02 -0.4360801 -0.8288770 -1.198215 -1.529872 -1.797892 -1.964185 -2.002220 -1.883306 -1.634398 -1.295791 -0.9022279 -0.4739109 -19.80499 2.130874 1.880387 1.523339 1.041448 0.5658737 0.1066288 -0.3304431 -0.7473359 -1.146221 -1.522060 -1.873497 -2.160903 -2.365455 -2.438608 -2.343534 -2.087990 -1.716585 -1.273151 -0.7853739 -19.80499 1.701705 1.486593 1.153726 0.6840634 0.2196895 -0.2303821 -0.6692976 -1.085559 -1.482143 -1.858946 -2.210914 -2.519355 -2.752321 -2.864339 -2.808549 -2.566071 -2.174875 -1.687015 -1.141769 -19.80499 1.216342 1.034469 0.7289207 0.2793954 -0.1705318 -0.6113030 -1.040081 -1.450403 -1.839290 -2.203491 -2.553040 -2.871667 -3.117092 -3.267054 -3.260985 -3.051950 -2.659393 -2.135591 -1.536077 -19.80499 0.6741840 0.5255906 0.2481095 -0.1799749 -0.6104258 -1.033687 -1.446519 -1.843032 -2.213259 -2.566588 -2.903338 -3.210542 -3.469154 -3.643944 -3.690964 -3.535863 -3.162431 -2.615321 -1.966675 -19.80499 7.1121126E-02 -4.5809623E-02 -0.2941623 -0.6934399 -1.099472 -1.498439 -1.884826 -2.260930 -2.615789 -2.947326 -3.256516 -3.553003 -3.809057 -4.003123 -4.091630 -4.009754 -3.678953 -3.127451 -2.438220 -19.80499 -0.5966663 -0.6825559 -0.8977758 -1.260754 -1.633986 -2.002800 -2.362117 -2.711163 -3.036171 -3.341164 -3.628088 -3.900135 -4.150753 -4.348429 -4.477750 -4.462587 -4.198579 -3.669751 -2.953608 -19.80499 -1.336038 -1.387785 -1.564864 -1.886430 -2.222371 -2.552431 -2.872244 -3.185303 -3.482640 -3.758863 -4.019494 -4.270267 -4.500925 -4.703642 -4.850951 -4.888455 -4.703794 -4.230237 -3.507401 -19.80499 -2.163917 -2.176244 -2.309705 -2.578276 -2.862951 -3.147736 -3.426272 -3.700213 -3.966657 -4.215813 -4.446946 -4.672954 -4.889906 -5.080273 -5.226313 -5.292565 -5.194028 -4.807115 -4.106589 -19.80499 -3.111419 -3.076167 -3.156488 -3.360287 -3.586452 -3.820437 -4.052223 -4.284864 -4.517848 -4.736584 -4.941442 -5.139256 -5.326995 -5.493124 -5.620797 -5.701992 -5.670501 -5.395771 -4.733722 -19.80499 -4.250833 -4.160772 -4.177128 -4.306533 -4.465244 -4.636539 -4.814652 -4.999990 -5.189436 -5.369457 -5.534559 -5.693092 -5.847067 -5.985389 -6.099387 -6.179256 -6.216786 -6.024880 -5.420506 -19.80499 -5.860136 -5.691133 -5.622645 -5.653358 -5.718146 -5.802523 -5.900442 -6.015128 -6.141403 -6.273775 -6.395152 -6.511440 -6.645728 -6.769732 -6.878895 -6.956226 -7.000294 -6.857233 -6.243796 -19.80499 -37.50359 -37.07403 -36.54813 -35.93898 -35.25743 -34.51219 -33.71027 -32.85737 -31.95811 -31.01638 -30.03543 -29.01804 -27.96665 -26.88335 -25.77000 -24.62827 -23.45963 -22.26543 -21.04685 -19.80499 2.762966 1.906436 1.492955 1.395180 1.258604 1.092605 0.9053608 0.6980637 0.4801519 0.2608612 5.2997064E-02 -0.1310141 -0.2823584 -0.3972318 -0.4776608 -0.5283787 -0.5579019 -0.5738453 -0.5823907 -21.71970 3.289462 2.550644 2.121015 1.919465 1.695868 1.460319 1.212284 0.9573241 0.7036450 0.4610351 0.2476221 7.5254381E-02 -4.3857016E-02 -0.1115022 -0.1324653 -0.1172156 -7.7791624E-02 -2.3349650E-02 3.9955150E-02 -21.71970 3.569313 2.932210 2.478265 2.160839 1.845598 1.535302 1.226589 0.9265069 0.6382363 0.3726868 0.1491533 -1.8227166E-02 -0.1155168 -0.1444307 -0.1140049 -3.9853785E-02 6.3841626E-02 0.1855771 0.3187073 -21.71970 3.662875 3.110766 2.639990 2.236480 1.845444 1.470482 1.111042 0.7650669 0.4415272 0.1510052 -9.0743951E-02 -0.2635200 -0.3536882 -0.3545514 -0.2796547 -0.1503014 1.5388330E-02 0.2033429 0.4057361 -21.71970 3.617597 3.136378 2.662605 2.198036 1.750551 1.325897 0.9253032 0.5392138 0.1819215 -0.1393054 -0.4067228 -0.5990933 -0.6957273 -0.6826943 -0.5718713 -0.3915671 -0.1659439 8.7338306E-02 0.3587247 -21.71970 3.462541 3.041509 2.574282 2.071350 1.587986 1.128671 0.6936470 0.2809064 -0.1054169 -0.4590225 -0.7562401 -0.9810065 -1.098769 -1.085849 -0.9520981 -0.7266469 -0.4436198 -0.1259546 0.2141367 -21.71970 3.217161 2.848850 2.393915 1.872957 1.367571 0.8848630 0.4303923 -1.2451410E-03 -0.4088952 -0.7850849 -1.117618 -1.376814 -1.530826 -1.535205 -1.392192 -1.130361 -0.7937759 -0.4131308 -4.7495323E-03 -21.71970 2.893887 2.573030 2.135882 1.609694 1.094165 0.6023288 0.1362446 -0.3058943 -0.7219735 -1.119594 -1.478222 -1.770650 -1.962865 -2.006186 -1.869753 -1.584430 -1.200340 -0.7589865 -0.2829696 -21.71970 2.502846 2.224485 1.808464 1.285001 0.7754994 0.2823820 -0.1883944 -0.6311516 -1.054916 -1.460487 -1.836544 -2.154828 -2.385212 -2.477865 -2.369625 -2.076680 -1.654420 -1.156344 -0.6138152 -21.71970 2.050009 1.809013 1.419231 0.9104202 0.4102612 -7.5856000E-02 -0.5410908 -0.9855939 -1.407936 -1.809935 -2.194107 -2.526392 -2.792759 -2.928603 -2.871951 -2.594539 -2.148162 -1.599074 -0.9919069 -21.71970 1.539947 1.334595 0.9717342 0.4830453 2.1765247E-04 -0.4723969 -0.9313981 -1.369563 -1.782496 -2.175858 -2.548690 -2.894683 -3.176159 -3.355001 -3.356323 -3.121012 -2.670416 -2.079064 -1.410249 -21.71970 0.9689893 0.7987803 0.4665078 3.9387755E-03 -0.4612008 -0.9161550 -1.358464 -1.784022 -2.180561 -2.556004 -2.919005 -3.257665 -3.543508 -3.751640 -3.813581 -3.641343 -3.215601 -2.595946 -1.870742 -21.71970 0.3337395 0.1984431 -0.1012305 -0.5349052 -0.9743273 -1.405675 -1.824652 -2.225872 -2.604610 -2.963461 -3.300565 -3.620412 -3.903513 -4.123399 -4.236844 -4.145245 -3.770423 -3.143021 -2.369879 -21.71970 -0.3714257 -0.4727621 -0.7363366 -1.134107 -1.540658 -1.939105 -2.327492 -2.704960 -3.059276 -3.384798 -3.698301 -3.994903 -4.263450 -4.488325 -4.632778 -4.623501 -4.329287 -3.724448 -2.917655 -21.71970 -1.153642 -1.218743 -1.442008 -1.794744 -2.162002 -2.524662 -2.873620 -3.212366 -3.535803 -3.833888 -4.116069 -4.387820 -4.638766 -4.854651 -5.022633 -5.071425 -4.872397 -4.331001 -3.513190 -21.71970 -2.032923 -2.056835 -2.233438 -2.529721 -2.843449 -3.156297 -3.461608 -3.762120 -4.051714 -4.319127 -4.572042 -4.814263 -5.045431 -5.251416 -5.415083 -5.494834 -5.389448 -4.948244 -4.150301 -21.71970 -3.038726 -3.009888 -3.127679 -3.358122 -3.610994 -3.865530 -4.123736 -4.380674 -4.634196 -4.868642 -5.090706 -5.309025 -5.509280 -5.689968 -5.832227 -5.922893 -5.894929 -5.584608 -4.834843 -21.71970 -4.248429 -4.155849 -4.200974 -4.353170 -4.533475 -4.724592 -4.926770 -5.134000 -5.343368 -5.537344 -5.719129 -5.899508 -6.061566 -6.208289 -6.333836 -6.424257 -6.462869 -6.260246 -5.579689 -21.71970 -5.941930 -5.763430 -5.713645 -5.761253 -5.846063 -5.946071 -6.065607 -6.198657 -6.341037 -6.484019 -6.619995 -6.756798 -6.894213 -7.025582 -7.145620 -7.233988 -7.278254 -7.134196 -6.467426 -21.71970 -41.26020 -40.79369 -40.21677 -39.54544 -38.79271 -37.96885 -37.08197 -36.13860 -35.14401 -34.10258 -33.01797 -31.89332 -30.73133 -29.53437 -28.30450 -27.04356 -25.75320 -24.43490 -23.09000 -21.71970 3.026621 2.085815 1.722953 1.632390 1.495134 1.324705 1.123697 0.9033992 0.6657839 0.4273424 0.1988407 -4.2982553E-03 -0.1724203 -0.2982782 -0.3855788 -0.4395207 -0.4702855 -0.4860940 -0.4939593 -23.67435 3.626079 2.813182 2.406055 2.195740 1.962971 1.712546 1.450179 1.179588 0.9061404 0.6460124 0.4135101 0.2275463 9.8918542E-02 2.9025894E-02 1.0471756E-02 3.1008489E-02 7.6966487E-02 0.1385960 0.2093239 -23.67435 3.949693 3.250716 2.788043 2.449066 2.110220 1.781068 1.454629 1.135924 0.8292638 0.5454015 0.3053732 0.1259658 2.5165826E-02 -4.3604342E-04 3.9254718E-02 0.1261905 0.2431244 0.3787268 0.5259674 -23.67435 4.064472 3.459117 2.959766 2.521667 2.102877 1.706153 1.322541 0.9573389 0.6138991 0.3036208 4.4782571E-02 -0.1420471 -0.2326479 -0.2258468 -0.1359397 1.2462950E-02 0.1981484 0.4066401 0.6298833 -23.67435 4.026646 3.498327 2.980022 2.479194 2.000784 1.549410 1.123706 0.7161102 0.3350840 -7.7052573E-03 -0.2959087 -0.5040237 -0.6041163 -0.5808204 -0.4503063 -0.2451035 7.1972860E-03 0.2878495 0.5868561 -23.67435 3.868903 3.405760 2.888386 2.345578 1.828783 1.341191 0.8811987 0.4413877 3.1030446E-02 -0.3472601 -0.6681587 -0.9138875 -1.041897 -1.022215 -0.8649036 -0.6094314 -0.2933320 5.8489703E-02 0.4330538 -23.67435 3.614137 3.209255 2.698287 2.137761 1.599106 1.087885 0.6034786 0.1458395 -0.2878174 -0.6936442 -1.046350 -1.333960 -1.505243 -1.509204 -1.344033 -1.047886 -0.6718450 -0.2501870 0.1996247 -23.67435 3.275935 2.922667 2.427611 1.863752 1.316333 0.7899355 0.2951802 -0.1746004 -0.6187359 -1.040792 -1.423299 -1.745732 -1.965793 -2.014448 -1.861837 -1.539111 -1.109224 -0.6198674 -9.5358014E-02 -23.67435 2.869235 2.560879 2.087832 1.526953 0.9799120 0.4556000 -4.5729131E-02 -0.5178809 -0.9631588 -1.394633 -1.796403 -2.146661 -2.406680 -2.516517 -2.400316 -2.071849 -1.598325 -1.044938 -0.4467398 -23.67435 2.395838 2.128667 1.680075 1.133351 0.5980623 7.9849273E-02 -0.4179921 -0.8858025 -1.331825 -1.759232 -2.168480 -2.531986 -2.827761 -2.994682 -2.938460 -2.629396 -2.127695 -1.516535 -0.8463480 -23.67435 1.860104 1.631096 1.211782 0.6865091 0.1671019 -0.3352902 -0.8241642 -1.287807 -1.725272 -2.142970 -2.543688 -2.912512 -3.229582 -3.437519 -3.453819 -3.194877 -2.687602 -2.027574 -1.288248 -23.67435 1.261958 1.070465 0.6828929 0.1853139 -0.3125033 -0.7991357 -1.271598 -1.722531 -2.146425 -2.545378 -2.932212 -3.297669 -3.611537 -3.851795 -3.933959 -3.751729 -3.270872 -2.576886 -1.773321 -23.67435 0.5959765 0.4421271 9.0726957E-02 -0.3773670 -0.8498098 -1.311473 -1.761156 -2.192087 -2.592517 -2.972762 -3.342422 -3.681619 -3.991575 -4.240755 -4.377790 -4.285268 -3.867170 -3.162210 -2.303037 -23.67435 -0.1449174 -0.2621606 -0.5747473 -1.005409 -1.445228 -1.873955 -2.290375 -2.695671 -3.074855 -3.425112 -3.763339 -4.081658 -4.371400 -4.619853 -4.786236 -4.787363 -4.462508 -3.780206 -2.880005 -23.67435 -0.9694964 -1.048753 -1.317535 -1.700905 -2.097917 -2.488640 -2.871310 -3.238659 -3.582594 -3.902643 -4.212721 -4.500499 -4.767881 -5.001197 -5.188978 -5.253279 -5.041698 -4.428390 -3.511620 -23.67435 -1.896257 -1.929557 -2.148692 -2.478762 -2.821137 -3.160883 -3.497313 -3.822842 -4.133099 -4.417822 -4.696305 -4.955559 -5.194986 -5.415648 -5.596343 -5.692276 -5.587031 -5.089180 -4.191025 -23.67435 -2.961578 -2.938271 -3.092882 -3.352080 -3.630906 -3.914641 -4.197808 -4.478859 -4.747676 -4.999077 -5.242009 -5.474424 -5.685127 -5.876688 -6.032982 -6.134022 -6.116127 -5.766952 -4.926834 -23.67435 -4.239863 -4.147642 -4.221766 -4.396986 -4.599083 -4.815422 -5.041152 -5.269517 -5.491214 -5.703404 -5.903650 -6.098226 -6.266994 -6.424964 -6.555298 -6.655995 -6.700954 -6.487266 -5.732388 -23.67435 -6.012759 -5.833658 -5.797233 -5.863322 -5.960055 -6.082924 -6.224710 -6.376921 -6.534611 -6.687689 -6.841161 -6.995397 -7.129968 -7.271250 -7.392897 -7.491566 -7.541675 -7.402252 -6.685874 -23.67435 -45.10093 -44.59691 -43.96762 -43.23234 -42.40640 -41.50195 -40.52755 -39.49132 -38.39893 -37.25528 -36.06446 -34.82996 -33.55477 -32.24149 -30.89268 -29.50961 -28.09485 -26.64976 -25.17582 -23.67435 3.280943 2.255705 1.947259 1.861604 1.728739 1.554364 1.344150 1.106433 0.8518022 0.5913988 0.3427428 0.1168652 -6.8484016E-02 -0.2070833 -0.3015102 -0.3594262 -0.3915340 -0.4072088 -0.4145753 -25.66696 3.952378 3.063056 2.680682 2.464238 2.223084 1.963021 1.683994 1.396370 1.102417 0.8238370 0.5702015 0.3673316 0.2274864 0.1545268 0.1378285 0.1630118 0.2153423 0.2841543 0.3622208 -25.66696 4.322101 3.558183 3.089504 2.729116 2.372656 2.022484 1.677134 1.340095 1.013879 0.7136543 0.4517519 0.2605158 0.1541863 0.1329415 0.1822547 0.2811372 0.4114690 0.5610535 0.7224511 -25.66696 4.460973 3.800596 3.272575 2.804196 2.355825 1.934993 1.529709 1.142063 0.7817265 0.4498014 0.1692272 -3.0869981E-02 -0.1237451 -0.1091101 -3.7364345E-03 0.1635014 0.3692212 0.5984643 0.8427185 -25.66696 4.429793 3.854007 3.294708 2.755180 2.245457 1.768570 1.314888 0.8887427 0.4846790 0.1179776 -0.1936020 -0.4197059 -0.5221260 -0.4890047 -0.3386477 -0.1085266 0.1706069 0.4788744 0.8058139 -25.66696 4.269944 3.764900 3.196015 2.614696 2.065267 1.547976 1.062965 0.6018742 0.1610067 -0.2385265 -0.5860400 -0.8522783 -0.9898489 -0.9608260 -0.7808945 -0.4949798 -0.1452561 0.2412614 0.6507267 -25.66696 4.004492 3.562190 2.996969 2.398012 1.824412 1.284683 0.7745315 0.2877880 -0.1730138 -0.6015784 -0.9812356 -1.293310 -1.483631 -1.487868 -1.300188 -0.9694545 -0.5534326 -9.0074539E-02 0.4016691 -25.66696 3.653632 3.266616 2.714850 2.110913 1.532420 0.9766164 0.4482879 -4.6541512E-02 -0.5166788 -0.9639633 -1.370720 -1.722540 -1.967820 -2.026245 -1.859448 -1.499501 -1.023436 -0.4852421 8.8334836E-02 -25.66696 3.229779 2.890542 2.360241 1.764179 1.183517 0.6230013 9.2455834E-02 -0.4054249 -0.8765330 -1.329522 -1.756567 -2.133794 -2.428759 -2.557067 -2.438245 -2.074285 -1.549208 -0.9398108 -0.2852907 -25.66696 2.737174 2.442752 1.938004 1.353029 0.7819064 0.2307418 -0.2968184 -0.7908710 -1.258463 -1.710701 -2.141843 -2.535182 -2.859936 -3.056884 -3.006195 -2.667621 -2.109612 -1.434898 -0.7008931 -25.66696 2.176366 1.923811 1.447782 0.8866616 0.3319163 -0.2042475 -0.7196989 -1.209169 -1.669608 -2.112008 -2.537054 -2.928019 -3.275145 -3.517457 -3.552125 -3.274133 -2.709410 -1.979791 -1.169082 -25.66696 1.550718 1.338419 0.8972625 0.3628509 -0.1684851 -0.6849269 -1.186627 -1.663960 -2.108857 -2.536511 -2.943163 -3.328976 -3.675365 -3.945657 -4.053783 -3.868697 -3.333686 -2.564874 -1.682208 -25.66696 0.8545542 0.6817521 0.2801821 -0.2221884 -0.7271063 -1.218953 -1.696734 -2.156217 -2.579683 -2.983232 -3.375547 -3.737375 -4.069554 -4.349486 -4.511267 -4.428216 -3.968938 -3.186157 -2.240022 -25.66696 8.0208227E-02 -5.3178400E-02 -0.4136856 -0.8778943 -1.347234 -1.808123 -2.254618 -2.685485 -3.085339 -3.464500 -3.825404 -4.159938 -4.472707 -4.742352 -4.934585 -4.949254 -4.599686 -3.840958 -2.846376 -25.66696 -0.7837070 -0.8747529 -1.189958 -1.606840 -2.033131 -2.455220 -2.866923 -3.262742 -3.626489 -3.967901 -4.302259 -4.605676 -4.891729 -5.143874 -5.345578 -5.429991 -5.210209 -4.528016 -3.510786 -25.66696 -1.756739 -1.799044 -2.060979 -2.422896 -2.798156 -3.168167 -3.530831 -3.881132 -4.208607 -4.516643 -4.815420 -5.090814 -5.341495 -5.574624 -5.768270 -5.883401 -5.779491 -5.230881 -4.231111 -25.66696 -2.876918 -2.860637 -3.053778 -3.342296 -3.647224 -3.959107 -4.270140 -4.572127 -4.858558 -5.129697 -5.392589 -5.635837 -5.858680 -6.057468 -6.223237 -6.338299 -6.326687 -5.948235 -5.016588 -25.66696 -4.222372 -4.133498 -4.235303 -4.434303 -4.658237 -4.900716 -5.151173 -5.398589 -5.639059 -5.866491 -6.088357 -6.291672 -6.471627 -6.629233 -6.766186 -6.876708 -6.922264 -6.705657 -5.874968 -25.66696 -6.077139 -5.890942 -5.873891 -5.954781 -6.067923 -6.213988 -6.377842 -6.547801 -6.720963 -6.891802 -7.060051 -7.222266 -7.367132 -7.503568 -7.630769 -7.736818 -7.788574 -7.663629 -6.893200 -25.66696 -49.02134 -48.47925 -47.79628 -46.99533 -46.09423 -45.10662 -44.04326 -42.91164 -41.71913 -40.47090 -39.17146 -37.82467 -36.43380 -35.00198 -33.53099 -32.02378 -30.48208 -28.90767 -27.30215 -25.66696 3.525904 2.415944 2.168486 2.086810 1.957958 1.783804 1.566027 1.311559 1.037520 0.7572803 0.4839545 0.2357935 3.1376049E-02 -0.1210468 -0.2229862 -0.2854385 -0.3187384 -0.3345709 -0.3415571 -27.69572 4.271824 3.306164 2.950336 2.725581 2.479383 2.208837 1.917848 1.609203 1.298488 0.9967295 0.7227572 0.5013408 0.3498819 0.2728602 0.2575530 0.2873363 0.3462960 0.4222906 0.5076964 -27.69572 4.685678 3.855906 3.382458 3.002770 2.628325 2.260694 1.895864 1.539343 1.195828 0.8734961 0.5912486 0.3858856 0.2732800 0.2562656 0.3144181 0.4252912 0.5692765 0.7329082 0.9085692 -27.69572 4.849704 4.132720 3.579041 3.079902 2.606496 2.160234 1.731555 1.326334 0.9439803 0.5909094 0.2888317 7.5511418E-02 -2.0692114E-02 3.8604036E-03 0.1247575 0.3108114 0.5370902 0.7872694 1.052761 -27.69572 4.828023 4.204431 3.603121 3.028358 2.486225 1.981931 1.505172 1.055320 0.6290786 0.2397013 -9.6496925E-02 -0.3402931 -0.4457300 -0.4024037 -0.2319862 2.3616917E-02 0.3300878 0.6662321 1.021437 -27.69572 4.665032 4.117715 3.499292 2.879206 2.296602 1.751936 1.239763 0.7548713 0.2892078 -0.1325612 -0.5073035 -0.7981147 -0.9435556 -0.9079498 -0.7060140 -0.3891349 -5.1421779E-03 0.4162773 0.8610889 -27.69572 4.389934 3.909889 3.289751 2.653101 2.046832 1.475757 0.9387307 0.4282096 -5.8872167E-02 -0.5109361 -0.9190663 -1.255826 -1.462845 -1.467635 -1.258717 -0.8922974 -0.4352075 7.0375428E-02 0.6046031 -27.69572 4.026801 3.604736 2.997021 2.355786 1.741743 1.155728 0.6004823 7.8932270E-02 -0.4161631 -0.8878390 -1.319118 -1.698593 -1.970294 -2.044020 -1.863203 -1.466045 -0.9431930 -0.3556647 0.2675777 -27.69572 3.585742 3.215661 2.629118 1.994164 1.380768 0.7885287 0.2277639 -0.2960485 -0.7912693 -1.267786 -1.715492 -2.121824 -2.447196 -2.598081 -2.479495 -2.078485 -1.500799 -0.8347054 -0.1231913 -27.69572 3.072475 2.750713 2.190369 1.568989 0.9622220 0.3787224 -0.1787085 -0.6987343 -1.189005 -1.663903 -2.115648 -2.533982 -2.890646 -3.114774 -3.079262 -2.712076 -2.097737 -1.358913 -0.5604725 -27.69572 2.489430 2.213169 1.681980 1.081952 0.4934992 -7.5390108E-02 -0.6220085 -1.132862 -1.614909 -2.083048 -2.525481 -2.942771 -3.314580 -3.592944 -3.650404 -3.357421 -2.736512 -1.936180 -1.053493 -27.69572 1.835578 1.601844 1.108357 0.5369710 -2.7827872E-02 -0.5750723 -1.105151 -1.605666 -2.072952 -2.526985 -2.952766 -3.357754 -3.731554 -4.029121 -4.171929 -3.985381 -3.399326 -2.554739 -1.592471 -27.69572 1.110624 0.9186981 0.4650208 -7.0900969E-02 -0.6054894 -1.129702 -1.636955 -2.118835 -2.566995 -2.996770 -3.403445 -3.791266 -4.141674 -4.447303 -4.642773 -4.573348 -4.073609 -3.212836 -2.179446 -27.69572 0.3038397 0.1552021 -0.2547199 -0.7508298 -1.252208 -1.745552 -2.223208 -2.673302 -3.095809 -3.500237 -3.883499 -4.235190 -4.565883 -4.855832 -5.080205 -5.110870 -4.739674 -3.906135 -2.817202 -27.69572 -0.5981717 -0.7014169 -1.062356 -1.512429 -1.971212 -2.423799 -2.863011 -3.278968 -3.669720 -4.036411 -4.387246 -4.709878 -5.007058 -5.278643 -5.499177 -5.604314 -5.376683 -4.629253 -3.511760 -27.69572 -1.614483 -1.667449 -1.971539 -2.364030 -2.768772 -3.173392 -3.562561 -3.934074 -4.283662 -4.616866 -4.930041 -5.219461 -5.484726 -5.726597 -5.936555 -6.069406 -5.968856 -5.374400 -4.273536 -27.69572 -2.786634 -2.779098 -3.009552 -3.326676 -3.661736 -4.002151 -4.338657 -4.662300 -4.969193 -5.261945 -5.536366 -5.790313 -6.024171 -6.233712 -6.411436 -6.538646 -6.533823 -6.129177 -5.105779 -27.69572 -4.200890 -4.112677 -4.244379 -4.465097 -4.717646 -4.984553 -5.257058 -5.527620 -5.785646 -6.032318 -6.266162 -6.474868 -6.666933 -6.833141 -6.978019 -7.093637 -7.142141 -6.926195 -6.016143 -27.69572 -6.140816 -5.945895 -5.949120 -6.041884 -6.177992 -6.344219 -6.527686 -6.721950 -6.915103 -7.098893 -7.280332 -7.443881 -7.601212 -7.736358 -7.876876 -7.986167 -8.051484 -7.929133 -7.101888 -27.69572 -53.01744 -52.43675 -51.69884 -50.83057 -49.85244 -48.77992 -47.62476 -46.39611 -45.10127 -43.74620 -42.33587 -40.87448 -39.36563 -37.81244 -36.21765 -34.58367 -32.91266 -31.20655 -29.46704 -27.69572 3.766524 2.571370 2.382616 2.309316 2.183150 2.009081 1.786426 1.518838 1.226263 0.9256800 0.6259381 0.3566029 0.1325080 -3.3745099E-02 -0.1447570 -0.2109564 -0.2457010 -0.2617972 -0.2684423 -29.75901 4.583809 3.541403 3.215545 2.980952 2.728201 2.448737 2.149181 1.821771 1.492831 1.167205 0.8717500 0.6313984 0.4680770 0.3855728 0.3713874 0.4062015 0.4717853 0.5548944 0.6476879 -29.75901 5.043795 4.147925 3.669245 3.267628 2.876935 2.494176 2.111779 1.735477 1.374418 1.024987 0.7259880 0.5037498 0.3855546 0.3709442 0.4374204 0.5608389 0.7185065 0.8962892 1.086364 -29.75901 5.229962 4.456785 3.876594 3.348782 2.852047 2.381812 1.930432 1.507114 1.100940 0.7251820 0.4020936 0.1737977 7.3652081E-02 0.1061786 0.2416525 0.4471402 0.6940362 0.9653099 1.252290 -29.75901 5.218600 4.546567 3.905192 3.296215 2.724000 2.191151 1.693624 1.217183 0.7690586 0.3583349 -4.5152167E-03 -0.2659761 -0.3779382 -0.3257140 -0.1353495 0.1459841 0.4800166 0.8442422 1.228056 -29.75901 5.054812 4.465213 3.796832 3.140517 2.523536 1.952634 1.413209 0.8995151 0.4171144 -3.1705569E-02 -0.4321918 -0.7471432 -0.9051479 -0.8670068 -0.6429737 -0.2945489 0.1237931 0.5803421 1.060946 -29.75901 4.770799 4.252437 3.578935 2.903338 2.266182 1.663028 1.096255 0.5663621 5.5452678E-02 -0.4214377 -0.8553088 -1.219646 -1.446122 -1.455372 -1.225082 -0.8225879 -0.3238762 0.2240732 0.8013703 -29.75901 4.394763 3.936942 3.274597 2.597037 1.947113 1.327271 0.7493853 0.2037801 -0.3171595 -0.8113024 -1.269928 -1.674524 -1.973478 -2.064187 -1.869460 -1.434596 -0.8640938 -0.2268694 0.4467415 -29.75901 3.936791 3.536371 2.893068 2.219539 1.571097 0.9506999 0.3618816 -0.1876141 -0.7089043 -1.208160 -1.676034 -2.107669 -2.460897 -2.639618 -2.521824 -2.085395 -1.455161 -0.7320520 3.7266143E-02 -29.75901 3.402671 3.054049 2.436540 1.780094 1.141086 0.5228928 -6.2282071E-02 -0.6072647 -1.123973 -1.617349 -2.087825 -2.528777 -2.916547 -3.171807 -3.155575 -2.761194 -2.091782 -1.288807 -0.4250650 -29.75901 2.796867 2.496662 1.912284 1.275987 0.6519469 5.1664490E-02 -0.5246950 -1.060451 -1.564966 -2.053198 -2.513344 -2.952355 -3.347237 -3.661255 -3.747513 -3.443413 -2.769037 -1.897398 -0.9417369 -29.75901 2.116656 1.861960 1.314496 0.7091346 0.1115109 -0.4695739 -1.026779 -1.549809 -2.039916 -2.515320 -2.960126 -3.382282 -3.777658 -4.109571 -4.285035 -4.102365 -3.469697 -2.548625 -1.505576 -29.75901 1.362777 1.151851 0.6481023 7.7364765E-02 -0.4887106 -1.045270 -1.580353 -2.082944 -2.554016 -3.009270 -3.430292 -3.834814 -4.209200 -4.539771 -4.767342 -4.716449 -4.182580 -3.242859 -2.120842 -29.75901 0.5248154 0.3599239 -9.6728869E-02 -0.6275089 -1.160329 -1.685510 -2.189738 -2.663344 -3.107432 -3.535087 -3.934243 -4.305573 -4.652732 -4.966044 -5.214225 -5.266765 -4.884150 -3.974517 -2.789658 -29.75901 -0.4123304 -0.5292318 -0.9357614 -1.416582 -1.907145 -2.391766 -2.856664 -3.296819 -3.709478 -4.100968 -4.460855 -4.804326 -5.116990 -5.407575 -5.644127 -5.770239 -5.547321 -4.734377 -3.515033 -29.75901 -1.470120 -1.534682 -1.879645 -2.301958 -2.739608 -3.174087 -3.593191 -3.986173 -4.357280 -4.709668 -5.034653 -5.341030 -5.619438 -5.875490 -6.098250 -6.245243 -6.157281 -5.515705 -4.310639 -29.75901 -2.694702 -2.694525 -2.961896 -3.306901 -3.675114 -4.042247 -4.405839 -4.752233 -5.078979 -5.388580 -5.674109 -5.938410 -6.180383 -6.404535 -6.594765 -6.729077 -6.734078 -6.305461 -5.184586 -29.75901 -4.176106 -4.089016 -4.252422 -4.495613 -4.775778 -5.068948 -5.364937 -5.652999 -5.931915 -6.193168 -6.435521 -6.657230 -6.857202 -7.029063 -7.182515 -7.303312 -7.357085 -7.140078 -6.154376 -29.75901 -6.200813 -5.999253 -6.021564 -6.129189 -6.290624 -6.479617 -6.681639 -6.888064 -7.097380 -7.298028 -7.489351 -7.662161 -7.820308 -7.968609 -8.105475 -8.221861 -8.297987 -8.184060 -7.307651 -29.75901 -57.08566 -56.46583 -55.67174 -54.73454 -53.67762 -52.51829 -51.26960 -49.94162 -48.54235 -47.07832 -45.55494 -43.97677 -42.34772 -40.67119 -38.95013 -37.18716 -35.38460 -33.54451 -31.66876 -29.75901 3.997607 2.716030 2.596395 2.525975 2.405831 2.224525 1.999793 1.728217 1.416481 1.091071 0.7676851 0.4732374 0.2288642 4.7763370E-02 -7.2621770E-02 -0.1430426 -0.1793962 -0.1958444 -0.2022168 -31.85535 4.889987 3.771666 3.471844 3.232590 2.967151 2.681154 2.374004 2.035724 1.686078 1.337486 1.018945 0.7605566 0.5860926 0.4992055 0.4868684 0.5270799 0.5994192 0.6897598 0.7900214 -31.85535 5.394385 4.433121 3.950967 3.524088 3.115184 2.718035 2.324366 1.931547 1.546159 1.173957 0.8531260 0.6151549 0.4920989 0.4784817 0.5544906 0.6904961 0.8619874 1.054022 1.258674 -31.85535 5.604169 4.777411 4.166344 3.607396 3.088996 2.599438 2.129424 1.681393 1.254115 0.8524868 0.5082531 0.2651991 0.1626956 0.2016848 0.3527809 0.5781167 0.8458051 1.138444 1.447179 -31.85535 5.599814 4.879768 4.198104 3.557064 2.957927 2.399084 1.876324 1.373826 0.9046749 0.4678500 7.8753680E-02 -0.2007257 -0.3228919 -0.2640851 -5.4661300E-02 0.2525403 0.6140013 1.006605 1.419381 -31.85535 5.436933 4.804516 4.088936 3.397369 2.749020 2.147386 1.581612 1.043538 0.5379823 6.4639263E-02 -0.3646079 -0.7009152 -0.8789141 -0.8402259 -0.5953714 -0.2159468 0.2365449 0.7285686 1.245406 -31.85535 5.147696 4.589799 3.863517 3.152099 2.479448 1.844882 1.252693 0.6973526 0.1635230 -0.3377315 -0.7955002 -1.186700 -1.436953 -1.454577 -1.204279 -0.7658186 -0.2260040 0.3647562 0.9856650 -31.85535 4.757888 4.265463 3.548845 2.832284 2.146685 1.496802 0.8906815 0.3216729 -0.2252087 -0.7381410 -1.218853 -1.649598 -1.975675 -2.085664 -1.877726 -1.406438 -0.7876395 -0.1001335 0.6245542 -31.85535 4.281937 3.850958 3.151868 2.440206 1.757429 1.105400 0.4899113 -8.5402347E-02 -0.6308205 -1.146668 -1.636543 -2.091742 -2.473450 -2.683959 -2.564201 -2.096318 -1.412560 -0.6317397 0.1961760 -31.85535 3.726983 3.351290 2.679143 1.984466 1.312488 0.6637995 4.7217477E-02 -0.5194619 -1.061292 -1.571964 -2.062598 -2.524892 -2.938352 -3.228310 -3.231268 -2.816390 -2.091137 -1.223365 -0.2934093 -31.85535 3.097807 2.773340 2.135848 1.464373 0.8067181 0.1734986 -0.4306836 -0.9886277 -1.519062 -2.023556 -2.504520 -2.960828 -3.379516 -3.724894 -3.842875 -3.537332 -2.809466 -1.866270 -0.8366033 -31.85535 2.393329 2.117224 1.517656 0.8760048 0.2455547 -0.3675720 -0.9522324 -1.496273 -2.012974 -2.505324 -2.968606 -3.406842 -3.820425 -4.184401 -4.390943 -4.225999 -3.549713 -2.552001 -1.427031 -31.85535 1.611008 1.380939 0.8277537 0.2235650 -0.3779596 -0.9634390 -1.525886 -2.050812 -2.547400 -3.018006 -3.456997 -3.874178 -4.273197 -4.624612 -4.883791 -4.861336 -4.300035 -3.282372 -2.070669 -31.85535 0.7434494 0.5615366 5.6947343E-02 -0.5038233 -1.071062 -1.626234 -2.157365 -2.656469 -3.123623 -3.563880 -3.978824 -4.368050 -4.733444 -5.071407 -5.340514 -5.423225 -5.030679 -4.045790 -2.763196 -31.85535 -0.2281238 -0.3590065 -0.8091437 -1.321195 -1.845505 -2.360290 -2.852316 -3.315408 -3.748492 -4.159189 -4.532995 -4.890449 -5.223166 -5.530096 -5.785437 -5.933796 -5.719443 -4.842564 -3.519480 -31.85535 -1.325187 -1.401213 -1.788640 -2.239474 -2.710761 -3.173247 -3.621538 -4.041561 -4.426980 -4.797659 -5.137393 -5.454525 -5.754303 -6.017728 -6.246441 -6.418499 -6.348118 -5.660661 -4.349591 -31.85535 -2.600445 -2.607464 -2.914111 -3.287797 -3.686728 -4.085264 -4.470428 -4.839893 -5.182764 -5.510492 -5.807987 -6.080605 -6.340965 -6.570222 -6.758264 -6.911306 -6.933536 -6.483183 -5.261478 -31.85535 -4.147547 -4.062778 -4.255588 -4.527123 -4.835907 -5.158156 -5.472576 -5.779555 -6.068151 -6.349170 -6.598948 -6.830219 -7.040313 -7.224664 -7.365478 -7.498232 -7.570292 -7.349832 -6.287702 -31.85535 -6.250834 -6.044511 -6.083033 -6.212775 -6.396515 -6.611754 -6.833347 -7.060729 -7.273944 -7.493635 -7.689969 -7.869730 -8.036219 -8.192706 -8.317282 -8.444099 -8.534480 -8.431672 -7.508961 -31.85535 -61.22277 -60.56327 -59.71178 -58.70412 -57.56668 -56.31872 -54.97460 -53.54534 -52.03965 -50.46464 -48.82615 -47.12913 -45.37781 -43.57583 -41.72640 -39.83231 -37.89606 -35.91986 -33.90569 -31.85535 4.221165 2.852161 2.803618 2.738650 2.617598 2.426281 2.206289 1.927885 1.605539 1.253235 0.9035479 0.5864393 0.3208091 0.1221152 -8.5281953E-03 -8.3818935E-02 -0.1220568 -0.1388875 -0.1450848 -33.98338 5.188638 3.994509 3.725757 3.474521 3.192223 2.898354 2.587686 2.246973 1.873414 1.501076 1.160169 0.8846805 0.6961660 0.6043742 0.5936019 0.6390232 0.7180904 0.8157348 0.9234931 -33.98338 5.740141 4.716855 4.224787 3.770855 3.338797 2.932891 2.531080 2.122998 1.711506 1.316674 0.9760931 0.7264373 0.5954446 0.5844439 0.6704054 0.8193531 1.004805 1.211311 1.430698 -33.98338 5.968050 5.091711 4.448069 3.855141 3.317006 2.809392 2.323730 1.850348 1.398743 0.9746858 0.6104596 0.3521782 0.2445486 0.2897584 0.4574095 0.7025625 0.9912536 1.305516 1.636257 -33.98338 5.973028 5.206707 4.481564 3.809376 3.185137 2.603804 2.052018 1.525264 1.032837 0.5703620 0.1593033 -0.1465013 -0.2842760 -0.2227592 4.1724299E-03 0.3363358 0.7251444 1.146428 1.588482 -33.98338 5.810409 5.135227 4.373254 3.649813 2.971370 2.336444 1.744599 1.182073 0.6528707 0.1589179 -0.2988755 -0.6627669 -0.8670248 -0.8320375 -0.5699925 -0.1609032 0.3254192 0.8533222 1.406786 -33.98338 5.517992 4.919924 4.144843 3.396741 2.686848 2.021358 1.402444 0.8224159 0.2684503 -0.2551847 -0.7385213 -1.155345 -1.436297 -1.466697 -1.202324 -0.7296338 -0.1490930 0.4849521 1.149927 -33.98338 5.115910 4.589516 3.818238 3.061197 2.341537 1.659897 1.026960 0.4347432 -0.1326727 -0.6672898 -1.167969 -1.624728 -1.982098 -2.108466 -1.892634 -1.383868 -0.7167393 2.1829566E-02 0.7981641 -33.98338 4.621395 4.160374 3.404306 2.655757 1.937865 1.253083 0.6136817 1.5681526E-02 -0.5550999 -1.087562 -1.598107 -2.074393 -2.489632 -2.723848 -2.614292 -2.115481 -1.378098 -0.5387177 0.3484001 -33.98338 4.045387 3.642656 2.915424 2.183881 1.476804 0.7998329 0.1571206 -0.4351156 -0.9999377 -1.528975 -2.035800 -2.519550 -2.957321 -3.277739 -3.310254 -2.879709 -2.099483 -1.166141 -0.1693593 -33.98338 3.393383 3.043988 2.352344 1.647366 0.9575189 0.2894787 -0.3377290 -0.9208556 -1.476514 -1.996079 -2.494558 -2.966447 -3.409873 -3.777785 -3.939545 -3.636104 -2.855898 -1.840530 -0.7362677 -33.98338 2.665228 2.366083 1.716441 1.040387 0.3747703 -0.2697039 -0.8783774 -1.447815 -1.987917 -2.493413 -2.972926 -3.428127 -3.862186 -4.249533 -4.494679 -4.352957 -3.634417 -2.559409 -1.351958 -33.98338 1.855344 1.605358 1.003814 0.3663705 -0.2677335 -0.8865145 -1.472466 -2.023139 -2.540807 -3.021080 -3.480243 -3.910080 -4.330650 -4.699527 -4.993318 -5.005027 -4.419105 -3.324561 -2.022531 -33.98338 0.9589923 0.7602612 0.2089168 -0.3841922 -0.9839963 -1.570515 -2.128531 -2.649891 -3.136540 -3.589345 -4.020913 -4.430715 -4.812217 -5.157610 -5.457003 -5.575504 -5.176705 -4.121103 -2.740484 -33.98338 -4.4748969E-02 -0.1902629 -0.6857257 -1.227894 -1.785918 -2.329314 -2.848844 -3.334180 -3.784751 -4.209849 -4.605290 -4.972654 -5.327936 -5.636041 -5.919471 -6.086205 -5.885254 -4.952512 -3.525700 -33.98338 -1.181747 -1.269094 -1.696229 -2.179323 -2.681466 -3.176435 -3.645329 -4.088984 -4.495461 -4.879325 -5.232251 -5.562136 -5.880491 -6.150639 -6.394225 -6.578361 -6.524230 -5.804464 -4.388412 -33.98338 -2.506058 -2.520916 -2.863034 -3.270485 -3.700915 -4.128426 -4.536433 -4.922042 -5.284252 -5.626877 -5.933918 -6.219515 -6.487954 -6.721995 -6.924966 -7.084363 -7.114582 -6.654502 -5.335428 -33.98338 -4.114406 -4.033651 -4.254977 -4.553231 -4.894290 -5.240175 -5.582976 -5.906670 -6.206936 -6.500285 -6.759156 -6.996620 -7.216329 -7.398012 -7.550309 -7.683541 -7.763217 -7.545145 -6.411261 -33.98338 -6.299214 -6.089386 -6.145109 -6.294376 -6.505353 -6.741286 -6.987785 -7.229264 -7.452457 -7.683037 -7.883322 -8.073200 -8.241811 -8.388412 -8.519546 -8.648333 -8.749258 -8.652204 -7.696215 -33.98338 -65.42577 -64.72607 -63.81600 -62.73664 -61.51680 -60.17846 -58.73710 -57.20469 -55.59093 -53.90275 -52.14721 -50.32937 -48.45378 -46.52437 -44.54455 -42.51733 -40.44536 -38.33099 -36.17636 -33.98338 0.7995963 -6.8672270E-02 0.1793261 0.4973170 0.8327925 1.131704 1.422020 1.728617 2.039001 2.345856 2.649627 2.952539 3.245929 3.534964 3.820469 4.101643 4.377836 4.649801 4.914869 5.176029 -0.1250684 -0.8429193 -0.5940138 -0.2834751 4.8262395E-02 0.3514790 0.6456679 0.9508473 1.257548 1.557132 1.851480 2.142165 2.428889 2.709035 2.979384 3.243381 3.501156 3.754847 4.001112 4.242345 -0.5305336 -1.357123 -1.269198 -1.031641 -0.7268364 -0.4246037 -0.1268308 0.1760808 0.4782652 0.7686042 1.051872 1.329675 1.604093 1.870529 2.124056 2.369241 2.606015 2.838805 3.062389 3.278955 -0.5900738 -1.407906 -1.305856 -0.9830396 -0.6045073 -0.2244738 0.1423378 0.4941987 0.8381707 1.175259 1.506482 1.832339 2.153035 2.468722 2.779444 3.085042 3.385176 3.680392 3.970589 4.255506 -0.1250684 -0.8429193 -0.5940138 -0.2834751 4.8262395E-02 0.3514790 0.6456679 0.9508474 1.257548 1.557132 1.851480 2.142165 2.428889 2.709035 2.979384 3.243381 3.501156 3.754847 4.001112 4.242345 -1.446824 -1.721935 -1.397868 -1.071191 -0.7378978 -0.4274693 -0.1275555 0.1759099 0.4781934 0.7685279 1.052152 1.330581 1.599754 1.861850 2.115571 2.362439 2.600549 2.834391 3.058789 3.275999 -1.136669 -1.650536 -1.378366 -1.065995 -0.7365690 -0.4271421 -0.1274644 0.1759246 0.4782272 0.7685952 1.051869 1.329675 1.604092 1.870529 2.124056 2.369241 2.606015 2.838805 3.062389 3.278955 -1.525010 -2.062881 -1.951741 -1.658081 -1.308514 -0.9503499 -0.5980750 -0.2555618 8.0704629E-02 0.4106318 0.7340404 1.050757 1.361245 1.666518 1.966179 2.259129 2.544802 2.823586 3.095982 3.362019 0.7995963 -0.7894697 -0.9503295 -0.9797196 -0.9870713 -0.9890559 -0.9897087 -0.9897208 -0.9903132 -0.9897352 -0.9811710 -0.9506864 -1.280635 -1.648908 -1.682908 -1.682991 -1.682991 -1.682991 -1.682991 -1.682991 -0.1250684 -1.433705 -1.586878 -1.616891 -1.624495 -1.626571 -1.627149 -1.627310 -1.627355 -1.627368 -1.627372 -1.627373 -1.627373 -1.627373 -1.627373 -1.627373 -1.627373 -1.627373 -1.627373 -1.627373 -0.5305336 -1.803804 -2.101460 -2.188770 -2.213684 -2.220715 -2.222690 -2.223243 -2.223399 -2.223443 -2.223454 -2.223458 -2.223459 -2.223459 -2.223459 -2.223459 -2.223459 -2.223459 -2.223459 -2.223459 -0.5900738 -1.467401 -1.592416 -1.618154 -1.624816 -1.626654 -1.627170 -1.627316 -1.627357 -1.627369 -1.627372 -1.627373 -1.627373 -1.627373 -1.627373 -1.627373 -1.627373 -1.627373 -1.627373 -1.627373 -0.1250684 -1.433705 -1.586878 -1.616891 -1.624495 -1.626571 -1.627149 -1.627310 -1.627355 -1.627368 -1.627372 -1.627373 -1.627373 -1.627373 -1.627373 -1.627373 -1.627373 -1.627373 -1.627373 -1.627373 -1.446824 -2.145541 -2.206491 -2.219090 -2.222264 -2.223110 -2.223453 -2.223379 -2.223814 -2.224115 -2.214866 -2.193193 -2.423728 -2.823014 -2.914409 -2.916596 -2.916604 -2.916607 -2.916606 -2.916607 -1.136669 -2.085389 -2.193797 -2.215887 -2.221392 -2.222884 -2.223299 -2.223414 -2.223447 -2.223456 -2.223458 -2.223459 -2.223459 -2.223459 -2.223459 -2.223459 -2.223459 -2.223459 -2.223459 -2.223459 -1.525010 -2.108372 -2.197889 -2.216806 -2.221623 -2.222944 -2.223314 -2.223418 -2.223448 -2.223456 -2.223459 -2.223459 -2.223459 -2.223459 -2.223459 -2.223459 -2.223459 -2.223459 -2.223459 -2.223459 -0.5900738 -0.5891786 -0.5882775 -0.5873709 -0.5864583 -0.5855394 -0.5846149 -0.5836849 -0.5827487 -0.5818061 -0.5808583 -0.5799037 -0.5789428 -0.5779759 -0.5770021 -0.5760226 -0.5750362 -0.5740439 -0.5730448 -0.5720388 -1.085444 -1.146182 -1.203588 -1.259512 -1.311772 -1.358204 -1.410090 -1.469090 -1.524793 -1.576122 -1.619431 -1.658801 -1.689906 -1.712505 -1.742488 -1.761773 -1.766493 -1.751202 -1.706592 -1.594102 -1.033486 -1.156095 -1.267136 -1.413355 -1.556533 -1.700170 -1.836372 -1.964995 -2.079506 -2.195903 -2.334326 -2.465546 -2.583504 -2.688459 -2.770887 -2.853589 -2.928970 -2.968506 -2.944901 -2.747458 -0.9066472 -1.124870 -1.340968 -1.539565 -1.725618 -1.957537 -2.188849 -2.411983 -2.626170 -2.817894 -3.004548 -3.232382 -3.446283 -3.646255 -3.821872 -3.962253 -4.124968 -4.239711 -4.266828 -4.027280 -0.7486222 -1.055199 -1.364111 -1.666419 -1.938051 -2.204374 -2.525553 -2.843236 -3.155462 -3.450812 -3.698873 -4.006285 -4.320112 -4.620224 -4.897262 -5.114279 -5.368268 -5.570419 -5.662806 -5.410901 -0.6303532 -0.9797431 -1.373619 -1.768455 -2.148422 -2.470465 -2.869287 -3.278039 -3.686476 -4.087068 -4.444635 -4.799623 -5.213884 -5.615871 -5.998673 -6.317933 -6.654226 -6.953719 -7.122209 -6.880484 -0.5159621 -0.9113752 -1.394971 -1.878598 -2.355664 -2.792371 -3.221559 -3.724146 -4.229668 -4.730764 -5.199837 -5.612937 -6.129785 -6.632714 -7.124556 -7.556324 -7.980055 -8.384832 -8.641709 -8.423812 -0.3806867 -0.8652502 -1.412150 -1.988485 -2.569556 -3.120060 -3.595762 -4.190442 -4.784974 -5.386368 -5.969396 -6.445223 -7.067869 -7.674480 -8.277194 -8.826497 -9.343482 -9.860533 -10.21663 -10.03237 -0.2414379 -0.8399660 -1.440873 -2.103097 -2.776701 -3.439495 -3.985583 -4.678209 -5.363657 -6.059793 -6.750099 -7.299952 -8.029325 -8.743117 -9.458138 -10.12813 -10.74330 -11.37756 -11.84338 -11.69990 -0.1015769 -0.8113340 -1.485633 -2.237850 -2.997814 -3.758842 -4.396687 -5.179386 -5.963641 -6.754569 -7.548548 -8.193689 -9.016459 -9.837244 -10.66693 -11.45942 -12.17360 -12.93377 -13.51791 -13.42153 4.0099230E-02 -0.7796937 -1.541921 -2.388826 -3.244477 -4.094587 -4.853351 -5.685294 -6.571281 -7.468508 -8.364120 -9.134686 -10.02596 -10.95804 -11.90316 -12.81801 -13.63695 -14.52703 -15.23623 -15.19339 0.1889395 -0.7371463 -1.599020 -2.546597 -3.496443 -4.450836 -5.324548 -6.207076 -7.189524 -8.192515 -9.198438 -10.09548 -11.05905 -12.10423 -13.16628 -14.20460 -15.13242 -16.15386 -16.99545 -17.01217 0.3327669 -0.6882640 -1.641851 -2.699188 -3.757349 -4.808924 -5.805830 -6.749858 -7.824869 -8.929916 -10.04580 -11.07411 -12.11498 -13.27403 -14.45409 -15.61936 -16.65794 -17.81310 -18.79237 -18.87486 0.4670433 -0.6476118 -1.714439 -2.836345 -4.005079 -5.173931 -6.286157 -7.305942 -8.478972 -9.684251 -10.90695 -12.06866 -13.19199 -14.46871 -15.76720 -17.05898 -18.21349 -19.50293 -20.62381 -20.77944 0.5962187 -0.6172694 -1.804821 -2.986559 -4.245952 -5.524694 -6.769937 -7.868701 -9.147433 -10.45569 -11.78427 -13.07699 -14.29033 -15.68611 -17.10487 -18.52362 -19.79818 -21.22161 -22.48756 -22.72339 0.7233431 -0.5940542 -1.902467 -3.170504 -4.502943 -5.874255 -7.242424 -8.439306 -9.823742 -11.24260 -12.67873 -14.09949 -15.40771 -16.92420 -18.46562 -20.01476 -21.40966 -22.96991 -24.38409 -24.70477 0.8491464 -0.5770904 -2.001993 -3.358990 -4.794505 -6.239272 -7.713378 -9.012062 -10.51015 -12.03836 -13.59012 -15.13661 -16.54305 -18.18346 -19.84792 -21.52959 -23.04759 -24.74575 -26.30932 -26.72183 0.9718812 -0.5652584 -2.104484 -3.553849 -5.088193 -6.633286 -8.195215 -9.587678 -11.20565 -12.84524 -14.51612 -16.18787 -17.69688 -19.46289 -21.25300 -23.06709 -24.70854 -26.55006 -28.26179 -28.77296 1.090041 -0.5580710 -2.209574 -3.754288 -5.387943 -7.035547 -8.696449 -10.17399 -11.90363 -13.66352 -15.45354 -17.25382 -18.86857 -20.76074 -22.68116 -24.62678 -26.39495 -28.37996 -30.24464 -30.85672 1.203619 -0.5557930 -2.318095 -3.959703 -5.693493 -7.440253 -9.212717 -10.77368 -12.61168 -14.49171 -16.40275 -18.33287 -20.05614 -22.07528 -24.12885 -26.20877 -28.10666 -30.23252 -32.25216 -32.97178 -1.525010 -1.524589 -1.524164 -1.523733 -1.523297 -1.522856 -1.522410 -1.521959 -1.521502 -1.521039 -1.520572 -1.520099 -1.519620 -1.519135 -1.518645 -1.518149 -1.517648 -1.517140 -1.516627 -1.516108 -1.886304 -1.950156 -2.012101 -2.072295 -2.130009 -2.184465 -2.241493 -2.301740 -2.359418 -2.413970 -2.464107 -2.510510 -2.551484 -2.587012 -2.624024 -2.652958 -2.671059 -2.674107 -2.653882 -2.579681 -1.822767 -1.955020 -2.080329 -2.225615 -2.369824 -2.512283 -2.650151 -2.782649 -2.906891 -3.032905 -3.170714 -3.302874 -3.426620 -3.540414 -3.639438 -3.736057 -3.822949 -3.882028 -3.892575 -3.750286 -1.698151 -1.918816 -2.135401 -2.341630 -2.542480 -2.771681 -2.998789 -3.220541 -3.434993 -3.635906 -3.836353 -4.060802 -4.276351 -4.480881 -4.667878 -4.832975 -5.006388 -5.142301 -5.210138 -5.036098 -1.546307 -1.855076 -2.160212 -2.458458 -2.738380 -3.019786 -3.335946 -3.648734 -3.955395 -4.249671 -4.516795 -4.824709 -5.136178 -5.437191 -5.720064 -5.965153 -6.231320 -6.456479 -6.596514 -6.421646 -1.413994 -1.783895 -2.174895 -2.562687 -2.939049 -3.282391 -3.679039 -4.081563 -4.481723 -4.873433 -5.236513 -5.607154 -6.016493 -6.416821 -6.800728 -7.142130 -7.497696 -7.821647 -8.044955 -7.891827 -1.288862 -1.719861 -2.201489 -2.678592 -3.146610 -3.586245 -4.031690 -4.525978 -5.021163 -5.509890 -5.972847 -6.410701 -6.920061 -7.421265 -7.910719 -8.356280 -8.804937 -9.234733 -9.551297 -9.435336 -1.159267 -1.678788 -2.229403 -2.798442 -3.364341 -3.903257 -4.403980 -4.988669 -5.574299 -6.161188 -6.728469 -7.235701 -7.847797 -8.452966 -9.051217 -9.605603 -10.15101 -10.69285 -11.11153 -11.04394 -1.026945 -1.651737 -2.268162 -2.923854 -3.580461 -4.221379 -4.791746 -5.470082 -6.147507 -6.830317 -7.500940 -8.083835 -8.800656 -9.512870 -10.22185 -10.88899 -11.53481 -12.19361 -12.72209 -12.71149 -0.9032663 -1.629626 -2.323237 -3.065784 -3.808742 -4.544419 -5.197309 -5.964564 -6.739331 -7.518871 -8.292657 -8.964972 -9.779803 -10.59989 -11.42180 -12.20512 -12.95308 -13.73428 -14.37955 -14.43313 -0.7827411 -1.613694 -2.386691 -3.220227 -4.055513 -4.880816 -5.636638 -6.467973 -7.342035 -8.225100 -9.102187 -9.884957 -10.78303 -11.71408 -12.65026 -13.55211 -14.40546 -15.31326 -16.08085 -16.20499 -0.6605759 -1.590869 -2.453106 -3.379237 -4.306003 -5.230517 -6.089300 -6.985880 -7.957689 -8.944009 -9.929825 -10.82697 -11.81021 -12.85430 -13.90637 -14.92873 -15.89158 -16.92802 -17.82317 -18.02378 -0.5397620 -1.563654 -2.510791 -3.537532 -4.562804 -5.582761 -6.551532 -7.519646 -8.588681 -9.677395 -10.77237 -11.78894 -12.86066 -14.01883 -15.18846 -16.33522 -17.40966 -18.57659 -19.60418 -19.88647 -0.4266192 -1.548774 -2.593187 -3.689056 -4.815506 -5.940939 -7.017300 -8.064921 -9.235039 -10.42647 -11.63016 -12.76935 -13.93278 -15.20773 -16.49640 -17.76925 -18.95809 -20.25778 -21.42140 -21.79104 -0.3319629 -1.552846 -2.698718 -3.854701 -5.068392 -6.295216 -7.488991 -8.618285 -9.894393 -11.19112 -12.50381 -13.76681 -15.02588 -16.42007 -17.82951 -19.22938 -20.53617 -21.96961 -23.27231 -23.73499 -0.2469985 -1.568659 -2.814188 -4.048305 -5.336169 -6.653592 -7.960093 -9.180987 -10.56368 -11.97030 -13.39346 -14.78085 -16.13851 -17.65434 -19.18676 -20.71601 -22.14257 -23.71139 -25.15677 -25.71637 -0.1691570 -1.591302 -2.935436 -4.245872 -5.628399 -7.025500 -8.435659 -9.750223 -11.24371 -12.76075 -14.29885 -15.81098 -17.27007 -18.90969 -20.56650 -22.22769 -23.77602 -25.48220 -27.07218 -27.73343 -9.1113560E-02 -1.617015 -3.062355 -4.451201 -5.923808 -7.416659 -8.921625 -10.32627 -11.93421 -13.56303 -15.21885 -16.85659 -18.42027 -20.18534 -21.96829 -23.76308 -25.43404 -27.28115 -29.01600 -29.78456 -1.9711861E-02 -1.644229 -3.190990 -4.662608 -6.225805 -7.815084 -9.421268 -10.91307 -12.63170 -14.37715 -16.15175 -17.91715 -19.58826 -21.48051 -23.39314 -25.32107 -27.11785 -29.10698 -30.99041 -31.86833 4.2600617E-02 -1.675741 -3.320664 -4.876642 -6.533861 -8.218472 -9.931794 -11.51157 -13.33997 -15.20250 -17.09753 -18.99174 -20.77294 -22.79413 -24.83884 -26.90113 -28.82712 -30.95704 -32.99231 -33.98338 diff --git a/modules/epos/epos.param b/modules/epos/epos.param new file mode 100644 index 0000000000000000000000000000000000000000..6982144b244830d1f555419497a68c9d30b0f228 --- /dev/null +++ b/modules/epos/epos.param @@ -0,0 +1,5 @@ +echo off + +!switch fusion off + +echo on diff --git a/modules/epos/epos_j.f b/modules/epos/epos_j.f new file mode 100644 index 0000000000000000000000000000000000000000..51ab4ebfd7dff5f54ce36875f74ff64b735b649c --- /dev/null +++ b/modules/epos/epos_j.f @@ -0,0 +1,15 @@ + SUBROUTINE FASTJETPPgenkt(P,NPART,R,PALG,F77JETS,NJETS) + DOUBLE PRECISION P(4,*), R, PALG, F77JETS(4,*) + DOUBLE PRECISION dP, dR, dPALG + INTEGER NPART, NJETS,Nd + + F77JETS(1,1)=0d0 + NJETS=0 + dP=P(1,1) + Nd=NPART + dR=R + dPALG=PALG +c write(*,*)"FastJet called with :",F77JETS(1,1),NJETS,R,PALG +c stop"But FastJet not installed !" + + END diff --git a/modules/epos/eposm.f b/modules/epos/eposm.f new file mode 100644 index 0000000000000000000000000000000000000000..3715d1e342a8af226dc70b1df1649aa4d51ef311 --- /dev/null +++ b/modules/epos/eposm.f @@ -0,0 +1,90 @@ + subroutine NumberModel(cmodel,model) + character cmodel*21,cmodel2*21 + cmodel2=cmodel + model2=model + stop' ***** This program can only run EPOS ***** ' + end + + subroutine IniModel(model) + model2=model + end + + subroutine IniEvtModel + end + + subroutine emsaaaModel(model,id,iret) + model2=model + id2=id + iret2=iret + end + + function crseModel(model,ekin,maproj,matarg,idtarg) + crseModel=0. + model2=model + ekin2=ekin + maproj2=maproj + matarg2=matarg + idtarg2=idtarg + end + + subroutine crseaaModel(sigt,sigi,sigc,sigel) + sigt=0. + sigi=0. + sigc=0. + sigel=0. + end + + subroutine m2XXFZ( a,b) + double precision a, b(2),c,d(2) + c=a + d(1)=b(1) + d(2)=b(2) + + end + + subroutine m3SIGMA(ek,idpro,idtar,latar,matar,sigi,sige) + sige=0. + sigi=0. + ek2=ek + idpro2=idpro + matar2=matar + idtar2=idtar + latar2=latar + end + + subroutine m6SIGMA(icl,engy,stot,sela,sine,sdifr,slela,Rho) + icl2=icl + engy2=engy + stot=0. + sela=0. + sine=0. + sdifr=0. + slela=0. + Rho=0. + end + + subroutine m7SIGMA(stot,scut,sine,slela) + stot=0. + scut=0. + sine=0. + slela=0. + end + + subroutine m8SIGMA(stot,scut,sine,sela,slela,ssd) + stot=0. + scut=0. + sine=0. + sela=0. + slela=0. + ssd=0. + end + + subroutine m9SIGMA(stot,sine,sela) + stot=0. + sine=0. + sela=0. + end + + subroutine decaymod(ip) + idum=ip + end diff --git a/modules/epos/eposu_no.f b/modules/epos/eposu_no.f new file mode 100644 index 0000000000000000000000000000000000000000..b4fe7f423c7ec63c0eb663dfd6c207a443896758 --- /dev/null +++ b/modules/epos/eposu_no.f @@ -0,0 +1,7 @@ + subroutine urqmd(n) + include 'epos.inc' + + print *,n + if(iurqmd.eq.1)stop'compile with eposu.f instead of eposu_no.f ' + + end diff --git a/tests/modules/CMakeLists.txt b/tests/modules/CMakeLists.txt index 5c0b9e860a75c4f673d6cabdb156293702afd4aa..121eb11f05324c229696fde27aef25aa064b39ac 100644 --- a/tests/modules/CMakeLists.txt +++ b/tests/modules/CMakeLists.txt @@ -11,6 +11,7 @@ set (test_modules_sources # testOnShellCheck.cpp testParticleCut.cpp testSibyll.cpp + testEpos.cpp ) CORSIKA_ADD_TEST (testModules SOURCES ${test_modules_sources}) diff --git a/tests/modules/testEpos.cpp b/tests/modules/testEpos.cpp new file mode 100644 index 0000000000000000000000000000000000000000..f0b01ce36f5ff790856d559986dd1f69421e9248 --- /dev/null +++ b/tests/modules/testEpos.cpp @@ -0,0 +1,101 @@ +/* + * (c) Copyright 2019 CORSIKA Project, corsika-project@lists.kit.edu + * + * This software is distributed under the terms of the GNU General Public + * Licence version 3 (GPL Version 3). See file LICENSE for a full version of + * the license. + */ + +#include <corsika/modules/Epos.hpp> +//#include <corsika/modules/epos/ParticleConversion.hpp> + +#include <corsika/framework/core/ParticleProperties.hpp> +#include <corsika/framework/core/PhysicalUnits.hpp> +#include <corsika/framework/geometry/Point.hpp> +#include <corsika/framework/random/RNGManager.hpp> + +#include <catch2/catch.hpp> +#include <tuple> + +/* + NOTE, WARNING, ATTENTION + + The epos/Random.hpp implements the hook of epos to the C8 random + number generator. It has to occur excatly ONCE per linked + executable. If you include the header below in multiple "tests" and + link them togehter, it will fail. + */ +#include <corsika/modules/epos/Random.hpp> + +using namespace corsika; +using namespace corsika::epos; + +TEST_CASE("Epos", "[processes]") { + + corsika_logger->set_pattern("[%n:%^%-8l%$] custom pattern: %v"); + logging::set_level(logging::level::trace); + + SECTION("Epos -> Corsika") { + } + + SECTION("Corsika -> Epos") { + } + + SECTION("canInteractInEpos") { + } + + SECTION("cross-section type") { + } + +} + +#include <corsika/framework/geometry/Point.hpp> +#include <corsika/framework/geometry/RootCoordinateSystem.hpp> +#include <corsika/framework/geometry/Vector.hpp> + +#include <corsika/framework/core/PhysicalUnits.hpp> + +#include <corsika/framework/core/ParticleProperties.hpp> + +#include <SetupTestEnvironment.hpp> +#include <SetupTestStack.hpp> + +#include <corsika/media/Environment.hpp> +#include <corsika/media/HomogeneousMedium.hpp> +#include <corsika/media/NuclearComposition.hpp> +#include <corsika/media/UniformMagneticField.hpp> + +template <typename TStackView> +auto sumMomentum(TStackView const& view, CoordinateSystemPtr const& vCS) { + Vector<hepenergy_d> sum{vCS, 0_eV, 0_eV, 0_eV}; + for (auto const& p : view) { sum += p.getMomentum(); } + return sum; +} + +TEST_CASE("EposInterface", "[processes]") { + + corsika_logger->set_pattern("[%n:%^%-8l%$] custom pattern: %v"); + logging::set_level(logging::level::trace); + + auto [env, csPtr, nodePtr] = setup::testing::setup_environment(Code::Oxygen); + auto const& cs = *csPtr; + [[maybe_unused]] auto const& env_dummy = env; + + // RNGManager::getInstance().registerRandomStream("epos"); + + SECTION("InteractionInterface - low energy") { + + const HEPEnergyType P0 = 60_GeV; + auto [stack, viewPtr] = setup::testing::setup_stack( + Code::Proton, 0, 0, P0, (setup::Environment::BaseNodeType* const)nodePtr, cs); + MomentumVector plab = + MomentumVector(cs, {P0, 0_eV, 0_eV}); // this is secret knowledge about setupStack + setup::StackView& view = *viewPtr; + + auto particle = stack->first(); + + Interaction model; + model.doInteraction(view); + } + +}