aboutsummaryrefslogtreecommitdiff
diff options
context:
space:
mode:
authorcott <cott@8e189c6b-2ab8-4400-aa02-70a9cfce18b9>2013-02-23 23:43:44 +0000
committercott <cott@8e189c6b-2ab8-4400-aa02-70a9cfce18b9>2013-02-23 23:43:44 +0000
commit691b9206f998884e1987b07322f1657aaeb7fcc8 (patch)
treed59e1ea9dd463976abc37f6d5ca77357e1f1bace
parente35d6e7aa0f9bdfa99bebe01df327eca59ef9817 (diff)
* add support for cold tabulated EOS (P=P(rho)) that
can be supplemented with a thermal gamma law git-svn-id: http://svn.einsteintoolkit.org/cactus/EinsteinEOS/EOS_Omni/trunk@74 8e189c6b-2ab8-4400-aa02-70a9cfce18b9
-rw-r--r--doc/documentation.tex92
-rw-r--r--param.ccl15
-rw-r--r--schedule.ccl8
-rw-r--r--src/EOS_Omni_Handles.c2
-rw-r--r--src/EOS_Omni_Module.F9016
-rw-r--r--src/EOS_Omni_SingleVarCalls.F90281
-rw-r--r--src/make.code.defn2
-rw-r--r--tables/README15
-rw-r--r--tables/SLy_Tabulated.dat607
9 files changed, 1013 insertions, 25 deletions
diff --git a/doc/documentation.tex b/doc/documentation.tex
index 743c472..8bbee49 100644
--- a/doc/documentation.tex
+++ b/doc/documentation.tex
@@ -88,7 +88,7 @@ Erik Schnetter \textless eschnetter@perimeterinstitute.ca\textgreater}
% the date your document was last changed, if your document is in CVS,
% please use:
% \date{$ $Date: 2004-01-07 12:12:39 -0800 (Wed, 07 Jan 2004) $ $}
-\date{April 19, 2011}
+\date{February 24, 2013}
\maketitle
@@ -172,6 +172,7 @@ Here,
\item \texttt{eoskey = 3}: Hybrid EOS (2 Polys, 1 Gamma-Law), used
for stellar core collapse simulations.
\item \texttt{eoskey = 4}: Finite-temperature microphysical EOS
+ \item \texttt{eoskey = 5}: Cold tabulated EOS with Gamma-Law
\end{itemize}
\item \texttt{havetemp} determines whether the EOS is to be called as
a function of $(\rho,\epsilon,Y_e)$ (\texttt{havetemp = 0}), or as a
@@ -210,16 +211,9 @@ wrong. This is also true for the Einstein Toolkit GR hydro code
\begin{verbatim}
eos_omni::poly_gamma
-eos_omni::poly_gamma_ini
eos_omni::poly_k
\end{verbatim}
-The only non-obvious parameter here is \texttt{poly\_gamma\_ini}.
-In most simulations it should be set equal to \texttt{poly\_gamma}.
-In simulations that are run with a different adiabatic index than
-what was used to set up the initial data, \texttt{poly\_gamma} should
-be the evolution value, and \texttt{poly\_gamma\_ini} should be the initial
-data value.
Check \texttt{param.ccl} for parameters for the other EOS\@.
@@ -247,16 +241,7 @@ relation
\end{eqnarray}
(which actually ignores the temperature).
-Internally, \texttt{EOS\_Omni} uses cgs units, and on startup converts
-the EOS parameters from solar units to cgs units. This conversion
-depends on $\gamma$ and the value of $\gamma$ at the initial
-data stage (\texttt{poly\_gamma\_ini}) is used for this.
-Note that contrary to what the parameter name suggests,
-\texttt{EOS\_Omni} does not make a distinction between initial data
-setup and time evolution; if such a distinction is required, it must
-be implemented outside of this thorn.
-
-Note also: This polytropic EOS is also used as fall-back when other
+Note: This polytropic EOS is also used as fall-back when other
EOS fail.
\subsection{Gamma-Law}
@@ -361,7 +346,57 @@ are the following:
\texttt{nuceos\_table\_name}& STRING & Path/Name of the table file.
\end{tabular}
+\subsection{Cold Tabulated Nuclear EOS with Gamma Law}
+
+Many equations of state for neutron stars are generated under the
+assumption of zero temperature. This is perfectly appropriate for cold
+old neutron stars. In simulations of binary mergers, however, shocks
+will drive the temperature up, adding a thermal pressure component,
+which can be accounted for approximately with a Gamma-Law:
+$P_\mathrm{th} = (\Gamma_\mathrm{th} - 1)\rho\epsilon_\mathrm{th}$\,.
+
+{\tt EOS\_Omni} implements such an equation of state. It reads in an
+ASCII EOS table (see subdirector {\tt tables} for an example table for
+the SLy EOS \cite{douchin:01,haensel:04}, which was generated
+according to the prescription in \cite{shibata:05,corvino:10}). All
+EOS parameters are read from the ASCII file, which has the following
+format:
+
+\begin{verbatim}
+EoSType = Tabulated
+Nrho = 600 NYe = 1 NT = 1
+RhoMin = 1e-09 RhoMax = 0.01
+HeatCapacityE = 1
+GammaTh = 2
+Kappa = 1
+RhoSpacing = Log
+ 1.57940636422747e-03 1.38773826035349e+00 2.62139412738900e-02
+[...]
+ 2.81804006881059e+00 6.89967555695907e-01 8.30537612378975e-01
+\end{verbatim}
+
+The header completely determines the range in baryon rest mass density
+(in $c=G=M_\odot=1$ units), gives the number of zones (currently only
+{\tt NYe = 1}, {\tt NT = 1}, {\tt HeatCapacityE = 1}, and {\tt
+ RhoSpacing = Log} are supported). {\tt GammaTh} is the
+$\Gamma_\mathrm{th}$ of the thermal gamma law. The tabulated columns
+are $\epsilon$, $\Gamma$, $c_s$ (the speed of sound of the cold
+component of the EOS). The pressure is obtained via $P= \kappa
+\rho^\Gamma$, where $\kappa$ is the {\tt Kappa} scaling parameter.
+
+Generally, $P = P(\rho,\epsilon)$ in this EOS, but note that
+$\epsilon_\mathrm{th} = \epsilon - \epsilon_\mathrm{cold}$. {\tt
+ EOS\_Omni} uses linear interpolation to first find $P(\rho)$ and
+$\epsilon_\mathrm{cold}(\rho)$ and then computes the thermal component
+analytically.
+
+\begin{tabular}{lll}
+\texttt{coldeos\_read\_table}& BOOLEAN & Set to {\tt yes} to read table.\\
+\texttt{coldeos\_use\_thermal\_gamma\_law}& BOOLEAN & Set to {\tt yes} to use the thermal
+gamma law (default).\\
+\texttt{coldeos\_table\_name}& STRING & Path/Name of the table file.\\
+\end{tabular}
\section{Converting Old Parameter Files}
@@ -386,7 +421,7 @@ this conversion.
\ref{tab:eosnames}.
\end{enumerate}
-\begin{table}
+\begin{table}[h]
\begin{tabular}{ll|ll}
Old Parameter & Old Value & New Parameter & New Value\\
\hline
@@ -414,7 +449,7 @@ this conversion.
\label{tab:paramconv}
\end{table}
-\begin{table}
+\begin{table}[h]
\begin{tabular}{llll}
EOS & Description & Old Name & New Name \\\hline
poly & polytropic & ??? & 2D\_Polytrope \\
@@ -433,6 +468,23 @@ this conversion.
\bibitem{oconnor:10} O'Connor, E., \& Ott, C.~D.\ 2010, Class. Quantum Grav., 27, 114103
+\bibitem{douchin:01} Douchin, F., \& Haensel, P.\ 2001, Astron.~Astrophys., 380, 151
+
+\bibitem{haensel:04} Haensel, P., \& Potekhin, A.~Y.\ 2004, Astron.~Astrophys., 428, 191
+
+\bibitem{shibata:05} Shibata, M., Taniguchi, K., \& Ury{\= u}, K.\ 2005, Phys.~Rev.~D, 71, 084021
+
+\bibitem{corvino:10} Corvino, G., Rezzolla, L., Bernuzzi, S., De Pietri, R.,
+\& Giacomazzo, B.\ 2010, Class. Quantum Grav., 27, 114104
+
+
+
+
+
+
+
+
+
diff --git a/param.ccl b/param.ccl
index 3a55c8e..456cb4d 100644
--- a/param.ccl
+++ b/param.ccl
@@ -51,6 +51,21 @@ REAL hybrid_rho_nuc "Density at which to switch between gammas; c=G=Msun=1" STEE
: :: ""
} 3.238607e-4
+################ cold tabulated EOS + gamma-Law
+
+STRING coldeos_table_name "table name for cold EOS (ASCII)"
+{
+ .* :: "Can be anything"
+} "blah.asc"
+
+BOOLEAN coldeos_read_table "Read in cold EOS table?"
+{
+} "No"
+
+BOOLEAN coldeos_use_thermal_gamma_law "use an additional thermal gamma?"
+{
+} "Yes"
+
################ Finite-Temperature Nuclear EOS
BOOLEAN nuceos_read_table "Read in EOS table?" STEERABLE=RECOVER
diff --git a/schedule.ccl b/schedule.ccl
index 9920825..d445705 100644
--- a/schedule.ccl
+++ b/schedule.ccl
@@ -26,3 +26,11 @@ if (nuceos_read_table)
}
+if (coldeos_read_table)
+{
+ SCHEDULE EOS_OMNI_ReadColdTable AT CCTK_BASEGRID
+ {
+ LANG: Fortran
+ OPTIONS: global
+ } "Read Cold EOS ASCII table"
+}
diff --git a/src/EOS_Omni_Handles.c b/src/EOS_Omni_Handles.c
index b744cac..1ecd349 100644
--- a/src/EOS_Omni_Handles.c
+++ b/src/EOS_Omni_Handles.c
@@ -12,6 +12,8 @@ CCTK_INT EOS_Omni_GetHandle_(CCTK_STRING name)
return 3;
if (CCTK_EQUALS(name, "nuc_eos"))
return 4;
+ if (CCTK_EQUALS(name, "cold_tabulated"))
+ return 5;
return 0;
}
diff --git a/src/EOS_Omni_Module.F90 b/src/EOS_Omni_Module.F90
index e6ecc14..04dd10d 100644
--- a/src/EOS_Omni_Module.F90
+++ b/src/EOS_Omni_Module.F90
@@ -25,7 +25,21 @@ module EOS_Omni_Module
real*8,parameter :: cliteinv2 = 1.11265005605362d-21
! These values are set by EOS_Omni_Startup
-
real*8 :: hybrid_k2 = 0.0d0
+ ! stuff for the cold, tabulated EOS with a gamma law
+ ! set by the reader routine
+ integer :: coldeos_nrho = 0
+ real*8 :: coldeos_gammath = 0.0d0
+ real*8 :: coldeos_rhomin = 0.0d0
+ real*8 :: coldeos_rhomax = 0.0d0
+ real*8 :: coldeos_kappa = 0.0d0
+ real*8 :: coldeos_thfac = 1.0d0
+ real*8 :: coldeos_dlrho = 1.0d0
+ real*8 :: coldeos_dlrhoi = 1.0d0
+ real*8, allocatable :: coldeos_logrho(:)
+ real*8, allocatable :: coldeos_eps(:)
+ real*8, allocatable :: coldeos_gamma(:)
+ real*8, allocatable :: coldeos_cs2(:)
+
end module EOS_Omni_Module
diff --git a/src/EOS_Omni_SingleVarCalls.F90 b/src/EOS_Omni_SingleVarCalls.F90
index bbff17c..350e622 100644
--- a/src/EOS_Omni_SingleVarCalls.F90
+++ b/src/EOS_Omni_SingleVarCalls.F90
@@ -34,6 +34,11 @@ subroutine EOS_Omni_EOS_Press(eoskey,keytemp,rf_precision,npoints,&
real*8 :: xrho,xye,xtemp,xenr,xent
real*8 :: xprs,xmunu,xcs2
real*8 :: xdedt,xdpderho,xdpdrhoe
+ ! temporary vars for coldeos + gamma law
+ integer :: ir
+ real*8 :: press_cold, press_th
+ real*8 :: eps_cold, eps_th
+ real*8 :: gamma
anyerr = 0
keyerr(:) = 0
@@ -89,7 +94,7 @@ subroutine EOS_Omni_EOS_Press(eoskey,keytemp,rf_precision,npoints,&
enddo
case (4)
-
+ ! nuc eos
do i=1,npoints
xrho = rho(i) * inv_rho_gf
@@ -113,6 +118,41 @@ subroutine EOS_Omni_EOS_Press(eoskey,keytemp,rf_precision,npoints,&
enddo
+ case (5)
+ ! cold tabular EOS with gamma law
+ do i=1,npoints
+ if(rho(i).lt.coldeos_rhomin) then
+ keyerr(i) = 104
+ anyerr = 1
+ else if(rho(i).gt.coldeos_rhomax) then
+ keyerr(i) = 103
+ anyerr = 1
+ else
+ xrho = log10(rho(i))
+ ir = 2 + INT( (xrho - coldeos_logrho(1) - 1.0d-10) * coldeos_dlrhoi )
+ endif
+ ir = max(2, min(ir,coldeos_nrho))
+
+ gamma = (coldeos_gamma(ir) - coldeos_gamma(ir-1)) / &
+ (coldeos_logrho(ir) - coldeos_logrho(ir-1)) * &
+ (xrho - coldeos_logrho(ir-1)) + coldeos_gamma(ir-1)
+
+ eps_cold = (coldeos_eps(ir) - coldeos_eps(ir-1)) / &
+ (coldeos_logrho(ir) - coldeos_logrho(ir-1)) * &
+ (xrho - coldeos_logrho(ir-1)) + coldeos_eps(ir-1)
+
+ if(keytemp.eq.0) then
+ eps_th = max(0.0d0,eps(i) - eps_cold)
+ else if (keytemp.eq.1) then
+ eps_th = 0.0d0
+ eps(i) = eps_cold
+ endif
+
+ press_cold = coldeos_kappa * rho(i)**gamma
+ press_th = coldeos_thfac*(coldeos_gammath - 1.0d0)*rho(i)*eps_th
+ press(i) = press_cold !+ press_th
+ enddo
+
case DEFAULT
write(warnstring,*) "eoskey ",eoskey," not implemented!"
call CCTK_WARN(0,warnstring)
@@ -147,6 +187,11 @@ subroutine EOS_Omni_EOS_DPressByDRho(eoskey,keytemp,rf_precision,npoints,&
real*8 :: xrho,xye,xtemp,xenr,xent
real*8 :: xprs,xmunu,xcs2
real*8 :: xdedt,xdpderho,xdpdrhoe
+ ! temporary vars for cold tabulated EOS + gamma law
+ integer :: ir
+ real*8 :: press_cold, press_th
+ real*8 :: eps_cold, eps_th
+ real*8 :: gamma, cs2, h
anyerr = 0
keyerr(:) = 0
@@ -205,8 +250,6 @@ subroutine EOS_Omni_EOS_DPressByDRho(eoskey,keytemp,rf_precision,npoints,&
dpdrhoe(i) = hybrid_dp_poly + max(0.0d0,hybrid_dp_th1 + hybrid_dp_th2)
-
-
enddo
case (4)
@@ -231,6 +274,54 @@ subroutine EOS_Omni_EOS_DPressByDRho(eoskey,keytemp,rf_precision,npoints,&
dpdrhoe(i) = xdpdrhoe * press_gf * inv_rho_gf
enddo
+
+ case (5)
+ ! with the cold eos we have to assume P = P(rho), so
+ ! by definition dPdrho is at constant internal energy
+ ! and entropy (the latter, because T=0)
+ do i=1,npoints
+ if(rho(i).lt.coldeos_rhomin) then
+ keyerr(i) = 104
+ anyerr = 1
+ else if(rho(i).gt.coldeos_rhomax) then
+ keyerr(i) = 103
+ anyerr = 1
+ else
+ xrho = log10(rho(i))
+ ir = 2 + INT( (xrho - coldeos_logrho(1) - 1.0d-10) * coldeos_dlrhoi )
+ endif
+ ir = max(2, min(ir,coldeos_nrho))
+
+ gamma = (coldeos_gamma(ir) - coldeos_gamma(ir-1)) / &
+ (coldeos_logrho(ir) - coldeos_logrho(ir-1)) * &
+ (xrho - coldeos_logrho(ir-1)) + coldeos_gamma(ir-1)
+
+ ! this is the cold speed of sound squared
+ cs2 = (coldeos_cs2(ir) - coldeos_cs2(ir-1)) / &
+ (coldeos_cs2(ir) - coldeos_cs2(ir-1)) * &
+ (xrho - coldeos_logrho(ir-1)) + coldeos_cs2(ir-1)
+
+ eps_cold = (coldeos_eps(ir) - coldeos_eps(ir-1)) / &
+ (coldeos_logrho(ir) - coldeos_logrho(ir-1)) * &
+ (xrho - coldeos_logrho(ir-1)) + coldeos_eps(ir-1)
+
+ if(keytemp.eq.0) then
+ eps_th = max(0.0d0,eps(i) - eps_cold)
+ else if (keytemp.eq.1) then
+ eps_th = 0.0d0
+ eps(i) = eps_cold
+ endif
+
+ press_cold = coldeos_kappa * rho(i)**gamma
+ press_th = coldeos_thfac*(coldeos_gammath - 1.0d0)*rho(i)*eps_th
+
+ ! this is the cold enthalpy, because it belongs to the
+ ! cold speed of sound squared
+ h = 1.0d0 + eps_cold + press_cold / rho(i)
+ dpdrhoe(i) = cs2*h + press_th / rho(i)
+
+ enddo
+
case DEFAULT
write(warnstring,*) "eoskey ",eoskey," not implemented!"
call CCTK_WARN(0,warnstring)
@@ -260,6 +351,9 @@ subroutine EOS_Omni_EOS_DPressByDEps(eoskey,keytemp,rf_precision,npoints,&
real*8 :: xrho,xye,xtemp,xenr,xent
real*8 :: xprs,xmunu,xcs2
real*8 :: xdedt,xdpderho,xdpdrhoe
+ ! temporary vars for coldeos + gamma law
+ integer :: ir
+ real*8 :: eps_cold, eps_th
anyerr = 0
keyerr(:) = 0
@@ -322,6 +416,36 @@ subroutine EOS_Omni_EOS_DPressByDEps(eoskey,keytemp,rf_precision,npoints,&
enddo
+ case (5)
+ ! with the cold eos we have to assume P = P(rho), so
+ ! only the gamma law has non-zero dPdeps
+ do i=1,npoints
+ if(rho(i).lt.coldeos_rhomin) then
+ keyerr(i) = 104
+ anyerr = 1
+ else if(rho(i).gt.coldeos_rhomax) then
+ keyerr(i) = 103
+ anyerr = 1
+ else
+ xrho = log10(rho(i))
+ ir = 2 + INT( (xrho - coldeos_logrho(1) - 1.0d-10) * coldeos_dlrhoi )
+ endif
+ ir = max(2, min(ir,coldeos_nrho))
+
+ eps_cold = (coldeos_eps(ir) - coldeos_eps(ir-1)) / &
+ (coldeos_logrho(ir) - coldeos_logrho(ir-1)) * &
+ (xrho - coldeos_logrho(ir-1)) + coldeos_eps(ir-1)
+
+ if(keytemp.eq.0) then
+ eps_th = max(0.0d0,eps(i) - eps_cold)
+ else if (keytemp.eq.1) then
+ eps_th = 0.0d0
+ eps(i) = eps_cold
+ endif
+
+ dpdepsrho(i) = coldeos_thfac * (coldeos_gammath - 1.0d0)*rho(i)
+
+ enddo
case DEFAULT
write(warnstring,*) "eoskey ",eoskey," not implemented!"
call CCTK_WARN(0,warnstring)
@@ -355,6 +479,11 @@ subroutine EOS_Omni_EOS_cs2(eoskey,keytemp,rf_precision,npoints,&
real*8 :: xrho,xye,xtemp,xenr,xent
real*8 :: xprs,xmunu,xcs2
real*8 :: xdedt
+ ! temporary vars for cold tabulated EOS + gamma law
+ integer :: ir
+ real*8 :: press_cold, press_th
+ real*8 :: eps_cold, eps_th
+ real*8 :: gamma, cs2_cold, cs2_th, h, h_cold
anyerr = 0
keyerr(:) = 0
@@ -443,8 +572,56 @@ subroutine EOS_Omni_EOS_cs2(eoskey,keytemp,rf_precision,npoints,&
(1.0d0 + eps(i) + xprs * press_gf / rho(i))
enddo
+ case (5)
+ ! with the cold eos we have to assume P = P(rho), so
+ ! by definition dPdrho is at constant internal energy
+ ! and entropy (the latter, because T=0)
+ do i=1,npoints
+ if(rho(i).lt.coldeos_rhomin) then
+ keyerr(i) = 104
+ anyerr = 1
+ else if(rho(i).gt.coldeos_rhomax) then
+ keyerr(i) = 103
+ anyerr = 1
+ else
+ xrho = log10(rho(i))
+ ir = 2 + INT( (xrho - coldeos_logrho(1) - 1.0d-10) * coldeos_dlrhoi )
+ endif
+ ir = max(2, min(ir,coldeos_nrho))
+
+ gamma = (coldeos_gamma(ir) - coldeos_gamma(ir-1)) / &
+ (coldeos_logrho(ir) - coldeos_logrho(ir-1)) * &
+ (xrho - coldeos_logrho(ir-1)) + coldeos_gamma(ir-1)
+
+ ! this is the cold speed of sound squared
+ cs2_cold = (coldeos_cs2(ir) - coldeos_cs2(ir-1)) / &
+ (coldeos_cs2(ir) - coldeos_cs2(ir-1)) * &
+ (xrho - coldeos_logrho(ir-1)) + coldeos_cs2(ir-1)
+
+ eps_cold = (coldeos_eps(ir) - coldeos_eps(ir-1)) / &
+ (coldeos_logrho(ir) - coldeos_logrho(ir-1)) * &
+ (xrho - coldeos_logrho(ir-1)) + coldeos_eps(ir-1)
+
+ if(keytemp.eq.0) then
+ eps_th = max(0.0d0,eps(i) - eps_cold)
+ else if (keytemp.eq.1) then
+ eps_th = 0.0d0
+ eps(i) = eps_cold
+ endif
+ press_cold = coldeos_kappa * rho(i)**gamma
+ press_th = coldeos_thfac*(coldeos_gammath - 1.0d0)*rho(i)*eps_th
+ xdpdrhoe = coldeos_thfac*(coldeos_gammath - 1.0d0)*eps_th
+ xdpderho = coldeos_thfac*(coldeos_gammath - 1.0d0)*rho(i)
+ cs2_th = (xdpdrhoe + press_th * xdpderho / (rho(i)**2))
+
+ h = 1.0d0 + eps(i) + (press_cold+press_th) / rho(i)
+ h_cold = 1.0d0 + eps_cold + press_cold / rho(i)
+
+ cs2(i) = (cs2_cold * h_cold + cs2_th) / h
+ enddo
+
case DEFAULT
write(warnstring,*) "eoskey ",eoskey," not implemented!"
call CCTK_WARN(0,warnstring)
@@ -541,6 +718,9 @@ subroutine EOS_Omni_EOS_RhoFromPressEpsTempEnt(eoskey,&
real*8 :: xrho,xye,xtemp,xenr,xent
real*8 :: xprs,xmunu,xcs2
real*8 :: xdedt,xdpderho,xdpdrhoe
+ ! temporary vars for cold tabulated EOS
+ integer :: ir
+ real*8 :: gamma
! helper vars
logical :: cont
@@ -632,6 +812,101 @@ subroutine EOS_Omni_EOS_RhoFromPressEpsTempEnt(eoskey,&
endif
enddo
enddo
+
+ case (5)
+ ! cold tabulate EOS
+ ! deal only with case in which thermal pressure is zero
+ if(keytemp.ne.1) then
+ call CCTK_WARN(0,"finding rho(press) for tabulated cold EOS only possible if keytemp=1")
+ endif
+
+ do i=1,npoints
+ fac = 1.0d0
+ counter = 0
+ cont = .true.
+ xprs = press(i)
+ press_guess = xprs
+ rho_guess = rho(i)
+ xprs = press(i)
+ do while(cont)
+ counter = counter + 1
+ rho_guess2 = rho_guess * 1.0001d0
+
+ ! press 2
+ if(rho_guess2.lt.coldeos_rhomin) then
+ keyerr(i) = 104
+ anyerr = 1
+ else if(rho_guess2.gt.coldeos_rhomax) then
+ keyerr(i) = 103
+ anyerr = 1
+ else
+ xrho = log10(rho_guess2)
+ ir = 2 + INT( (xrho - coldeos_logrho(1) - 1.0d-10) * coldeos_dlrhoi )
+ endif
+ ir = max(2, min(ir,coldeos_nrho))
+
+ gamma = (coldeos_gamma(ir) - coldeos_gamma(ir-1)) / &
+ (coldeos_logrho(ir) - coldeos_logrho(ir-1)) * &
+ (xrho - coldeos_logrho(ir-1)) + coldeos_gamma(ir-1)
+
+ press_guess2 = coldeos_kappa * rho_guess2**gamma
+ ! end press 2
+ ! press 1
+ if(rho_guess.lt.coldeos_rhomin) then
+ keyerr(i) = 104
+ anyerr = 1
+ else if(rho_guess.gt.coldeos_rhomax) then
+ keyerr(i) = 103
+ anyerr = 1
+ else
+ xrho = log10(rho_guess)
+ ir = 2 + INT( (xrho - coldeos_logrho(1) - 1.0d-10) * coldeos_dlrhoi )
+ endif
+ ir = max(2, min(ir,coldeos_nrho))
+
+ gamma = (coldeos_gamma(ir) - coldeos_gamma(ir-1)) / &
+ (coldeos_logrho(ir) - coldeos_logrho(ir-1)) * &
+ (xrho - coldeos_logrho(ir-1)) + coldeos_gamma(ir-1)
+
+ press_guess = coldeos_kappa * rho_guess**gamma
+ ! end press 1
+
+ ! derivative
+ mydpdrho = (press_guess2-press_guess)/(rho_guess2-rho_guess)
+ if (mydpdrho.lt.0.0d0) then
+ !$OMP CRITICAL
+ write(warnstring,"(A25,1P10E15.6)") "Issue with table, dpdrho.lt.0",&
+ rho_guess,rho_guess2
+ call CCTK_WARN(0,warnstring)
+ !$OMP END CRITICAL
+ endif
+
+ if (abs(1.0d0-press_guess/xprs).lt.rf_precision) then
+ cont = .false.
+ rho(i) = rho_guess
+ eps(i) = (coldeos_eps(ir) - coldeos_eps(ir-1)) / &
+ (coldeos_logrho(ir) - coldeos_logrho(ir-1)) * &
+ (xrho - coldeos_logrho(ir-1)) + coldeos_eps(ir-1)
+ else
+ if (fac*(xprs-press_guess)/mydpdrho/rho_guess.gt.0.1d0) then
+ rho_guess = 0.99d0*rho_guess
+ else
+ rho_guess = rho_guess + fac*(xprs-press_guess)/mydpdrho
+ endif
+ endif
+
+ if (counter.gt.100) then
+ fac = 0.01d0
+ endif
+
+ if (rho_guess.lt.1.0d-15.or.counter.gt.100000) then
+ keyerr(i) = 473
+ anyerr = 1
+ return
+ endif
+ enddo
+
+ enddo
case DEFAULT
write(warnstring,*) "eoskey ",eoskey," not implemented!"
diff --git a/src/make.code.defn b/src/make.code.defn
index c071792..f23abc5 100644
--- a/src/make.code.defn
+++ b/src/make.code.defn
@@ -3,7 +3,7 @@
# Source files in this directory
SRCS = EOS_Omni_Module.F90 EOS_Omni_Startup.F90 EOS_Omni_SingleVarCalls.F90 \
EOS_Omni_SingleVarCalls_harm.F90 EOS_Omni_Handles.c \
- EOS_Omni_MultiVarCalls.F90
+ EOS_Omni_MultiVarCalls.F90 EOS_Omni_ColdEOSReadTable.F90
# Subdirectories containing source files
SUBDIRS = nuc_eos
diff --git a/tables/README b/tables/README
new file mode 100644
index 0000000..a2a8bbc
--- /dev/null
+++ b/tables/README
@@ -0,0 +1,15 @@
+Directory holding EOS tables for the cold tabulated
++ Gamma-law EOS implemented in EOS_Omni. See Thorn
+documentation for format details.
+
+SLy_Tabulated.dat:
+
+Sly EOS of [1], generated via the fitting formula given
+in [2,3]. Credit: Matt Duez, Washington State University
+
+
+References:
+
+[1] Douchin & Haensel 2001, Astron. Astrophys. 380, 151
+[2] Haensel & Pothekin 2004, Astron. Astrophys. 428, 191
+[3] Shibata, Taniguchi, Uryu 2005, Phys.Rev.D 71 084021
diff --git a/tables/SLy_Tabulated.dat b/tables/SLy_Tabulated.dat
new file mode 100644
index 0000000..523e510
--- /dev/null
+++ b/tables/SLy_Tabulated.dat
@@ -0,0 +1,607 @@
+EoSType = Tabulated
+Nrho = 600 NYe = 1 NT = 1
+RhoMin = 1e-09 RhoMax = 0.01
+HeatCapacityE = 1
+GammaTh = 2
+Kappa = 1
+RhoSpacing = Log
+ 1.57940636422747e-03 1.38773826035349e+00 2.62139412738900e-02
+ 1.58815010286069e-03 1.38791882984854e+00 2.62874297500455e-02
+ 1.59695262269705e-03 1.38809949206894e+00 2.63612210399340e-02
+ 1.60581438808230e-03 1.38828024684584e+00 2.64353169310338e-02
+ 1.61473586751417e-03 1.38846109400215e+00 2.65097192265350e-02
+ 1.62371753368467e-03 1.38864203335234e+00 2.65844297455522e-02
+ 1.63275986352299e-03 1.38882306470221e+00 2.66594503233397e-02
+ 1.64186333823882e-03 1.38900418784867e+00 2.67347828115106e-02
+ 1.65102844336636e-03 1.38918540257956e+00 2.68104290782585e-02
+ 1.66025566880863e-03 1.38936670867337e+00 2.68863910085833e-02
+ 1.66954550888257e-03 1.38954810589907e+00 2.69626705045194e-02
+ 1.67889846236452e-03 1.38972959401584e+00 2.70392694853682e-02
+ 1.68831503253638e-03 1.38991117277291e+00 2.71161898879327e-02
+ 1.69779572723221e-03 1.39009284190928e+00 2.71934336667569e-02
+ 1.70734105888556e-03 1.39027460115349e+00 2.72710027943678e-02
+ 1.71695154457725e-03 1.39045645022345e+00 2.73488992615204e-02
+ 1.72662770608381e-03 1.39063838882617e+00 2.74271250774472e-02
+ 1.73637006992655e-03 1.39082041665754e+00 2.75056822701100e-02
+ 1.74617916742110e-03 1.39100253340211e+00 2.75845728864563e-02
+ 1.75605553472783e-03 1.39118473873286e+00 2.76637989926782e-02
+ 1.76599971290255e-03 1.39136703231096e+00 2.77433626744748e-02
+ 1.77601224794818e-03 1.39154941378559e+00 2.78232660373191e-02
+ 1.78609369086684e-03 1.39173188279364e+00 2.79035112067269e-02
+ 1.79624459771270e-03 1.39191443895957e+00 2.79841003285303e-02
+ 1.80646552964544e-03 1.39209708189512e+00 2.80650355691543e-02
+ 1.81675705298441e-03 1.39227981119911e+00 2.81463191158964e-02
+ 1.82711973926347e-03 1.39246262645724e+00 2.82279531772106e-02
+ 1.83755416528652e-03 1.39264552724184e+00 2.83099399829939e-02
+ 1.84806091318371e-03 1.39282851311167e+00 2.83922817848768e-02
+ 1.85864057046835e-03 1.39301158361171e+00 2.84749808565170e-02
+ 1.86929373009460e-03 1.39319473827295e+00 2.85580394938967e-02
+ 1.88002099051582e-03 1.39337797661216e+00 2.86414600156228e-02
+ 1.89082295574368e-03 1.39356129813172e+00 2.87252447632311e-02
+ 1.90170023540801e-03 1.39374470231939e+00 2.88093961014933e-02
+ 1.91265344481743e-03 1.39392818864814e+00 2.88939164187274e-02
+ 1.92368320502072e-03 1.39411175657593e+00 2.89788081271114e-02
+ 1.93479014286894e-03 1.39429540554556e+00 2.90640736630004e-02
+ 1.94597489107842e-03 1.39447913498445e+00 2.91497154872465e-02
+ 1.95723808829445e-03 1.39466294430451e+00 2.92357360855219e-02
+ 1.96858037915580e-03 1.39484683290192e+00 2.93221379686453e-02
+ 1.98000241436012e-03 1.39503080015702e+00 2.94089236729110e-02
+ 1.99150485073005e-03 1.39521484543412e+00 2.94960957604211e-02
+ 2.00308835128025e-03 1.39539896808137e+00 2.95836568194203e-02
+ 2.01475358528523e-03 1.39558316743063e+00 2.96716094646341e-02
+ 2.02650122834806e-03 1.39576744279733e+00 2.97599563376089e-02
+ 2.03833196246992e-03 1.39595179348034e+00 2.98487001070557e-02
+ 2.05024647612046e-03 1.39613621876189e+00 2.99378434691948e-02
+ 2.06224546430924e-03 1.39632071790747e+00 3.00273891481051e-02
+ 2.07432962865781e-03 1.39650529016572e+00 3.01173398960735e-02
+ 2.08649967747283e-03 1.39668993476838e+00 3.02076984939484e-02
+ 2.09875632582009e-03 1.39687465093023e+00 3.02984677514939e-02
+ 2.11110029559943e-03 1.39705943784902e+00 3.03896505077471e-02
+ 2.12353231562056e-03 1.39724429470549e+00 3.04812496313762e-02
+ 2.13605312167982e-03 1.39742922066330e+00 3.05732680210414e-02
+ 2.14866345663795e-03 1.39761421486906e+00 3.06657086057568e-02
+ 2.16136407049871e-03 1.39779927645236e+00 3.07585743452537e-02
+ 2.17415572048856e-03 1.39798440452577e+00 3.08518682303453e-02
+ 2.18703917113717e-03 1.39816959818493e+00 3.09455932832929e-02
+ 2.20001519435909e-03 1.39835485650862e+00 3.10397525581724e-02
+ 2.21308456953621e-03 1.39854017855886e+00 3.11343491412421e-02
+ 2.22624808360138e-03 1.39872556338100e+00 3.12293861513107e-02
+ 2.23950653112284e-03 1.39891101000393e+00 3.13248667401063e-02
+ 2.25286071438986e-03 1.39909651744018e+00 3.14207940926449e-02
+ 2.26631144349923e-03 1.39928208468615e+00 3.15171714275993e-02
+ 2.27985953644278e-03 1.39946771072234e+00 3.16140019976678e-02
+ 2.29350581919600e-03 1.39965339451359e+00 3.17112890899421e-02
+ 2.30725112580765e-03 1.39983913500936e+00 3.18090360262751e-02
+ 2.32109629849029e-03 1.40002493114404e+00 3.19072461636471e-02
+ 2.33504218771200e-03 1.40021078183732e+00 3.20059228945314e-02
+ 2.34908965228905e-03 1.40039668599452e+00 3.21050696472580e-02
+ 2.36323955947956e-03 1.40058264250708e+00 3.22046898863761e-02
+ 2.37749278507831e-03 1.40076865025295e+00 3.23047871130139e-02
+ 2.39185021351247e-03 1.40095470809712e+00 3.24053648652368e-02
+ 2.40631273793845e-03 1.40114081489214e+00 3.25064267184029e-02
+ 2.42088126033970e-03 1.40132696947871e+00 3.26079762855152e-02
+ 2.43555669162570e-03 1.40151317068629e+00 3.27100172175710e-02
+ 2.45033995173172e-03 1.40169941733379e+00 3.28125532039079e-02
+ 2.46523196971987e-03 1.40188570823026e+00 3.29155879725456e-02
+ 2.48023368388102e-03 1.40207204217571e+00 3.30191252905236e-02
+ 2.49534604183775e-03 1.40225841796189e+00 3.31231689642348e-02
+ 2.51057000064839e-03 1.40244483437319e+00 3.32277228397538e-02
+ 2.52590652691192e-03 1.40263129018758e+00 3.33327908031599e-02
+ 2.54135659687396e-03 1.40281778417759e+00 3.34383767808550e-02
+ 2.55692119653371e-03 1.40300431511143e+00 3.35444847398752e-02
+ 2.57260132175191e-03 1.40319088175405e+00 3.36511186881960e-02
+ 2.58839797835957e-03 1.40337748286839e+00 3.37582826750309e-02
+ 2.60431218226783e-03 1.40356411721660e+00 3.38659807911228e-02
+ 2.62034495957867e-03 1.40375078356145e+00 3.39742171690282e-02
+ 2.63649734669645e-03 1.40393748066770e+00 3.40829959833930e-02
+ 2.65277039044040e-03 1.40412420730363e+00 3.41923214512203e-02
+ 2.66916514815791e-03 1.40431096224262e+00 3.43021978321296e-02
+ 2.68568268783870e-03 1.40449774426483e+00 3.44126294286062e-02
+ 2.70232408822966e-03 1.40468455215894e+00 3.45236205862422e-02
+ 2.71909043895061e-03 1.40487138472409e+00 3.46351756939665e-02
+ 2.73598284061067e-03 1.40505824077173e+00 3.47472991842649e-02
+ 2.75300240492533e-03 1.40524511912780e+00 3.48599955333900e-02
+ 2.77015025483425e-03 1.40543201863480e+00 3.49732692615587e-02
+ 2.78742752461956e-03 1.40561893815415e+00 3.50871249331395e-02
+ 2.80483536002477e-03 1.40580587656856e+00 3.52015671568269e-02
+ 2.82237491837423e-03 1.40599283278454e+00 3.53166005858044e-02
+ 2.84004736869295e-03 1.40617980573505e+00 3.54322299178940e-02
+ 2.85785389182691e-03 1.40636679438231e+00 3.55484598956933e-02
+ 2.87579568056365e-03 1.40655379772067e+00 3.56652953066989e-02
+ 2.89387393975317e-03 1.40674081477967e+00 3.57827409834167e-02
+ 2.91208988642901e-03 1.40692784462727e+00 3.59008018034577e-02
+ 2.93044474992946e-03 1.40711488637318e+00 3.60194826896195e-02
+ 2.94893977201882e-03 1.40730193917234e+00 3.61387886099544e-02
+ 2.96757620700864e-03 1.40748900222868e+00 3.62587245778211e-02
+ 2.98635532187881e-03 1.40767607479889e+00 3.63792956519231e-02
+ 3.00527839639843e-03 1.40786315619647e+00 3.65005069363312e-02
+ 3.02434672324640e-03 1.40805024579596e+00 3.66223635804914e-02
+ 3.04356160813149e-03 1.40823734303733e+00 3.67448707792168e-02
+ 3.06292436991194e-03 1.40842444743056e+00 3.68680337726650e-02
+ 3.08243634071435e-03 1.40861155856050e+00 3.69918578463002e-02
+ 3.10209886605185e-03 1.40879867609188e+00 3.71163483308398e-02
+ 3.12191330494116e-03 1.40898579977455e+00 3.72415106021862e-02
+ 3.14188103001874e-03 1.40917292944898e+00 3.73673500813442e-02
+ 3.16200342765564e-03 1.40936006505198e+00 3.74938722343234e-02
+ 3.18228189807095e-03 1.40954720662273e+00 3.76210825720267e-02
+ 3.20271785544369e-03 1.40973435430897e+00 3.77489866501254e-02
+ 3.22331272802290e-03 1.40992150837356e+00 3.78775900689208e-02
+ 3.24406795823587e-03 1.41010866920126e+00 3.80068984731939e-02
+ 3.26498500279416e-03 1.41029583730587e+00 3.81369175520427e-02
+ 3.28606533279725e-03 1.41048301333762e+00 3.82676530387096e-02
+ 3.30731043383366e-03 1.41067019809088e+00 3.83991107103984e-02
+ 3.32872180607913e-03 1.41085739251228e+00 3.85312963880828e-02
+ 3.35030096439185e-03 1.41104459770907e+00 3.86642159363078e-02
+ 3.37204943840421e-03 1.41123181495794e+00 3.87978752629853e-02
+ 3.39396877261100e-03 1.41141904571414e+00 3.89322803191851e-02
+ 3.41606052645360e-03 1.41160629162102e+00 3.90674370989237e-02
+ 3.43832627440000e-03 1.41179355452002e+00 3.92033516389534e-02
+ 3.46076760602018e-03 1.41198083646100e+00 3.93400300185517e-02
+ 3.48338612605659e-03 1.41216813971307e+00 3.94774783593167e-02
+ 3.50618345448927e-03 1.41235546677590e+00 3.96157028249690e-02
+ 3.52916122659541e-03 1.41254282039141e+00 3.97547096211625e-02
+ 3.55232109300262e-03 1.41273020355612e+00 3.98945049953105e-02
+ 3.57566471973582e-03 1.41291761953384e+00 4.00350952364270e-02
+ 3.59919378825710e-03 1.41310507186905e+00 4.01764866749890e-02
+ 3.62290999549810e-03 1.41329256440077e+00 4.03186856828246e-02
+ 3.64681505388436e-03 1.41348010127705e+00 4.04616986730294e-02
+ 3.67091069135124e-03 1.41366768697006e+00 4.06055320999179e-02
+ 3.69519865135079e-03 1.41385532629182e+00 4.07501924590155e-02
+ 3.71968069284880e-03 1.41404302441064e+00 4.08956862870947e-02
+ 3.74435859031178e-03 1.41423078686820e+00 4.10420201622646e-02
+ 3.76923413368281e-03 1.41441861959744e+00 4.11892007041192e-02
+ 3.79430912834581e-03 1.41460652894111e+00 4.13372345739514e-02
+ 3.81958539507752e-03 1.41479452167121e+00 4.14861284750416e-02
+ 3.84506476998625e-03 1.41498260500925e+00 4.16358891530297e-02
+ 3.87074910443671e-03 1.41517078664732e+00 4.17865233963785e-02
+ 3.89664026496007e-03 1.41535907477013e+00 4.19380380369396e-02
+ 3.92274013314828e-03 1.41554747807800e+00 4.20904399506323e-02
+ 3.94905060553182e-03 1.41573600581079e+00 4.22437360582466e-02
+ 3.97557359343974e-03 1.41592466777299e+00 4.23979333263836e-02
+ 4.00231102284107e-03 1.41611347435975e+00 4.25530387685457e-02
+ 4.02926483416642e-03 1.41630243658416e+00 4.27090594463911e-02
+ 4.05643698210863e-03 1.41649156610569e+00 4.28660024711693e-02
+ 4.08382943540123e-03 1.41668087525991e+00 4.30238750053514e-02
+ 4.11144417657347e-03 1.41687037708945e+00 4.31826842644763e-02
+ 4.13928320168051e-03 1.41706008537644e+00 4.33424375192290e-02
+ 4.16734852000726e-03 1.41725001467628e+00 4.35031420977720e-02
+ 4.19564215374461e-03 1.41744018035304e+00 4.36648053883536e-02
+ 4.22416613763620e-03 1.41763059861634e+00 4.38274348422133e-02
+ 4.25292251859409e-03 1.41782128655994e+00 4.39910379768121e-02
+ 4.28191335528180e-03 1.41801226220210e+00 4.41556223794124e-02
+ 4.31114071766259e-03 1.41820354452773e+00 4.43211957110386e-02
+ 4.34060668651104e-03 1.41839515353249e+00 4.44877657108466e-02
+ 4.37031335288614e-03 1.41858711026892e+00 4.46553402009370e-02
+ 4.40026281756333e-03 1.41877943689464e+00 4.48239270916468e-02
+ 4.43045719042354e-03 1.41897215672286e+00 4.49935343873570e-02
+ 4.46089858979653e-03 1.41916529427522e+00 4.51641701928572e-02
+ 4.49158914175618e-03 1.41935887533701e+00 4.53358427203097e-02
+ 4.52253097936505e-03 1.41955292701515e+00 4.55085602968600e-02
+ 4.55372624186515e-03 1.41974747779872e+00 4.56823313729436e-02
+ 4.58517707381222e-03 1.41994255762255e+00 4.58571645313411e-02
+ 4.61688562415028e-03 1.42013819793365e+00 4.60330684970394e-02
+ 4.64885404522304e-03 1.42033443176101e+00 4.62100521479597e-02
+ 4.68108449171878e-03 1.42053129378861e+00 4.63881245266163e-02
+ 4.71357911954503e-03 1.42072882043203e+00 4.65672948527782e-02
+ 4.74634008462917e-03 1.42092704991882e+00 4.67475725372052e-02
+ 4.77936954164076e-03 1.42112602237274e+00 4.69289671965405e-02
+ 4.81266964263143e-03 1.42132577990215e+00 4.71114886694445e-02
+ 4.84624253558770e-03 1.42152636669278e+00 4.72951470340610e-02
+ 4.88009036289206e-03 1.42172782910515e+00 4.74799526269143e-02
+ 4.91421525968707e-03 1.42193021577672e+00 4.76659160633417e-02
+ 4.94861935213739e-03 1.42213357772930e+00 4.78530482595737e-02
+ 4.98330475558397e-03 1.42233796848183e+00 4.80413604565821e-02
+ 5.01827357258467e-03 1.42254344416876e+00 4.82308642458251e-02
+ 5.05352789083487e-03 1.42275006366466e+00 4.84215715970258e-02
+ 5.08906978096185e-03 1.42295788871497e+00 4.86134948881344e-02
+ 5.12490129418570e-03 1.42316698407362e+00 4.88066469376283e-02
+ 5.16102445983972e-03 1.42337741764769e+00 4.90010410393226e-02
+ 5.19744128274279e-03 1.42358926064952e+00 4.91966909998703e-02
+ 5.23415374041523e-03 1.42380258775681e+00 4.93936111791463e-02
+ 5.27116378013027e-03 1.42401747728097e+00 4.95918165337234e-02
+ 5.30847331579176e-03 1.42423401134441e+00 4.97913226636614e-02
+ 5.34608422462909e-03 1.42445227606706e+00 4.99921458628483e-02
+ 5.38399834369930e-03 1.42467236176277e+00 5.01943031731470e-02
+ 5.42221746618618e-03 1.42489436314610e+00 5.03978124426205e-02
+ 5.46074333748542e-03 1.42511837955017e+00 5.06026923881265e-02
+ 5.49957765106455e-03 1.42534451515597e+00 5.08089626625925e-02
+ 5.53872204408560e-03 1.42557287923410e+00 5.10166439273061e-02
+ 5.57817809277806e-03 1.42580358639934e+00 5.12257579295732e-02
+ 5.61794730754901e-03 1.42603675687895e+00 5.14363275861282e-02
+ 5.65803112781669e-03 1.42627251679541e+00 5.16483770726984e-02
+ 5.69843091655307e-03 1.42651099846441e+00 5.18619319201591e-02
+ 5.73914795452068e-03 1.42675234070892e+00 5.20770191177381e-02
+ 5.78018343418762e-03 1.42699668919026e+00 5.22936672237656e-02
+ 5.82153845330483e-03 1.42724419675714e+00 5.25119064844907e-02
+ 5.86321400812830e-03 1.42749502381351e+00 5.27317689615236e-02
+ 5.90521098626875e-03 1.42774933870645e+00 5.29532886684974e-02
+ 5.94753015915023e-03 1.42800731813504e+00 5.31765017175766e-02
+ 5.99017217405863e-03 1.42826914758135e+00 5.34014464764809e-02
+ 6.03313754576048e-03 1.42853502176476e+00 5.36281637367306e-02
+ 6.07642664767154e-03 1.42880514512087e+00 5.38566968938582e-02
+ 6.12003970255429e-03 1.42907973230617e+00 5.40870921403752e-02
+ 6.16397677272267e-03 1.42935900872986e+00 5.43193986723194e-02
+ 6.20823774973211e-03 1.42964321111423e+00 5.45536689102542e-02
+ 6.25282234353223e-03 1.42993258808492e+00 5.47899587356271e-02
+ 6.29773007105918e-03 1.43022740079253e+00 5.50283277434366e-02
+ 6.34296024424465e-03 1.43052792356718e+00 5.52688395121923e-02
+ 6.38851195741785e-03 1.43083444460738e+00 5.55115618921874e-02
+ 6.43438407407723e-03 1.43114726670488e+00 5.57565673131303e-02
+ 6.48057521300874e-03 1.43146670800700e+00 5.60039331122083e-02
+ 6.52708373372735e-03 1.43179310281803e+00 5.62537418836674e-02
+ 6.57390772121977e-03 1.43212680244131e+00 5.65060818510038e-02
+ 6.62104496996667e-03 1.43246817606337e+00 5.67610472628489e-02
+ 6.66849296722404e-03 1.43281761168187e+00 5.70187388136143e-02
+ 6.71624887554474e-03 1.43317551707853e+00 5.72792640899170e-02
+ 6.76430951452333e-03 1.43354232083863e+00 5.75427380437449e-02
+ 6.81267134174955e-03 1.43391847341811e+00 5.78092834932284e-02
+ 6.86133043295874e-03 1.43430444825947e+00 5.80790316517612e-02
+ 6.91028246137127e-03 1.43470074295737e+00 5.83521226860503e-02
+ 6.95952267621685e-03 1.43510788047444e+00 5.86287063034594e-02
+ 7.00904588044498e-03 1.43552641040779e+00 5.89089423687525e-02
+ 7.05884640762861e-03 1.43595691030609e+00 5.91930015500062e-02
+ 7.10891809807479e-03 1.43639998703686e+00 5.94810659930597e-02
+ 7.15925427416418e-03 1.43685627820282e+00 5.97733300233767e-02
+ 7.20984771495069e-03 1.43732645360583e+00 6.00700008735996e-02
+ 7.26069063006237e-03 1.43781121675601e+00 6.03712994343704e-02
+ 7.31177463295780e-03 1.43831130642269e+00 6.06774610251496e-02
+ 7.36309071360467e-03 1.43882749822314e+00 6.09887361807739e-02
+ 7.41462921066372e-03 1.43936060624334e+00 6.13053914483334e-02
+ 7.46637978327796e-03 1.43991148468411e+00 6.16277101875962e-02
+ 7.51833138258694e-03 1.44048102952401e+00 6.19559933666469e-02
+ 7.57047222310754e-03 1.44107018018859e+00 6.22905603426016e-02
+ 7.62278975414693e-03 1.44167992121349e+00 6.26317496152070e-02
+ 7.67527063144028e-03 1.44231128388628e+00 6.29799195387897e-02
+ 7.72790068923520e-03 1.44296534784900e+00 6.33354489753779e-02
+ 7.78066491307730e-03 1.44364324264021e+00 6.36987378688513e-02
+ 7.83354741358678e-03 1.44434614915151e+00 6.40702077166731e-02
+ 7.88653140155387e-03 1.44507530096907e+00 6.44503019121015e-02
+ 7.93959916472237e-03 1.44583198556588e+00 6.48394859257793e-02
+ 7.99273204667522e-03 1.44661754530498e+00 6.52382472912526e-02
+ 8.04591042828186e-03 1.44743337820726e+00 6.56470953543051e-02
+ 8.09911371221834e-03 1.44828093843068e+00 6.60665607410455e-02
+ 8.15232031112118e-03 1.44916173639926e+00 6.64971944945107e-02
+ 8.20550763999105e-03 1.45007733851164e+00 6.69395668242374e-02
+ 8.25865211351585e-03 1.45102936634824e+00 6.73942654079082e-02
+ 8.31172914903835e-03 1.45201949528539e+00 6.78618931789596e-02
+ 8.36471317594734e-03 1.45304945241157e+00 6.83430655291146e-02
+ 8.41757765232367e-03 1.45412101362748e+00 6.88384068504184e-02
+ 8.47029508972094e-03 1.45523599979587e+00 6.93485463377647e-02
+ 8.52283708700411e-03 1.45639627179063e+00 6.98741129704461e-02
+ 8.57517437420480e-03 1.45760372427612e+00 7.04157295902864e-02
+ 8.62727686737844e-03 1.45886027802820e+00 7.09740059948627e-02
+ 8.67911373546114e-03 1.46016787058740e+00 7.15495309676221e-02
+ 8.73065348012247e-03 1.46152844501281e+00 7.21428631728602e-02
+ 8.78186402958797e-03 1.46294393648242e+00 7.27545208530410e-02
+ 8.83271284736200e-03 1.46441625646279e+00 7.33849702793198e-02
+ 8.88316705671006e-03 1.46594727414852e+00 7.40346129238594e-02
+ 8.93319358165907e-03 1.46753879485146e+00 7.47037713450506e-02
+ 8.98275930513861e-03 1.46919253500150e+00 7.53926738043931e-02
+ 9.03183124471189e-03 1.47091009340831e+00 7.61014376668085e-02
+ 9.08037674613115e-03 1.47269291842761e+00 7.68300516745937e-02
+ 9.12836369469137e-03 1.47454227068080e+00 7.75783572289465e-02
+ 9.17576074405105e-03 1.47645918099628e+00 7.83460288616138e-02
+ 9.22253756183466e-03 1.47844440327971e+00 7.91325541320546e-02
+ 9.26866509093150e-03 1.48049836208581e+00 7.99372132415846e-02
+ 9.31411582496025e-03 1.48262109476147e+00 8.07590587139474e-02
+ 9.35886409588352e-03 1.48481218817006e+00 8.15968955499717e-02
+ 9.40288637123748e-03 1.48707071019760e+00 8.24492623204049e-02
+ 9.44616155789873e-03 1.48939513649461e+00 8.33144137133555e-02
+ 9.48867130875549e-03 1.49178327323413e+00 8.41903050984486e-02
+ 9.53040032809816e-03 1.49423217707615e+00 8.50745797060432e-02
+ 9.57133667101390e-03 1.49673807403069e+00 8.59645590438320e-02
+ 9.61147203158092e-03 1.49929627950902e+00 8.68572371820291e-02
+ 9.65080201423437e-03 1.50190112254197e+00 8.77492795295055e-02
+ 9.68932638234097e-03 1.50454587791073e+00 8.86370266943328e-02
+ 9.72704927779921e-03 1.50722271074825e+00 8.95165039714119e-02
+ 9.76397940540085e-03 1.50992263897676e+00 9.03834369260049e-02
+ 9.80013017577016e-03 1.51263551967209e+00 9.12332734446930e-02
+ 9.83551980096062e-03 1.51535006598245e+00 9.20612125051155e-02
+ 9.87017133724822e-03 1.51805390144594e+00 9.28622397744330e-02
+ 9.90411267032708e-03 1.52073365829083e+00 9.36311699865708e-02
+ 9.93737643898529e-03 1.52337512540410e+00 9.43626958737902e-02
+ 9.96999989441213e-03 1.52596344996914e+00 9.50514432439982e-02
+ 1.00020246935425e-02 1.52848339420515e+00 9.56920316073226e-02
+ 1.00334966262541e-02 1.53091964518147e+00 9.62791395705088e-02
+ 1.00644652777617e-02 1.53325717145140e+00 9.68075740427475e-02
+ 1.00949836291533e-02 1.53548161553770e+00 9.72723421388487e-02
+ 1.01251076006334e-02 1.53757970655819e+00 9.76687245321973e-02
+ 1.01548955436205e-02 1.53953967309946e+00 9.79923489069296e-02
+ 1.01844076893308e-02 1.54135163349039e+00 9.82392620914316e-02
+ 1.02137055628001e-02 1.54300793951437e+00 9.84059994272936e-02
+ 1.02428513724112e-02 1.54450345077105e+00 9.84896499411731e-02
+ 1.02719073858334e-02 1.54583572049986e+00 9.84879159416076e-02
+ 1.03009353038281e-02 1.54700507947736e+00 9.83991657565657e-02
+ 1.03299956435836e-02 1.54801461199626e+00 9.82224784563857e-02
+ 1.03591471431131e-02 1.54887002603512e+00 9.79576795648911e-02
+ 1.03884461977774e-02 1.54957942752036e+00 9.76053669416409e-02
+ 1.04179463392003e-02 1.55015301511273e+00 9.71669262123231e-02
+ 1.04476977657522e-02 1.55060271650472e+00 9.66445353236637e-02
+ 1.04777469324407e-02 1.55094178942794e+00 9.60411579956236e-02
+ 1.05081362065052e-02 1.55118441045101e+00 9.53605260296886e-02
+ 1.05389035933339e-02 1.55134527253474e+00 9.46071106017818e-02
+ 1.05700825355659e-02 1.55143920875425e+00 9.37860828178498e-02
+ 1.06017017864670e-02 1.55148085523301e+00 9.29032639379844e-02
+ 1.06337853569390e-02 1.55148436176988e+00 9.19650657822389e-02
+ 1.06663525338939e-02 1.55146315436693e+00 9.09784219219879e-02
+ 1.06994179662363e-02 1.55142975022025e+00 8.99507103412851e-02
+ 1.07329918133961e-02 1.55139562289387e+00 8.88896683318222e-02
+ 1.07670799502576e-02 1.55137111339798e+00 8.78033004728629e-02
+ 1.08016842214693e-02 1.55136538167581e+00 8.66997806543534e-02
+ 1.08368027374824e-02 1.55138639244752e+00 8.55873492367008e-02
+ 1.08724302042790e-02 1.55144092931547e+00 8.44742066112384e-02
+ 1.09085582785740e-02 1.55153463135394e+00 8.33684046333511e-02
+ 1.09451759403233e-02 1.55167204695326e+00 8.22777376415051e-02
+ 1.09822698746033e-02 1.55185670035415e+00 8.12096350378950e-02
+ 1.10198248553294e-02 1.55209116700805e+00 8.01710576692888e-02
+ 1.10578241238289e-02 1.55237715457586e+00 7.91684004804540e-02
+ 1.10962497559474e-02 1.55271558699230e+00 7.82074040811432e-02
+ 1.11350830121184e-02 1.55310668955742e+00 7.72930779314411e-02
+ 1.11743046656485e-02 1.55355007346186e+00 7.64296377717109e-02
+ 1.12138953053245e-02 1.55404481851102e+00 7.56204596728663e-02
+ 1.12538356093263e-02 1.55458955309261e+00 7.48680526453774e-02
+ 1.12941065882987e-02 1.55518253064260e+00 7.41740511265009e-02
+ 1.13346897962852e-02 1.55582170202020e+00 7.35392278928513e-02
+ 1.13755675090312e-02 1.55650478331485e+00 7.29635270701535e-02
+ 1.14167228699202e-02 1.55722931869038e+00 7.24461160019334e-02
+ 1.14581400044891e-02 1.55799273793496e+00 7.19854538715868e-02
+ 1.14998041050789e-02 1.55879240843802e+00 7.15793742241708e-02
+ 1.15417014876966e-02 1.55962568136669e+00 7.12251779702222e-02
+ 1.15838196236002e-02 1.56048993186767e+00 7.09197331183265e-02
+ 1.16261471484513e-02 1.56138259317984e+00 7.06595773948799e-02
+ 1.16686738521295e-02 1.56230118460983e+00 7.04410200610139e-02
+ 1.17113906524522e-02 1.56324333339539e+00 7.02602395972793e-02
+ 1.17542895561120e-02 1.56420679055812e+00 7.01133744491483e-02
+ 1.17973636101299e-02 1.56518944092440e+00 6.99966046542906e-02
+ 1.18406068470397e-02 1.56618930756683e+00 6.99062228485415e-02
+ 1.18840142268783e-02 1.56720455098394e+00 6.98386938191607e-02
+ 1.19275815788672e-02 1.56823346338934e+00 6.97907023986846e-02
+ 1.19713055454489e-02 1.56927445851926e+00 6.97591900392856e-02
+ 1.20151835311021e-02 1.57032605738743e+00 6.97413808568258e-02
+ 1.20592136581116e-02 1.57138687041746e+00 6.97347982769500e-02
+ 1.21033947312285e-02 1.57245557636506e+00 6.97372736525097e-02
+ 1.21477262129312e-02 1.57353089840872e+00 6.97469483581345e-02
+ 1.21922082108060e-02 1.57461157773933e+00 6.97622709137768e-02
+ 1.22368414783968e-02 1.57569634492368e+00 6.97819906558971e-02
+ 1.22816274307546e-02 1.57678388925683e+00 6.98051493746702e-02
+ 1.23265681758274e-02 1.57787282626426e+00 6.98310721785983e-02
+ 1.23716665627847e-02 1.57896166347113e+00 6.98593586432833e-02
+ 1.24169262483491e-02 1.58004876453512e+00 6.98898750548022e-02
+ 1.24623517822118e-02 1.58113231184853e+00 6.99227482735315e-02
+ 1.25079487126135e-02 1.58221026776753e+00 6.99583614214180e-02
+ 1.25537237131659e-02 1.58328033473254e+00 6.99973512315595e-02
+ 1.25996847319424e-02 1.58433991471828e+00 7.00406064880281e-02
+ 1.26458411637472e-02 1.58538606870700e+00 7.00892665192789e-02
+ 1.26922040462450e-02 1.58641547723017e+00 7.01447181831626e-02
+ 1.27387862802453e-02 1.58742440348300e+00 7.02085891924068e-02
+ 1.27856028738372e-02 1.58840866109358e+00 7.02827349799132e-02
+ 1.28326712091962e-02 1.58936358932476e+00 7.03692156106570e-02
+ 1.28800113296583e-02 1.59028403929411e+00 7.04702585482690e-02
+ 1.29276462430145e-02 1.59116437568533e+00 7.05882024462821e-02
+ 1.29756022348299e-02 1.59199849933857e+00 7.07254166598190e-02
+ 1.30239091828917e-02 1.59277989695539e+00 7.08841910125221e-02
+ 1.30726008605767e-02 1.59350172479803e+00 7.10665907014836e-02
+ 1.31217152130211e-02 1.59415693351581e+00 7.12742723171904e-02
+ 1.31712945855317e-02 1.59473844085241e+00 7.15082590545862e-02
+ 1.32213858788791e-02 1.59523935770286e+00 7.17686765351699e-02
+ 1.32720406012582e-02 1.59565327051406e+00 7.20544554115835e-02
+ 1.33233147822785e-02 1.59597457912364e+00 7.23630130901263e-02
+ 1.33752687110433e-02 1.59619888369434e+00 7.26899342423996e-02
+ 1.34279664590721e-02 1.59632340753133e+00 7.30286777159158e-02
+ 1.34814751506132e-02 1.59634743467913e+00 7.33703450536052e-02
+ 1.35358639489346e-02 1.59627273307454e+00 7.37035517937991e-02
+ 1.35912027385913e-02 1.59610392684933e+00 7.40144454933712e-02
+ 1.36475605012765e-02 1.59584877657467e+00 7.42869123960699e-02
+ 1.37050034068392e-02 1.59551832533694e+00 7.45030064933540e-02
+ 1.37635926706933e-02 1.59512687278679e+00 7.46436196263132e-02
+ 1.38233822621180e-02 1.59469174936364e+00 7.46893894148639e-02
+ 1.38844165814938e-02 1.59423287848837e+00 7.46218145409171e-02
+ 1.39467282536597e-02 1.59377213428427e+00 7.44245169317471e-02
+ 1.40103362038934e-02 1.59333252398052e+00 7.40845615398601e-02
+ 1.40752441871735e-02 1.59293724457559e+00 7.35937212856839e-02
+ 1.41414399263908e-02 1.59260867947690e+00 7.29495619182835e-02
+ 1.42088949794713e-02 1.59236741008376e+00 7.21562227452694e-02
+ 1.42775654008983e-02 1.59223131806051e+00 7.12247862612954e-02
+ 1.43473931954431e-02 1.59221484612218e+00 7.01731621061271e-02
+ 1.44183084896556e-02 1.59232846965624e+00 6.90254554129993e-02
+ 1.44902322800195e-02 1.59257841068928e+00 6.78108413289259e-02
+ 1.45630795653817e-02 1.59296660250390e+00 6.65620200643959e-02
+ 1.46367626425555e-02 1.59349089068804e+00 6.53133739643036e-02
+ 1.47111943411214e-02 1.59414543725317e+00 6.40989841805830e-02
+ 1.47862909952769e-02 1.59492128062985e+00 6.29506849386484e-02
+ 1.48619749919482e-02 1.59580699682408e+00 6.18963344964582e-02
+ 1.49381767876941e-02 1.59678940580510e+00 6.09584613684981e-02
+ 1.50148363437788e-02 1.59785427148429e+00 6.01534022138199e-02
+ 1.50919039816041e-02 1.59898695206020e+00 5.94909877922850e-02
+ 1.51693407040037e-02 1.60017296840614e+00 5.89747642121428e-02
+ 1.52471180585958e-02 1.60139846994321e+00 5.86026708524733e-02
+ 1.53252176369548e-02 1.60265058868538e+00 5.83680469688252e-02
+ 1.54036303089564e-02 1.60391768184765e+00 5.82608153499370e-02
+ 1.54823552877759e-02 1.60518947097006e+00 5.82686956129153e-02
+ 1.55613991105247e-02 1.60645709071600e+00 5.83783265027087e-02
+ 1.56407746052223e-02 1.60771306345104e+00 5.85762158851377e-02
+ 1.57204998991060e-02 1.60895121671423e+00 5.88494782900770e-02
+ 1.58005975079473e-02 1.61016656018532e+00 5.91863547672649e-02
+ 1.58810935322402e-02 1.61135513718990e+00 5.95765343598785e-02
+ 1.59620169744956e-02 1.61251386359644e+00 6.00113102201317e-02
+ 1.60433991826048e-02 1.61364036450203e+00 6.04836081576081e-02
+ 1.61252734172950e-02 1.61473281664681e+00 6.09879240176930e-02
+ 1.62076745367917e-02 1.61578980222438e+00 6.15202014335727e-02
+ 1.62906387886590e-02 1.61681017777414e+00 6.20776752728490e-02
+ 1.63742036970332e-02 1.61779296019835e+00 6.26586998741626e-02
+ 1.64584080327663e-02 1.61873723064595e+00 6.32625756775332e-02
+ 1.65432918541037e-02 1.61964205602390e+00 6.38893833826435e-02
+ 1.66288966061591e-02 1.62050642719459e+00 6.45398313355856e-02
+ 1.67152652684725e-02 1.62132921245187e+00 6.52151193203667e-02
+ 1.68024425411530e-02 1.62210912459213e+00 6.59168201400405e-02
+ 1.68904750614490e-02 1.62284469977065e+00 6.66467791380377e-02
+ 1.69794116439400e-02 1.62353428632047e+00 6.74070309831693e-02
+ 1.70693035388749e-02 1.62417604178149e+00 6.81997325053453e-02
+ 1.71602047044164e-02 1.62476793651593e+00 6.90271100387959e-02
+ 1.72521720897010e-02 1.62530776245263e+00 6.98914195471955e-02
+ 1.73452659266387e-02 1.62579314568984e+00 7.07949177315684e-02
+ 1.74395500292632e-02 1.62622156188149e+00 7.17398423309833e-02
+ 1.75350921001901e-02 1.62659035352424e+00 7.27283998992245e-02
+ 1.76319640443748e-02 1.62689674844395e+00 7.37627594632213e-02
+ 1.77302422908452e-02 1.62713787894482e+00 7.48450506281427e-02
+ 1.78300081234809e-02 1.62731080122731e+00 7.59773648775162e-02
+ 1.79313480221923e-02 1.62741251480070e+00 7.71617590128234e-02
+ 1.80343540160606e-02 1.62743998171121e+00 7.84002598748714e-02
+ 1.81391240501276e-02 1.62739014547771e+00 7.96948696792399e-02
+ 1.82457623676163e-02 1.62725994967619e+00 8.10475714725033e-02
+ 1.83543799093938e-02 1.62704635614323e+00 8.24603343690538e-02
+ 1.84650947325096e-02 1.62674636278160e+00 8.39351183568763e-02
+ 1.85780324496378e-02 1.62635702095079e+00 8.54738785632967e-02
+ 1.86933266912485e-02 1.62587545241505e+00 8.70785689492541e-02
+ 1.88111195923213e-02 1.62529886580585e+00 8.87511454551242e-02
+ 1.89315623054117e-02 1.62462457253591e+00 9.04935686557002e-02
+ 1.90548155418916e-02 1.62385000208298e+00 9.23078060002491e-02
+ 1.91810501432023e-02 1.62297271654293e+00 9.41958337193896e-02
+ 1.93104476839880e-02 1.62199042433812e+00 9.61596384774611e-02
+ 1.94432011090244e-02 1.62090099295647e+00 9.82012188402011e-02
+ 1.95795154059097e-02 1.61970246059276e+00 1.00322586615536e-01
+ 1.97196083155607e-02 1.61839304656450e+00 1.02525768112085e-01
+ 1.98637110826289e-02 1.61697116038155e+00 1.04812805347048e-01
+ 2.00120692480499e-02 1.61543540936052e+00 1.07185757223312e-01
+ 2.01649434860296e-02 1.61378460469152e+00 1.09646700685524e-01
+ 2.03226104878914e-02 1.61201776588507e+00 1.12197731856534e-01
+ 2.04853638953133e-02 1.61013412355066e+00 1.14840967149135e-01
+ 2.06535152856164e-02 1.60813312048337e+00 1.17578544343155e-01
+ 2.08273952118958e-02 1.60601441106203e+00 1.20412623614479e-01
+ 2.10073543009228e-02 1.60377785898858e+00 1.23345388500222e-01
+ 2.11937644118952e-02 1.60142353342462e+00 1.26379046782778e-01
+ 2.13870198592676e-02 1.59895170360535e+00 1.29515831274614e-01
+ 2.15875387030464e-02 1.59636283203330e+00 1.32758000485279e-01
+ 2.17957641101199e-02 1.59365756637351e+00 1.36107839151933e-01
+ 2.20121657903420e-02 1.59083673018807e+00 1.39567658614794e-01
+ 2.22372415113030e-02 1.58790131266020e+00 1.43139797018959e-01
+ 2.24715186958906e-02 1.58485245746684e+00 1.46826619324236e-01
+ 2.27155561069459e-02 1.58169145096376e+00 1.50630517104675e-01
+ 2.29699456235424e-02 1.57841970984853e+00 1.54553908119543e-01
+ 2.32353141136135e-02 1.57503876846455e+00 1.58599235637417e-01
+ 2.35123254078897e-02 1.57155026590418e+00 1.62768967494933e-01
+ 2.38016823803451e-02 1.56795593306116e+00 1.67065594871477e-01
+ 2.41041291405846e-02 1.56425757977218e+00 1.71491630760774e-01
+ 2.44204533438659e-02 1.56045708217562e+00 1.76049608119877e-01
+ 2.47514886247124e-02 1.55655637040187e+00 1.80742077675577e-01
+ 2.50981171603397e-02 1.55255741669569e+00 1.85571605367651e-01
+ 2.54612723704069e-02 1.54846222405592e+00 1.90540769407717e-01
+ 2.58419417598934e-02 1.54427281546358e+00 1.95652156931809e-01
+ 2.62411699122036e-02 1.53999122375443e+00 2.00908360224052e-01
+ 2.66600616399157e-02 1.53561948217838e+00 2.06311972488135e-01
+ 2.70997853009110e-02 1.53115961567500e+00 2.11865583142558e-01
+ 2.75615762879489e-02 1.52661363288228e+00 2.17571772615030e-01
+ 2.80467407001062e-02 1.52198351888480e+00 2.23433106610775e-01
+ 2.85566592048294e-02 1.51727122869763e+00 2.29452129829065e-01
+ 2.90927910997323e-02 1.51247868147411e+00 2.35631359101945e-01
+ 2.96566785836185e-02 1.50760775541800e+00 2.41973275928933e-01
+ 3.02499512466003e-02 1.50266028337481e+00 2.48480318381542e-01
+ 3.08743307895620e-02 1.49763804907222e+00 2.55154872351701e-01
+ 3.15316359836104e-02 1.49254278397557e+00 2.61999262118764e-01
+ 3.22237878805522e-02 1.48737616472201e+00 2.69015740210670e-01
+ 3.29528152858443e-02 1.48213981109475e+00 2.76206476536101e-01
+ 3.37208605058597e-02 1.47683528449808e+00 2.83573546766229e-01
+ 3.45301853817417e-02 1.47146408689322e+00 2.91118919946833e-01
+ 3.53831776225093e-02 1.46602766015582e+00 2.98844445324353e-01
+ 3.62823574505016e-02 1.46052738581602e+00 3.06751838372792e-01
+ 3.72303845726600e-02 1.45496458514393e+00 3.14842666012440e-01
+ 3.82300654915402e-02 1.44934051954419e+00 3.23118331016147e-01
+ 3.92843611703593e-02 1.44365639122559e+00 3.31580055604425e-01
+ 4.03963950667712e-02 1.43791334411330e+00 3.40228864237034e-01
+ 4.15694615504258e-02 1.43211246497358e+00 3.49065565616037e-01
+ 4.28070347197584e-02 1.42625478472266e+00 3.58090733923465e-01
+ 4.41127776337755e-02 1.42034127989404e+00 3.67304689326003e-01
+ 4.54905519749367e-02 1.41437287424023e+00 3.76707477789262e-01
+ 4.69444281595250e-02 1.40835044044729e+00 3.86298850255436e-01
+ 4.84786959121606e-02 1.40227480194249e+00 3.96078241250398e-01
+ 5.00978753213288e-02 1.39614673477739e+00 4.06044746999452e-01
+ 5.18067283929948e-02 1.38996696957043e+00 4.16197103145194e-01
+ 5.36102711194857e-02 1.38373619349515e+00 4.26533662175868e-01
+ 5.55137860809141e-02 1.37745505230135e+00 4.37052370688465e-01
+ 5.75228355964181e-02 1.37112415235854e+00 4.47750746627141e-01
+ 5.96432754424390e-02 1.36474406271207e+00 4.58625856654408e-01
+ 6.18812691551116e-02 1.35831531714388e+00 4.69674293829555e-01
+ 6.42433029336114e-02 1.35183841623084e+00 4.80892155785775e-01
+ 6.67362011609689e-02 1.34531382939490e+00 4.92275023614107e-01
+ 6.93671425584141e-02 1.33874199694006e+00 5.03817941678178e-01
+ 7.21436769887527e-02 1.33212333207228e+00 5.15515398598605e-01
+ 7.50737429235566e-02 1.32545822289901e+00 5.27361309659087e-01
+ 7.81656855881108e-02 1.31874703440599e+00 5.39349000897511e-01
+ 8.14282757970202e-02 1.31199011040925e+00 5.51471195154005e-01
+ 8.48707294921980e-02 1.30518777548123e+00 5.63720000353568e-01
+ 8.85027279935455e-02 1.29834033684994e+00 5.76086900302839e-01
+ 9.23344389710312e-02 1.29144808627092e+00 5.88562748278548e-01
+ 9.63765381450301e-02 1.28451130187176e+00 6.01137763678368e-01
+ 1.00640231719699e-01 1.27753024996963e+00 6.13801531993063e-01
+ 1.05137279551794e-01 1.27050518686202e+00 6.26543008341491e-01
+ 1.09880019054683e-01 1.26343636059160e+00 6.39350524786747e-01
+ 1.14881389834357e-01 1.25632401268597e+00 6.52211801622593e-01
+ 1.20154959050911e-01 1.24916837987329e+00 6.65113962783812e-01
+ 1.25714947495369e-01 1.24196969577479e+00 6.78043555492792e-01
+ 1.31576256367603e-01 1.23472819257542e+00 6.90986574207228e-01
+ 1.37754494736763e-01 1.22744410267373e+00 7.03928488881169e-01
+ 1.44266007660694e-01 1.22011766031214e+00 7.16854277494025e-01
+ 1.51127904935517e-01 1.21274910318877e+00 7.29748462740507e-01
+ 1.58358090440821e-01 1.20533867405203e+00 7.42595152709874e-01
+ 1.65975292039536e-01 1.19788662227884e+00 7.55378085316221e-01
+ 1.73999091984862e-01 1.19039320543768e+00 7.68080676174493e-01
+ 1.82449957779223e-01 1.18285869083718e+00 7.80686069550599e-01
+ 1.91349273422380e-01 1.17528335706107e+00 7.93177191950271e-01
+ 2.00719370977333e-01 1.16766749549025e+00 8.05536807851424e-01
+ 2.10583562373658e-01 1.16001141181223e+00 8.17747577030641e-01
+ 2.20966171358243e-01 1.15231542751856e+00 8.29792112887288e-01
+ 2.31892565493180e-01 1.14457988139024e+00 8.41653041130163e-01
+ 2.43389188089730e-01 1.13680513097115e+00 8.53313058162824e-01
+ 2.55483589955829e-01 1.12899155402930e+00 8.64754988485598e-01
+ 2.68204460822623e-01 1.12113955000555e+00 8.75961840425721e-01
+ 2.81581660302859e-01 1.11324954144906e+00 8.86916859512336e-01
+ 2.95646248220897e-01 1.10532197543867e+00 8.97603578830370e-01
+ 3.10430514140378e-01 1.09735732498915e+00 9.08005865716296e-01
+ 3.25968005901539e-01 1.08935609044086e+00 9.18107964198858e-01
+ 3.42293556965522e-01 1.08131880083139e+00 9.27894532638060e-01
+ 3.59443312348262e-01 1.07324601524711e+00 9.37350676074797e-01
+ 3.77454752911261e-01 1.06513832415258e+00 9.46461972869909e-01
+ 3.96366717761265e-01 1.05699635069538e+00 9.55214495283433e-01
+ 4.16219424495482e-01 1.04882075198357e+00 9.63594823720530e-01
+ 4.37054487013536e-01 1.04061222033280e+00 9.71590054447835e-01
+ 4.58914930602287e-01 1.03237148447969e+00 9.79187800661033e-01
+ 4.81845203984740e-01 1.02409931075780e+00 9.86376186858982e-01
+ 5.05891188010072e-01 1.01579650423232e+00 9.93143836550081e-01
+ 5.31100200648169e-01 1.00746390978906e+00 9.99479853380827e-01
+ 5.57520997939492e-01 9.99102413173243e-01 1.00537379583309e+00
+ 5.85203770539644e-01 9.90712941973122e-01 1.01081564568431e+00
+ 6.14200135487925e-01 9.82296466543228e-01 1.01579577046206e+00
+ 6.44563122820938e-01 9.73854000861691e-01 1.02030488015091e+00
+ 6.76347156645814e-01 9.65386603315810e-01 1.02433397842376e+00
+ 7.09608030283730e-01 9.56895377409739e-01 1.02787430867204e+00
+ 7.44402875092738e-01 9.48381472387916e-01 1.03091729509830e+00
+ 7.80790122580569e-01 9.39846083767555e-01 1.03345447911120e+00
+ 8.18829459422637e-01 9.31290453773331e-01 1.03547745122567e+00
+ 8.58581775008913e-01 9.22715871667143e-01 1.03697777862048e+00
+ 9.00109101155556e-01 9.14123673965655e-01 1.03794692844104e+00
+ 9.43474543633696e-01 9.05515244538180e-01 1.03837618685593e+00
+ 9.88742205188997e-01 8.96892014577315e-01 1.03825657378099e+00
+ 1.03597709975157e+00 8.88255462434678e-01 1.03757875307354e+00
+ 1.08524505756717e+00 8.79607113314024e-01 1.03633293786839e+00
+ 1.13661262101703e+00 8.70948538814076e-01 1.03450879057567e+00
+ 1.19014693093643e+00 8.62281356313370e-01 1.03209531688245e+00
+ 1.24591560328970e+00 8.53607228189633e-01 1.02908075289198e+00
+ 1.30398659611375e+00 8.44927860866267e-01 1.02545244428853e+00
+ 1.36442806670215e+00 8.36245003678830e-01 1.02119671612304e+00
+ 1.42730821906745e+00 8.27560447554637e-01 1.01629873146365e+00
+ 1.49269514179132e+00 8.18876023499002e-01 1.01074233672890e+00
+ 1.56065663644920e+00 8.10193600882043e-01 1.00450989099927e+00
+ 1.63126003687861e+00 8.01515085520505e-01 9.97582075956461e-01
+ 1.70457201964761e+00 7.92842417549614e-01 9.89937682291418e-01
+ 1.78065840617139e+00 7.84177569080631e-01 9.81553367400070e-01
+ 1.85958395702006e+00 7.75522541640513e-01 9.72403377881213e-01
+ 1.94141215905905e+00 7.66879363390882e-01 9.62459228666742e-01
+ 2.02620500616298e+00 7.58250086124389e-01 9.51689328417656e-01
+ 2.11402277434514e+00 7.49636782037489e-01 9.40058537921155e-01
+ 2.20492379224527e+00 7.41041540279683e-01 9.27527644356141e-01
+ 2.29896420801737e+00 7.32466463280349e-01 9.14052729067358e-01
+ 2.39619775375610e+00 7.23913662855405e-01 8.99584399330655e-01
+ 2.49667550869228e+00 7.15385256097266e-01 8.84066844649049e-01
+ 2.60044566247495e+00 7.06883361052753e-01 8.67436664091159e-01
+ 2.70755327993677e+00 6.98410092194905e-01 8.49621391052088e-01
+ 2.81804006881059e+00 6.89967555695907e-01 8.30537612378975e-01